From f714e7b0b4e8601867cbd4606ffca39421e30be9 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 15 Dec 2020 13:48:51 +0100 Subject: [PATCH 001/120] Clean the use of the mappers to makes easier the friction implemententation --- ipi/engine/motion/instanton.py | 301 +++++++++++++++++---------------- 1 file changed, 156 insertions(+), 145 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 2462efe18..98e81d0bb 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -205,9 +205,10 @@ def step(self, step=None): class Fix(object): """Class that applies a fixatoms type constrain""" - def __init__(self, natoms, fixatoms, nbeads=1): - self.natoms = natoms - self.nbeads = nbeads + def __init__(self, fixatoms, beads, nbeads=1): + + self.natoms = beads.natoms + self.nbeads = beads.nbeads self.fixatoms = fixatoms self.mask0 = np.delete(np.arange(self.natoms), self.fixatoms) @@ -220,6 +221,11 @@ def __init__(self, natoms, fixatoms, nbeads=1): mask2 = np.tile(mask1, self.nbeads) self.mask2 = np.arange(3 * self.natoms * self.nbeads)[mask2] + self.fixbeads = Beads(beads.natoms - len(fixatoms), beads.nbeads) + self.fixbeads.q[:] = self.get_active_vector(beads.copy().q, 1) + self.fixbeads.m[:] = self.get_active_vector(beads.copy().m, 0) + self.fixbeads.names[:] = self.get_active_vector(beads.copy().names, 0) + def get_mask(self, m): if m == 0: @@ -350,13 +356,14 @@ def __init__(self): self.fcount = 0 pass - def bind(self, dumop, discretization, max_ms, max_e): + def bind(self, fm, max_ms, max_e): + + self.dbeads = fm.beads.copy() + self.dcell = fm.cell.copy() + self.dforces = fm.forces.copy(self.dbeads, self.dcell) + self.fix = fm.fix + self.coef = fm.coef - self.dbeads = dumop.beads.copy() - self.dcell = dumop.cell.copy() - self.dforces = dumop.forces.copy(self.dbeads, self.dcell) - self.fix = Fix(dumop.beads.natoms, dumop.fixatoms, dumop.beads.nbeads) - self.set_coef(discretization) if max_ms > 0 or max_e > 0: self.spline = True @@ -371,9 +378,6 @@ def bind(self, dumop, discretization, max_ms, max_e): else: self.spline = False - def set_coef(self, coef): - self.coef = coef.reshape(-1, 1) - def set_pos(self, x): """Set the positions """ self.dbeads.q = x @@ -382,7 +386,7 @@ def save(self, e, g): self.pot = e self.f = -g - def __call__(self, x, full=False, new_disc=True): + def __call__(self, x, new_disc=True): """computes energy and gradient for optimization step""" self.fcount += 1 full_q = x.copy() @@ -416,7 +420,7 @@ def __call__(self, x, full=False, new_disc=True): else: indexes = np.arange(self.dbeads.nbeads) - # Create reduced bead and force objet and evaluate forces + # Create reduced bead and force objects reduced_b = Beads(self.dbeads.natoms, len(indexes)) reduced_b.q[:] = full_q[indexes] reduced_b.m[:] = self.dbeads.m @@ -425,10 +429,11 @@ def __call__(self, x, full=False, new_disc=True): reduced_cell = self.dcell.copy() reduced_forces = self.dforces.copy(reduced_b, reduced_cell) + # Evaluate forces rpots = reduced_forces.pots # reduced energy rforces = reduced_forces.f # reduced gradient - # Interpolate if necesary to get full pot and forces + # Interpolate if necessary to get full pot and forces if self.spline: red_mspath = full_mspath[indexes] spline = interp1d(red_mspath, rpots.T, kind="cubic") @@ -450,10 +455,8 @@ def __call__(self, x, full=False, new_disc=True): self.save(full_pot, g) - if not full: - g = self.fix.get_active_vector(g, 1) - - # APPLY OTHERS CONSTRAIN? + # if not full: + # g = self.fix.get_active_vector(g, 1) # Discretization if new_disc: @@ -470,31 +473,30 @@ class SpringMapper(object): def __init__(self): - self.pot = None - self.f = None - self.dbeads = None - self.fix = None + pass - def bind(self, dumop, discretization): + def bind(self, fm): - self.temp = dumop.temp - self.fix = Fix(dumop.beads.natoms, dumop.fixatoms, dumop.beads.nbeads) - self.dbeads = Beads( - dumop.beads.natoms - len(dumop.fixatoms), dumop.beads.nbeads - ) - self.dbeads.q[:] = self.fix.get_active_vector(dumop.beads.copy().q, 1) - self.dbeads.m[:] = self.fix.get_active_vector(dumop.beads.copy().m, 0) - self.dbeads.names[:] = self.fix.get_active_vector(dumop.beads.copy().names, 0) - self.set_coef(discretization) + self.temp = fm.temp + self.fix = fm.fix + self.coef = fm.coef + + self.dbeads = fm.beads.copy() + # self.dbeads = Beads( + # fm.beads.natoms - len(fm.fixatoms), fm.beads.nbeads + # ) + # self.dbeads.q[:] = self.fix.get_active_vector(fm.beads.copy().q, 1) + # self.dbeads.m[:] = self.fix.get_active_vector(fm.beads.copy().m, 0) + # self.dbeads.names[:] = self.fix.get_active_vector(fm.beads.copy().names, 0) - if dumop.options["mode"] == "rate": + if fm.options["mode"] == "rate": self.omega2 = ( self.temp * (2 * self.dbeads.nbeads) * units.Constants.kb / units.Constants.hbar ) ** 2 - elif dumop.options["mode"] == "splitting": + elif fm.options["mode"] == "splitting": self.omega2 = ( self.temp * self.dbeads.nbeads @@ -503,22 +505,18 @@ def bind(self, dumop, discretization): ) ** 2 if ( - dumop.options["opt"] == "nichols" - or dumop.options["opt"] == "NR" - or dumop.options["opt"] == "lanczos" + fm.options["opt"] == "nichols" + or fm.options["opt"] == "NR" + or fm.options["opt"] == "lanczos" ): self.h = self.spring_hessian( - natoms=self.dbeads.natoms, - nbeads=self.dbeads.nbeads, - m3=self.dbeads.m3[0], + natoms=self.fix.fixbeads.natoms, + nbeads=self.fix.fixbeads.nbeads, + m3=self.fix.fixbeads.m3[0], omega2=self.omega2, coef=self.coef, ) - def set_coef(self, coef): - """ Sets coeficients for non-uniform instanton calculation """ - self.coef = coef.reshape(-1, 1) - def save(self, e, g): """ Stores potential and forces in this class for convenience """ self.pot = e @@ -588,7 +586,7 @@ def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): def __call__(self, x, ret=True, new_disc=True): """Computes spring energy and gradient for instanton optimization step""" - x = self.fix.get_active_vector(x, 1).copy() + # x = self.fix.get_active_vector(x, 1).copy() if new_disc: coef = self.coef @@ -649,8 +647,8 @@ def __call__(self, x, ret=True, new_disc=True): class FullMapper(object): - """Creation of the multi-dimensional function to compute the physical and the spring forces. - """ + """Creation of the multi-dimensional function that is the proxy between all the energy and force components and the optimization algorithm. + It also handles fixatoms """ def __init__(self, im, gm, esum=False): @@ -658,33 +656,76 @@ def __init__(self, im, gm, esum=False): self.gm = gm self.esum = esum - def __call__(self, x): + def save(self, e, g): + self.pot = e + self.f = -g + + def bind(self, dumop): + + self.temp = dumop.temp + self.beads = dumop.beads + self.forces = dumop.forces + self.cell = dumop.cell + self.nm = dumop.nm + + self.options = dumop.options + self.fixatoms = dumop.fixatoms + self.fix = Fix(self.fixatoms, self.beads, self.beads.nbeads) + self.fixbeads = self.fix.fixbeads + + self.coef = np.ones(self.beads.nbeads + 1).reshape(-1, 1) + self.set_coef(self.options["discretization"]) + + self.gm.bind( + self, self.options["max_ms"], self.options["max_e"], + ) + + self.im.bind(self) + + def set_coef(self, coef): + """ Sets coeficients for non-uniform instanton calculation """ + self.coef[:] = coef.reshape(-1, 1) + + def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): + + print("HEEEEEERE") + if mode == "all": + e1, g1 = self.im(x, new_disc) + e2, g2 = self.gm(x, new_disc) + e = e1 + e2 + g = np.add(g1, g2) + + elif mode == "physical": + e, g = self.gm(x, new_disc) + elif mode == "springs": + e, g = self.im(x, new_disc) + else: + softexit.trigger("Mode not recognized when calling FullMapper") - e1, g1 = self.im(x) - e2, g2 = self.gm(x) - e = e1 + e2 - g = np.add(g1, g2) + if apply_fix: + g = self.fix.get_active_vector(g, 1) if self.esum: e = np.sum(e) - return e, g + if mode == "all": + self.save(e, g) + + if ret: + return e, g class DummyOptimizer(dobject): """ Dummy class for all optimization classes """ def __init__(self): - """Initialises object for GradientMapper (physical potential, forces and hessian) + """Initializes object for GradientMapper (physical potential, forces and hessian) and SpringMapper ( spring potential,forces and hessian) """ self.options = {} # Optimization options self.optarrays = {} # Optimization arrays - self.gm = GradientMapper() - self.im = SpringMapper() - self.fm = FullMapper(self.im, self.gm) - self.fix = None + self.fm = FullMapper(SpringMapper(), GradientMapper()) self.exit = False self.init = False @@ -701,8 +742,9 @@ def bind(self, geop): self.fixcom = geop.fixcom self.fixatoms = geop.fixatoms self.nm = geop.nm - # self.ensemble = geop.ens + self.output_maker = geop.output_maker + # The resize action must be done before the bind if geop.optarrays["old_x"].size != self.beads.q.size: @@ -763,17 +805,12 @@ def bind(self, geop): self.options["hessian_final"] = geop.options["hessian_final"] self.optarrays["energy_shift"] = geop.optarrays["energy_shift"] - self.gm.bind( - self, - self.options["discretization"], - self.options["max_ms"], - self.options["max_e"], - ) - self.im.bind(self, self.options["discretization"]) - self.fix = Fix(geop.beads.natoms, geop.fixatoms, geop.beads.nbeads) + # self.fix = Fix(geop.beads.natoms, geop.fixatoms, geop.beads.nbeads) + + self.fm.bind(self) def initial_geo(self): - # TODO : add linear interpolation + """ Generates the initial instanton geometry by stretching the transitions-state geometry along the mode with imaginary frequency """ info( " @GEOP: We stretch the initial geometry with an 'amplitud' of {:4.2f}".format( @@ -782,11 +819,13 @@ def initial_geo(self): verbosity.low, ) - fix_onebead = Fix(self.beads.natoms, self.fixatoms, 1) + fix_onebead = Fix(self.fixatoms, self.beads, 1) active_hessian = fix_onebead.get_active_vector( self.optarrays["initial_hessian"], 2 ) - active_imvector = get_imvector(active_hessian, self.im.dbeads.m3[0].flatten()) + active_imvector = get_imvector( + active_hessian, fix_onebead.fixbeads.m3[0].flatten() + ) imvector = fix_onebead.get_full_vector(active_imvector, 1).flatten() for i in range(self.beads.nbeads): @@ -802,18 +841,20 @@ def exitstep(self, d_x_max, step): tolerances = self.options["tolerances"] d_u = self.forces.pot - self.optarrays["old_u"].sum() - active_force = self.fix.get_active_vector(self.forces.f, 1) + self.im.f - fff = ( - self.fix.get_active_vector(self.forces.f, 1) - * (self.im.coef[1:] + self.im.coef[:-1]) - / 2 - ) - active_force = fff + self.im.f + # fff = ( + # self.fm.fix.get_active_vector(self.forces.f, 1) + # * (self.fm.coef[1:] + self.fm.coef[:-1]) + # / 2 + # ) + # active_force = fff + self.fm.im.f + + active_force = self.fm.f + print("HERE") info( " @Exit step: Energy difference: {:4.2e}, (condition: {:4.2e})".format( - np.absolute(d_u / self.im.dbeads.natoms), tolerances["energy"] + np.absolute(d_u / self.fm.fix.fixbeads.natoms), tolerances["energy"] ), verbosity.low, ) @@ -831,7 +872,7 @@ def exitstep(self, d_x_max, step): ) if ( - (np.absolute(d_u / self.im.dbeads.natoms) <= tolerances["energy"]) + (np.absolute(d_u / self.fm.im.dbeads.natoms) <= tolerances["energy"]) and ( (np.amax(np.absolute(active_force)) <= tolerances["force"]) or ( @@ -867,13 +908,13 @@ def exitstep(self, d_x_max, step): else: info("We are going to compute the final hessian", verbosity.low) active_hessian = get_hessian( - self.gm, + self.fm.gm, self.beads.q.copy(), self.beads.natoms, self.beads.nbeads, self.fixatoms, ) - self.optarrays["hessian"][:] = self.fix.get_full_vector( + self.optarrays["hessian"][:] = self.fm.fix.get_full_vector( active_hessian, 2 ) print_instanton_hess( @@ -891,10 +932,10 @@ def exitstep(self, d_x_max, step): def update_pos_for(self): """ Update positions and forces """ - self.beads.q[:] = self.gm.dbeads.q[:] + self.beads.q[:] = self.fm.gm.dbeads.q[:] # This forces the update of the forces - self.forces.transfer_forces(self.gm.dforces) + self.forces.transfer_forces(self.fm.gm.dforces) def update_old_pos_for(self): # Update "old" positions and forces @@ -933,14 +974,13 @@ def pre_step(self, step=None, adaptative=False): if adaptative: softexit.trigger("Adaptative discretization is not fully implemented") # new_coef = - # self.im.set_coef(coef) - # self.gm.set_coef(coef) + # self.fm.set_coef(coef) raise NotImplementedError self.qtime = -time.time() info("\n Instanton optimization STEP {}".format(step), verbosity.low) - activearrays = self.fix.get_active_array(self.optarrays) + activearrays = self.fm.fix.get_active_array(self.optarrays) return activearrays @@ -959,8 +999,6 @@ def func(x): # c0 = 2*self.im.dbeads.nbeads - 2*np.sum(coef) # coef = np.insert(coef,0,c0) - self.im.set_coef(coef) - fphys = self.gm.dforces.f * ((coef[1:] + coef[:-1]) / 2).reshape(-1, 1) e, gspring = self.im(self.im.dbeads.q) return np.amax(np.absolute(-gspring + fphys)) @@ -1048,22 +1086,23 @@ def initialize(self, step): " the extended phase space (nbeads>1). Please check the inputs\n" ) - self.gm.save(self.forces.pots, self.forces.f) + # self.fm.gm.save(self.forces.pots, self.forces.f) if self.options["hessian_init"] == "true": active_hessian = get_hessian( - self.gm, + self.fm.gm, self.beads.q.copy(), self.beads.natoms, self.beads.nbeads, self.fixatoms, ) - self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) + self.optarrays["hessian"][:] = self.fm.fix.get_full_vector( + active_hessian, 2 + ) - if self.im.f is None: - self.im(self.beads.q, ret=False) # Init instanton mapper + self.fm.im(self.beads.q, ret=False) # Init instanton mapper - self.gm.save(self.forces.pots, self.forces.f) + self.fm.gm.save(self.forces.pots, self.forces.f) self.update_old_pos_for() self.init = True @@ -1073,8 +1112,8 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): if update == "powell": - i = self.im.dbeads.natoms * 3 - for j in range(self.im.dbeads.nbeads): + i = self.fm.im.dbeads.natoms * 3 + for j in range(self.fm.fixbeads.nbeads): aux = active_hessian[:, j * i : (j + 1) * i] dg = d_g[j, :] dx = d_x[j, :] @@ -1085,7 +1124,7 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): self.gm, new_x, self.beads.natoms, self.beads.nbeads, self.fixatoms ) - self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) + self.optarrays["hessian"][:] = self.fm.fix.get_full_vector(active_hessian, 2) def print_hess(self, step): if ( @@ -1104,17 +1143,15 @@ def post_step(self, step, new_x, d_x, activearrays): d_x_max = np.amax(np.absolute(d_x)) info("Current step norm = {}".format(d_x_max), verbosity.medium) - # Get new energy (u) and forces(f) using mapper - self.im(new_x, ret=False, new_disc=True) # Only to update the mapper - - u, g2 = self.gm(new_x, new_disc=False) - f = -g2 - d_g = np.subtract(activearrays["old_f"], f) + # Get energy and forces(f) for the new position + self.fm(new_x, ret=False) # Update + d_g = np.subtract(activearrays["old_f"], self.fm.gm.f) self.update_hessian( self.options["hessian_update"], activearrays["hessian"], new_x, d_x, d_g ) + self.update_pos_for() # Print @@ -1129,14 +1166,6 @@ def post_step(self, step, new_x, d_x, activearrays): class NicholsOptimizer(HessianOptimizer): """ Class that implements a nichols optimizations. It can find first order saddle points or minimum""" - def bind(self, geop): - # call bind function from HessianOptimizer - super(NicholsOptimizer, self).bind(geop) - - def initialize(self, step): - # call initialize function from HessianOptimizer - super(NicholsOptimizer, self).initialize(step) - def step(self, step=None): """ Does one simulation time step.""" @@ -1145,22 +1174,22 @@ def step(self, step=None): # First construct complete hessian from reduced h0 = red2comp( activearrays["hessian"], - self.im.dbeads.nbeads, - self.im.dbeads.natoms, - self.im.coef, + self.fm.fix.fixbeads.nbeads, + self.fm.fix.fixbeads.natoms, + self.fm.coef, ) # Add spring terms to the physical hessian - h1 = np.add(self.im.h, h0) + h1 = np.add(self.fm.im.h, h0) # Get eigenvalues and eigenvector. d, w = clean_hessian( h1, - self.im.dbeads.q, - self.im.dbeads.natoms, - self.im.dbeads.nbeads, - self.im.dbeads.m, - self.im.dbeads.m3, + self.fm.fix.fixbeads.q, + self.fm.fix.fixbeads.natoms, + self.fm.fix.fixbeads.nbeads, + self.fm.fix.fixbeads.m, + self.fm.fix.fixbeads.m3, self.options["hessian_asr"], ) @@ -1189,14 +1218,12 @@ def step(self, step=None): ), verbosity.medium, ) - # info('@Nichols: 4th freq {} cm^-1'.format(units.unit_to_user('frequency','inversecm',np.sign(d[3])*np.sqrt(np.absolute(d[3])))),verbosity.medium) - # info('@Nichols: 8th freq {} cm^-1\n'.format(units.unit_to_user('frequency','inversecm',np.sign(d[7])*np.sqrt(np.absolute(d[7])))),verbosity.medium) # Find new movement direction if self.options["mode"] == "rate": - f = activearrays["old_f"] * (self.im.coef[1:] + self.im.coef[:-1]) / 2 + f = activearrays["old_f"] * (self.fm.coef[1:] + self.fm.coef[:-1]) / 2 d_x = nichols( - f, self.im.f, d, w, self.im.dbeads.m3, activearrays["big_step"] + f, self.fm.im.f, d, w, self.fm.fixbeads.m3, activearrays["big_step"] ) elif self.options["mode"] == "splitting": d_x = nichols( @@ -1218,7 +1245,7 @@ def step(self, step=None): d_x *= activearrays["big_step"] / np.amax(np.absolute(d_x)) # Get the new full-position - d_x_full = self.fix.get_full_vector(d_x, t=1) + d_x_full = self.fm.fix.get_full_vector(d_x, t=1) new_x = self.optarrays["old_x"].copy() + d_x_full self.post_step(step, new_x, d_x, activearrays) @@ -1227,14 +1254,6 @@ def step(self, step=None): class NROptimizer(HessianOptimizer): """ Class that implements a Newton-Raphson optimizations. It can find first order saddle points or minima""" - def bind(self, geop): - # call bind function from HessianOptimizer - super(NROptimizer, self).bind(geop) - - def initialize(self, step): - # call initialize function from HessianOptimizer - super(NROptimizer, self).initialize(step) - def step(self, step=None): """ Does one simulation time step.""" activearrays = self.pre_step(step) @@ -1246,7 +1265,7 @@ def step(self, step=None): dyn_mat, self.im, masses=False, shift=0.0000001 ) # create upper band matrix - fff = activearrays["old_f"] * (self.im.coef[1:] + self.im.coef[:-1]) / 2 + fff = activearrays["old_f"] * (self.fm.coef[1:] + self.fm.coef[:-1]) / 2 f = (fff + self.im.f).reshape( self.im.dbeads.natoms * 3 * self.im.dbeads.nbeads, 1 ) @@ -1274,20 +1293,12 @@ class LanczosOptimizer(HessianOptimizer): """ Class that implements a modified Nichols algorithm based on Lanczos diagonalization to avoid constructing and diagonalizing the full (3*natoms*nbeads)^2 matrix """ - def bind(self, geop): - # call bind function from HessianOptimizer - super(LanczosOptimizer, self).bind(geop) - - def initialize(self, step): - # call initialize function from HessianOptimizer - super(LanczosOptimizer, self).initialize(step) - def step(self, step=None): """ Does one simulation time step.""" activearrays = self.pre_step(step) - fff = activearrays["old_f"] * (self.im.coef[1:] + self.im.coef[:-1]) / 2 + fff = activearrays["old_f"] * (self.fm.coef[1:] + self.fm.coef[:-1]) / 2 f = (fff + self.im.f).reshape( self.im.dbeads.natoms * 3 * self.im.dbeads.nbeads, 1 ) @@ -1314,7 +1325,7 @@ def step(self, step=None): activearrays["hessian"], self.im.dbeads.nbeads, self.im.dbeads.natoms, - self.im.coef, + self.fm.coef, ) h_test = np.add(self.im.h, h_0) # add spring terms to the physical hessian d, w = clean_hessian( From 04b949eaf6b1fc46d8939bb0babfaacfad9d8bca Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 15 Dec 2020 14:52:51 +0100 Subject: [PATCH 002/120] Continue the cleaning ... --- ipi/engine/motion/instanton.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 98e81d0bb..2cf97a407 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1121,7 +1121,7 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): elif update == "recompute": active_hessian = get_hessian( - self.gm, new_x, self.beads.natoms, self.beads.nbeads, self.fixatoms + self.fm.gm, new_x, self.beads.natoms, self.beads.nbeads, self.fixatoms ) self.optarrays["hessian"][:] = self.fm.fix.get_full_vector(active_hessian, 2) From 83920f447c43855b5430f886175dc19d1f3b28df Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 16 Dec 2020 17:26:37 +0100 Subject: [PATCH 003/120] Reorganize the use of the mappers and fix objects. Add friction calls --- ipi/engine/motion/instanton.py | 514 +++++++++++++++++++-------------- ipi/inputs/motion/instanton.py | 15 + ipi/utils/hesstools.py | 40 +-- ipi/utils/instools.py | 26 +- 4 files changed, 348 insertions(+), 247 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 2cf97a407..3039619f5 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -34,6 +34,13 @@ __all__ = ["InstantonMotion"] +# ALBERTO: +# -test friction file, establish format,create spline function +# -test old instantons +# -code equations,including spline of g function +# -resolve hessian problem + + class InstantonMotion(Motion): """Instanton motion class. @@ -102,6 +109,8 @@ def __init__( old_direction=np.zeros(0, float), hessian_final="False", energy_shift=np.zeros(0, float), + friction=False, + z_friction=np.zeros(0, float), ): """Initialises InstantonMotion. """ @@ -126,6 +135,9 @@ def __init__( self.options["max_e"] = max_e self.options["max_ms"] = max_ms self.options["discretization"] = discretization + self.options["friction"] = friction + self.options["z_friction"] = z_friction + self.optarrays["big_step"] = biggest_step self.optarrays["energy_shift"] = energy_shift self.optarrays["delta"] = delta @@ -158,7 +170,7 @@ def __init__( if self.options["opt"] == "nichols": self.optimizer = NicholsOptimizer() elif self.options["opt"] == "NR": - self.optimizer = NROptimizer() + self.optimizer = NROptsmizer() else: self.optimizer = LanczosOptimizer() @@ -205,10 +217,14 @@ def step(self, step=None): class Fix(object): """Class that applies a fixatoms type constrain""" - def __init__(self, fixatoms, beads, nbeads=1): + def __init__(self, fixatoms, beads, nbeads=None): self.natoms = beads.natoms - self.nbeads = beads.nbeads + if nbeads is None: + self.nbeads = beads.nbeads + else: + self.nbeads = nbeads + self.fixatoms = fixatoms self.mask0 = np.delete(np.arange(self.natoms), self.fixatoms) @@ -254,7 +270,7 @@ def get_active_array(self, arrays): t = -1 elif key == "old_x" or key == "old_f" or key == "d": t = 1 - elif key == "hessian": + elif key == "hessian" or key == "eta": t = 2 elif key == "qlist" or key == "glist": t = 3 @@ -342,9 +358,9 @@ def get_active_vector(self, vector, t): raise ValueError("@apply_fix_atoms: type number is not valid") -class GradientMapper(object): +class PesMapper(object): - """Creation of the multi-dimensional function to compute the physical potential and forces + """Creation of the multi-dimennsional function to compute the physical potential and forces Attributes: dbeads: copy of the bead object @@ -356,13 +372,19 @@ def __init__(self): self.fcount = 0 pass - def bind(self, fm, max_ms, max_e): + def bind(self, mapper): + + self.dbeads = mapper.beads.copy() + self.dcell = mapper.cell.copy() + self.dforces = mapper.forces.copy(self.dbeads, self.dcell) + self.fix = mapper.fix + self.coef = mapper.coef + self.friction = mapper.friction + if self.friction: + self.z_friction = mapper.z_friction - self.dbeads = fm.beads.copy() - self.dcell = fm.cell.copy() - self.dforces = fm.forces.copy(self.dbeads, self.dcell) - self.fix = fm.fix - self.coef = fm.coef + max_ms = mapper.options["max_ms"] + max_e = mapper.options["max_e"] if max_ms > 0 or max_e > 0: self.spline = True @@ -382,9 +404,21 @@ def set_pos(self, x): """Set the positions """ self.dbeads.q = x - def save(self, e, g): + def save(self, e, g, eta=None): + """ Stores potential and forces in this class for convenience """ self.pot = e self.f = -g + self.eta = eta + + def compute_friction_terms(): + """ Computes friction component of the energy and gradient """ + + # self.z_friction + # self.eta + + # WRITE FORMULAS HERE ALBERTO + + return e, g def __call__(self, x, new_disc=True): """computes energy and gradient for optimization step""" @@ -429,11 +463,10 @@ def __call__(self, x, new_disc=True): reduced_cell = self.dcell.copy() reduced_forces = self.dforces.copy(reduced_b, reduced_cell) - # Evaluate forces + # Evaluate energy and forces (and maybe friction) rpots = reduced_forces.pots # reduced energy rforces = reduced_forces.f # reduced gradient - # Interpolate if necessary to get full pot and forces if self.spline: red_mspath = full_mspath[indexes] spline = interp1d(red_mspath, rpots.T, kind="cubic") @@ -448,55 +481,69 @@ def __call__(self, x, new_disc=True): self.dbeads.q[:] = x[:] self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) - # e = self.dforces.pot # Energy - # g = -self.dforces.f # Gradient e = np.sum(full_pot) # Energy g = -full_forces # Gradient - self.save(full_pot, g) + if self.friction: + # ALBERTO: The following has to be joined to the json implementation for the + # communication of the extras strings + red_eta = np.zeros(nbeads, (self.dbeads.natoms * 3) ** 2) + + # Interpolate if necessary to get full pot and forces + if self.spline: + red_mspath = full_mspath[indexes] + spline = interp1d(red_mspath, red_eta.T, kind="cubic") + full_eta = spline(full_mspath).T + else: + full_eta = red_eta - # if not full: - # g = self.fix.get_active_vector(g, 1) + else: + full_eta = None - # Discretization - if new_disc: - e = e * (self.coef[1:] + self.coef[:-1]) / 2 - g = g * (self.coef[1:] + self.coef[:-1]) / 2 + self.save(full_pot, g, full_eta) + + return self.evaluate() + + def evaluate(self): + """ Evaluate the energy and forces including: + - non uniform discretization + - friction term (if required) + """ + e = self.pot * (self.coef[1:] + self.coef[:-1]) / 2 + g = -self.f * (self.coef[1:] + self.coef[:-1]) / 2 + + if self.friction: + e_friction, g_friction = self.compute_friction_terms() + e += e_friction + g += g_friction return e, g class SpringMapper(object): - """Creation of the multi-dimensional function to compute full or half ring polymer pot + """Creation of the multi-dimensional function to compute full or half ring polymer potential and forces. """ def __init__(self): - pass - def bind(self, fm): + def bind(self, mapper): - self.temp = fm.temp - self.fix = fm.fix - self.coef = fm.coef + self.temp = mapper.temp + self.fix = mapper.fix + self.coef = mapper.coef + self.dbeads = mapper.beads.copy() - self.dbeads = fm.beads.copy() - # self.dbeads = Beads( - # fm.beads.natoms - len(fm.fixatoms), fm.beads.nbeads - # ) - # self.dbeads.q[:] = self.fix.get_active_vector(fm.beads.copy().q, 1) - # self.dbeads.m[:] = self.fix.get_active_vector(fm.beads.copy().m, 0) - # self.dbeads.names[:] = self.fix.get_active_vector(fm.beads.copy().names, 0) - - if fm.options["mode"] == "rate": + # Set omega2 depending of the case + if mapper.options["mode"] == "rate": self.omega2 = ( self.temp * (2 * self.dbeads.nbeads) * units.Constants.kb / units.Constants.hbar ) ** 2 - elif fm.options["mode"] == "splitting": + elif mapper.options["mode"] == "splitting": self.omega2 = ( self.temp * self.dbeads.nbeads @@ -504,10 +551,11 @@ def bind(self, fm): / units.Constants.hbar ) ** 2 + # Computes the spring hessian if the optimization modes requires it if ( - fm.options["opt"] == "nichols" - or fm.options["opt"] == "NR" - or fm.options["opt"] == "lanczos" + mapper.options["opt"] == "nichols" + or mapper.options["opt"] == "NR" + or mapper.options["opt"] == "lanczos" ): self.h = self.spring_hessian( natoms=self.fix.fixbeads.natoms, @@ -522,6 +570,66 @@ def save(self, e, g): self.pot = e self.f = -g + def __call__(self, x, ret=True, new_disc=True): + """Computes spring energy and gradient for instanton optimization step""" + + if new_disc: + coef = self.coef + elif new_disc == "one": + coef = np.ones(self.coef.shape) + else: + coef = new_disc.reshape(self.coef.shape) + + if x.shape[0] == 1: # only one bead + self.dbeads.q = x + e = 0.0 + g = np.zeros(x.shape[1]) + self.save(e, g) + + else: + self.dbeads.q = x + e = 0.00 + g = np.zeros(self.dbeads.q.shape, float) + + # OLD reference + # for i in range(self.dbeads.nbeads - 1): + # dq = self.dbeads.q[i + 1, :] - self.dbeads.q[i, :] + # e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) + # for i in range(0, self.dbeads.nbeads - 1): + # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i + 1, :]) + # for i in range(1, self.dbeads.nbeads): + # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) + + # With new discretization + for i in range(self.dbeads.nbeads - 1): + dq = (self.dbeads.q[i + 1, :] - self.dbeads.q[i, :]) / np.sqrt( + coef[i + 1] + ) # coef[0] and coef[-1] do not enter + e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) + for i in range(0, self.dbeads.nbeads - 1): + g[i, :] += ( + self.dbeads.m3[i, :] + * self.omega2 + * ( + self.dbeads.q[i, :] / coef[i + 1] + - self.dbeads.q[i + 1, :] / coef[i + 1] + ) + ) + for i in range(1, self.dbeads.nbeads): + g[i, :] += ( + self.dbeads.m3[i, :] + * self.omega2 + * ( + self.dbeads.q[i, :] / coef[i] + - self.dbeads.q[i - 1, :] / coef[i] + ) + ) + + self.save(e, g) + + if ret: + return e, g + @staticmethod def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): """Compute the 'spring hessian' @@ -583,78 +691,29 @@ def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): return h - def __call__(self, x, ret=True, new_disc=True): - """Computes spring energy and gradient for instanton optimization step""" - - # x = self.fix.get_active_vector(x, 1).copy() - if new_disc: - coef = self.coef - elif new_disc == "one": - coef = np.ones(self.coef.shape) - else: - coef = new_disc.reshape(self.coef.shape) - - if x.shape[0] == 1: # only one bead - self.dbeads.q = x - e = 0.0 - g = np.zeros(x.shape[1]) - self.save(e, g) - - else: - self.dbeads.q = x - e = 0.00 - g = np.zeros(self.dbeads.q.shape, float) - - # OLD reference - # for i in range(self.dbeads.nbeads - 1): - # dq = self.dbeads.q[i + 1, :] - self.dbeads.q[i, :] - # e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) - # for i in range(0, self.dbeads.nbeads - 1): - # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i + 1, :]) - # for i in range(1, self.dbeads.nbeads): - # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) - - # With new discretization - for i in range(self.dbeads.nbeads - 1): - dq = (self.dbeads.q[i + 1, :] - self.dbeads.q[i, :]) / np.sqrt( - coef[i + 1] - ) # coef[0] and coef[-1] do not enter - e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) - for i in range(0, self.dbeads.nbeads - 1): - g[i, :] += ( - self.dbeads.m3[i, :] - * self.omega2 - * ( - self.dbeads.q[i, :] / coef[i + 1] - - self.dbeads.q[i + 1, :] / coef[i + 1] - ) - ) - for i in range(1, self.dbeads.nbeads): - g[i, :] += ( - self.dbeads.m3[i, :] - * self.omega2 - * ( - self.dbeads.q[i, :] / coef[i] - - self.dbeads.q[i - 1, :] / coef[i] - ) - ) +class Mapper(object): + """Creation of the multi-dimensional function that is the proxy between all the energy and force components and the optimization algorithm. + It also handles fixatoms """ - self.save(e, g) + def __init__(self, esum=False): - if ret: - return e, g + self.sm = SpringMapper() + self.gm = PesMapper() + self.esum = esum + def initialize(self, q, forces): + # ALBERTO get friction from forces object + eta = np.zeros((q.shape[0], q.shape[1] ** 2)) -class FullMapper(object): - """Creation of the multi-dimensional function that is the proxy between all the energy and force components and the optimization algorithm. - It also handles fixatoms """ + self.gm.save(forces.pots, -forces.f, eta) + e1, g1 = self.gm.evaluate() + e2, g2 = self.sm(q) - def __init__(self, im, gm, esum=False): + g = self.fix.get_active_vector(g1 + g2, 1) + e = np.sum(e1) + np.sum(e2) - self.im = im - self.gm = gm - self.esum = esum + self.save(e, g) def save(self, e, g): self.pot = e @@ -668,29 +727,38 @@ def bind(self, dumop): self.cell = dumop.cell self.nm = dumop.nm - self.options = dumop.options self.fixatoms = dumop.fixatoms - self.fix = Fix(self.fixatoms, self.beads, self.beads.nbeads) + self.fix = dumop.fix self.fixbeads = self.fix.fixbeads + self.options = dumop.options self.coef = np.ones(self.beads.nbeads + 1).reshape(-1, 1) self.set_coef(self.options["discretization"]) - self.gm.bind( - self, self.options["max_ms"], self.options["max_e"], - ) + self.friction = self.options["friction"] + if self.friction: + self.set_z_friction(self.options["z_friction"]) - self.im.bind(self) + self.sm.bind(self) + self.gm.bind(self) def set_coef(self, coef): """ Sets coeficients for non-uniform instanton calculation """ self.coef[:] = coef.reshape(-1, 1) + def set_z_friction(self, z_friction): + """Sets the scaling factors corresponding to frequency dependence of the friction """ + + print("ALBERTO") + print("Here we have to specify format somewhere and perform spline") + print("Also add zeros with a warning msg") + # self.z_friction[:] = z_fricition + self.z_friction = np.zeros(self.beads.nbeads).reshape(-1, 1) + def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): - print("HEEEEEERE") if mode == "all": - e1, g1 = self.im(x, new_disc) + e1, g1 = self.sm(x, new_disc) e2, g2 = self.gm(x, new_disc) e = e1 + e2 g = np.add(g1, g2) @@ -698,7 +766,7 @@ def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): elif mode == "physical": e, g = self.gm(x, new_disc) elif mode == "springs": - e, g = self.im(x, new_disc) + e, g = self.sm(x, new_disc) else: softexit.trigger("Mode not recognized when calling FullMapper") @@ -719,13 +787,13 @@ class DummyOptimizer(dobject): """ Dummy class for all optimization classes """ def __init__(self): - """Initializes object for GradientMapper (physical potential, forces and hessian) + """Initializes object for PesMapper (physical potential, forces and hessian) and SpringMapper ( spring potential,forces and hessian) """ self.options = {} # Optimization options self.optarrays = {} # Optimization arrays - self.fm = FullMapper(SpringMapper(), GradientMapper()) + self.mapper = Mapper() self.exit = False self.init = False @@ -741,6 +809,8 @@ def bind(self, geop): self.forces = geop.forces self.fixcom = geop.fixcom self.fixatoms = geop.fixatoms + + self.fix = Fix(self.fixatoms, self.beads, self.beads.nbeads) self.nm = geop.nm self.output_maker = geop.output_maker @@ -791,6 +861,8 @@ def bind(self, geop): self.options["max_ms"] = geop.options["max_ms"] self.options["max_e"] = geop.options["max_e"] self.options["discretization"] = geop.options["discretization"] + self.options["friction"] = geop.options["friction"] + self.options["tolerances"] = geop.options["tolerances"] self.optarrays["big_step"] = geop.optarrays["big_step"] self.optarrays["old_x"] = geop.optarrays["old_x"] @@ -807,7 +879,7 @@ def bind(self, geop): # self.fix = Fix(geop.beads.natoms, geop.fixatoms, geop.beads.nbeads) - self.fm.bind(self) + self.mapper.bind(self) def initial_geo(self): """ Generates the initial instanton geometry by stretching the transitions-state geometry along the mode with imaginary frequency """ @@ -842,19 +914,11 @@ def exitstep(self, d_x_max, step): tolerances = self.options["tolerances"] d_u = self.forces.pot - self.optarrays["old_u"].sum() - # fff = ( - # self.fm.fix.get_active_vector(self.forces.f, 1) - # * (self.fm.coef[1:] + self.fm.coef[:-1]) - # / 2 - # ) - # active_force = fff + self.fm.im.f - - active_force = self.fm.f - print("HERE") + active_force = self.mapper.f info( " @Exit step: Energy difference: {:4.2e}, (condition: {:4.2e})".format( - np.absolute(d_u / self.fm.fix.fixbeads.natoms), tolerances["energy"] + np.absolute(d_u / self.fix.fixbeads.natoms), tolerances["energy"] ), verbosity.low, ) @@ -872,7 +936,7 @@ def exitstep(self, d_x_max, step): ) if ( - (np.absolute(d_u / self.fm.im.dbeads.natoms) <= tolerances["energy"]) + (np.absolute(d_u / self.mapper.sm.dbeads.natoms) <= tolerances["energy"]) and ( (np.amax(np.absolute(active_force)) <= tolerances["force"]) or ( @@ -907,16 +971,14 @@ def exitstep(self, d_x_max, step): else: info("We are going to compute the final hessian", verbosity.low) - active_hessian = get_hessian( - self.fm.gm, + self.optarrays["hessian"][:] = get_hessian( + self.mapper.gm, self.beads.q.copy(), self.beads.natoms, self.beads.nbeads, self.fixatoms, ) - self.optarrays["hessian"][:] = self.fm.fix.get_full_vector( - active_hessian, 2 - ) + print_instanton_hess( self.options["prefix"] + "_FINAL", step, @@ -932,19 +994,21 @@ def exitstep(self, d_x_max, step): def update_pos_for(self): """ Update positions and forces """ - self.beads.q[:] = self.fm.gm.dbeads.q[:] + self.beads.q[:] = self.mapper.gm.dbeads.q[:] # This forces the update of the forces - self.forces.transfer_forces(self.fm.gm.dforces) + self.forces.transfer_forces(self.mapper.gm.dforces) def update_old_pos_for(self): - # Update "old" positions and forces + """ Update 'old' positions and forces arrays """ + self.optarrays["old_x"][:] = self.beads.q self.optarrays["old_u"][:] = self.forces.pots self.optarrays["old_f"][:] = self.forces.f def print_geo(self, step): - # Print current instanton geometry + """ Small interface to call the function that prints thet instanton geometry """ + if ( self.options["save"] > 0 and np.mod(step, self.options["save"]) == 0 ) or self.exit: @@ -966,7 +1030,7 @@ def pre_step(self, step=None, adaptative=False): """ General tasks that have to be performed before actual step""" if self.exit: - softexit.trigger("Geometry optimization converged. Exiting simulation") + softexit.trigger("Geometry optimzation converged. Exiting simulation") if not self.init: self.initialize(step) @@ -974,18 +1038,18 @@ def pre_step(self, step=None, adaptative=False): if adaptative: softexit.trigger("Adaptative discretization is not fully implemented") # new_coef = - # self.fm.set_coef(coef) + # self.mapper.set_coef(coef) raise NotImplementedError self.qtime = -time.time() info("\n Instanton optimization STEP {}".format(step), verbosity.low) - activearrays = self.fm.fix.get_active_array(self.optarrays) + activearrays = self.fix.get_active_array(self.optarrays) return activearrays def step(self, step=None): - """Dummy simulation time step which does nothing.""" + """Dummy simulationt step which does nothing.""" pass def opt_coef(self, coef): @@ -995,12 +1059,12 @@ def func(x): coef = np.absolute(coef) s = func(coef) - coef *= 2 * self.im.dbeads.nbeads / s - # c0 = 2*self.im.dbeads.nbeads - 2*np.sum(coef) + coef *= 2 * self.sm.dbeads.nbeads / s + # c0 = 2*self.sm.dbeads.nbeads - 2*np.sum(coef) # coef = np.insert(coef,0,c0) fphys = self.gm.dforces.f * ((coef[1:] + coef[:-1]) / 2).reshape(-1, 1) - e, gspring = self.im(self.im.dbeads.q) + e, gspring = self.sm(self.sm.dbeads.q) return np.amax(np.absolute(-gspring + fphys)) @@ -1086,24 +1150,23 @@ def initialize(self, step): " the extended phase space (nbeads>1). Please check the inputs\n" ) - # self.fm.gm.save(self.forces.pots, self.forces.f) + # Initialize all the mappers + # self.mapper.gm.save(self.forces.pots, self.forces.f) + # self.mapper.sm(self.beads.q, ret=False) # Init instanton mapper + self.mapper.initialize(self.beads.q, self.forces) if self.options["hessian_init"] == "true": - active_hessian = get_hessian( - self.fm.gm, + self.optarrays["hessian"][:] = get_hessian( + self.mapper.gm, self.beads.q.copy(), self.beads.natoms, self.beads.nbeads, self.fixatoms, ) - self.optarrays["hessian"][:] = self.fm.fix.get_full_vector( - active_hessian, 2 - ) + # active_hessian = self.mapper.fix.get_active_vector( self.optarrays["hessian"],t=2 ) - self.fm.im(self.beads.q, ret=False) # Init instanton mapper - - self.fm.gm.save(self.forces.pots, self.forces.f) - self.update_old_pos_for() + self.update_pos_for() + self.update_old_pos_for() self.init = True @@ -1112,8 +1175,8 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): if update == "powell": - i = self.fm.im.dbeads.natoms * 3 - for j in range(self.fm.fixbeads.nbeads): + i = self.fix.fixbeads.natoms * 3 + for j in range(self.fix.fixbeads.nbeads): aux = active_hessian[:, j * i : (j + 1) * i] dg = d_g[j, :] dx = d_x[j, :] @@ -1121,10 +1184,14 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): elif update == "recompute": active_hessian = get_hessian( - self.fm.gm, new_x, self.beads.natoms, self.beads.nbeads, self.fixatoms + self.mapper.gm, + new_x, + self.beads.natoms, + self.beads.nbeads, + self.fixatoms, ) - self.optarrays["hessian"][:] = self.fm.fix.get_full_vector(active_hessian, 2) + self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) def print_hess(self, step): if ( @@ -1138,16 +1205,18 @@ def print_hess(self, step): ) def post_step(self, step, new_x, d_x, activearrays): - """ General tasks that have to be performed after the actual step""" + """ General tasks that have to be performed after finding the new step""" d_x_max = np.amax(np.absolute(d_x)) info("Current step norm = {}".format(d_x_max), verbosity.medium) # Get energy and forces(f) for the new position - self.fm(new_x, ret=False) + self.mapper(new_x, ret=False) # Update - d_g = np.subtract(activearrays["old_f"], self.fm.gm.f) + f = self.fix.get_active_vector(self.mapper.gm.f, t=1) + d_g = np.subtract(activearrays["old_f"], f) + self.update_hessian( self.options["hessian_update"], activearrays["hessian"], new_x, d_x, d_g ) @@ -1164,32 +1233,32 @@ def post_step(self, step, new_x, d_x, activearrays): class NicholsOptimizer(HessianOptimizer): - """ Class that implements a nichols optimizations. It can find first order saddle points or minimum""" + """ Class that implements a nichols optimization. It can find first order saddle points or minimum""" def step(self, step=None): - """ Does one simulation time step.""" + """ Does one simulation step.""" activearrays = self.pre_step(step) # First construct complete hessian from reduced h0 = red2comp( activearrays["hessian"], - self.fm.fix.fixbeads.nbeads, - self.fm.fix.fixbeads.natoms, - self.fm.coef, + self.fix.fixbeads.nbeads, + self.fix.fixbeads.natoms, + self.mapper.coef, ) # Add spring terms to the physical hessian - h1 = np.add(self.fm.im.h, h0) + h1 = np.add(self.mapper.sm.h, h0) # Get eigenvalues and eigenvector. d, w = clean_hessian( h1, - self.fm.fix.fixbeads.q, - self.fm.fix.fixbeads.natoms, - self.fm.fix.fixbeads.nbeads, - self.fm.fix.fixbeads.m, - self.fm.fix.fixbeads.m3, + self.fix.fixbeads.q, + self.fix.fixbeads.natoms, + self.fix.fixbeads.nbeads, + self.fix.fixbeads.m, + self.fix.fixbeads.m3, self.options["hessian_asr"], ) @@ -1221,17 +1290,26 @@ def step(self, step=None): # Find new movement direction if self.options["mode"] == "rate": - f = activearrays["old_f"] * (self.fm.coef[1:] + self.fm.coef[:-1]) / 2 + f = ( + activearrays["old_f"] + * (self.mapper.coef[1:] + self.mapper.coef[:-1]) + / 2 + ) d_x = nichols( - f, self.fm.im.f, d, w, self.fm.fixbeads.m3, activearrays["big_step"] + f, + self.mapper.sm.f, + d, + w, + self.fix.fixbeads.m3, + activearrays["big_step"], ) elif self.options["mode"] == "splitting": d_x = nichols( activearrays["old_f"], - self.im.f, + self.sm.f, d, w, - self.im.dbeads.m3, + self.sm.dbeads.m3, activearrays["big_step"], mode=0, ) @@ -1245,34 +1323,34 @@ def step(self, step=None): d_x *= activearrays["big_step"] / np.amax(np.absolute(d_x)) # Get the new full-position - d_x_full = self.fm.fix.get_full_vector(d_x, t=1) + d_x_full = self.fix.get_full_vector(d_x, t=1) new_x = self.optarrays["old_x"].copy() + d_x_full self.post_step(step, new_x, d_x, activearrays) class NROptimizer(HessianOptimizer): - """ Class that implements a Newton-Raphson optimizations. It can find first order saddle points or minima""" + """ Class that implements a Newton-Raphson optsmization. It can find first order saddle points or minimum""" def step(self, step=None): - """ Does one simulation time step.""" + """ Does one simulaion step.""" activearrays = self.pre_step(step) dyn_mat = get_dynmat( - activearrays["hessian"], self.im.dbeads.m3, self.im.dbeads.nbeads + activearrays["hessian"], self.sm.dbeads.m3, self.sm.dbeads.nbeads ) h_up_band = banded_hessian( - dyn_mat, self.im, masses=False, shift=0.0000001 + dyn_mat, self.sm, masses=False, shift=0.0000001 ) # create upper band matrix - fff = activearrays["old_f"] * (self.fm.coef[1:] + self.fm.coef[:-1]) / 2 - f = (fff + self.im.f).reshape( - self.im.dbeads.natoms * 3 * self.im.dbeads.nbeads, 1 + fff = activearrays["old_f"] * (self.mapper.coef[1:] + self.mapper.coef[:-1]) / 2 + f = (fff + self.sm.f).reshape( + self.sm.dbeads.natoms * 3 * self.sm.dbeads.nbeads, 1 ) - f = np.multiply(f, self.im.dbeads.m3.reshape(f.shape) ** -0.5) + f = np.multiply(f, self.sm.dbeads.m3.reshape(f.shape) ** -0.5) - d_x = invmul_banded(h_up_band, f).reshape(self.im.dbeads.q.shape) - d_x = np.multiply(d_x, self.im.dbeads.m3 ** -0.5) + d_x = invmul_banded(h_up_band, f).reshape(self.sm.dbeads.q.shape) + d_x = np.multiply(d_x, self.sm.dbeads.m3 ** -0.5) # Rescale step if necessary if np.amax(np.absolute(d_x)) > activearrays["big_step"]: @@ -1294,13 +1372,12 @@ class LanczosOptimizer(HessianOptimizer): the full (3*natoms*nbeads)^2 matrix """ def step(self, step=None): - """ Does one simulation time step.""" + """ Does one simulation step.""" activearrays = self.pre_step(step) - fff = activearrays["old_f"] * (self.fm.coef[1:] + self.fm.coef[:-1]) / 2 - f = (fff + self.im.f).reshape( - self.im.dbeads.natoms * 3 * self.im.dbeads.nbeads, 1 + f = self.mapper.f.reshape( + self.fix.fixbeads.natoms * 3 * self.fix.fixbeads.nbeads, 1 ) banded = False @@ -1309,32 +1386,33 @@ def step(self, step=None): # BANDED Version # MASS-scaled dyn_mat = get_dynmat( - activearrays["hessian"], self.im.dbeads.m3, self.im.dbeads.nbeads + activearrays["hessian"], self.fix.fixbeads.m3, self.fix.fixbeads.nbeads ) + h_up_band = banded_hessian( - dyn_mat, self.im, masses=False, shift=0.000000001 + dyn_mat, self.mapper.sm, masses=False, shift=0.000000001 ) # create upper band matrix - f = np.multiply(f, self.im.dbeads.m3.reshape(f.shape) ** -0.5) + f = np.multiply(f, self.fix.fixbeads.m3.reshape(f.shape) ** -0.5) # CARTESIAN - # h_up_band = banded_hessian(activearrays["hessian"], self.im,masses=True) # create upper band matrix + # h_up_band = banded_hessian(activearrays["hessian"], self.sm.masses=True) # create upper band matrix d = diag_banded(h_up_band) else: - # FULL dimensions version + # FULL dimensional version h_0 = red2comp( activearrays["hessian"], - self.im.dbeads.nbeads, - self.im.dbeads.natoms, - self.fm.coef, + self.sm.dbeads.nbeads, + self.sm.dbeads.natoms, + self.mapper.coef, ) - h_test = np.add(self.im.h, h_0) # add spring terms to the physical hessian + h_test = np.add(self.sm.h, h_0) # add spring terms to the physical hessian d, w = clean_hessian( h_test, - self.im.dbeads.q, - self.im.dbeads.natoms, - self.im.dbeads.nbeads, - self.im.dbeads.m, - self.im.dbeads.m3, + self.sm.dbeads.q, + self.sm.dbeads.natoms, + self.sm.dbeads.nbeads, + self.sm.dbeads.m, + self.sm.dbeads.m3, None, ) # CARTESIAN @@ -1397,10 +1475,10 @@ def step(self, step=None): h_test = alpha * (h_test - np.eye(h_test.shape[0]) * lamb) d_x = np.linalg.solve(h_test, f) - d_x.shape = self.im.dbeads.q.shape + d_x.shape = self.fix.fixbeads.q.shape # MASS-scaled - d_x = np.multiply(d_x, self.im.dbeads.m3 ** -0.5) + d_x = np.multiply(d_x, self.fix.fixbeads.m3 ** -0.5) # Rescale step if necessary if np.amax(np.absolute(d_x)) > activearrays["big_step"]: @@ -1436,7 +1514,7 @@ def bind(self, geop): ) self.optarrays["hessian"] = geop.optarrays["hessian"] - self.im.bind(self, self.options["discretization"]) + self.sm.bind(self, self.options["discretization"]) # Specific for LBFGS self.options["corrections"] = geop.options["corrections"] @@ -1478,7 +1556,7 @@ def bind(self, geop): self.optarrays["d"] = geop.optarrays["d"] - self.fm.esum = True + self.mapper.esum = True def initialize(self, step): @@ -1501,8 +1579,8 @@ def initialize(self, step): ) # This must be done after the stretching and before the self.d. - if self.im.f is None: - self.im(self.beads.q, ret=False) # Init instanton mapper + if self.sm.f is None: + self.sm(self.beads.q, ret=False) # Init instanton mapper if ( self.optarrays["old_x"] @@ -1512,7 +1590,7 @@ def initialize(self, step): # Specific for LBFGS if np.linalg.norm(self.optarrays["d"]) == 0.0: - f = self.forces.f + self.im.f + f = self.forces.f + self.sm.f self.optarrays["d"] += dstrip(f) / np.sqrt(np.dot(f.flatten(), f.flatten())) self.update_old_pos_for() @@ -1543,18 +1621,18 @@ def post_step(self, step, activearrays): self.update_old_pos_for() def step(self, step=None): - """ Does one simulation time step.""" + """ Does one simulation step.""" activearrays = self.pre_step(step) - e, g = self.fm(self.beads.q) + e, g = self.mapper(self.beads.q) fdf0 = (e, g) # Do one step. Update the position and force inside the mapper. L_BFGS( activearrays["old_x"], activearrays["d"], - self.fm, + self.mapper, activearrays["qlist"], activearrays["glist"], fdf0, diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 7201c8b8b..b368a3f50 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -144,6 +144,18 @@ class InputInst(InputDictionary): "help": "Allows to specified non uniform time discretization as proposed in J. Chem. Phys. 134, 184107 (2011)", }, ), + "friction": ( + InputValue, + {"dtype": bool, "default": False, "help": "Activates Friction",}, + ), + "z_friction": ( + InputArray, + { + "dtype": float, + "default": input_default(factory=np.ones, args=(0,)), + "help": "Normalized frequency dependence of the friction tensor ", + }, + ), "alt_out": ( InputValue, { @@ -317,6 +329,9 @@ def store(self, geop): self.max_e.store(options["max_e"]) self.max_ms.store(options["max_ms"]) self.discretization.store(options["discretization"]) + self.friction.store(options["friction"]) + if options["friction"]: + self.friction.store(options["z_friction"]) self.alt_out.store(options["save"]) self.prefix.store(options["prefix"]) self.delta.store(optarrays["delta"]) diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index adda5df82..fe1d4dbea 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -175,7 +175,7 @@ def clean_hessian(h, q, natoms, nbeads, m, m3, asr, mofi=False): return d, w -def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001): +def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): """Compute the physical hessian given a function to evaluate energy and forces (gm). The intermediate steps are written as a temporary files so the full hessian calculations is only ONE step. @@ -189,10 +189,12 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001): OUT h = physical hessian ( (natoms-len(fixatoms) )*3 , nbeads*( natoms-len(fixatoms) )*3) """ - # TODO What about the case you have numerical gradients? - info(" @get_hessian: Computing hessian", verbosity.low) - ii = (natoms - len(fixatoms)) * 3 + fixdofs = list() + for i in fixatoms: + fixdofs.extend([3 * i, 3 * i + 1, 3 * i + 2]) + + ii = natoms * 3 if x0.size != natoms * 3 * nbeads: raise ValueError( "The position vector is not consistent with the number of atoms/beads." @@ -221,22 +223,26 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001): # Start calculation: for j in range(i0 + 1, ii): - info( - " @get_hessian: Computing hessian: %d of %d" % ((j + 1), ii), verbosity.low - ) - x = x0.copy() + if j in fixdofs: + continue + else: + info( + " @get_hessian: Computing hessian: %d of %d" % ((j + 1), ii), + verbosity.low, + ) + x = x0.copy() - x[:, j] = x0[:, j] + d - e, f1 = gm(x, new_disc=False) - x[:, j] = x0[:, j] - d - e, f2 = gm(x, new_disc=False) - g = (f1 - f2) / (2 * d) + x[:, j] = x0[:, j] + d + e, f1 = gm(x, new_disc) + x[:, j] = x0[:, j] - d + e, f2 = gm(x, new_disc) + g = (f1 - f2) / (2 * d) - h[j, :] = g.flatten() + h[j, :] = g.flatten() - f = open("hessian_" + str(j) + ".tmp", "w") - np.savetxt(f, h) - f.close() + f = open("hessian_" + str(j) + ".tmp", "w") + np.savetxt(f, h) + f.close() u, g = gm(x0) # Keep the mapper updated diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 56f82fc23..20ac2f79f 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -8,14 +8,16 @@ import copy -def banded_hessian(h, im, masses=True, shift=0.001): +def banded_hessian(h, sm, masses=True, shift=0.001): """Given Hessian in the reduced format (h), construct the upper band hessian including the RP terms. If masses is True returns hessian otherwise it returns dynmat shift is value that is added to the diagonal to avoid numerical problems with close to 0 frequencies""" - nbeads = im.dbeads.nbeads - natoms = im.dbeads.natoms - coef = im.coef # new_disc + nbeads = sm.fix.fixbeads.nbeads + natoms = sm.fix.fixbeads.natoms + coef = sm.coef # new_disc + m3 = sm.fix.fixbeads.m3 + omega2 = sm.omega2 ii = natoms * 3 * nbeads ndiag = natoms * 3 + 1 # only upper diagonal form @@ -36,17 +38,17 @@ def banded_hessian(h, im, masses=True, shift=0.001): if nbeads > 1: # Diagonal if masses: - d_corner = im.dbeads.m3[0] * im.omega2 + d_corner = m3[0] * omega2 else: - d_corner = np.ones(im.dbeads.m3[0].shape) * im.omega2 + d_corner = np.ones(m3[0].shape) * omega2 - d_0 = np.array([[d_corner * 2]]).repeat(im.dbeads.nbeads - 2, axis=0).flatten() + d_0 = np.array([[d_corner * 2]]).repeat(nbeads - 2, axis=0).flatten() diag_sp = np.concatenate((d_corner, d_0, d_corner)) href[-1, :] += diag_sp # Non-Diagonal d_out = -d_corner - ndiag_sp = np.array([[d_out]]).repeat(im.dbeads.nbeads - 1, axis=0).flatten() + ndiag_sp = np.array([[d_out]]).repeat(nbeads - 1, axis=0).flatten() href[0, :] = np.concatenate((np.zeros(natoms * 3), ndiag_sp)) # Add safety shift value @@ -68,15 +70,15 @@ def banded_hessian(h, im, masses=True, shift=0.001): if nbeads > 1: # Diagonal if masses: - d_corner = im.dbeads.m3[0] * im.omega2 + d_corner = m3[0] * omega2 else: - d_corner = np.ones(im.dbeads.m3[0].shape) * im.omega2 + d_corner = np.ones(m3[0].shape) * omega2 d_init = d_corner / coef[1] d_fin = d_corner / coef[-2] d_mid = d_corner * (1.0 / coef[1] + 1.0 / coef[2]) - for i in range(2, im.dbeads.nbeads - 1): + for i in range(2, nbeads - 1): d_mid = np.concatenate( (d_mid, d_corner * (1.0 / coef[i] + 1.0 / coef[i + 1])) ) @@ -86,7 +88,7 @@ def banded_hessian(h, im, masses=True, shift=0.001): # Non-Diagonal d_mid = -d_corner * (1.0 / coef[1]) - for i in range(2, im.dbeads.nbeads): + for i in range(2, nbeads): d_mid = np.concatenate((d_mid, -d_corner * (1.0 / coef[i]))) hnew[0, :] = np.concatenate((np.zeros(natoms * 3), d_mid)) From 0cfc27693fe353da865bc94ceca527128835ab87 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 16 Dec 2020 17:35:44 +0100 Subject: [PATCH 004/120] linting --- ipi/engine/motion/instanton.py | 9 +++++---- ipi/inputs/motion/instanton.py | 2 +- 2 files changed, 6 insertions(+), 5 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 3039619f5..64a0239e2 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -170,7 +170,7 @@ def __init__( if self.options["opt"] == "nichols": self.optimizer = NicholsOptimizer() elif self.options["opt"] == "NR": - self.optimizer = NROptsmizer() + self.optimizer = NROptimizer() else: self.optimizer = LanczosOptimizer() @@ -417,11 +417,12 @@ def compute_friction_terms(): # self.eta # WRITE FORMULAS HERE ALBERTO - + e = 0 + g = 0 return e, g def __call__(self, x, new_disc=True): - """computes energy and gradient for optimization step""" + """ Computes energy and gradient for optimization step""" self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) @@ -487,7 +488,7 @@ def __call__(self, x, new_disc=True): if self.friction: # ALBERTO: The following has to be joined to the json implementation for the # communication of the extras strings - red_eta = np.zeros(nbeads, (self.dbeads.natoms * 3) ** 2) + red_eta = np.zeros(self.dbeads.nbeads, (self.dbeads.natoms * 3) ** 2) # Interpolate if necessary to get full pot and forces if self.spline: diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index b368a3f50..0501f3042 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -146,7 +146,7 @@ class InputInst(InputDictionary): ), "friction": ( InputValue, - {"dtype": bool, "default": False, "help": "Activates Friction",}, + {"dtype": bool, "default": False, "help": "Activates Friction."}, ), "z_friction": ( InputArray, From 167705cca75e872ada7247b7b7df8f69280259ba Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 16 Dec 2020 19:44:15 +0100 Subject: [PATCH 005/120] Incorporate input section for the instanton calculations with frictions. Eliminate one instanton regtest that takes too long and test the same as other tests --- ipi/engine/motion/instanton.py | 36 ++- ipi/inputs/motion/instanton.py | 14 +- .../INSTANTON/{100K_D => 070K_D}/driver.txt | 0 .../{100K_D => 070K_D}/files_to_check.txt | 0 .../INSTANTON/{100K_D => 070K_D}/init.xyz | 0 .../INSTANTON/{100K_D => 070K_D}/input.xml | 0 .../ref_simulation.instanton_FINAL.hess_14 | 0 .../ref_simulation.instanton_FINAL_14.ener | 0 .../ref_simulation.instanton_FINAL_14.xyz | 0 ...f_simulation.instanton_FINAL_forces_14.xyz | 0 .../tests/INSTANTON/100K/driver.txt | 4 - .../tests/INSTANTON/100K/files_to_check.txt | 7 - .../tests/INSTANTON/100K/init.xyz | 300 ------------------ .../tests/INSTANTON/100K/input.xml | 39 --- .../ref_simulation.instanton_FINAL.hess_7 | 1 - .../ref_simulation.instanton_FINAL_7.ener | 101 ------ .../100K/ref_simulation.instanton_FINAL_7.xyz | 300 ------------------ ...ef_simulation.instanton_FINAL_forces_7.xyz | 300 ------------------ .../tests/INSTANTON/100K/ref_simulation.out | 11 - .../tests/INSTANTON/100K_D/ref_simulation.out | 18 -- 20 files changed, 25 insertions(+), 1106 deletions(-) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/driver.txt (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/files_to_check.txt (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/init.xyz (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/input.xml (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/ref_simulation.instanton_FINAL.hess_14 (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/ref_simulation.instanton_FINAL_14.ener (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/ref_simulation.instanton_FINAL_14.xyz (100%) rename ipi_tests/regression_tests/tests/INSTANTON/{100K_D => 070K_D}/ref_simulation.instanton_FINAL_forces_14.xyz (100%) delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/driver.txt delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/files_to_check.txt delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/init.xyz delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/input.xml delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL.hess_7 delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.ener delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.xyz delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_forces_7.xyz delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.out delete mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.out diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 64a0239e2..aaee66240 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -35,7 +35,6 @@ # ALBERTO: -# -test friction file, establish format,create spline function # -test old instantons # -code equations,including spline of g function # -resolve hessian problem @@ -137,7 +136,6 @@ def __init__( self.options["discretization"] = discretization self.options["friction"] = friction self.options["z_friction"] = z_friction - self.optarrays["big_step"] = biggest_step self.optarrays["energy_shift"] = energy_shift self.optarrays["delta"] = delta @@ -704,7 +702,7 @@ def __init__(self, esum=False): self.esum = esum def initialize(self, q, forces): - # ALBERTO get friction from forces object + print('\n\n ALBERTO get friction from forces object\n\n') eta = np.zeros((q.shape[0], q.shape[1] ** 2)) self.gm.save(forces.pots, -forces.f, eta) @@ -749,12 +747,14 @@ def set_coef(self, coef): def set_z_friction(self, z_friction): """Sets the scaling factors corresponding to frequency dependence of the friction """ - - print("ALBERTO") - print("Here we have to specify format somewhere and perform spline") - print("Also add zeros with a warning msg") - # self.z_friction[:] = z_fricition - self.z_friction = np.zeros(self.beads.nbeads).reshape(-1, 1) + try: + from scipy.interpolate import interp1d + except ImportError: + softexit.trigger("Scipy required to use friction in a instanton calculation") + + freq = units.unit_to_internal("frequency", "inversecm", z_friction[:,0]) + spline = interp1d(freq,z_friction[:,1],kind="cubic") + self.z_friction = spline(self.nm.get_omegak()) def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -864,6 +864,11 @@ def bind(self, geop): self.options["discretization"] = geop.options["discretization"] self.options["friction"] = geop.options["friction"] + if self.options["friction"]: + if len(geop.options["z_friction"]) ==0: + geop.options["z_friction"] = np.ones((11,2))*3 #ALBERTO + self.options["z_friction"] = geop.options["z_friction"] + self.options["tolerances"] = geop.options["tolerances"] self.optarrays["big_step"] = geop.optarrays["big_step"] self.optarrays["old_x"] = geop.optarrays["old_x"] @@ -963,7 +968,7 @@ def exitstep(self, d_x_max, step): self.optarrays["energy_shift"], self.output_maker, ) - if self.options["hessian_final"] != "true": + if not self.options["hessian_final"]: info("We are not going to compute the final hessian.", verbosity.low) info( "Warning, The current hessian is not the real hessian is only an approximation .", @@ -1095,10 +1100,7 @@ def bind(self, geop): (self.beads.natoms * 3, self.beads.q.size), float ) - elif ( - geop.optarrays["hessian"].size == 0 - and geop.options["hessian_init"] == "true" - ): + elif geop.optarrays["hessian"].size == 0 and geop.options["hessian_init"]: info( " Initial hessian is not provided. We are going to compute it.", verbosity.low, @@ -1137,7 +1139,7 @@ def initialize(self, step): if ((self.beads.q - self.beads.q[0]) == 0).all(): self.initial_geo() - self.options["hessian_init"] = "true" + self.options["hessian_init"] = True else: @@ -1156,7 +1158,7 @@ def initialize(self, step): # self.mapper.sm(self.beads.q, ret=False) # Init instanton mapper self.mapper.initialize(self.beads.q, self.forces) - if self.options["hessian_init"] == "true": + if self.options["hessian_init"]: self.optarrays["hessian"][:] = get_hessian( self.mapper.gm, self.beads.q.copy(), @@ -1507,7 +1509,7 @@ def bind(self, geop): (self.beads.natoms * 3, self.beads.q.size) ) - if geop.options["hessian_final"] == "true": + if geop.options["hessian_final"]: self.options["hessian_asr"] = geop.options["hessian_asr"] if geop.optarrays["hessian"].size == 0: geop.optarrays["hessian"] = np.zeros( diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 0501f3042..08baab6a4 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -153,7 +153,7 @@ class InputInst(InputDictionary): { "dtype": float, "default": input_default(factory=np.ones, args=(0,)), - "help": "Normalized frequency dependence of the friction tensor ", + "help": "Normalized frequency dependence of the friction tensor (z). A two column data is expected. First column: omega (cm^-1). Second column: z(omega). ", }, ), "alt_out": ( @@ -193,9 +193,7 @@ class InputInst(InputDictionary): "hessian_init": ( InputValue, { - "dtype": str, - "default": "false", - "options": ["true", "false"], + "dtype": bool, "default": False, "help": "How to initialize the hessian if it is not fully provided.", }, ), @@ -297,9 +295,8 @@ class InputInst(InputDictionary): "hessian_final": ( InputValue, { - "dtype": str, - "default": "false", - "options": ["false", "true"], + "dtype": bool, + "default": False, "help": "Decide if we are going to compute the final big-hessian by finite difference.", }, ), @@ -330,8 +327,9 @@ def store(self, geop): self.max_ms.store(options["max_ms"]) self.discretization.store(options["discretization"]) self.friction.store(options["friction"]) + print('inside store',options["friction"]) if options["friction"]: - self.friction.store(options["z_friction"]) + self.z_friction.store(options["z_friction"]) self.alt_out.store(options["save"]) self.prefix.store(options["prefix"]) self.delta.store(optarrays["delta"]) diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/driver.txt b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/driver.txt similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/driver.txt rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/driver.txt diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/files_to_check.txt b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/files_to_check.txt similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/files_to_check.txt rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/files_to_check.txt diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/init.xyz b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/init.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/init.xyz rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/init.xyz diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/input.xml b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/input.xml similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/input.xml rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/input.xml diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL.hess_14 b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL.hess_14 similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL.hess_14 rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL.hess_14 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL_14.ener b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.ener similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL_14.ener rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.ener diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL_14.xyz b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL_14.xyz rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.xyz diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL_forces_14.xyz b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_forces_14.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.instanton_FINAL_forces_14.xyz rename to ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_forces_14.xyz diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/driver.txt b/ipi_tests/regression_tests/tests/INSTANTON/100K/driver.txt deleted file mode 100644 index 31dad2df6..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/driver.txt +++ /dev/null @@ -1,4 +0,0 @@ -driver doublewell_1D -address localhost -port 33335 -socket_mode unix diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/files_to_check.txt b/ipi_tests/regression_tests/tests/INSTANTON/100K/files_to_check.txt deleted file mode 100644 index 0218bf4db..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/files_to_check.txt +++ /dev/null @@ -1,7 +0,0 @@ - filename format -------------------------------------------------------------------- -ref_simulation.instanton_FINAL_7.xyz xyz -ref_simulation.instanton_FINAL_forces_7.xyz xyz -ref_simulation.instanton_FINAL_7.ener numpy -ref_simulation.instanton_FINAL.hess_7 numpy -ref_simulation.out numpy diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/init.xyz b/ipi_tests/regression_tests/tests/INSTANTON/100K/init.xyz deleted file mode 100644 index ded650017..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/init.xyz +++ /dev/null @@ -1,300 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -1.0000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.9484616 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.8979531 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.8485368 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.8002749 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.7532297 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.7074637 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.6630390 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.6200180 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.5784629 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.5384362 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.5000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.4632167 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.4281487 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.3948581 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.3634073 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.3338586 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.3062744 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.2807169 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.2572484 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.2359312 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.2168276 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.2000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1854483 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1729233 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1621136 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1527075 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1443935 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1368602 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1297960 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1228894 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1158289 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1083029 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.1000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0907075 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0806087 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0699859 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0591211 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0482967 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0377948 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0278976 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0188873 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0110462 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0046563 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0027487 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0038482 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0036650 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0025655 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0009162 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0009162 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0025655 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0036650 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0038482 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H -0.0027487 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0046563 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0110462 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0188873 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0278976 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0377948 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0482967 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0591211 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0699859 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0806087 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.0907075 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1083029 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1158289 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1228894 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1297960 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1368602 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1443935 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1527075 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1621136 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1729233 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.1854483 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.2000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.2168276 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.2359312 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.2572484 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.2807169 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.3062744 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.3338586 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.3634073 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.3948581 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.4281487 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.4632167 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.5000000 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.5384362 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.5784629 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.6200180 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.6630390 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.7074637 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.7532297 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.8002749 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.8485368 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.8979531 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 0.9484616 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.0000000 0.0000000 0.0000000 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/input.xml b/ipi_tests/regression_tests/tests/INSTANTON/100K/input.xml deleted file mode 100644 index c32261d48..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/input.xml +++ /dev/null @@ -1,39 +0,0 @@ - - - [ step, potential{electronvolt}] - - 100 - -
localhost
- 33335 -
- - - init.xyz - [300.0, 300.0, 300.0 ] - - - - - - 100 - - - - 1 - - 5e-6 - 5e-6 - 1e-3 - - 0.1 - nichols - recompute - none - true - true - 0.2 - - - -
diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL.hess_7 b/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL.hess_7 deleted file mode 100644 index 6254fa203..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL.hess_7 +++ /dev/null @@ -1 +0,0 @@ --6.090966626392038674e-04 0.000000000000000000e+00 0.000000000000000000e+00 -6.249744747511762344e-04 0.000000000000000000e+00 0.000000000000000000e+00 -6.566863644807963141e-04 0.000000000000000000e+00 0.000000000000000000e+00 -7.041447786636928496e-04 0.000000000000000000e+00 0.000000000000000000e+00 -7.672181801953066593e-04 0.000000000000000000e+00 0.000000000000000000e+00 -8.457308077287548076e-04 0.000000000000000000e+00 0.000000000000000000e+00 -9.394623694475648379e-04 0.000000000000000000e+00 0.000000000000000000e+00 -1.048147682965270416e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.171476276260081939e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.309091967357026154e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.460592443114534789e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.625528859954851468e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.803405491723406029e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.993679451905809585e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.195760519259955940e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.409011097416046548e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.632746340112783467e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.866234474473931121e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.108697354942385055e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.359311280255131843e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.617208104981194106e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.881476675699629952e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.151164619804314365e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.425280512137565181e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.702796441174387360e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.982650992309267668e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.263752660888618151e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.544983702096030476e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.825204418611045626e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.103257880203660779e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.377975062199503498e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.648180382178535408e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.912697606375420994e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.170356089387496662e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.419997302832593428e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.660481601062460455e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.890695164755601176e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.109557056709855438e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.316026318319885008e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.509109030511042421e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.687865259254714395e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.851415803505600227e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.998948662561779416e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.129725140488102048e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.243085507543028281e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.338454142357085694e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.415344084091328489e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.473360930688408399e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.512206027656726348e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.531678901364040724e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.531678901364040724e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.512206027656672572e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.473360930688408399e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.415344084091328489e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.338454142357085694e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.243085507543028281e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.129725140488102048e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.998948662561562575e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.851415803505600227e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.687865259254714395e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.509109030511042421e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.316026318319885008e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.109557056709855438e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.890695164755601176e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.660481601062460455e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.419997302832593428e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.170356089387496662e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.912697606375420994e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.648180382178535408e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.377975062199503498e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.103257880203660779e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.825204418611045626e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.544983702096030476e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.263752660888618151e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.982650992309267668e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.702796441174387360e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.425280512137565181e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.151164619804314365e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.881476675699629952e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.617208104981194106e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.359311280255131843e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.108697354942385055e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.866234474473931121e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.632746340112783467e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.409011097416046548e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.195760519259955940e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.993679451905809585e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.803405491723406029e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.625528859954851468e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.460592443114534789e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.309091967357026154e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.171476276260081939e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.048147682965270416e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.394623694475648379e-04 0.000000000000000000e+00 0.000000000000000000e+00 -8.457308077287548076e-04 0.000000000000000000e+00 0.000000000000000000e+00 -7.672181801953066593e-04 0.000000000000000000e+00 0.000000000000000000e+00 -7.041447786636928496e-04 0.000000000000000000e+00 0.000000000000000000e+00 -6.566863644807963141e-04 0.000000000000000000e+00 0.000000000000000000e+00 -6.249744747511762344e-04 0.000000000000000000e+00 0.000000000000000000e+00 -6.090966626392038674e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.316363437257378632e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.316363437257378632e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.316363437257378632e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.316363437257378632e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.317098121226642562e-33 5.511521610893899137e-01 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.ener b/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.ener deleted file mode 100644 index 2d3f3748c..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.ener +++ /dev/null @@ -1,101 +0,0 @@ -#Bead Energy (eV) -0 -0.13615775758485366 -1 -0.13596022856520623 -2 -0.13556523773366455 -3 -0.13497292712807243 -4 -0.13418352880393097 -5 -0.13319738747133422 -6 -0.1320149904034348 -7 -0.1306370043719294 -8 -0.12906431929241854 -9 -0.12729809818284332 -10 -0.12533983295082152 -11 -0.12319140543022081 -12 -0.12085515298378698 -13 -0.11833393787764937 -14 -0.11563121951612754 -15 -0.11275112850314774 -16 -0.10969854137200448 -17 -0.10647915470109237 -18 -0.10309955721309175 -19 -0.09956729834304316 -20 -0.0958909516614263 -21 -0.09208017145685796 -22 -0.0881457407247401 -23 -0.0840996087786886 -24 -0.07995491670636554 -25 -0.07572600893568839 -26 -0.07142842926601252 -27 -0.06707889985571241 -28 -0.06269528184544743 -29 -0.05829651653675241 -30 -0.0539025463382438 -31 -0.04953421503461935 -32 -0.04521314732261861 -33 -0.04096160798691327 -34 -0.03680234154901866 -35 -0.03275839370316515 -36 -0.02885291634211809 -37 -0.025108958459052456 -38 -0.021549245673445325 -39 -0.01819595155354917 -40 -0.015070464279303622 -41 -0.012193152492110162 -42 -0.009583134397647594 -43 -0.007258054312806803 -44 -0.005233870868538172 -45 -0.0035246609908934543 -46 -0.0021424435805081194 -47 -0.0010970264979616954 -48 -0.000395880044786437 -49 -4.403961736566623e-05 -50 -4.403961736566623e-05 -51 -0.00039588004478643686 -52 -0.0010970264979616954 -53 -0.0021424435805081194 -54 -0.0035246609908934534 -55 -0.005233870868538172 -56 -0.007258054312806803 -57 -0.00958313439764759 -58 -0.012193152492110162 -59 -0.015070464279303622 -60 -0.01819595155354917 -61 -0.021549245673445325 -62 -0.025108958459052456 -63 -0.02885291634211809 -64 -0.03275839370316515 -65 -0.03680234154901866 -66 -0.04096160798691327 -67 -0.04521314732261861 -68 -0.04953421503461935 -69 -0.0539025463382438 -70 -0.05829651653675241 -71 -0.06269528184544743 -72 -0.06707889985571241 -73 -0.07142842926601252 -74 -0.07572600893568839 -75 -0.07995491670636554 -76 -0.0840996087786886 -77 -0.0881457407247401 -78 -0.09208017145685796 -79 -0.0958909516614263 -80 -0.09956729834304316 -81 -0.10309955721309175 -82 -0.10647915470109237 -83 -0.10969854137200448 -84 -0.11275112850314774 -85 -0.11563121951612754 -86 -0.11833393787764937 -87 -0.12085515298378698 -88 -0.12319140543022081 -89 -0.12533983295082152 -90 -0.12729809818284332 -91 -0.12906431929241854 -92 -0.1306370043719294 -93 -0.1320149904034348 -94 -0.13319738747133422 -95 -0.13418352880393097 -96 -0.13497292712807243 -97 -0.13556523773366455 -98 -0.13596022856520623 -99 -0.13615775758485366 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.xyz b/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.xyz deleted file mode 100644 index ff00c27b1..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_7.xyz +++ /dev/null @@ -1,300 +0,0 @@ -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 0 -H -0.5901404982879411 9.078171236931236e-22 6.293685049475745e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 1 -H -0.5896153278995013 1.2866086548722858e-21 5.023012781540679e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 2 -H -0.5885650310882056 6.529591162963341e-22 6.277408681626339e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 3 -H -0.5869896991727866 7.774326123103429e-22 3.734651780874192e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 4 -H -0.5848894775834099 7.750983361174401e-22 3.717480805857778e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 5 -H -0.5822645759567958 1.4024445862453065e-22 1.0018945336108896e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 6 -H -0.5791152815169126 -1.1509174656504585e-22 1.0628948683716586e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 7 -H -0.5754419756720506 -5.599427326751646e-22 1.124123259166436e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 8 -H -0.5712451537405001 -1.0677203968860183e-21 1.8812609489438318e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 9 -H -0.5665254476976629 -1.6387423040237152e-21 1.8803978855717054e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 10 -H -0.56128365181714 -1.1345697433927864e-21 1.4380623125476375e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 11 -H -0.5555207510570968 -5.795817153549597e-22 1.65155269196155e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 12 -H -0.5492379520209874 -6.889591856916204e-22 1.2362054845429122e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 13 -H -0.5424367162985383 -7.298499448253081e-22 7.734282288368197e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 14 -H -0.535118795968839 -7.344669477126578e-22 5.925491131391912e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 15 -H -0.5272862710225651 -7.244341078573068e-22 4.479458042712707e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 16 -H -0.5189415884349686 -7.53824276606815e-22 3.738613171504953e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 17 -H -0.5100876025955496 -7.192294294294663e-22 2.8313640914080497e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 18 -H -0.5007276167745547 -7.621240681498184e-22 2.1712556186352577e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 19 -H -0.4908654252810247 -9.387733883638061e-22 2.1919979967939335e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 20 -H -0.48050535594242594 -1.2545921331115598e-21 1.4826977305371833e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 21 -H -0.4696523125124343 -1.3511651025053312e-21 7.681547538262432e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 22 -H -0.4583118165917232 -1.2110043182672653e-21 -5.293536913153761e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 23 -H -0.44649004862719316 -1.34287432389378e-21 -5.983768884459103e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 24 -H -0.4341938875385743 -1.208074286670725e-21 -5.571236513726097e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 25 -H -0.4214309485083544 -1.0442755860130991e-21 -5.559953945451195e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 26 -H -0.40820961846214915 -6.762818153316965e-22 -3.0192562080632025e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 27 -H -0.3945390887625667 -7.98826608993858e-22 -3.703240496177591e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 28 -H -0.38042938464090115 -1.3050472048110144e-21 4.671328534646483e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 29 -H -0.36589139089817385 -1.5884655903959865e-21 5.240969031306547e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 30 -H -0.35093687342059227 -1.0109759377743193e-21 1.3778337807389472e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 31 -H -0.33557849607481605 -1.5428480006423429e-21 1.3906639517016432e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 32 -H -0.319829832575779 -1.8432156383109948e-21 9.840021012558533e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 33 -H -0.30370537295438255 -1.3439096977545212e-21 8.025637600274184e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 34 -H -0.2872205242941564 -1.052876004924979e-21 5.786087945403629e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 35 -H -0.2703916054548367 -7.621592281472511e-22 4.810453412353864e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 36 -H -0.2532358355564187 -5.276235121776751e-22 3.3305038477956576e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 37 -H -0.23577131605912155 -4.59677524893803e-22 2.730303074098951e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 38 -H -0.21801700634217108 -3.93235413783964e-22 1.7831918944804414e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 39 -H -0.19999269275653322 -3.051778247677056e-22 1.642816385319269e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 40 -H -0.18171895120269282 -2.536897475288539e-22 1.1076604016901196e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 41 -H -0.16321710336311532 -1.6987014071980392e-22 5.612895829552308e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 42 -H -0.14450916679885872 -1.2519907077986792e-22 3.806956098962501e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 43 -H -0.1256177991995281 -1.2114133326823013e-22 1.1952632674006422e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 44 -H -0.10656623715392201 -9.779458190080445e-23 1.4980169778735957e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 45 -H -0.08737822988381534 -1.2044367593268231e-22 1.212664662764945e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 46 -H -0.06807796845386276 -6.465680392826937e-23 1.531228548028866e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 47 -H -0.048690011035153025 2.0796583818062603e-23 7.106583608649648e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 48 -H -0.029239204857137654 -1.6502609864676455e-23 -6.089664139329361e-25 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 49 -H -0.009750605531276435 1.5946029444127188e-24 -6.866000390598732e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 50 -H 0.009750605531276435 2.846881895696057e-23 -1.046358989141541e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 51 -H 0.02923920485713765 -9.811280772136615e-24 -6.857039036515236e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 52 -H 0.048690011035153025 1.2340909165120575e-23 -6.130089970957646e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 53 -H 0.06807796845386276 6.3127614270763944e-24 -7.498161057913146e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 54 -H 0.08737822988381533 -1.3898874091803341e-23 -3.06616359193808e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 55 -H 0.10656623715392201 2.750288803410218e-23 -6.641425189193571e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 56 -H 0.1256177991995281 -4.821718713639728e-24 -7.224919518069643e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 57 -H 0.1445091667988587 -1.142645392708382e-24 -3.0958655085810805e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 58 -H 0.16321710336311532 5.0709165663305964e-23 4.3574525625981346e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 59 -H 0.18171895120269282 2.2399088595170758e-23 3.3673999426163784e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 60 -H 0.19999269275653322 2.025403703330705e-23 5.977648827509924e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 61 -H 0.21801700634217108 1.8401207704997608e-23 1.2671129947827866e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 62 -H 0.23577131605912155 -3.1600449610246217e-23 -1.1057875462816284e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 63 -H 0.2532358355564187 -3.8589020674022465e-24 -1.964638994903192e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 64 -H 0.2703916054548367 2.0742079879214607e-23 -1.6999452077870684e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 65 -H 0.2872205242941564 -1.4532201351163465e-23 -4.20284135030566e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 66 -H 0.30370537295438255 -4.0297587403150335e-23 -8.15965218056878e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 67 -H 0.319829832575779 -4.6010969430988735e-23 -3.8252822631613477e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 68 -H 0.33557849607481605 -3.2816533606603693e-23 -4.11525797886767e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 69 -H 0.35093687342059227 -7.327962334377538e-24 4.859030104942728e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 70 -H 0.36589139089817385 -2.1507244016579004e-23 1.486140693211683e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 71 -H 0.38042938464090115 -2.3681469158254017e-23 5.656765180167993e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 72 -H 0.3945390887625667 1.5191135799738723e-23 3.982719926304124e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 73 -H 0.40820961846214915 4.309461001364038e-23 3.544254052442535e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 74 -H 0.4214309485083544 1.4720924658550932e-23 3.2343895160892695e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 75 -H 0.4341938875385743 -2.308980347930464e-23 3.626930297389299e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 76 -H 0.44649004862719316 -1.6864083191547813e-23 3.6626453603868835e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 77 -H 0.4583118165917232 -2.2787662209632912e-23 -2.8349674953641277e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 78 -H 0.4696523125124343 -1.9437623934742368e-23 -2.2407259203917332e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 79 -H 0.48050535594242594 6.413559495839694e-24 -7.689521351882469e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 80 -H 0.4908654252810247 2.6747023488952534e-23 -5.0495142707911955e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 81 -H 0.5007276167745547 1.8756329765469694e-23 -7.026493050240111e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 82 -H 0.5100876025955496 5.0171596091920777e-23 3.454768012239971e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 83 -H 0.5189415884349686 2.062818358080441e-23 -4.142386834280639e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 84 -H 0.5272862710225651 2.1909769809934063e-23 1.5842507337568664e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 85 -H 0.535118795968839 9.412658650895201e-24 -2.135897607914458e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 86 -H 0.5424367162985383 -7.845876198672925e-24 8.033541268175241e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 87 -H 0.5492379520209874 -2.677081188838481e-23 -1.7832690173305788e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 88 -H 0.5555207510570968 -4.243624007903766e-24 6.157534609296761e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 89 -H 0.56128365181714 -5.465120125983879e-23 -1.2081617584710881e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 90 -H 0.5665254476976629 -1.0687728980147612e-23 3.758002455147056e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 91 -H 0.5712451537405001 2.9195032577259055e-24 -3.2255290759134977e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 92 -H 0.5754419756720506 4.506476578258912e-24 -5.221743022277905e-25 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 93 -H 0.5791152815169126 1.1518615589547894e-23 -5.154921569323275e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 94 -H 0.5822645759567958 2.0022460511670837e-23 9.731546479347984e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 95 -H 0.5848894775834099 -1.679909005808942e-23 -1.0836924352678114e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 96 -H 0.5869896991727866 2.0256084798357683e-23 2.769778629461784e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 97 -H 0.5885650310882056 5.97465778776041e-24 -1.4941619906348795e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 98 -H 0.5896153278995013 -1.7999381347411395e-23 -5.3086573109531675e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 99 -H 0.5901404982879411 6.106974122370453e-24 1.0192627560582765e-23 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_forces_7.xyz b/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_forces_7.xyz deleted file mode 100644 index 664158b84..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.instanton_FINAL_forces_7.xyz +++ /dev/null @@ -1,300 +0,0 @@ -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.007314746772340194 -9.455157039423895e-22 -6.555040541357247e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.007314134405304525 -1.3400371685665248e-21 -5.231601544074322e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.007312862488100437 -6.800743039291111e-22 -6.538088270901991e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.007310836889121686 -8.097167639953744e-22 -3.8897392607088876e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.007307917000158562 -8.072855531929721e-22 -3.87185523307128e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.007303916450500245 -1.460683375093697e-22 -1.0434998310776053e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.007298604070598201 1.1987111823657779e-22 -1.1070333037966628e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.007291705114682677 5.831952639304393e-22 -1.1708043029468764e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.007282902753463663 1.1120592202186697e-21 -1.9593833647945633e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.007271839849384011 1.7067937393224704e-21 -1.9584844613143962e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.007258121027748702 1.1816845943945837e-21 -1.497780185319718e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.007241315057356782 6.036497872574037e-22 -1.7201360994219824e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.007220957553941576 7.175693346659023e-22 -1.2875409247404217e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.007196554018717124 7.601581489743851e-22 -8.055460919954669e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0071675832225789275 7.649668804041e-22 -6.171556772921496e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.007133500943969893 7.545174105816073e-22 -4.665474812047748e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.00709374406506578 7.851280538146056e-22 -3.8938651545184224e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.007047735026742065 7.490965994302671e-22 -2.948941083105022e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.006994886637757813 7.937725076793145e-22 -2.2614205340620564e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.006934607227755879 9.777574777728437e-22 -2.2830242731569466e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0068663061270800175 1.3066911087486306e-21 -1.5442691615239325e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.006789399449123241 1.4072744275195872e-21 -8.000536273715748e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0067033161430510475 1.2612932391114576e-21 5.513359629551911e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.006607504276421481 1.3986393608629451e-21 6.232254604320999e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.006501437498615238 1.2582415331948454e-21 5.802591156989402e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.006384621627286844 1.0876408255026458e-21 5.7908400617453255e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0062566012914739245 7.043655159152286e-22 3.1446357250189116e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.006116966556802304 8.31999181132499e-22 3.857023571407041e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.005965359450666035 1.3592414092334888e-21 -4.865313037734118e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.005801480298623576 1.6544292035178988e-21 -5.458608781046953e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0056250937778193205 1.0529583552960508e-21 -1.4350505659236415e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.005436034589295873 1.6069172692721512e-21 -1.4484135305702475e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.005234212648874535 1.9197581608566015e-21 -1.0248643864138271e-21 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.005019617696092655 1.3997177303045787e-21 -8.358915234314204e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.004792323222702495 1.0965983907759071e-21 -6.026364643260722e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0045524896266151095 7.938091277527363e-22 -5.010215301910684e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.004300366504012265 5.495339353191904e-22 -3.4688084284207036e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.004036294001678893 4.787663805770879e-22 -2.843683342940994e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.003760703163380103 4.095651529092631e-22 -1.857241833592006e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.003474115218189822 3.1785082951396853e-22 -1.7110370034596493e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H -0.0031771397748579467 2.642246262572104e-22 -1.1536577985801173e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H -0.0028704719042803523 1.7692427416226184e-22 -5.84598044355511e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H -0.0025548881115337986 1.3039816550252246e-22 -3.965046133019497e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H -0.0022312412193073532 1.2617192385142696e-22 -1.2448985155459885e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H -0.0019004542053972834 1.0185566072109902e-22 -1.5602245654826396e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H -0.0015635130576846365 1.254452951621073e-22 -1.2630225321106071e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H -0.0012214587301111008 6.734178270641242e-23 -1.5948153000202792e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H -0.000875378302032778 -2.1660195732306292e-23 -7.401696033252203e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H -0.000526395460404973 1.7187907537598665e-23 6.342547331611145e-25 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H -0.00017566043901573247 -1.6608214211265147e-24 7.15112220639296e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.00017566043901573247 -2.965103289415172e-23 1.0898107453291972e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0005263954604049729 1.0218710138562074e-23 7.141788717528967e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.000875378302032778 -1.285338545838277e-23 6.384651911544576e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0012214587301111008 -6.574909096515549e-24 7.809534371971948e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.001563513057684636 1.4476047408597277e-23 3.1934910141812506e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0019004542053972834 -2.864499012116378e-23 6.917221155065817e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0022312412193073532 5.021948413125964e-24 7.52494603347442e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0025548881115337978 1.1900955981619113e-24 3.22442635114526e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0028704719042803523 -5.281494611317735e-23 -4.538402856248912e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0031771397748579467 -2.3329247122562566e-23 -3.50723669349376e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.003474115218189822 -2.109511881128179e-23 -6.225880402068756e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.003760703163380103 -1.9165347736338057e-23 -1.3197319195331572e-22 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.004036294001678893 3.291270959571379e-23 1.1517071698094925e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.004300366504012265 4.019149242152826e-24 2.0462238195084954e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 64 -H 0.0045524896266151095 -2.1603428428889662e-23 1.7705381930508923e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 65 -H 0.004792323222702495 1.5135674610851078e-23 4.377371162295624e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 66 -H 0.005019617696092655 4.197101015859397e-23 8.498494987679402e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 67 -H 0.005234212648874535 4.7921649652996746e-23 3.9841333209462296e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 68 -H 0.005436034589295873 3.417929345479695e-23 4.286150749133609e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 69 -H 0.0056250937778193205 7.632267870058876e-24 -5.0608092205421186e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 70 -H 0.005801480298623576 2.2400367249594407e-23 -1.547855098814456e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 71 -H 0.005965359450666035 2.4664880620962597e-23 -5.891671540193762e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 72 -H 0.006116966556802304 -1.5821972382435233e-23 -4.148108838711201e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 73 -H 0.0062566012914739245 -4.4884183675019354e-23 -3.6914349574206574e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 74 -H 0.006384621627286844 -1.5332234960042197e-23 -3.368702793011873e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 75 -H 0.006501437498615238 2.404864506389959e-23 -3.7775444676953046e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 76 -H 0.006607504276421481 1.7564391631358397e-23 -3.8147426566809123e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 77 -H 0.0067033161430510475 2.3733956887362965e-23 2.952694124261879e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 78 -H 0.006789399449123241 2.0244802833040653e-23 2.3337757029105443e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 79 -H 0.0068663061270800175 -6.679892968768417e-24 8.00884121289489e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 80 -H 0.006934607227755879 -2.7857737073341945e-23 5.259203550701257e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 81 -H 0.006994886637757813 -1.9535216817047576e-23 7.318279584347093e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 82 -H 0.007047735026742065 -5.225505309239083e-23 -3.5982328640839107e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 83 -H 0.00709374406506578 -2.1484802401733836e-23 4.3144061743216626e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 84 -H 0.007133500943969893 -2.2819608580172937e-23 -1.6500393181124094e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 85 -H 0.0071675832225789275 -9.80353458642081e-24 2.224594224528838e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 86 -H 0.007196554018717124 8.171688948600145e-24 -8.367147114859479e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 87 -H 0.007220957553941576 2.78825133246902e-23 1.8573221590937336e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 88 -H 0.007241315057356782 4.419847385976716e-24 -6.413236233057577e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 89 -H 0.007258121027748702 5.692068113925694e-23 1.2583326374037627e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 90 -H 0.007271839849384011 1.1131554281659216e-23 -3.914059609649673e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 91 -H 0.007282902753463663 -3.040740371431835e-24 3.359474408669492e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 92 -H 0.007291705114682677 -4.693615336157423e-24 5.438584380772626e-25 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 93 -H 0.007298604070598201 -1.1996944806776676e-23 5.368988058473899e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 94 -H 0.007303916450500245 -2.0853925698531686e-23 -1.0135664749786307e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 95 -H 0.007307917000158562 1.7496699552491957e-23 1.128694523430973e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 96 -H 0.007310836889121686 -2.1097251613101484e-23 -2.8847981848439134e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 97 -H 0.007312862488100437 -6.2227651545365466e-24 1.5562094936387915e-23 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 98 -H 0.007314134405304525 1.874683488673448e-23 5.5291079264236795e-24 -1 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 99 -H 0.007314746772340194 -6.3605761398073895e-24 -1.0615892971660645e-23 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.out b/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.out deleted file mode 100644 index 8a521d5ca..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K/ref_simulation.out +++ /dev/null @@ -1,11 +0,0 @@ -# column 1 --> step : The current simulation time step. -# column 2 --> potential{electronvolt} : The physical system potential energy. - 0.00000000e+00 -5.69172696e-02 - 1.00000000e+00 -6.64000668e-02 - 2.00000000e+00 -7.41303579e-02 - 3.00000000e+00 -7.66310379e-02 - 4.00000000e+00 -7.44810258e-02 - 5.00000000e+00 -7.30480680e-02 - 6.00000000e+00 -7.29795472e-02 - 7.00000000e+00 -7.29764823e-02 - 8.00000000e+00 -7.29763457e-02 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.out b/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.out deleted file mode 100644 index 16c444214..000000000 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_D/ref_simulation.out +++ /dev/null @@ -1,18 +0,0 @@ -# column 1 --> step : The current simulation time step. -# column 2 --> potential{electronvolt} : The physical system potential energy. - 0.00000000e+00 -3.02631856e-02 - 1.00000000e+00 -3.26726054e-02 - 2.00000000e+00 -3.53615880e-02 - 3.00000000e+00 -3.83162245e-02 - 4.00000000e+00 -4.15223147e-02 - 5.00000000e+00 -4.49653444e-02 - 6.00000000e+00 -4.86304516e-02 - 7.00000000e+00 -5.25023800e-02 - 8.00000000e+00 -5.65654159e-02 - 9.00000000e+00 -6.08032975e-02 - 1.00000000e+01 -6.51990610e-02 - 1.10000000e+01 -6.97347243e-02 - 1.20000000e+01 -7.43903939e-02 - 1.30000000e+01 -7.90101239e-02 - 1.40000000e+01 -7.89643349e-02 - 1.50000000e+01 -7.89641435e-02 From 18f8c411aec4c3c6dcbb0d963f2b9f8a87bd03b9 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 16 Dec 2020 19:47:02 +0100 Subject: [PATCH 006/120] linting --- ipi/engine/motion/instanton.py | 20 +++++++++++--------- ipi/inputs/motion/instanton.py | 5 +++-- 2 files changed, 14 insertions(+), 11 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index aaee66240..f694356e8 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -37,7 +37,7 @@ # ALBERTO: # -test old instantons # -code equations,including spline of g function -# -resolve hessian problem +# -resolve hessian problem, needed to code? class InstantonMotion(Motion): @@ -702,7 +702,7 @@ def __init__(self, esum=False): self.esum = esum def initialize(self, q, forces): - print('\n\n ALBERTO get friction from forces object\n\n') + print("\n\n ALBERTO get friction from forces object\n\n") eta = np.zeros((q.shape[0], q.shape[1] ** 2)) self.gm.save(forces.pots, -forces.f, eta) @@ -748,12 +748,14 @@ def set_coef(self, coef): def set_z_friction(self, z_friction): """Sets the scaling factors corresponding to frequency dependence of the friction """ try: - from scipy.interpolate import interp1d + from scipy.interpolate import interp1d except ImportError: - softexit.trigger("Scipy required to use friction in a instanton calculation") - - freq = units.unit_to_internal("frequency", "inversecm", z_friction[:,0]) - spline = interp1d(freq,z_friction[:,1],kind="cubic") + softexit.trigger( + "Scipy required to use friction in a instanton calculation" + ) + + freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) + spline = interp1d(freq, z_friction[:, 1], kind="cubic") self.z_friction = spline(self.nm.get_omegak()) def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -865,8 +867,8 @@ def bind(self, geop): self.options["friction"] = geop.options["friction"] if self.options["friction"]: - if len(geop.options["z_friction"]) ==0: - geop.options["z_friction"] = np.ones((11,2))*3 #ALBERTO + if len(geop.options["z_friction"]) == 0: + geop.options["z_friction"] = np.ones((11, 2)) * 3 # ALBERTO self.options["z_friction"] = geop.options["z_friction"] self.options["tolerances"] = geop.options["tolerances"] diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 08baab6a4..5abec7f1a 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -193,7 +193,8 @@ class InputInst(InputDictionary): "hessian_init": ( InputValue, { - "dtype": bool, "default": False, + "dtype": bool, + "default": False, "help": "How to initialize the hessian if it is not fully provided.", }, ), @@ -327,7 +328,7 @@ def store(self, geop): self.max_ms.store(options["max_ms"]) self.discretization.store(options["discretization"]) self.friction.store(options["friction"]) - print('inside store',options["friction"]) + print("inside store", options["friction"]) if options["friction"]: self.z_friction.store(options["z_friction"]) self.alt_out.store(options["save"]) From 6b697fd830750ac31f912e492e0242443eb86ad6 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 28 Dec 2020 14:44:45 +0100 Subject: [PATCH 007/120] Fix of splitting calculations. --- ipi/engine/motion/instanton.py | 101 +++++++++++++++++++++------------ ipi/inputs/motion/instanton.py | 1 - ipi/utils/hesstools.py | 4 +- 3 files changed, 68 insertions(+), 38 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index f694356e8..58493806b 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -17,9 +17,8 @@ from ipi.utils.depend import dstrip, dobject from ipi.utils.softexit import softexit from ipi.utils.messages import verbosity, info -from ipi.utils import units -from ipi.utils.mintools import nichols, Powell -from ipi.engine.motion.geop import L_BFGS +from ipi.utils import units, nmtransform +from ipi.utils.mintools import nichols, Powell, L_BFGS from ipi.utils.instools import ( banded_hessian, invmul_banded, @@ -35,9 +34,12 @@ # ALBERTO: -# -test old instantons -# -code equations,including spline of g function -# -resolve hessian problem, needed to code? +# - fix LBFGS example +# - Add bath-driver to this branch +# - finish equations (search CONTINUE HERE) +# - code spline and integration to obtain g +# - resolve hessian problem, implement sparse and dense spring hessian +# - fix omegak and normal mode transformation (the fact that we are using half RP) class InstantonMotion(Motion): @@ -375,6 +377,8 @@ def bind(self, mapper): self.dbeads = mapper.beads.copy() self.dcell = mapper.cell.copy() self.dforces = mapper.forces.copy(self.dbeads, self.dcell) + self.nm = mapper.nm + self.nm_trans = nmtransform.nm_trans(self.dbeads.nbeads) self.fix = mapper.fix self.coef = mapper.coef self.friction = mapper.friction @@ -408,13 +412,26 @@ def save(self, e, g, eta=None): self.f = -g self.eta = eta - def compute_friction_terms(): + def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ - # self.z_friction - # self.eta + z = self.z_friction / self.z_friction[1] + s = self.eta + zk = np.multiply(2 * self.nm.get_omegak(), self.z_friction) + + # g = obtain_g(self.dbeads, self.eta) + # s = obtain_s(self.dbeads, self.eta) + + gq = self.dbeads.q + e = 0.5 * np.dot(zk, self.nm_trans.b2nm(gq) ** 2) + + print("CONTINUE HERE") + print(zk.shape, self.nm_trans.b2nm(gq).shape) + aux = np.multiply(zk, self.nm_trans.b2nm(gq)) + print(aux.shape) + g = self.nm_trans.nm2b(aux.reshape(1, -1)) + print(g.shape, s.shape) - # WRITE FORMULAS HERE ALBERTO e = 0 g = 0 return e, g @@ -424,7 +441,6 @@ def __call__(self, x, new_disc=True): self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) - if self.spline: try: from scipy.interpolate import interp1d @@ -480,13 +496,14 @@ def __call__(self, x, new_disc=True): self.dbeads.q[:] = x[:] self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) - e = np.sum(full_pot) # Energy - g = -full_forces # Gradient - if self.friction: # ALBERTO: The following has to be joined to the json implementation for the # communication of the extras strings - red_eta = np.zeros(self.dbeads.nbeads, (self.dbeads.natoms * 3) ** 2) + print("\n ALBERTO2 get friction from forces object\n") + print("\n pick only the tensor corresponding to the first RP frequency") + red_eta = np.zeros( + (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) + ) # Interpolate if necessary to get full pot and forces if self.spline: @@ -499,8 +516,7 @@ def __call__(self, x, new_disc=True): else: full_eta = None - self.save(full_pot, g, full_eta) - + self.save(full_pot, -full_forces, full_eta) return self.evaluate() def evaluate(self): @@ -525,6 +541,8 @@ class SpringMapper(object): """ def __init__(self): + self.pot = None + self.f = None pass def bind(self, mapper): @@ -702,7 +720,8 @@ def __init__(self, esum=False): self.esum = esum def initialize(self, q, forces): - print("\n\n ALBERTO get friction from forces object\n\n") + + print("\nALBERTO1 get friction from forces object\n") eta = np.zeros((q.shape[0], q.shape[1] ** 2)) self.gm.save(forces.pots, -forces.f, eta) @@ -710,7 +729,7 @@ def initialize(self, q, forces): e2, g2 = self.sm(q) g = self.fix.get_active_vector(g1 + g2, 1) - e = np.sum(e1) + np.sum(e2) + e = np.sum(e1+e2) self.save(e, g) @@ -755,8 +774,11 @@ def set_z_friction(self, z_friction): ) freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) - spline = interp1d(freq, z_friction[:, 1], kind="cubic") - self.z_friction = spline(self.nm.get_omegak()) + spline = interp1d( + freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False + ) + self.z_friction = spline(2 * self.nm.get_omegak()) + print(self.z_friction) def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -776,12 +798,12 @@ def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): if apply_fix: g = self.fix.get_active_vector(g, 1) + if mode == "all": + self.save(np.sum(e), g) + if self.esum: e = np.sum(e) - if mode == "all": - self.save(e, g) - if ret: return e, g @@ -1156,8 +1178,6 @@ def initialize(self, step): ) # Initialize all the mappers - # self.mapper.gm.save(self.forces.pots, self.forces.f) - # self.mapper.sm(self.beads.q, ret=False) # Init instanton mapper self.mapper.initialize(self.beads.q, self.forces) if self.options["hessian_init"]: @@ -1170,8 +1190,7 @@ def initialize(self, step): ) # active_hessian = self.mapper.fix.get_active_vector( self.optarrays["hessian"],t=2 ) - self.update_pos_for() - self.update_old_pos_for() + self.update_old_pos_for() self.init = True @@ -1311,10 +1330,10 @@ def step(self, step=None): elif self.options["mode"] == "splitting": d_x = nichols( activearrays["old_f"], - self.sm.f, + self.mapper.sm.f, d, w, - self.sm.dbeads.m3, + self.mapper.sm.dbeads.m3, activearrays["big_step"], mode=0, ) @@ -1330,7 +1349,6 @@ def step(self, step=None): # Get the new full-position d_x_full = self.fix.get_full_vector(d_x, t=1) new_x = self.optarrays["old_x"].copy() + d_x_full - self.post_step(step, new_x, d_x, activearrays) @@ -1519,7 +1537,7 @@ def bind(self, geop): ) self.optarrays["hessian"] = geop.optarrays["hessian"] - self.sm.bind(self, self.options["discretization"]) + # self.sm.bind(self, self.options["discretization"]) # Specific for LBFGS self.options["corrections"] = geop.options["corrections"] @@ -1584,8 +1602,10 @@ def initialize(self, step): ) # This must be done after the stretching and before the self.d. - if self.sm.f is None: - self.sm(self.beads.q, ret=False) # Init instanton mapper + # Initialize all the mapper + self.mapper.initialize(self.beads.q, self.forces) + # if self.mapper.sm.f is None: + # self.mapper.sm(self.beads.q, ret=False) # Init instanton mapper if ( self.optarrays["old_x"] @@ -1595,7 +1615,8 @@ def initialize(self, step): # Specific for LBFGS if np.linalg.norm(self.optarrays["d"]) == 0.0: - f = self.forces.f + self.sm.f + # f = self.forces.f + self.mapper.sm.f + f = self.mapper.f self.optarrays["d"] += dstrip(f) / np.sqrt(np.dot(f.flatten(), f.flatten())) self.update_old_pos_for() @@ -1634,6 +1655,16 @@ def step(self, step=None): fdf0 = (e, g) # Do one step. Update the position and force inside the mapper. + print( + activearrays["big_step"], + self.options["ls_options"]["tolerance"], + self.options["tolerances"]["energy"], + self.options["ls_options"]["iter"], + self.options["corrections"], + self.options["scale"], + step, + ) + L_BFGS( activearrays["old_x"], activearrays["d"], diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 5abec7f1a..b82f71244 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -328,7 +328,6 @@ def store(self, geop): self.max_ms.store(options["max_ms"]) self.discretization.store(options["discretization"]) self.friction.store(options["friction"]) - print("inside store", options["friction"]) if options["friction"]: self.z_friction.store(options["z_friction"]) self.alt_out.store(options["save"]) diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index fe1d4dbea..2c1a59c1a 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -193,8 +193,8 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): fixdofs = list() for i in fixatoms: fixdofs.extend([3 * i, 3 * i + 1, 3 * i + 2]) - ii = natoms * 3 + ncalc = ii - len(fixdofs) if x0.size != natoms * 3 * nbeads: raise ValueError( "The position vector is not consistent with the number of atoms/beads." @@ -227,7 +227,7 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): continue else: info( - " @get_hessian: Computing hessian: %d of %d" % ((j + 1), ii), + " @get_hessian: Computing hessian: %d of %d" % ((j + 1), ncalc), verbosity.low, ) x = x0.copy() From b6af604d006f2fbf5e6545eabd8260fef73029d3 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 28 Dec 2020 14:45:26 +0100 Subject: [PATCH 008/120] flake8 --- ipi/engine/motion/instanton.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 58493806b..5ed4f096f 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -729,7 +729,7 @@ def initialize(self, q, forces): e2, g2 = self.sm(q) g = self.fix.get_active_vector(g1 + g2, 1) - e = np.sum(e1+e2) + e = np.sum(e1 + e2) self.save(e, g) From 60d9e7393c18dce1bfa00d69414236619094de22 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 28 Dec 2020 15:04:24 +0100 Subject: [PATCH 009/120] Add harmonic bath to the driver --- drivers/Makefile | 3 +- drivers/driver.f90 | 23 ++++++++++++++-- drivers/pes/harmonic_bath.f90 | 52 +++++++++++++++++++++++++++++++++++ 3 files changed, 74 insertions(+), 4 deletions(-) create mode 100644 drivers/pes/harmonic_bath.f90 diff --git a/drivers/Makefile b/drivers/Makefile index 68b41a64d..988e8fe49 100644 --- a/drivers/Makefile +++ b/drivers/Makefile @@ -22,12 +22,13 @@ .PHONY: all modules clean FLAGS=-g -O3 -Wall +#FLAGS=-g -O0 -Wall -fbacktrace CFLAGS=$(FLAGS) FFLAGS=$(FLAGS) -ffree-line-length-none -ffixed-line-length-none -Wno-maybe-uninitialized #FFLAGS=-g -O0 -fcheck=all -Wall -pedantic -ffree-line-length-none MODULES=distance.f90 LJ.f90 SG.f90 pes/pswater.f90 pes/LEPS.f90 LJPolymer.f90 pes/efield.f90 pes/eckart.f90 pes/doublewell.f90 pes/doublewell_1D.f90 pes/MB.f90 -PES=pes/zundel.f pes/morse.f pes/qtip4pf.f pes/utility.f pes/ch52008.f +PES=pes/zundel.f pes/morse.f pes/qtip4pf.f pes/utility.f pes/ch52008.f pes/harmonic_bath.f90 OBJECTS=$(MODULES:%.f90=%.o) $(PES:%.f=%.o) FC=gfortran CC=gcc diff --git a/drivers/driver.f90 b/drivers/driver.f90 index 4d0acb497..ee9891fdc 100644 --- a/drivers/driver.f90 +++ b/drivers/driver.f90 @@ -152,11 +152,13 @@ PROGRAM DRIVER vstyle = 25 ELSEIF (trim(cmdbuffer) == "doublewell_1D") THEN vstyle = 24 + ELSEIF (trim(cmdbuffer) == "harmonic_bath") THEN + vstyle = 26 ELSEIF (trim(cmdbuffer) == "gas") THEN vstyle = 0 ! ideal gas ELSE WRITE(*,*) " Unrecognized potential type ", trim(cmdbuffer) - WRITE(*,*) " Use -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4pf-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D] " + WRITE(*,*) " Use -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4pf-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D|harmonic_bath] " STOP "ENDED" ENDIF ELSEIF (ccmd == 4) THEN @@ -249,6 +251,20 @@ PROGRAM DRIVER STOP "ENDED" ENDIF isinit = .true. + ELSEIF (26 == vstyle) THEN !harmonic_bath + IF (par_count /= 3) THEN ! defaults values + WRITE(*,*) "Error: parameters not initialized correctly." + WRITE(*,*) "For harmonic bath use " + WRITE(*,*) "Available bath_type are: " + WRITE(*,*) "1 = Ohmic " + STOP "ENDED" + ENDIF + IF (vpars(1) /= 1) THEN + WRITE(*,*) "Only Ohmic bath implemented" + STOP "ENDED" + END IF + vpars(3) = vpars(3) * 4.5563353e-06 !Change omega_c from invcm to a.u. + isinit = .true. ELSEIF (22 == vstyle) THEN !ljpolymer IF (4/= par_count) THEN WRITE(*,*) "Error: parameters not initialized correctly." @@ -576,7 +592,8 @@ PROGRAM DRIVER ELSEIF (vstyle == 20) THEN ! eckart potential. CALL geteckart(nat,vpars(1), vpars(2), vpars(3),vpars(4), atoms, pot, forces) - + ELSEIF (vstyle == 26) THEN ! harmonic_bath. + CALL get_harmonic_bath(nat,vpars(1),vpars(2),vpars(3),atoms, pot, forces) ELSEIF (vstyle == 23) THEN ! MB. IF (nat/=1) THEN WRITE(*,*) "Expecting 1 atom for MB" @@ -672,7 +689,7 @@ PROGRAM DRIVER CONTAINS SUBROUTINE helpmessage ! Help banner - WRITE(*,*) " SYNTAX: driver.x [-u] -h hostname -p port -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4p-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D] " + WRITE(*,*) " SYNTAX: driver.x [-u] -h hostname -p port -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4p-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D|harmonic_bath" WRITE(*,*) " -o 'comma_separated_parameters' [-v] " WRITE(*,*) "" WRITE(*,*) " For LJ potential use -o sigma,epsilon,cutoff " diff --git a/drivers/pes/harmonic_bath.f90 b/drivers/pes/harmonic_bath.f90 new file mode 100644 index 000000000..388163a24 --- /dev/null +++ b/drivers/pes/harmonic_bath.f90 @@ -0,0 +1,52 @@ +!Harmonic bath +!JCP 122, 084106(2005) + +! V(q,x1,..,xn) = sum_1^(nat-1) [ 0.5 m omega_i^2(q - (c_i q)/m omega_i)^2 ] + + SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,q,pot,force) + IMPLICIT NONE + integer :: nat, i + real(kind=8),PARAMETER :: pi= 3.141592653589793D0 + real(kind=8) :: bath_type,friction,omega_c,mass + real(kind=8) :: A,B + real(kind=8) :: q(nat*3),pot,force(nat*3),x(nat*3-1) + real(kind=8) :: c(nat*3-1),omega(nat*3-1), omega2(nat*3-1),aux + mass = 1837 + A = -0.00476705894242374 + B = 0.0005980249683218661 + + DO i = 1, 3*nat -1 + x(i) = q(i+1) + ENDDO + IF (IDINT(bath_type) .EQ. 1 ) THEN !Ohmic + DO i = 1, 3*nat -1 + omega(i) = - omega_c * LOG( (i - 0.5 ) / (3*nat-1) ) + omega2(i) = omega(i)**2 + c(i) = omega(i) * ( ( 2 * friction * mass *omega_c) / ( (3*nat-1) * pi ) )**0.5 + !write(6,*)'Ohmic',i,omega(i),c(i) + ENDDO + END IF + + !SYSTEM + pot = A * (q(1) ** 2) + B * (q(1) ** 4) + force(1) = - ( 2 * A * (q(1)) + 4 * B * (q(1) ** 3) ) + + !BATH + DO i = 1,3*nat-1 + aux = x(i) - c(i)*q(1) / ( mass*omega2(i) ) + + pot = pot + 0.5 * mass * omega2(i) * aux **2 + + force(1) = force(1) + aux * c(i) + force(i+1) = -mass * omega2(i) * aux + !WRITE(6,*)i,mass,omega2(i),aux + !WRITE(6,*)i ,x(i), c(i),q(1) , mass, omega2(i) + ENDDO + + DO i = 1,3*nat + WRITE(6,*) i, q(i), force(i) + !WRITE(6,*) i, force(i),x(i) - (c(i)*q(1)) / ( mass*omega2(i) ),x(i+1) - (c(i+1)*q(1)) / ( mass*omega2(i+1) ) + ENDDO + return + end + From 845dd1c57322c813e9c141c58d21e1b29b77cead Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 28 Dec 2020 15:17:05 +0100 Subject: [PATCH 010/120] Add reference results to INSTANTON-200K-070D --- ipi/engine/motion/instanton.py | 1 - .../tests/INSTANTON/070K_D/ref_simulation.out | 18 ++++++++++++++++++ 2 files changed, 18 insertions(+), 1 deletion(-) create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.out diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 5ed4f096f..72f165023 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -35,7 +35,6 @@ # ALBERTO: # - fix LBFGS example -# - Add bath-driver to this branch # - finish equations (search CONTINUE HERE) # - code spline and integration to obtain g # - resolve hessian problem, implement sparse and dense spring hessian diff --git a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.out b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.out new file mode 100644 index 000000000..16c444214 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.out @@ -0,0 +1,18 @@ +# column 1 --> step : The current simulation time step. +# column 2 --> potential{electronvolt} : The physical system potential energy. + 0.00000000e+00 -3.02631856e-02 + 1.00000000e+00 -3.26726054e-02 + 2.00000000e+00 -3.53615880e-02 + 3.00000000e+00 -3.83162245e-02 + 4.00000000e+00 -4.15223147e-02 + 5.00000000e+00 -4.49653444e-02 + 6.00000000e+00 -4.86304516e-02 + 7.00000000e+00 -5.25023800e-02 + 8.00000000e+00 -5.65654159e-02 + 9.00000000e+00 -6.08032975e-02 + 1.00000000e+01 -6.51990610e-02 + 1.10000000e+01 -6.97347243e-02 + 1.20000000e+01 -7.43903939e-02 + 1.30000000e+01 -7.90101239e-02 + 1.40000000e+01 -7.89643349e-02 + 1.50000000e+01 -7.89641435e-02 From 47b3f747d63ec09556cc91ba24c8289e6fea9c62 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 12 Jan 2021 15:07:04 +0100 Subject: [PATCH 011/120] black 20.8b --- ipi/engine/barostats.py | 124 +++++++-------- ipi/engine/ensembles.py | 4 +- ipi/engine/forcefields.py | 28 ++-- ipi/engine/forces.py | 12 +- ipi/engine/motion/alchemy.py | 3 +- ipi/engine/motion/atomswap.py | 3 +- ipi/engine/motion/constrained_dynamics.py | 18 +-- ipi/engine/motion/dynamics.py | 2 +- ipi/engine/motion/geop.py | 54 +++---- ipi/engine/motion/instanton.py | 177 ++++++++++++---------- ipi/engine/motion/multi.py | 3 +- ipi/engine/motion/phonons.py | 18 +-- ipi/engine/motion/planetary.py | 4 +- ipi/engine/motion/scphonons.py | 3 +- ipi/engine/normalmodes.py | 8 +- ipi/engine/outputs.py | 6 +- ipi/engine/properties.py | 5 +- ipi/engine/smotion/multi.py | 3 +- ipi/inputs/motion/constrained_dynamics.py | 8 +- ipi/inputs/motion/phonons.py | 2 +- ipi/inputs/motion/scphonons.py | 2 +- ipi/inputs/motion/vscf.py | 2 +- ipi/inputs/normalmodes.py | 4 +- ipi/inputs/outputs.py | 4 +- ipi/inputs/simulation.py | 5 +- ipi/inputs/smotion/metad.py | 2 +- ipi/interfaces/sockets.py | 16 +- ipi/utils/constrtools.py | 56 +++---- ipi/utils/depend.py | 10 +- ipi/utils/hesstools.py | 42 ++--- ipi/utils/inputvalue.py | 15 +- ipi/utils/instools.py | 18 +-- ipi/utils/io/__init__.py | 4 +- ipi/utils/io/inputs/io_xml.py | 36 ++--- ipi/utils/mathtools.py | 4 +- ipi/utils/mintools.py | 80 +++++----- tools/py/Instanton_postproc.py | 6 +- tools/py/regtest-parallel.py | 43 +++--- 38 files changed, 418 insertions(+), 416 deletions(-) diff --git a/ipi/engine/barostats.py b/ipi/engine/barostats.py index 09a2bd8eb..7f0122d89 100644 --- a/ipi/engine/barostats.py +++ b/ipi/engine/barostats.py @@ -757,13 +757,13 @@ def qcstep(self): class BaroRGB(Barostat): """Raiteri-Gale-Bussi constant stress barostat class (JPCM 23, 334213, 2011). - Just extends the standard class adding finite-dt propagators for the barostat - velocities, positions, piston. + Just extends the standard class adding finite-dt propagators for the barostat + velocities, positions, piston. - Depend objects: - p: The momentum matrix associated with the cell degrees of freedom. - m: The mass associated with the cell degree of freedom. - """ + Depend objects: + p: The momentum matrix associated with the cell degrees of freedom. + m: The mass associated with the cell degree of freedom. + """ def __init__( self, @@ -778,18 +778,18 @@ def __init__( ): """Initializes RGB barostat. - Args: - dt: Optional float giving the time step for the algorithms. Defaults - to the simulation dt. - temp: Optional float giving the temperature for the thermostat. - Defaults to the simulation temp. - stressext: Optional float giving the external pressure. - tau: Optional float giving the time scale associated with the barostat. - ebaro: Optional float giving the conserved quantity already stored - in the barostat initially. Used on restart. - thermostat: The thermostat connected to the barostat degree of freedom. - p: Optional initial volume conjugate momentum. Defaults to 0. - """ + Args: + dt: Optional float giving the time step for the algorithms. Defaults + to the simulation dt. + temp: Optional float giving the temperature for the thermostat. + Defaults to the simulation temp. + stressext: Optional float giving the external pressure. + tau: Optional float giving the time scale associated with the barostat. + ebaro: Optional float giving the conserved quantity already stored + in the barostat initially. Used on restart. + thermostat: The thermostat connected to the barostat degree of freedom. + p: Optional initial volume conjugate momentum. Defaults to 0. + """ super(BaroRGB, self).__init__(dt, temp, tau, ebaro, thermostat) @@ -832,20 +832,20 @@ def __init__( def bind(self, beads, nm, cell, forces, bias=None, prng=None, fixdof=None, nmts=1): """Binds beads, cell and forces to the barostat. - This takes a beads object, a cell object and a forcefield object and - makes them members of the barostat. It also then creates the objects that - will hold the data needed in the barostat algorithms and the dependency - network. + This takes a beads object, a cell object and a forcefield object and + makes them members of the barostat. It also then creates the objects that + will hold the data needed in the barostat algorithms and the dependency + network. - Args: - beads: The beads object from which the bead positions are taken. - nm: The normal modes propagator object - cell: The cell object from which the system box is taken. - forces: The forcefield object from which the force and virial are - taken. - prng: The parent PRNG to bind the thermostat to - fixdof: The number of blocked degrees of freedom. - """ + Args: + beads: The beads object from which the bead positions are taken. + nm: The normal modes propagator object + cell: The cell object from which the system box is taken. + forces: The forcefield object from which the force and virial are + taken. + prng: The parent PRNG to bind the thermostat to + fixdof: The number of blocked degrees of freedom. + """ super(BaroRGB, self).bind(beads, nm, cell, forces, bias, prng, fixdof, nmts) @@ -1017,13 +1017,13 @@ def qcstep(self): class BaroMTK(Barostat): """Martyna-Tobias-Klein flexible cell, constant pressure barostat class (JCP 101, 1994). - Just extends the standard class adding finite-dt propagators for the barostat - velocities, positions, piston. + Just extends the standard class adding finite-dt propagators for the barostat + velocities, positions, piston. - Depend objects: - p: The momentum matrix associated with the cell degrees of freedom. - m: The mass associated with the cell degree of freedom. - """ + Depend objects: + p: The momentum matrix associated with the cell degrees of freedom. + m: The mass associated with the cell degree of freedom. + """ def __init__( self, @@ -1037,18 +1037,18 @@ def __init__( ): """Initializes RGB barostat. - Args: - dt: Optional float giving the time step for the algorithms. Defaults - to the simulation dt. - temp: Optional float giving the temperature for the thermostat. - Defaults to the simulation temp. - stressext: Optional float giving the external pressure. - tau: Optional float giving the time scale associated with the barostat. - ebaro: Optional float giving the conserved quantity already stored - in the barostat initially. Used on restart. - thermostat: The thermostat connected to the barostat degree of freedom. - p: Optional initial volume conjugate momentum. Defaults to 0. - """ + Args: + dt: Optional float giving the time step for the algorithms. Defaults + to the simulation dt. + temp: Optional float giving the temperature for the thermostat. + Defaults to the simulation temp. + stressext: Optional float giving the external pressure. + tau: Optional float giving the time scale associated with the barostat. + ebaro: Optional float giving the conserved quantity already stored + in the barostat initially. Used on restart. + thermostat: The thermostat connected to the barostat degree of freedom. + p: Optional initial volume conjugate momentum. Defaults to 0. + """ super(BaroMTK, self).__init__(dt, temp, tau, ebaro, thermostat) @@ -1086,20 +1086,20 @@ def __init__( def bind(self, beads, nm, cell, forces, bias=None, prng=None, fixdof=None, nmts=1): """Binds beads, cell and forces to the barostat. - This takes a beads object, a cell object and a forcefield object and - makes them members of the barostat. It also then creates the objects that - will hold the data needed in the barostat algorithms and the dependency - network. + This takes a beads object, a cell object and a forcefield object and + makes them members of the barostat. It also then creates the objects that + will hold the data needed in the barostat algorithms and the dependency + network. - Args: - beads: The beads object from which the bead positions are taken. - nm: The normal modes propagator object - cell: The cell object from which the system box is taken. - forces: The forcefield object from which the force and virial are - taken. - prng: The parent PRNG to bind the thermostat to - fixdof: The number of blocked degrees of freedom. - """ + Args: + beads: The beads object from which the bead positions are taken. + nm: The normal modes propagator object + cell: The cell object from which the system box is taken. + forces: The forcefield object from which the force and virial are + taken. + prng: The parent PRNG to bind the thermostat to + fixdof: The number of blocked degrees of freedom. + """ super(BaroMTK, self).bind(beads, nm, cell, forces, bias, prng, fixdof, nmts) diff --git a/ipi/engine/ensembles.py b/ipi/engine/ensembles.py index 1f3c161f7..a557151dd 100755 --- a/ipi/engine/ensembles.py +++ b/ipi/engine/ensembles.py @@ -28,8 +28,8 @@ def ensemble_swap(ens1, ens2): - """ Swaps the definitions of the two ensembles, by - exchanging all of the inner properties. """ + """Swaps the definitions of the two ensembles, by + exchanging all of the inner properties.""" if ens1.temp != ens2.temp: ens1.temp, ens2.temp = ens2.temp, ens1.temp diff --git a/ipi/engine/forcefields.py b/ipi/engine/forcefields.py index 601ebae58..e1bc8e12e 100644 --- a/ipi/engine/forcefields.py +++ b/ipi/engine/forcefields.py @@ -270,8 +270,8 @@ def softexit(self): self.stop() def update(self): - """ Makes updates to the potential that only need to be triggered - upon completion of a time step. """ + """Makes updates to the potential that only need to be triggered + upon completion of a time step.""" pass @@ -475,8 +475,8 @@ def __init__( ) def poll(self): - """ Polls the forcefield checking if there are requests that should - be answered, and if necessary evaluates the associated forces and energy. """ + """Polls the forcefield checking if there are requests that should + be answered, and if necessary evaluates the associated forces and energy.""" # we have to be thread-safe, as in multi-system mode this might get called by many threads at once with self._threadlock: @@ -635,8 +635,8 @@ def evaluate(self, r): r["status"] = "Done" def mtd_update(self, pos, cell): - """ Makes updates to the potential that only need to be triggered - upon completion of a time step. """ + """Makes updates to the potential that only need to be triggered + upon completion of a time step.""" self.plumedstep += 1 f = np.zeros(3 * self.natoms) @@ -743,8 +743,8 @@ def __init__( log._active = False def poll(self): - """ Polls the forcefield checking if there are requests that should - be answered, and if necessary evaluates the associated forces and energy. """ + """Polls the forcefield checking if there are requests that should + be answered, and if necessary evaluates the associated forces and energy.""" # we have to be thread-safe, as in multi-system mode this might get called by many threads at once with self._threadlock: @@ -773,10 +773,10 @@ def evaluate(self, r): class FFsGDML(ForceField): - """ A symmetric Gradient Domain Machine Learning (sGDML) force field. - Chmiela et al. Sci. Adv., 3(5), e1603015, 2017; Nat. Commun., 9(1), 3887, 2018. - http://sgdml.org/doc/ - https://github.com/stefanch/sGDML + """A symmetric Gradient Domain Machine Learning (sGDML) force field. + Chmiela et al. Sci. Adv., 3(5), e1603015, 2017; Nat. Commun., 9(1), 3887, 2018. + http://sgdml.org/doc/ + https://github.com/stefanch/sGDML """ def __init__( @@ -862,8 +862,8 @@ def __init__( self.predictor.prepare_parallel(n_bulk=1) def poll(self): - """ Polls the forcefield checking if there are requests that should - be answered, and if necessary evaluates the associated forces and energy. """ + """Polls the forcefield checking if there are requests that should + be answered, and if necessary evaluates the associated forces and energy.""" # we have to be thread-safe, as in multi-system mode this might get called by many threads at once with self._threadlock: diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index c93e19aa8..ff1b5c9a0 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -827,7 +827,7 @@ def make_rpc(rpc, beads): dself.virs.add_dependency(dd(fc).weight) def copy(self, beads=None, cell=None): - """ Returns a copy of this force object that can be used to compute forces, + """Returns a copy of this force object that can be used to compute forces, e.g. for use in internal loops of geometry optimizers, or for property calculation. @@ -897,11 +897,11 @@ def transfer_forces_manual( self, new_q, new_v, new_forces, vir=np.zeros((3, 3)), extra="" ): """Manual (and flexible) version of the transfer forces function. - Instead of passing a force object, list with vectors are passed - Expected shape and sizes: - - new_q list of length equal to number of force type, containing the beads positions - - new_v list of length equal to number of force type, containing the beads potential energy - - new_f list of length equal to number of force type, containing the beads forces + Instead of passing a force object, list with vectors are passed + Expected shape and sizes: + - new_q list of length equal to number of force type, containing the beads positions + - new_v list of length equal to number of force type, containing the beads potential energy + - new_f list of length equal to number of force type, containing the beads forces """ msg = "Unconsistent dimensions inside transfer_forces_manual" assert len(self.mforces) == len(new_q), msg diff --git a/ipi/engine/motion/alchemy.py b/ipi/engine/motion/alchemy.py index c9d259762..28c9e29b1 100644 --- a/ipi/engine/motion/alchemy.py +++ b/ipi/engine/motion/alchemy.py @@ -73,8 +73,7 @@ def bind(self, ens, beads, cell, bforce, nm, prng, omaker): self.ensemble.add_econs(dd(self).ealc) def AXlist(self, atomtype): - """This compile a list of atoms ready for exchanges. - """ + """This compile a list of atoms ready for exchanges.""" # selects the types of atoms for exchange atomexchangelist = [] diff --git a/ipi/engine/motion/atomswap.py b/ipi/engine/motion/atomswap.py index 7933896e4..fcd5c62fd 100644 --- a/ipi/engine/motion/atomswap.py +++ b/ipi/engine/motion/atomswap.py @@ -71,8 +71,7 @@ def bind(self, ens, beads, cell, bforce, nm, prng, omaker): self.dforces = self.forces.copy(self.dbeads, self.dcell) def AXlist(self, atomtype): - """This compile a list of atoms ready for exchanges. - """ + """This compile a list of atoms ready for exchanges.""" # selects the types of atoms for exchange atomexchangelist = [] diff --git a/ipi/engine/motion/constrained_dynamics.py b/ipi/engine/motion/constrained_dynamics.py index 34ec3f8c3..9f8fb7f0b 100644 --- a/ipi/engine/motion/constrained_dynamics.py +++ b/ipi/engine/motion/constrained_dynamics.py @@ -191,7 +191,7 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): class ConstraintSolverBase(dobject): - """ Empty base class for the constraint solver. Provides the interface + """Empty base class for the constraint solver. Provides the interface that must be used to offer constraint functionalities to an integrator. """ @@ -226,7 +226,7 @@ def proj_manifold(self, beads, stepsize=None, proj_p=True): class ConstraintSolver(ConstraintSolverBase): - """ An implementation of a constraint solver that uses M-RATTLE to + """An implementation of a constraint solver that uses M-RATTLE to impose constraints onto the momenta and a quasi-Newton method to impose constraints onto the positions. The constraint is applied sparsely, i.e. on each block of constraints separately. @@ -243,9 +243,9 @@ class ConstraintSolver(ConstraintSolverBase): def __init__( self, constraint_list, dt=1.0, tolerance=0.001, maxit=1000, norm_order=2 ): - """ Solver options include a tolerance for the projection on the + """Solver options include a tolerance for the projection on the manifold, maximum number of iterations for the projection, and - the order of the norm to estimate the convergence """ + the order of the norm to estimate the convergence""" super(ConstraintSolver, self).__init__(constraint_list, dt) self.tolerance = tolerance @@ -331,7 +331,7 @@ def proj_manifold(self): class ConstrainedIntegrator(DummyIntegrator): - """ No-op integrator for classical constrained propagation. + """No-op integrator for classical constrained propagation. It also incorporates a constraint solver, so as to make the integration modular in case one wanted to implement multiple solvers. @@ -419,7 +419,7 @@ def step_Ag(self): self.proj_cotangent() def mtsprop_ba(self, index): - """ Recursive MTS step -- this is adapted directly from the + """Recursive MTS step -- this is adapted directly from the NVEIntegrator class""" mk = int(self.nmts[index] / 2) @@ -448,7 +448,7 @@ def mtsprop_ba(self, index): self.mtsprop_ba(index + 1) def mtsprop_ab(self, index): - """ Recursive MTS step -- this is adapted directly from the + """Recursive MTS step -- this is adapted directly from the NVEIntegrator class""" if self.nmts[index] % 2 == 1: @@ -503,9 +503,9 @@ class NVTConstrainedIntegrator(NVEConstrainedIntegrator): """ def step_Oc(self): - """ Constrained stochastic propagation. We solve the problem that + """Constrained stochastic propagation. We solve the problem that the thermostat and the projective step do not necessarily commute - (e.g. in GLE) by doing a MTS splitting scheme """ + (e.g. in GLE) by doing a MTS splitting scheme""" m3 = dstrip(self.beads.m3) for i in range(self.nsteps_o): diff --git a/ipi/engine/motion/dynamics.py b/ipi/engine/motion/dynamics.py index 5eb7c9967..707637899 100644 --- a/ipi/engine/motion/dynamics.py +++ b/ipi/engine/motion/dynamics.py @@ -393,7 +393,7 @@ def pconstraints(self): class NVEIntegrator(DummyIntegrator): - """ Integrator object for constant energy simulations. + """Integrator object for constant energy simulations. Has the relevant conserved quantity and normal mode propagator for the constant energy ensemble. Note that a temperature of some kind must be diff --git a/ipi/engine/motion/geop.py b/ipi/engine/motion/geop.py index 3de7dbe97..c34ba46f4 100755 --- a/ipi/engine/motion/geop.py +++ b/ipi/engine/motion/geop.py @@ -143,12 +143,12 @@ def reset(self): # necessary for Al6xxx-kmc def bind(self, ens, beads, nm, cell, bforce, prng, omaker): """Binds beads, cell, bforce and prng to GeopMotion - Args: - beads: The beads object from which the bead positions are taken. - nm: A normal modes object used to do the normal modes transformation. - cell: The cell object from which the system box is taken. - bforce: The forcefield object from which the force and virial are taken. - prng: The random number generator object which controls random number generation. + Args: + beads: The beads object from which the bead positions are taken. + nm: A normal modes object used to do the normal modes transformation. + cell: The cell object from which the system box is taken. + bforce: The forcefield object from which the force and virial are taken. + prng: The random number generator object which controls random number generation. """ super(GeopMotion, self).bind(ens, beads, nm, cell, bforce, prng, omaker) @@ -214,8 +214,8 @@ def set_dir(self, x0, mdir): ) def __call__(self, x): - """ computes energy and gradient for optimization step - determines new position (x0+d*x)""" + """computes energy and gradient for optimization step + determines new position (x0+d*x)""" self.fcount += 1 self.dbeads.q[:, self.fixatoms_mask] = ( @@ -419,9 +419,9 @@ def bind(self, geop): self.ls_options = geop.ls_options def step(self, step=None): - """ Does one simulation time step. - Attributes: - qtime: The time taken in updating the positions. + """Does one simulation time step. + Attributes: + qtime: The time taken in updating the positions. """ self.qtime = -time.time() @@ -528,11 +528,11 @@ def bind(self, geop): self.big_step = geop.big_step def step(self, step=None): - """ Does one simulation time step. + """Does one simulation time step. - Attributes: - qtime : The time taken in updating the real positions. - tr : current trust radius + Attributes: + qtime : The time taken in updating the real positions. + tr : current trust radius """ self.qtime = -time.time() @@ -601,8 +601,8 @@ def step(self, step=None): class LBFGSOptimizer(DummyOptimizer): - """ L-BFGS Minimization: Note that the accuracy you can achieve with this method depends - on how many ''corrections'' you store (default is 5). """ + """L-BFGS Minimization: Note that the accuracy you can achieve with this method depends + on how many ''corrections'' you store (default is 5).""" def bind(self, geop): # call bind function from DummyOptimizer @@ -637,9 +637,9 @@ def bind(self, geop): self.scale = geop.scale def step(self, step=None): - """ Does one simulation time step - Attributes: - ttime: The time taken in applying the thermostat steps. + """Does one simulation time step + Attributes: + ttime: The time taken in applying the thermostat steps. """ self.qtime = -time.time() @@ -738,9 +738,9 @@ def bind(self, geop): self.ls_options = geop.ls_options def step(self, step=None): - """ Does one simulation time step - Attributes: - ttime: The time taken in applying the thermostat steps. + """Does one simulation time step + Attributes: + ttime: The time taken in applying the thermostat steps. """ self.qtime = -time.time() @@ -823,10 +823,10 @@ def bind(self, geop): def step(self, step=None): """Does one simulation time step - Attributes: - ptime: The time taken in updating the velocities. - qtime: The time taken in updating the positions. - ttime: The time taken in applying the thermostat steps. + Attributes: + ptime: The time taken in updating the velocities. + qtime: The time taken in updating the positions. + ttime: The time taken in applying the thermostat steps. """ self.ptime = 0.0 diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 72f165023..8af65d22a 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -13,6 +13,8 @@ import time import sys +from ipi.engine.beads import Beads +from ipi.engine.normalmodes import NormalModes from ipi.engine.motion import Motion from ipi.utils.depend import dstrip, dobject from ipi.utils.softexit import softexit @@ -34,11 +36,19 @@ # ALBERTO: -# - fix LBFGS example -# - finish equations (search CONTINUE HERE) -# - code spline and integration to obtain g # - resolve hessian problem, implement sparse and dense spring hessian -# - fix omegak and normal mode transformation (the fact that we are using half RP) +# add boolean option hessian mode: +# add boolean option sparse in: +# get_hessian +# update_hessian +# print_hessian +# red2comp +# test ch4hcbe with dense hessian +# test 1D double well with Ohmic +# test 1D double well with Ohmic +SD + +# - code spline and integration to obtain g +# test 2x*1D double well with Ohmic +SD class InstantonMotion(Motion): @@ -112,8 +122,7 @@ def __init__( friction=False, z_friction=np.zeros(0, float), ): - """Initialises InstantonMotion. - """ + """Initialises InstantonMotion.""" super(InstantonMotion, self).__init__(fixcom=fixcom, fixatoms=fixatoms) @@ -196,17 +205,28 @@ def __init__( def bind(self, ens, beads, nm, cell, bforce, prng, omaker): """Binds beads, cell, bforce and prng to InstantonMotion - Args: - beads: The beads object from whcih the bead positions are taken. - nm: A normal modes object used to do the normal modes transformation. - cell: The cell object from which the system box is taken. - bforce: The forcefield object from which the force and virial are taken. - prng: The random number generator object which controls random number generation. + Args: + beads: The beads object from whcih the bead positions are taken. + nm: A normal modes object used to do the normal modes transformation. + cell: The cell object from which the system box is taken. + bforce: The forcefield object from which the force and virial are taken. + prng: The random number generator object which controls random number generation. """ super(InstantonMotion, self).bind(ens, beads, nm, cell, bforce, prng, omaker) - # Binds optimizer + # Redefine normal modes + self.nm = NormalModes() + if self.options["mode"] == "rate": + self.nm.bind( + self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads * 2) + ) + elif self.options["mode"] == "splitting": + self.nm.bind( + self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads) + ) + + # Binds optimizer self.optimizer.bind(self) def step(self, step=None): @@ -253,8 +273,8 @@ def get_mask(self, m): raise ValueError("Mask number not valid") def get_active_array(self, arrays): - """ Functions that gets the subarray corresponding to the active degrees-of-freedom of the - full dimensional array """ + """Functions that gets the subarray corresponding to the active degrees-of-freedom of the + full dimensional array""" activearrays = {} for key in arrays: @@ -284,18 +304,18 @@ def get_active_array(self, arrays): def get_full_vector(self, vector, t): """Set 0 the degrees of freedom (dof) corresponding to the fix atoms - IN: - fixatoms indexes of the fixed atoms - vector vector to be reduced - t type of array: - type=-1 : do nothing - type=0 : names (natoms ) - type=1 : pos , force or m3 (nbeads,dof) - type=2 : hessian (dof, nbeads*dof) - type=3 : qlist or glist (corrections, nbeads*dof) - OUT: - clean_vector reduced vector - """ + IN: + fixatoms indexes of the fixed atoms + vector vector to be reduced + t type of array: + type=-1 : do nothing + type=0 : names (natoms ) + type=1 : pos , force or m3 (nbeads,dof) + type=2 : hessian (dof, nbeads*dof) + type=3 : qlist or glist (corrections, nbeads*dof) + OUT: + clean_vector reduced vector + """ if len(self.fixatoms) == 0 or t == -1: return vector @@ -330,17 +350,17 @@ def get_full_vector(self, vector, t): def get_active_vector(self, vector, t): """Delete the degrees of freedom (dof) corresponding to the fix atoms - IN: - fixatoms indexes of the fixed atoms - vector vector to be reduced - t type of array: - type=-1 : do nothing - type=0 : names (natoms ) - type=1 : pos , force or m3 (nbeads,dof) - type=2 : hessian (dof, nbeads*dof) - type=3 : qlist or glist (corrections, nbeads*dof) - OUT: - clean_vector reduced vector + IN: + fixatoms indexes of the fixed atoms + vector vector to be reduced + t type of array: + type=-1 : do nothing + type=0 : names (natoms ) + type=1 : pos , force or m3 (nbeads,dof) + type=2 : hessian (dof, nbeads*dof) + type=3 : qlist or glist (corrections, nbeads*dof) + OUT: + clean_vector reduced vector """ if len(self.fixatoms) == 0 or t == -1: return vector @@ -377,7 +397,6 @@ def bind(self, mapper): self.dcell = mapper.cell.copy() self.dforces = mapper.forces.copy(self.dbeads, self.dcell) self.nm = mapper.nm - self.nm_trans = nmtransform.nm_trans(self.dbeads.nbeads) self.fix = mapper.fix self.coef = mapper.coef self.friction = mapper.friction @@ -416,23 +435,24 @@ def compute_friction_terms(self): z = self.z_friction / self.z_friction[1] s = self.eta - zk = np.multiply(2 * self.nm.get_omegak(), self.z_friction) - # g = obtain_g(self.dbeads, self.eta) - # s = obtain_s(self.dbeads, self.eta) + # g = obtain_g(self.dbeads, self.eta) #Implement This + # s = obtain_s(self.dbeads, self.eta) #Implement THIS + gq = self.dbeads.q # For now + gq = np.concatenate((gq, np.flipud(gq)), axis=0) + gq_k = self.nm.transform.b2nm(gq) - gq = self.dbeads.q - e = 0.5 * np.dot(zk, self.nm_trans.b2nm(gq) ** 2) + z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) - print("CONTINUE HERE") - print(zk.shape, self.nm_trans.b2nm(gq).shape) - aux = np.multiply(zk, self.nm_trans.b2nm(gq)) - print(aux.shape) - g = self.nm_trans.nm2b(aux.reshape(1, -1)) - print(g.shape, s.shape) + e_f = (0.5 * z_k * gq_k ** 2).sum() + e = np.zeros(self.dbeads.nbeads) + e[0] = e_f # We can't do a meaningfull bead assigment - e = 0 - g = 0 + f = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] + + g = np.zeros(f.shape) + for i in range(self.dbeads.nbeads): + g[i, :] = np.dot(s[i], f[i]) return e, g def __call__(self, x, new_disc=True): @@ -499,7 +519,7 @@ def __call__(self, x, new_disc=True): # ALBERTO: The following has to be joined to the json implementation for the # communication of the extras strings print("\n ALBERTO2 get friction from forces object\n") - print("\n pick only the tensor corresponding to the first RP frequency") + # print("\n pick only the tensor corresponding to the RP frequencies") red_eta = np.zeros( (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) ) @@ -519,24 +539,28 @@ def __call__(self, x, new_disc=True): return self.evaluate() def evaluate(self): - """ Evaluate the energy and forces including: - - non uniform discretization - - friction term (if required) - """ - e = self.pot * (self.coef[1:] + self.coef[:-1]) / 2 - g = -self.f * (self.coef[1:] + self.coef[:-1]) / 2 + """Evaluate the energy and forces including: + - non uniform discretization + - friction term (if required) + """ + + e = self.pot.copy() + g = -self.f.copy() if self.friction: e_friction, g_friction = self.compute_friction_terms() e += e_friction g += g_friction + e = e * (self.coef[1:] + self.coef[:-1]) / 2 + g = g * (self.coef[1:] + self.coef[:-1]) / 2 + return e, g class SpringMapper(object): """Creation of the multi-dimensional function to compute full or half ring polymer potential - and forces. + and forces. """ def __init__(self): @@ -550,22 +574,9 @@ def bind(self, mapper): self.fix = mapper.fix self.coef = mapper.coef self.dbeads = mapper.beads.copy() + self.nm = mapper.nm - # Set omega2 depending of the case - if mapper.options["mode"] == "rate": - self.omega2 = ( - self.temp - * (2 * self.dbeads.nbeads) - * units.Constants.kb - / units.Constants.hbar - ) ** 2 - elif mapper.options["mode"] == "splitting": - self.omega2 = ( - self.temp - * self.dbeads.nbeads - * units.Constants.kb - / units.Constants.hbar - ) ** 2 + self.omega2 = self.nm.omegan2 # Computes the spring hessian if the optimization modes requires it if ( @@ -650,8 +661,8 @@ def __call__(self, x, ret=True, new_disc=True): def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): """Compute the 'spring hessian' - OUT h = hessian with only the spring terms ('spring hessian') - """ + OUT h = hessian with only the spring terms ('spring hessian') + """ if coef is None: coef = np.ones(nbeads + 1).reshape(-1, 1) @@ -710,7 +721,7 @@ def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): class Mapper(object): """Creation of the multi-dimensional function that is the proxy between all the energy and force components and the optimization algorithm. - It also handles fixatoms """ + It also handles fixatoms""" def __init__(self, esum=False): @@ -721,7 +732,7 @@ def __init__(self, esum=False): def initialize(self, q, forces): print("\nALBERTO1 get friction from forces object\n") - eta = np.zeros((q.shape[0], q.shape[1] ** 2)) + eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) self.gm.save(forces.pots, -forces.f, eta) e1, g1 = self.gm.evaluate() @@ -749,6 +760,7 @@ def bind(self, dumop): self.fixbeads = self.fix.fixbeads self.options = dumop.options + self.coef = np.ones(self.beads.nbeads + 1).reshape(-1, 1) self.set_coef(self.options["discretization"]) @@ -777,7 +789,6 @@ def set_z_friction(self, z_friction): freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False ) self.z_friction = spline(2 * self.nm.get_omegak()) - print(self.z_friction) def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -812,7 +823,7 @@ class DummyOptimizer(dobject): def __init__(self): """Initializes object for PesMapper (physical potential, forces and hessian) - and SpringMapper ( spring potential,forces and hessian) """ + and SpringMapper ( spring potential,forces and hessian)""" self.options = {} # Optimization options self.optarrays = {} # Optimization arrays @@ -1390,8 +1401,8 @@ def step(self, step=None): class LanczosOptimizer(HessianOptimizer): - """ Class that implements a modified Nichols algorithm based on Lanczos diagonalization to avoid constructing and diagonalizing - the full (3*natoms*nbeads)^2 matrix """ + """Class that implements a modified Nichols algorithm based on Lanczos diagonalization to avoid constructing and diagonalizing + the full (3*natoms*nbeads)^2 matrix""" def step(self, step=None): """ Does one simulation step.""" diff --git a/ipi/engine/motion/multi.py b/ipi/engine/motion/multi.py index d2afc8998..0d13217b5 100644 --- a/ipi/engine/motion/multi.py +++ b/ipi/engine/motion/multi.py @@ -11,8 +11,7 @@ class MultiMotion(Motion): - """A class to hold multiple motion objects to be executed serially. - """ + """A class to hold multiple motion objects to be executed serially.""" def __init__(self, motionlist=None): """Initialises MultiMotion. diff --git a/ipi/engine/motion/phonons.py b/ipi/engine/motion/phonons.py index 7bb37deee..6f4dd1c28 100644 --- a/ipi/engine/motion/phonons.py +++ b/ipi/engine/motion/phonons.py @@ -30,8 +30,7 @@ class DynMatrixMover(Motion): - """Dynamic matrix calculation routine by finite difference. - """ + """Dynamic matrix calculation routine by finite difference.""" def __init__( self, @@ -126,7 +125,11 @@ def printall(self, prefix, dmatx, deltaw=0.0, fixdof=np.array([])): # get active arrays: activedof = 3 * self.beads.natoms - fixdof.size - mask = np.delete(np.arange(3 * self.beads.natoms), fixdof) + if fixdof.size > 0: + mask = np.delete(np.arange(3 * self.beads.natoms), fixdof) + else: + mask = np.arange(3 * self.beads.natoms) + dmatx_full = dmatx.copy() ism_full = self.ism.copy() dmatx = dmatx[mask][:, mask] @@ -301,8 +304,7 @@ def transform(self): class FDPhononCalculator(DummyPhononCalculator): - """ Finite dinnerence phonon evaluator. - """ + """Finite dinnerence phonon evaluator.""" def bind(self, dm): """ Reference all the variables for simpler access.""" @@ -369,8 +371,7 @@ def transform(self): class NMFDPhononCalculator(FDPhononCalculator): - """ Normal mode finite difference phonon evaluator. - """ + """Normal mode finite difference phonon evaluator.""" def bind(self, dm): """ Reference all the variables for simpler access.""" @@ -423,8 +424,7 @@ def transform(self): class ENMFDPhononCalculator(NMFDPhononCalculator): - """ Energy scaled normal mode finite difference phonon evaluator. - """ + """Energy scaled normal mode finite difference phonon evaluator.""" def step(self, step=None): """Computes one row of the dynamic matrix.""" diff --git a/ipi/engine/motion/planetary.py b/ipi/engine/motion/planetary.py index 0ec7bdca0..a63624a8e 100644 --- a/ipi/engine/motion/planetary.py +++ b/ipi/engine/motion/planetary.py @@ -180,9 +180,9 @@ def increment(self, dnm): self.omega2 -= qffq def matrix_screen(self): - """ Computes a screening matrix to avoid the impact of + """Computes a screening matrix to avoid the impact of noisy elements of the covariance and frequency matrices for - far-away atoms """ + far-away atoms""" q = np.array(self.dbeads[0].q).reshape(self.natoms, 3) sij = q[:, np.newaxis, :] - q diff --git a/ipi/engine/motion/scphonons.py b/ipi/engine/motion/scphonons.py index 49f3d1f7a..82f4d1a22 100644 --- a/ipi/engine/motion/scphonons.py +++ b/ipi/engine/motion/scphonons.py @@ -228,8 +228,7 @@ def displace(self): class SCPhononator(DummyPhononator): - """ Self consistent phonon evaluator. - """ + """Self consistent phonon evaluator.""" def bind(self, dm): """ diff --git a/ipi/engine/normalmodes.py b/ipi/engine/normalmodes.py index 5dbc10adb..fb5a82504 100644 --- a/ipi/engine/normalmodes.py +++ b/ipi/engine/normalmodes.py @@ -140,7 +140,7 @@ def copy(self, freqs=None): return newnm def bind(self, ensemble, motion, beads=None, forces=None): - """ Initializes the normal modes object and binds to beads and ensemble. + """Initializes the normal modes object and binds to beads and ensemble. Do all the work down here as we need a full-formed necklace and ensemble to know how this should be done. @@ -387,9 +387,9 @@ def get_fspringnm(self): return -self.beads.m3 * self.omegak[:, np.newaxis] ** 2 * self.qnm def get_vspring(self): - """ Returns the spring energy calculated in NM representation for distinguishable particles. - For bosons, get the first element of vspring_and_fspring_B[0] - For a mixture of both, calculate separately and combine. + """Returns the spring energy calculated in NM representation for distinguishable particles. + For bosons, get the first element of vspring_and_fspring_B[0] + For a mixture of both, calculate separately and combine. """ if self.nbeads == 1: diff --git a/ipi/engine/outputs.py b/ipi/engine/outputs.py index d2e9f29ba..b3b62241d 100644 --- a/ipi/engine/outputs.py +++ b/ipi/engine/outputs.py @@ -35,8 +35,8 @@ class OutputList(list): - """ A simple decorated list to save the output prefix and bring it - back to the initialization phase of the simulation """ + """A simple decorated list to save the output prefix and bring it + back to the initialization phase of the simulation""" def __init__(self, prefix, olist): super(OutputList, self).__init__(olist) @@ -273,7 +273,7 @@ def __init__( cell_units="atomic_unit", ibead=-1, ): - """ Initializes a property output stream opening the corresponding + """Initializes a property output stream opening the corresponding file name. Also writes out headers. diff --git a/ipi/engine/properties.py b/ipi/engine/properties.py index a7fb1241f..35acd955d 100644 --- a/ipi/engine/properties.py +++ b/ipi/engine/properties.py @@ -1274,8 +1274,7 @@ def get_kintd(self, atom=""): return atd def get_sckinpr(self): - """Calculates the quantum centroid virial kinetic energy estimator. - """ + """Calculates the quantum centroid virial kinetic energy estimator.""" spring = self.beads.vpath * self.nm.omegan2 / self.beads.nbeads PkT32 = ( @@ -2716,7 +2715,7 @@ def __init__(self): } def bind(self, system): - """ Binds to a system object to fetch atomic and force data. + """Binds to a system object to fetch atomic and force data. Args: system: The system object that will be managed by this Trajectories. diff --git a/ipi/engine/smotion/multi.py b/ipi/engine/smotion/multi.py index 27425a191..5bbb1567c 100644 --- a/ipi/engine/smotion/multi.py +++ b/ipi/engine/smotion/multi.py @@ -13,8 +13,7 @@ class MultiSmotion(Smotion): - """A class to hold multiple Smotion objects to be executed serially. - """ + """A class to hold multiple Smotion objects to be executed serially.""" def __init__(self, smotionlist=None): """Initialises MultiSmotion. diff --git a/ipi/inputs/motion/constrained_dynamics.py b/ipi/inputs/motion/constrained_dynamics.py index c689c50bf..f93ca5c15 100644 --- a/ipi/inputs/motion/constrained_dynamics.py +++ b/ipi/inputs/motion/constrained_dynamics.py @@ -73,10 +73,10 @@ def fetch(self): class InputConstraintBase(Input): """ - An input class to define constraints. ATM built just for bonds, - but general enough to be extended. Also incorporate a "multi" - mode that makes it possible to define a set of constraints that - are coupled and should hence be handled simultaneously. + An input class to define constraints. ATM built just for bonds, + but general enough to be extended. Also incorporate a "multi" + mode that makes it possible to define a set of constraints that + are coupled and should hence be handled simultaneously. """ attribs = { diff --git a/ipi/inputs/motion/phonons.py b/ipi/inputs/motion/phonons.py index 375b1ec69..bbc2c8936 100644 --- a/ipi/inputs/motion/phonons.py +++ b/ipi/inputs/motion/phonons.py @@ -36,7 +36,7 @@ class InputDynMatrix(InputDictionary): """Dynamic matrix calculation options. - Contains options related with finite difference computation of force constats. + Contains options related with finite difference computation of force constats. """ diff --git a/ipi/inputs/motion/scphonons.py b/ipi/inputs/motion/scphonons.py index c8d450c5d..12a6b92a5 100644 --- a/ipi/inputs/motion/scphonons.py +++ b/ipi/inputs/motion/scphonons.py @@ -36,7 +36,7 @@ class InputSCPhonons(InputDictionary): """Calculation options for self-consistent phonons algorithm. - Contains options related to self consistent phonons method. + Contains options related to self consistent phonons method. """ diff --git a/ipi/inputs/motion/vscf.py b/ipi/inputs/motion/vscf.py index 25b2945a2..111ba89e9 100644 --- a/ipi/inputs/motion/vscf.py +++ b/ipi/inputs/motion/vscf.py @@ -36,7 +36,7 @@ class InputNormalMode(InputDictionary): """Vibrational self-consistent phonons calculation options. - Contains options related with finite difference computation of force constats. + Contains options related with finite difference computation of force constats. """ diff --git a/ipi/inputs/normalmodes.py b/ipi/inputs/normalmodes.py index ed8b07d31..e95a8ae9c 100644 --- a/ipi/inputs/normalmodes.py +++ b/ipi/inputs/normalmodes.py @@ -42,7 +42,7 @@ class InputNMFrequencies(InputArray): default_help = "Provides a compact way of specifying the ring polymer frequencies" def __init__(self, help=None, dimension=None, default=None, dtype=None): - """ Initializes InputNormalModes. + """Initializes InputNormalModes. Just calls the parent initialization function with appropriate arguments. """ @@ -75,7 +75,7 @@ def fetch(self): class InputNormalModes(Input): - """ Storage class for NormalModes engine. + """Storage class for NormalModes engine. Describes how normal-modes transformation and integration should be performed. diff --git a/ipi/inputs/outputs.py b/ipi/inputs/outputs.py index 040018cf2..f8a21a0f6 100644 --- a/ipi/inputs/outputs.py +++ b/ipi/inputs/outputs.py @@ -314,7 +314,7 @@ def check(self): class InputOutputs(Input): - """ List of outputs input class. + """List of outputs input class. An example of a dynamic input class: a variable number of tags might be present, corresponding to different output requests. This allows for @@ -418,7 +418,7 @@ def fetch(self): return outlist def store(self, plist): - """ Stores a list of the output objects, creating a sequence of + """Stores a list of the output objects, creating a sequence of dynamic containers. Args: diff --git a/ipi/inputs/simulation.py b/ipi/inputs/simulation.py index bdb6b7d86..9e154c211 100644 --- a/ipi/inputs/simulation.py +++ b/ipi/inputs/simulation.py @@ -196,7 +196,10 @@ def store(self, simul): if len(self.extra) != len(_fflist) + len(simul.syslist): self.extra = [0] * (len(_fflist) + len(simul.syslist)) - for _ii, _obj, in enumerate(_fflist + simul.syslist): + for ( + _ii, + _obj, + ) in enumerate(_fflist + simul.syslist): if self.extra[_ii] == 0: if isinstance(_obj, eforcefields.FFSocket): _iobj = iforcefields.InputFFSocket() diff --git a/ipi/inputs/smotion/metad.py b/ipi/inputs/smotion/metad.py index 95f6fe3b7..8347fbe08 100644 --- a/ipi/inputs/smotion/metad.py +++ b/ipi/inputs/smotion/metad.py @@ -30,7 +30,7 @@ class InputMetaDyn(InputDictionary): - """ Metadynamics Options + """Metadynamics Options Contains options related with MetaDynamics diff --git a/ipi/interfaces/sockets.py b/ipi/interfaces/sockets.py index 1cfa630be..a7ba7e126 100644 --- a/ipi/interfaces/sockets.py +++ b/ipi/interfaces/sockets.py @@ -292,8 +292,8 @@ def _getstatus(self): return Status.Up def get_status(self): - """ Sets (and returns) the client internal status. Wait for an answer if - the client is busy. """ + """Sets (and returns) the client internal status. Wait for an answer if + the client is busy.""" status = self._getstatus() while status & Status.Busy: status = self._getstatus() @@ -416,10 +416,10 @@ def getforce(self): return [mu, mf, mvir, mxtra] def dispatch(self, r): - """ Dispatches a request r and looks after it setting results - once it has been evaluated. This is meant to be launched as a - separate thread, and takes clear of all the communication related to - the request. + """Dispatches a request r and looks after it setting results + once it has been evaluated. This is meant to be launched as a + separate thread, and takes clear of all the communication related to + the request. """ if not self.status & Status.Up: @@ -793,7 +793,7 @@ def pool_distribute(self): def dispatch_free_client(self, fc, match_ids="any", send_threads=[]): """ - Tries to find a request to match a free client. + Tries to find a request to match a free client. """ # first, makes sure that the client is REALLY free @@ -849,7 +849,7 @@ def dispatch_free_client(self, fc, match_ids="any", send_threads=[]): def check_job_finished(self, r, c, ct): """ - Checks if a job has been completed, and retrieves the results + Checks if a job has been completed, and retrieves the results """ if r["status"] == "Done": diff --git a/ipi/utils/constrtools.py b/ipi/utils/constrtools.py index fe68307e3..4d3f0aea1 100644 --- a/ipi/utils/constrtools.py +++ b/ipi/utils/constrtools.py @@ -23,12 +23,12 @@ class ConstraintBase(dobject): - """ Base constraint class for MD. Takes care of indexing of + """Base constraint class for MD. Takes care of indexing of the atoms that are affected by the constraint, and creates depend objects to store the constraint function and gradient.""" def __init__(self, constrained_indices, ncons=0): - """ Initialize the constraint. + """Initialize the constraint. constrained_indices: Indices of the atoms that are involved in the constraint """ @@ -43,8 +43,8 @@ def __init__(self, constrained_indices, ncons=0): self.mk_idmaps() def mk_idmaps(self): - """ Creates arrays of indices that can be used for bookkeeping - and quickly accessing elements and positions """ + """Creates arrays of indices that can be used for bookkeeping + and quickly accessing elements and positions""" # position of the UID associated with each index (i_reverse[atom_id] # gives the position in the list of unique atoms of atom_id @@ -66,8 +66,8 @@ def mk_idmaps(self): self.i3_indirect[ri] = [3 * rri, 3 * rri + 1, 3 * rri + 2] def bind(self, beads): - """ Binds the constraint to a beads object - so that all of the - necessary quantities are easily and depend-ably accessable """ + """Binds the constraint to a beads object - so that all of the + necessary quantities are easily and depend-ably accessable""" self.beads = beads dself = dd(self) @@ -134,8 +134,8 @@ def Dgfunc(self): raise NotImplementedError() def Gfunc(self): - """ Computes a cholesky decomposition of the mass-scaled Jacobian, - used in a few places """ + """Computes a cholesky decomposition of the mass-scaled Jacobian, + used in a few places""" dg = dstrip(self.Dg).copy() dgm = dg / self.m3 @@ -144,16 +144,16 @@ def Gfunc(self): if spla is None: def GCfunc(self): - """ Computes a cholesky decomposition of the mass-scaled Jacobian, - used in a few places """ + """Computes a cholesky decomposition of the mass-scaled Jacobian, + used in a few places""" return np.linalg.cholesky(self.Gram) else: def GCfunc(self): - """ Computes a cholesky decomposition of the mass-scaled Jacobian, - used in a few places """ + """Computes a cholesky decomposition of the mass-scaled Jacobian, + used in a few places""" return spla.cho_factor(self.Gram) @@ -162,7 +162,7 @@ class ValueConstraintBase(ConstraintBase): """ Base class for a constraint that contains target values. """ def __init__(self, constrained_indices, constraint_values, ncons): - """ Initialize the constraint. + """Initialize the constraint. constrained_indices: Indices of the atoms that are involved in the constraint constraint_values: Value or values associated with the constraint @@ -199,10 +199,10 @@ def bind(self, beads): class RigidBondConstraint(ValueConstraintBase): - """ Constraint class for MD. - Specialized for rigid bonds. This can actually hold a *list* - of rigid bonds, i.e. there will be a list of pairs of atoms and - a list of bond lengths. """ + """Constraint class for MD. + Specialized for rigid bonds. This can actually hold a *list* + of rigid bonds, i.e. there will be a list of pairs of atoms and + a list of bond lengths.""" def __init__(self, constrained_indices, constraint_values): @@ -262,10 +262,10 @@ def Dgfunc(self, reduced=False): class AngleConstraint(ValueConstraintBase): - """ Constraint class for MD specialized for angles. - This can hold a list of angles, i.e. a list of triples of atoms - and the corresponding values. We adopt the convention that the - middle atom appears first in the list. + """Constraint class for MD specialized for angles. + This can hold a list of angles, i.e. a list of triples of atoms + and the corresponding values. We adopt the convention that the + middle atom appears first in the list. """ def __init__(self, constrained_indices, constraint_values): @@ -329,10 +329,10 @@ def Dgfunc(self, reduced=False): class EckartConstraint(ConstraintBase): - """ Constraint class for MD specialized for enforcing the Eckart conditions - (see E. Bright Wilson et al. 'Molecular Vibrations') - Unlike the constraints above, a single instance of this class can only - describe one set of Eckart conditions. + """Constraint class for MD specialized for enforcing the Eckart conditions + (see E. Bright Wilson et al. 'Molecular Vibrations') + Unlike the constraints above, a single instance of this class can only + describe one set of Eckart conditions. """ def __init__(self, constrained_indices, constraint_values): @@ -447,14 +447,14 @@ def Dgfunc(self, reduced=False): class ConstraintList(ConstraintBase): - """ Class to hold a list of constraints to be treated + """Class to hold a list of constraints to be treated simultaneously by the solver.""" def __init__(self, constraint_list): - """ Initialize the constraint list. + """Initialize the constraint list. Contains a list of constraint objects, that will be stored and used to compute the different blocks - of the constraint values and Jacobian """ + of the constraint values and Jacobian""" self.constraint_list = constraint_list self.ncons = sum([constr.ncons for constr in constraint_list]) diff --git a/ipi/utils/depend.py b/ipi/utils/depend.py index 023a52e2a..417928afe 100644 --- a/ipi/utils/depend.py +++ b/ipi/utils/depend.py @@ -564,7 +564,7 @@ def __array_prepare__(self, arr, context=None): ) def __array_wrap__(self, arr, context=None): - """ Wraps up output array from ufunc. + """Wraps up output array from ufunc. See docstring of __array_prepare__(). """ @@ -843,8 +843,8 @@ class dobject(object): """ def __new__(cls, *args, **kwds): - """ Initialize the object using __new__, because we do not want - to impose to derived classes to call the super __init__ """ + """Initialize the object using __new__, because we do not want + to impose to derived classes to call the super __init__""" obj = object.__new__(cls) obj._direct = ddirect(obj) @@ -881,8 +881,8 @@ def __setattr__(self, name, value): return super(dobject, self).__setattr__(name, value) def __deepcopy__(self, memo): - """ Overrides deepcopy behavior, so that _direct is not actually copied - but linked to a ddirect object """ + """Overrides deepcopy behavior, so that _direct is not actually copied + but linked to a ddirect object""" newone = type(self)() diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 2c1a59c1a..7f26e3d18 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -32,19 +32,19 @@ def get_dynmat(h, m3, nbeads=1): def clean_hessian(h, q, natoms, nbeads, m, m3, asr, mofi=False): """ - Removes the translations and rotations modes. - IN h = hessian (3*natoms*nbeads, 3*natoms*nbeads) - q = positions - natoms = number of atoms - nbeads = number of beads - m = mass vector, one value for each atom - m3 = mass vector, one value for each degree of freedom - mofi = An optional boolean which decides whether the det(M_of_I) - is returned or not - OUT d = non zero eigenvalues of the dynmatrix - w = eigenvectors without external modes - - #Adapted from ipi/engine/motion/phonons.py apply_asr """ + Removes the translations and rotations modes. + IN h = hessian (3*natoms*nbeads, 3*natoms*nbeads) + q = positions + natoms = number of atoms + nbeads = number of beads + m = mass vector, one value for each atom + m3 = mass vector, one value for each degree of freedom + mofi = An optional boolean which decides whether the det(M_of_I) + is returned or not + OUT d = non zero eigenvalues of the dynmatrix + w = eigenvectors without external modes + + #Adapted from ipi/engine/motion/phonons.py apply_asr""" info(" @clean_hessian: asr = %s " % asr, verbosity.medium) # Set some useful things @@ -177,16 +177,16 @@ def clean_hessian(h, q, natoms, nbeads, m, m3, asr, mofi=False): def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): """Compute the physical hessian given a function to evaluate energy and forces (gm). - The intermediate steps are written as a temporary files so the full hessian calculations is only ONE step. + The intermediate steps are written as a temporary files so the full hessian calculations is only ONE step. - IN gm = gradient mapper - x0 = position vector - natoms = number of atoms - nbeads = number of beads - fixatoms = indexes of fixed atoms - d = displacement + IN gm = gradient mapper + x0 = position vector + natoms = number of atoms + nbeads = number of beads + fixatoms = indexes of fixed atoms + d = displacement - OUT h = physical hessian ( (natoms-len(fixatoms) )*3 , nbeads*( natoms-len(fixatoms) )*3) + OUT h = physical hessian ( (natoms-len(fixatoms) )*3 , nbeads*( natoms-len(fixatoms) )*3) """ info(" @get_hessian: Computing hessian", verbosity.low) diff --git a/ipi/utils/inputvalue.py b/ipi/utils/inputvalue.py index 740ab8df6..e755fea6f 100644 --- a/ipi/utils/inputvalue.py +++ b/ipi/utils/inputvalue.py @@ -229,7 +229,7 @@ def check(self): raise ValueError("Uninitialized Input value of type " + type(self).__name__) def extend(self, name, xml): - """ Dynamically add elements to the 'extra' list. + """Dynamically add elements to the 'extra' list. Picks from one of the templates in the self.dynamic dictionary, then parses. @@ -763,8 +763,7 @@ def help_xml(self, name="", indent="", level=0, stop_level=None): class InputDictionary(Input): - """Class that returns the value of all the fields as a dictionary. - """ + """Class that returns the value of all the fields as a dictionary.""" def __init__( self, help=None, default=None, dtype=str, options=None, dimension=None @@ -1054,11 +1053,11 @@ def parse(self, xml=None, text=""): class InputRaw(InputValue): """Reads the data for a single value from an xml file. - Args: - xml: An xml_node object containing the all the data for the parent - tag. - text: The data held between the start and end tags. - """ + Args: + xml: An xml_node object containing the all the data for the parent + tag. + text: The data held between the start and end tags. + """ def parse(self, xml=None, text=""): # transforms back to xml and returns a string diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 20ac2f79f..237863639 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -114,7 +114,7 @@ def invmul_banded(A, B, posdef=False): """A is in upper banded form Solve H.h = -G for Newton - Raphson step, h using invmul_banded(H, -G) take step x += h - to find minimum or transition state """ + to find minimum or transition state""" try: from scipy import linalg @@ -137,8 +137,8 @@ def invmul_banded(A, B, posdef=False): def diag_banded(A, n=2): """A is in upper banded form. - Returns the smallest n eigenvalue and its corresponding eigenvector. - """ + Returns the smallest n eigenvalue and its corresponding eigenvector. + """ try: from scipy.linalg import eig_banded @@ -155,7 +155,7 @@ def diag_banded(A, n=2): def red2comp(h, nbeads, natoms, coef=None): """Takes the reduced physical hessian (3*natoms*nbeads,3*natoms) - and construct the 'complete' one (3*natoms*nbeads)^2 """ + and construct the 'complete' one (3*natoms*nbeads)^2""" info("\n @Instanton: Creating 'complete' physical hessian \n", verbosity.high) if coef is None: @@ -172,11 +172,11 @@ def red2comp(h, nbeads, natoms, coef=None): def get_imvector(h, m3): - """ Compute eigenvector corresponding to the imaginary mode - IN h = hessian - m3 = mass vector (dimension = 1 x 3*natoms) - OUT imv = eigenvector corresponding to the imaginary mode - """ + """Compute eigenvector corresponding to the imaginary mode + IN h = hessian + m3 = mass vector (dimension = 1 x 3*natoms) + OUT imv = eigenvector corresponding to the imaginary mode + """ info("@get_imvector", verbosity.high) if h.size != m3.size ** 2: raise ValueError( diff --git a/ipi/utils/io/__init__.py b/ipi/utils/io/__init__.py index 5b5825d21..14a8bd3c9 100644 --- a/ipi/utils/io/__init__.py +++ b/ipi/utils/io/__init__.py @@ -231,7 +231,7 @@ def print_file( def read_file_raw(mode, filedesc): - """ Reads atom positions, or atom-vector properties, from a file of mode "mode", + """Reads atom positions, or atom-vector properties, from a file of mode "mode", returns positions and cell parameters in raw array format, without creating i-PI internal objects. @@ -257,7 +257,7 @@ def read_file_raw(mode, filedesc): def read_file( mode, filedesc, dimension="automatic", units="automatic", cell_units="automatic" ): - """ Reads one frame from an open `mode`-style file. Also performs units + """Reads one frame from an open `mode`-style file. Also performs units conversion as requested, or as guessed from the input comment line. Args: diff --git a/ipi/utils/io/inputs/io_xml.py b/ipi/utils/io/inputs/io_xml.py index 74d757067..233507cb5 100644 --- a/ipi/utils/io/inputs/io_xml.py +++ b/ipi/utils/io/inputs/io_xml.py @@ -199,24 +199,24 @@ def xml_parse_file(stream): def xml_write(xml, name="", indent="", text=""): """Writes data in xml file format. - Writes the tag, attributes, data and closing tag appropriate to the - particular fields and attribs data. Writes in a recursive manner, so - that objects contained in the fields dictionary have their write function - called, so that their tags are written between the start and end tags - of this object, as is required for the xml format. - - This also adds an indent to the lower levels of the xml heirarchy, - so that it is easy to see which tags contain other tags. - - Args: - name: An optional string giving the tag name. Defaults to "". - indent: An optional string giving the string to be added to the start - of the line, so usually a number of tabs. Defaults to "". - text: Additional text to be output between the tags. - - Returns: - A string giving all the data contained in the fields and attribs - dictionaries, in the appropriate xml format. + Writes the tag, attributes, data and closing tag appropriate to the + particular fields and attribs data. Writes in a recursive manner, so + that objects contained in the fields dictionary have their write function + called, so that their tags are written between the start and end tags + of this object, as is required for the xml format. + + This also adds an indent to the lower levels of the xml heirarchy, + so that it is easy to see which tags contain other tags. + + Args: + name: An optional string giving the tag name. Defaults to "". + indent: An optional string giving the string to be added to the start + of the line, so usually a number of tabs. Defaults to "". + text: Additional text to be output between the tags. + + Returns: + A string giving all the data contained in the fields and attribs + dictionaries, in the appropriate xml format. """ rstr = "" diff --git a/ipi/utils/mathtools.py b/ipi/utils/mathtools.py index 6f1a4517b..b8c74c33c 100644 --- a/ipi/utils/mathtools.py +++ b/ipi/utils/mathtools.py @@ -89,7 +89,7 @@ def matrix_exp(M, ntaylor=20, nsquare=10): def stab_cholesky(M): - """ A numerically stable version of the Cholesky decomposition. + """A numerically stable version of the Cholesky decomposition. Used in the GLE implementation. Since many of the matrices used in this algorithm have very large and very small numbers in at once, to handle a @@ -172,7 +172,7 @@ def h2abc(h): def genh2abc(h): - """ Returns a description of the cell in terms of the length of the + """Returns a description of the cell in terms of the length of the lattice vectors and the angles between them in radians. Takes the representation of the system box in terms of a full matrix diff --git a/ipi/utils/mintools.py b/ipi/utils/mintools.py index 2578c8306..efac10d74 100644 --- a/ipi/utils/mintools.py +++ b/ipi/utils/mintools.py @@ -67,11 +67,11 @@ def bracket(fdf, fdf0=None, x0=0.0, init_step=1.0e-3): """Given an initial point, determines the initial bracket for the minimum - Arguments: - fdf: function to minimize, derivative of function to minimize - x0: initial point - fdf0: value of function and its derivative at x0 - init_step: intial step size + Arguments: + fdf: function to minimize, derivative of function to minimize + x0: initial point + fdf0: value of function and its derivative at x0 + init_step: intial step size """ # Constants @@ -219,14 +219,14 @@ def bracket(fdf, fdf0=None, x0=0.0, init_step=1.0e-3): def min_brent(fdf, fdf0, x0, tol, itmax, init_step): """Given a maximum number of iterations and a convergence tolerance, - minimizes the specified function - Arguments: - x0: initial x-value - fdf: function to minimize - fdf0: initial function value - tol: convergence tolerance - itmax: maximum allowed iterations - init_step: initial step size + minimizes the specified function + Arguments: + x0: initial x-value + fdf: function to minimize + fdf0: initial function value + tol: convergence tolerance + itmax: maximum allowed iterations + init_step: initial step size """ # Initializations and constants @@ -598,13 +598,13 @@ def BFGS(x0, d0, fdf, fdf0, invhessian, big_step, tol, itmax): # BFGS algorithm trust radius method def BFGSTRM(x0, u0, f0, h0, tr, mapper, big_step): - """ Input: x0 = previous accepted positions - u0 = previous accepted energy - f0 = previous accepted forces - h0 = previous accepted hessian - tr = trust radius - mapper = function to evaluate energy and forces - big_step = limit on step length""" + """Input: x0 = previous accepted positions + u0 = previous accepted energy + f0 = previous accepted forces + h0 = previous accepted hessian + tr = trust radius + mapper = function to evaluate energy and forces + big_step = limit on step length""" # Make one movement, evaluate if it has to be accepted or not. # If accepted, update tr and Hessian. @@ -654,11 +654,11 @@ def BFGSTRM(x0, u0, f0, h0, tr, mapper, big_step): def TRM_UPDATE(dx, df, h): - """ Input: DX = X -X_old - DF = F -F_old - DG = -DF - H = hessian - Task: updated hessian""" + """Input: DX = X -X_old + DF = F -F_old + DG = -DF + H = hessian + Task: updated hessian""" dx = dx[:, np.newaxis] # dimension nx1 dx_t = dx.T # dimension 1xn @@ -677,7 +677,7 @@ def TRM_UPDATE(dx, df, h): def min_trm(f, h, tr): - """ Return the minimum of + """Return the minimum of E(dx) = -(F * dx + 0.5 * ( dx * H * dx ), whithin dx**2 Date: Tue, 12 Jan 2021 15:28:16 +0100 Subject: [PATCH 012/120] flake8 compliant --- ipi/engine/motion/instanton.py | 1 - 1 file changed, 1 deletion(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 054086f92..3570af679 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -30,7 +30,6 @@ ) from ipi.utils.instools import print_instanton_hess, diag_banded, ms_pathway from ipi.utils.hesstools import get_hessian, clean_hessian, get_dynmat -from ipi.engine.beads import Beads __all__ = ["InstantonMotion"] From 8e33d4ff67ab0a5d56deb7cf44b1ded3daef6ac7 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 12 Jan 2021 15:41:46 +0100 Subject: [PATCH 013/120] small bugfix with the final hessian --- ipi/engine/motion/instanton.py | 8 +++++--- 1 file changed, 5 insertions(+), 3 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 3570af679..2fba89762 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1013,7 +1013,7 @@ def exitstep(self, d_x_max, step): else: info("We are going to compute the final hessian", verbosity.low) - self.optarrays["hessian"][:] = get_hessian( + active_hessian = get_hessian( self.mapper.gm, self.beads.q.copy(), self.beads.natoms, @@ -1021,6 +1021,8 @@ def exitstep(self, d_x_max, step): self.fixatoms, ) + self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) + print_instanton_hess( self.options["prefix"] + "_FINAL", step, @@ -1193,14 +1195,14 @@ def initialize(self, step): self.mapper.initialize(self.beads.q, self.forces) if self.options["hessian_init"]: - self.optarrays["hessian"][:] = get_hessian( + active_hessian = get_hessian( self.mapper.gm, self.beads.q.copy(), self.beads.natoms, self.beads.nbeads, self.fixatoms, ) - # active_hessian = self.mapper.fix.get_active_vector( self.optarrays["hessian"],t=2 ) + self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) self.update_old_pos_for() From a2cfb21ef31f345861fd479d73932debbc25ef06 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 13 Jan 2021 14:31:51 +0100 Subject: [PATCH 014/120] split PesMapper from FrictionMapper --- ipi/engine/motion/instanton.py | 435 +++++++++++++++------------------ ipi/inputs/motion/instanton.py | 10 + ipi/utils/hesstools.py | 43 +++- ipi/utils/instools.py | 165 +++++++++++++ 4 files changed, 414 insertions(+), 239 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 2fba89762..2e5020666 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -27,6 +27,7 @@ red2comp, get_imvector, print_instanton_geo, + Fix, ) from ipi.utils.instools import print_instanton_hess, diag_banded, ms_pathway from ipi.utils.hesstools import get_hessian, clean_hessian, get_dynmat @@ -35,18 +36,14 @@ # ALBERTO: -# - resolve hessian problem, implement sparse and dense spring hessian -# add boolean option hessian mode: -# add boolean option sparse in: -# get_hessian -# update_hessian -# print_hessian -# red2comp +# 1) code spline and integration to obtain g +# 2) red2comp + +# TEST # test ch4hcbe with dense hessian # test 1D double well with Ohmic # test 1D double well with Ohmic +SD -# - code spline and integration to obtain g # test 2x*1D double well with Ohmic +SD @@ -108,6 +105,7 @@ def __init__( delta=np.zeros(0, float), hessian_init=None, hessian=np.eye(0, 0, 0, float), + fric_hessian=np.eye(0, 0, 0, float), hessian_update=None, hessian_asr=None, qlist_lbfgs=np.zeros(0, float), @@ -173,13 +171,19 @@ def __init__( self.options["hessian_asr"] = hessian_asr self.options["hessian_init"] = hessian_init self.optarrays["hessian"] = hessian + self.optarrays["fric_hessian"] = fric_hessian if self.options["opt"] == "nichols": self.optimizer = NicholsOptimizer() - elif self.options["opt"] == "NR": - self.optimizer = NROptimizer() else: - self.optimizer = LanczosOptimizer() + if self.options["friction"]: + raise ValueError( + "\nPlease select nichols opt algorithm for an instanton calculation with friction\n" + ) + if self.options["opt"] == "NR": + self.optimizer = NROptimizer() + else: + self.optimizer = LanczosOptimizer() elif self.options["opt"] == "lbfgs": self.optimizer = LBFGSOptimizer() @@ -233,153 +237,9 @@ def step(self, step=None): self.optimizer.step(step) -class Fix(object): - """Class that applies a fixatoms type constrain""" - - def __init__(self, fixatoms, beads, nbeads=None): - - self.natoms = beads.natoms - if nbeads is None: - self.nbeads = beads.nbeads - else: - self.nbeads = nbeads - - self.fixatoms = fixatoms - - self.mask0 = np.delete(np.arange(self.natoms), self.fixatoms) - - mask1 = np.ones(3 * self.natoms, dtype=bool) - for i in range(3): - mask1[3 * self.fixatoms + i] = False - self.mask1 = np.arange(3 * self.natoms)[mask1] - - mask2 = np.tile(mask1, self.nbeads) - self.mask2 = np.arange(3 * self.natoms * self.nbeads)[mask2] - - self.fixbeads = Beads(beads.natoms - len(fixatoms), beads.nbeads) - self.fixbeads.q[:] = self.get_active_vector(beads.copy().q, 1) - self.fixbeads.m[:] = self.get_active_vector(beads.copy().m, 0) - self.fixbeads.names[:] = self.get_active_vector(beads.copy().names, 0) - - def get_mask(self, m): - - if m == 0: - return self.mask0 - elif m == 1: - return self.mask1 - elif m == 2: - return self.mask2 - else: - raise ValueError("Mask number not valid") - - def get_active_array(self, arrays): - """Functions that gets the subarray corresponding to the active degrees-of-freedom of the - full dimensional array""" - - activearrays = {} - for key in arrays: - - if ( - key == "old_u" - or key == "big_step" - or key == "delta" - or key == "energy_shift" - or key == "initial_hessian" - ): - t = -1 - elif key == "old_x" or key == "old_f" or key == "d": - t = 1 - elif key == "hessian" or key == "eta": - t = 2 - elif key == "qlist" or key == "glist": - t = 3 - else: - raise ValueError( - "@get_active_array: There is an array that we can't recognize" - ) - - activearrays[key] = self.get_active_vector(arrays[key], t) - - return activearrays - - def get_full_vector(self, vector, t): - """Set 0 the degrees of freedom (dof) corresponding to the fix atoms - IN: - fixatoms indexes of the fixed atoms - vector vector to be reduced - t type of array: - type=-1 : do nothing - type=0 : names (natoms ) - type=1 : pos , force or m3 (nbeads,dof) - type=2 : hessian (dof, nbeads*dof) - type=3 : qlist or glist (corrections, nbeads*dof) - OUT: - clean_vector reduced vector - """ - if len(self.fixatoms) == 0 or t == -1: - return vector - - if t == 1: - - full_vector = np.zeros((self.nbeads, 3 * self.natoms)) - full_vector[:, self.get_mask(1)] = vector - - return full_vector - - elif t == 2: - - full_vector = np.zeros((3 * self.natoms, 3 * self.natoms * self.nbeads)) - - ii = 0 - for i in self.get_mask(1): - full_vector[i, self.get_mask(2)] = vector[ii] - ii += 1 - - return full_vector - - elif t == 3: - - full_vector = np.zeros((vector.shape[0], 3 * self.natoms * self.nbeads)) - full_vector[:, self.fix.get_mask(2)] = vector - - return full_vector - - else: - - raise ValueError("@apply_fix_atoms: type number is not valid") - - def get_active_vector(self, vector, t): - """Delete the degrees of freedom (dof) corresponding to the fix atoms - IN: - fixatoms indexes of the fixed atoms - vector vector to be reduced - t type of array: - type=-1 : do nothing - type=0 : names (natoms ) - type=1 : pos , force or m3 (nbeads,dof) - type=2 : hessian (dof, nbeads*dof) - type=3 : qlist or glist (corrections, nbeads*dof) - OUT: - clean_vector reduced vector - """ - if len(self.fixatoms) == 0 or t == -1: - return vector - if t == 0: - return vector[self.mask0] - elif t == 1: - return vector[:, self.mask1] - elif t == 2: - aux = vector[self.mask1] - return aux[:, self.mask2] - elif t == 3: - return vector[:, self.mask2] - else: - raise ValueError("@apply_fix_atoms: type number is not valid") - - class PesMapper(object): - """Creation of the multi-dimennsional function to compute the physical potential and forces + """Creation of the multi-dimensional function to compute the physical potential and forces Attributes: dbeads: copy of the bead object @@ -399,9 +259,6 @@ def bind(self, mapper): self.nm = mapper.nm self.fix = mapper.fix self.coef = mapper.coef - self.friction = mapper.friction - if self.friction: - self.z_friction = mapper.z_friction max_ms = mapper.options["max_ms"] max_e = mapper.options["max_e"] @@ -424,43 +281,15 @@ def set_pos(self, x): """Set the positions """ self.dbeads.q = x - def save(self, e, g, eta=None): + def save(self, e, g): """ Stores potential and forces in this class for convenience """ self.pot = e self.f = -g - self.eta = eta - - def compute_friction_terms(self): - """ Computes friction component of the energy and gradient """ - - z = self.z_friction / self.z_friction[1] - s = self.eta - - # g = obtain_g(self.dbeads, self.eta) #Implement This - # s = obtain_s(self.dbeads, self.eta) #Implement THIS - gq = self.dbeads.q # For now - gq = np.concatenate((gq, np.flipud(gq)), axis=0) - gq_k = self.nm.transform.b2nm(gq) - - z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) - - e_f = (0.5 * z_k * gq_k ** 2).sum() - e = np.zeros(self.dbeads.nbeads) - e[0] = e_f # We can't do a meaningfull bead assigment - - f = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] - - g = np.zeros(f.shape) - for i in range(self.dbeads.nbeads): - g[i, :] = np.dot(s[i], f[i]) - return e, g - - def __call__(self, x, new_disc=True): - """ Computes energy and gradient for optimization step""" - self.fcount += 1 - full_q = x.copy() - full_mspath = ms_pathway(full_q, self.dbeads.m3) + def interpolation(self, full_q, full_mspath): + """Creates the reduced bead object from which energy and forces will be + computed and interpolates the results to the full size + """ if self.spline: try: from scipy.interpolate import interp1d @@ -512,29 +341,104 @@ def __call__(self, x, new_disc=True): full_pot = rpots full_forces = rforces + return full_pot, full_forces + + def __call__(self, x, new_disc=True): + """ Computes energy and gradient for optimization step""" + self.fcount += 1 + full_q = x.copy() + full_mspath = ms_pathway(full_q, self.dbeads.m3) + full_pot, full_force = self.interpolation(full_q, full_mspath) + # This forces the update of the forces self.dbeads.q[:] = x[:] self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) - if self.friction: - # ALBERTO: The following has to be joined to the json implementation for the - # communication of the extras strings - print("\n ALBERTO2 get friction from forces object\n") - # print("\n pick only the tensor corresponding to the RP frequencies") - red_eta = np.zeros( - (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) - ) + self.save(full_pot, -full_forces) + return self.evaluate() - # Interpolate if necessary to get full pot and forces - if self.spline: - red_mspath = full_mspath[indexes] - spline = interp1d(red_mspath, red_eta.T, kind="cubic") - full_eta = spline(full_mspath).T - else: - full_eta = red_eta + def evaluate(self): + """Evaluate the energy and forces including: + - non uniform discretization + - friction term (if required) + """ + + e = self.pot.copy() + g = -self.f.copy() + + e = e * (self.coef[1:] + self.coef[:-1]) / 2 + g = g * (self.coef[1:] + self.coef[:-1]) / 2 + + return e, g + + +class FrictionMapper(PesMapper): + def bind(self, mapper): + + self.z_friction = mapper.z_friction + super(FrictionMapper, self).bind(mapper) + + def save(self, e, g, eta=None): + """ Stores potential and forces in this class for convenience """ + super(FrictionMapper, self).save(e, g) + self.eta = eta + + def obtain_g(self, s): + """ Computes g from s """ + ss = s ** 0.5 + + return self.dbeads.q.copy() + + def compute_friction_terms(self): + """ Computes friction component of the energy and gradient """ + + z = self.z_friction / self.z_friction[1] + s = self.eta + + gq = self.obtain_g(s) + if gq.shape != self.dbeads.q.shape: + raise ValueError("\nproblem here\n") + gq = np.concatenate((gq, np.flipud(gq)), axis=0) + gq_k = self.nm.transform.b2nm(gq) + + z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) + + e_f = (0.5 * z_k * gq_k ** 2).sum() + e = np.zeros(self.dbeads.nbeads) + e[0] = e_f # We can't do a meaningfull bead assigment so we just do one + + f = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] + + g = np.zeros(f.shape) + for i in range(self.dbeads.nbeads): + g[i, :] = np.dot(s[i] ** 0.5, f[i]) + return e, g + def __call__(self, x, new_disc=True): + """ Computes energy and gradient for optimization step""" + self.fcount += 1 + full_q = x.copy() + full_mspath = ms_pathway(full_q, self.dbeads.m3) + full_pot, full_forces = self.interpolation(full_q, full_mspath) + + # ALBERTO: The following has to be joined to the json implementation + print("\n ALBERTO2 get friction from forces object\n") + print("pick only the tensor corresponding to the first RP frequencies") + red_eta = 0.0001 * np.ones( + (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) + ) + + # Interpolate if necessary to get full pot and forces + if self.spline: + red_mspath = full_mspath[indexes] + spline = interp1d(red_mspath, red_eta.T, kind="cubic") + full_eta = spline(full_mspath).T else: - full_eta = None + full_eta = red_eta + + # This forces the update of the forces + self.dbeads.q[:] = x[:] + self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) self.save(full_pot, -full_forces, full_eta) return self.evaluate() @@ -542,16 +446,15 @@ def __call__(self, x, new_disc=True): def evaluate(self): """Evaluate the energy and forces including: - non uniform discretization - - friction term (if required) + - friction term """ e = self.pot.copy() g = -self.f.copy() - if self.friction: - e_friction, g_friction = self.compute_friction_terms() - e += e_friction - g += g_friction + e_friction, g_friction = self.compute_friction_terms() + e += e_friction + g += g_friction e = e * (self.coef[1:] + self.coef[:-1]) / 2 g = g * (self.coef[1:] + self.coef[:-1]) / 2 @@ -728,7 +631,7 @@ class Mapper(object): def __init__(self, esum=False): self.sm = SpringMapper() - self.gm = PesMapper() + # self.gm = PesMapper() ALBERTO self.esum = esum def initialize(self, q, forces): @@ -769,6 +672,7 @@ def bind(self, dumop): self.friction = self.options["friction"] if self.friction: self.set_z_friction(self.options["z_friction"]) + self.gm = FrictionMapper() self.sm.bind(self) self.gm.bind(self) @@ -790,7 +694,7 @@ def set_z_friction(self, z_friction): spline = interp1d( freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False ) - self.z_friction = spline(2 * self.nm.get_omegak()) + self.z_friction = spline(self.nm.get_omegak()) # ALBERTO checck frequencies def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -902,7 +806,8 @@ def bind(self, geop): if self.options["friction"]: if len(geop.options["z_friction"]) == 0: - geop.options["z_friction"] = np.ones((11, 2)) * 3 # ALBERTO + geop.options["z_friction"] = np.ones((1000, 2)) + geop.options["z_friction"][:, 0] = np.arange(1000) self.options["z_friction"] = geop.options["z_friction"] self.options["tolerances"] = geop.options["tolerances"] @@ -1013,15 +918,30 @@ def exitstep(self, d_x_max, step): else: info("We are going to compute the final hessian", verbosity.low) - active_hessian = get_hessian( - self.mapper.gm, - self.beads.q.copy(), - self.beads.natoms, - self.beads.nbeads, - self.fixatoms, + current_hessian = get_hessian( + gm=self.mapper.gm, + x0=self.beads.q.copy(), + natoms=self.beads.natoms, + nbeads=self.beads.nbeads, + fixatoms=self.fixatoms, + friction=self.options["friction"], ) - self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) + if self.options["friction"]: + friction_hessian = current_hessian[1] + phys_hessian = current_hessian[0] + + print_instanton_hess( + self.options["prefix"] + "fric_FINAL", + step, + self.optarrays["fric_hessian"], + self.output_maker, + ) + + else: + phys_hessian = active_hessian + + self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) print_instanton_hess( self.options["prefix"] + "_FINAL", @@ -1161,6 +1081,22 @@ def bind(self, geop): ) self.optarrays["hessian"] = geop.optarrays["hessian"] + if self.options["friction"]: + + if geop.optarrays["fric_hessian"].size != ( + self.beads.natoms * 9 * self.beads.q.size + ): + if geop.options["hessian_init"]: + geop.optarrays["fric_hessian"] = np.zeros( + (self.beads.natoms * 9, self.beads.q.size) + ) + else: + raise ValueError( + """ + 'Hessian_init' is false, 'friction' is true so an initial fric_hessian (of the proper size) must be provided. + """ + ) + self.optarrays["fric_hessian"] = geop.optarrays["fric_hessian"] def initialize(self, step): @@ -1196,13 +1132,20 @@ def initialize(self, step): if self.options["hessian_init"]: active_hessian = get_hessian( - self.mapper.gm, - self.beads.q.copy(), - self.beads.natoms, - self.beads.nbeads, - self.fixatoms, + gm=self.mapper.gm, + x0=self.beads.q.copy(), + natoms=self.beads.natoms, + nbeads=self.beads.nbeads, + fixatoms=self.fixatoms, + friction=self.options["friction"], ) - self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) + if self.options["friction"]: + friction_hessian = active_hessian[1] + phys_hessian = active_hessian[0] + else: + phys_hessian = active_hessian + + self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) self.update_old_pos_for() @@ -1219,17 +1162,29 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): dg = d_g[j, :] dx = d_x[j, :] Powell(dx, dg, aux) + if self.options["friction"]: + info( + "powell update for friction hessian is not implemented", + verbosity.medium, + ) elif update == "recompute": active_hessian = get_hessian( - self.mapper.gm, - new_x, - self.beads.natoms, - self.beads.nbeads, - self.fixatoms, + gm=self.mapper.gm, + x0=new_x, + natoms=self.beads.natoms, + nbeads=self.beads.nbeads, + fixatoms=self.fixatoms, + friction=self.options["friction"], ) - self.optarrays["hessian"][:] = self.fix.get_full_vector(active_hessian, 2) + if self.options["friction"]: + friction_hessian = active_hessian[1] + phys_hessian = active_hessian[0] + else: + phys_hessian = active_hessian + + self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) def print_hess(self, step): if ( @@ -1287,11 +1242,17 @@ def step(self, step=None): ) # Add spring terms to the physical hessian - h1 = np.add(self.mapper.sm.h, h0) + h = np.add(self.mapper.sm.h, h0) + + # Add friction terms to the hessian + if self.options["friction"]: + # ALBERTO + h_fric = np.zeros(h.shape) + h = np.add(h, h_fric) # Get eigenvalues and eigenvector. d, w = clean_hessian( - h1, + h, self.fix.fixbeads.q, self.fix.fixbeads.natoms, self.fix.fixbeads.nbeads, diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index b82f71244..d9b957140 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -224,6 +224,14 @@ class InputInst(InputDictionary): "help": "Removes the zero frequency vibrational modes depending on the symmerty of the system.", }, ), + "fric_hessian": ( + InputArray, + { + "dtype": float, + "default": input_default(factory=np.eye, args=(0,)), + "help": "(Approximate) friction second derivative from which a friction Hessian can be built.", + }, + ), # L-BFGS "qlist_lbfgs": ( InputArray, @@ -347,6 +355,8 @@ def store(self, geop): self.hessian.store(optarrays["hessian"]) self.hessian_update.store(options["hessian_update"]) self.hessian_asr.store(options["hessian_asr"]) + if options["friction"]: + self.fric_hessian.store(optarrays["fric_hessian"]) elif geop.options["opt"] == "lbfgs": self.qlist_lbfgs.store(optarrays["qlist"]) self.glist_lbfgs.store(optarrays["glist"]) diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 7f26e3d18..deab423c7 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -175,7 +175,9 @@ def clean_hessian(h, q, natoms, nbeads, m, m3, asr, mofi=False): return d, w -def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): +def get_hessian( + gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False, friction=False +): """Compute the physical hessian given a function to evaluate energy and forces (gm). The intermediate steps are written as a temporary files so the full hessian calculations is only ONE step. @@ -201,6 +203,7 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): ) h = np.zeros((ii, ii * nbeads), float) + eta_h = np.zeros((ii * 3, ii * 3 * nbeads), float) # Check if there is a temporary file: i0 = -1 @@ -220,6 +223,28 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): break else: continue + if friction: + for i in range(ii, -1, -1): + try: + b = np.loadtxt("hessianEta_" + str(i) + ".tmp") + except IOError: + pass + else: + eta_h[:] = b[:] + i0 = i + print( + ( + "We have found a temporary file ( hessianEta_" + + str(i) + + ".tmp). " + ) + ) + if ( + b.shape == h.shape + ): # Check that the last temporary file was properly written + break + else: + continue # Start calculation: for j in range(i0 + 1, ii): @@ -234,22 +259,36 @@ def get_hessian(gm, x0, natoms, nbeads=1, fixatoms=[], d=0.001, new_disc=False): x[:, j] = x0[:, j] + d e, f1 = gm(x, new_disc) + if friction: + eta1 = gm.eta x[:, j] = x0[:, j] - d + if friction: + eta2 = gm.eta e, f2 = gm(x, new_disc) g = (f1 - f2) / (2 * d) + if friction: + eta_h[j, :] = (eta1 - eta2).flatten() / (2 * d) h[j, :] = g.flatten() f = open("hessian_" + str(j) + ".tmp", "w") np.savetxt(f, h) f.close() + if friction: + f = open("hessianEta_" + str(j) + ".tmp", "w") + np.savetxt(f, eta_h) + f.close() u, g = gm(x0) # Keep the mapper updated for i in range(ii): try: + os.remove("hessianEta_" + str(i) + ".tmp") os.remove("hessian_" + str(i) + ".tmp") except OSError: pass - return h + if not friction: + return h + else: + return h, eta_h diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 237863639..f0af1f63d 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -1,5 +1,6 @@ import numpy as np +from ipi.engine.beads import Beads from ipi.utils.messages import verbosity, info from ipi.utils import units import ipi.utils.mathtools as mt @@ -302,3 +303,167 @@ def ms_pathway(pos, m3): dx.append(d_norm) path[i] = np.sum(dx[:i]) return path + + +class Fix(object): + """Class that applies a fixatoms type constrain""" + + def __init__(self, fixatoms, beads, nbeads=None): + + self.natoms = beads.natoms + if nbeads is None: + self.nbeads = beads.nbeads + else: + self.nbeads = nbeads + + self.fixatoms = fixatoms + + self.mask0 = np.delete(np.arange(self.natoms), self.fixatoms) + + mask1 = np.ones(3 * self.natoms, dtype=bool) + for i in range(3): + mask1[3 * self.fixatoms + i] = False + self.mask1 = np.arange(3 * self.natoms)[mask1] + + mask2 = np.tile(mask1, self.nbeads) + self.mask2 = np.arange(3 * self.natoms * self.nbeads)[mask2] + + self.fixbeads = Beads(beads.natoms - len(fixatoms), beads.nbeads) + self.fixbeads.q[:] = self.get_active_vector(beads.copy().q, 1) + self.fixbeads.m[:] = self.get_active_vector(beads.copy().m, 0) + self.fixbeads.names[:] = self.get_active_vector(beads.copy().names, 0) + + mask3a = np.ones(9 * self.natoms, dtype=bool) + for i in range(9): + mask3a[9 * self.fixatoms + i] = False + mask3b = np.tile(mask3a, self.nbeads) + self.mask3 = np.arange(9 * self.natoms * self.nbeads)[mask3b] + + def get_mask(self, m): + + if m == 0: + return self.mask0 + elif m == 1: + return self.mask1 + elif m == 2: + return self.mask2 + elif m == 3: + return self.mask3 + else: + raise ValueError("Mask number not valid") + + def get_active_array(self, arrays): + """Functions that gets the subarray corresponding to the active degrees-of-freedom of the + full dimensional array""" + + activearrays = {} + for key in arrays: + + if ( + key == "old_u" + or key == "big_step" + or key == "delta" + or key == "energy_shift" + or key == "initial_hessian" + ): + t = -1 + elif key == "old_x" or key == "old_f" or key == "d": + t = 1 + elif key == "hessian" or key == "eta": + t = 2 + elif key == "qlist" or key == "glist": + t = 3 + elif key == "fric_hessian": + t = 4 + else: + raise ValueError( + "@get_active_array: We can't recognize the key '{}' ".format(key) + ) + + activearrays[key] = self.get_active_vector(arrays[key], t) + + return activearrays + + def get_full_vector(self, vector, t): + """Set 0 the degrees of freedom (dof) corresponding to the fix atoms + IN: + fixatoms indexes of the fixed atoms + vector vector to be reduced + t type of array: + type=-1 : do nothing + type=0 : names (natoms ) + type=1 : pos , force or m3 (nbeads,dof) + type=2 : hessian (dof, nbeads*dof) + type=3 : qlist or glist (corrections, nbeads*dof) + type=4 : fric_hessian + OUT: + clean_vector reduced vector + """ + if len(self.fixatoms) == 0 or t == -1: + return vector + + if t == 1: + + full_vector = np.zeros((self.nbeads, 3 * self.natoms)) + full_vector[:, self.get_mask(1)] = vector + + return full_vector + + elif t == 2: + + full_vector = np.zeros((3 * self.natoms, 3 * self.natoms * self.nbeads)) + + ii = 0 + for i in self.get_mask(1): + full_vector[i, self.get_mask(2)] = vector[ii] + ii += 1 + + return full_vector + + elif t == 3: + + full_vector = np.zeros((vector.shape[0], 3 * self.natoms * self.nbeads)) + full_vector[:, self.fix.get_mask(2)] = vector + + return full_vector + elif t == 4: + + full_vector = np.zeros((9 * self.natoms, 9 * self.natoms * self.nbeads)) + ii = 0 + for i in self.get_mask(1): + full_vector[i, self.get_mask(3)] = vector[ii] + ii += 1 + + return full_vector + + else: + + raise ValueError("@apply_fix_atoms: type number is not valid") + + def get_active_vector(self, vector, t): + """Delete the degrees of freedom (dof) corresponding to the fix atoms + IN: + fixatoms indexes of the fixed atoms + vector vector to be reduced + t type of array: + type=-1 : do nothing + type=0 : names (natoms ) + type=1 : pos , force or m3 (nbeads,dof) + type=2 : hessian (dof, nbeads*dof) + type=3 : qlist or glist (corrections, nbeads*dof) + OUT: + clean_vector reduced vector + """ + if len(self.fixatoms) == 0 or t == -1: + return vector + if t == 0: + return vector[self.mask0] + elif t == 1: + return vector[:, self.mask1] + elif t == 2: + aux = vector[self.mask1] + return aux[:, self.mask2] + elif t == 3: + return vector[:, self.mask2] + else: + raise ValueError("@apply_fix_atoms: type number is not valid") From e04c32f653da124a2b1a3d6525b1f1bb16eb3808 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 13 Jan 2021 16:01:17 +0100 Subject: [PATCH 015/120] add some docstring --- ipi/engine/motion/instanton.py | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 2e5020666..1de530c59 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -37,7 +37,7 @@ # ALBERTO: # 1) code spline and integration to obtain g -# 2) red2comp +# 2) red2comp for friction # TEST # test ch4hcbe with dense hessian @@ -373,6 +373,10 @@ def evaluate(self): class FrictionMapper(PesMapper): + + """ Creation of the multi-dimensional function to compute the physical potential and forces, + as well as the friction terms """ + def bind(self, mapper): self.z_friction = mapper.z_friction From d36b2197fbd07f7343e6ca61740b4ea9b9e55dd8 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 13 Jan 2021 16:43:08 +0100 Subject: [PATCH 016/120] clean after the split two commits ago --- ipi/engine/motion/instanton.py | 24 ++++++++++++++++-------- 1 file changed, 16 insertions(+), 8 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 1de530c59..5a764c8af 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -286,7 +286,7 @@ def save(self, e, g): self.pot = e self.f = -g - def interpolation(self, full_q, full_mspath): + def interpolation(self, full_q, full_mspath, get_index=False): """Creates the reduced bead object from which energy and forces will be computed and interpolates the results to the full size """ @@ -340,15 +340,17 @@ def interpolation(self, full_q, full_mspath): else: full_pot = rpots full_forces = rforces - - return full_pot, full_forces + if get_index: + return full_pot, full_forces, indexes + else: + return full_pot, full_forces def __call__(self, x, new_disc=True): """ Computes energy and gradient for optimization step""" self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) - full_pot, full_force = self.interpolation(full_q, full_mspath) + full_pot, full_forces = self.interpolation(full_q, full_mspath) # This forces the update of the forces self.dbeads.q[:] = x[:] @@ -374,8 +376,8 @@ def evaluate(self): class FrictionMapper(PesMapper): - """ Creation of the multi-dimensional function to compute the physical potential and forces, - as well as the friction terms """ + """Creation of the multi-dimensional function to compute the physical potential and forces, + as well as the friction terms""" def bind(self, mapper): @@ -423,7 +425,9 @@ def __call__(self, x, new_disc=True): self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) - full_pot, full_forces = self.interpolation(full_q, full_mspath) + full_pot, full_forces, indexes = self.interpolation( + full_q, full_mspath, get_index=True + ) # ALBERTO: The following has to be joined to the json implementation print("\n ALBERTO2 get friction from forces object\n") @@ -434,6 +438,10 @@ def __call__(self, x, new_disc=True): # Interpolate if necessary to get full pot and forces if self.spline: + from scipy.interpolate import ( + interp1d, + ) # If we reach this point, we already know we have scipy + red_mspath = full_mspath[indexes] spline = interp1d(red_mspath, red_eta.T, kind="cubic") full_eta = spline(full_mspath).T @@ -943,7 +951,7 @@ def exitstep(self, d_x_max, step): ) else: - phys_hessian = active_hessian + phys_hessian = current_hessian self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) From 102d511908cad8f7af67fb851212fb5197eb8835 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 13 Jan 2021 19:15:08 +0100 Subject: [PATCH 017/120] obtain_g function --- ipi/engine/motion/instanton.py | 51 +++++++++++++++++++--------------- 1 file changed, 29 insertions(+), 22 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 5a764c8af..98cafa5a7 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -35,18 +35,13 @@ __all__ = ["InstantonMotion"] -# ALBERTO: -# 1) code spline and integration to obtain g -# 2) red2comp for friction - # TEST -# test ch4hcbe with dense hessian # test 1D double well with Ohmic # test 1D double well with Ohmic +SD - # test 2x*1D double well with Ohmic +SD + class InstantonMotion(Motion): """Instanton motion class. @@ -204,6 +199,14 @@ def __init__( "problem use nichols even though it may not be as efficient.", verbosity.low, ) + if self.options["friction"]: + try: + from scipy.interpolate import interp1d + except ImportError: + softexit.trigger( + "Scipy required to use friction in a instanton calculation" + ) + def bind(self, ens, beads, nm, cell, bforce, prng, omaker): """Binds beads, cell, bforce and prng to InstantonMotion @@ -392,8 +395,19 @@ def save(self, e, g, eta=None): def obtain_g(self, s): """ Computes g from s """ ss = s ** 0.5 - - return self.dbeads.q.copy() + from scipy.interpolate import interp1d + from scipy.integrate import quad + q = self.dbeads.q.copy() + gq = np.zeros(self.dbeads.q.copy().shape) + for nd in range(1,3*self.dbeads.natoms): + try: + spline = interp1d(q[:,nd], np.diag(s[:,nd,nd], kind="cubic")) #spline for each dof + for nb in range(self.dbeads.nbeads): + gq[nb,nd] = quad(spline,q[0,nd],q[nb,nd]) #Cumulative integral along the path for each dof + except: + gq[:,nd] = 0 + + return gq def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ @@ -432,15 +446,12 @@ def __call__(self, x, new_disc=True): # ALBERTO: The following has to be joined to the json implementation print("\n ALBERTO2 get friction from forces object\n") print("pick only the tensor corresponding to the first RP frequencies") - red_eta = 0.0001 * np.ones( + red_eta = 0.01 * np.ones( (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) ) # Interpolate if necessary to get full pot and forces if self.spline: - from scipy.interpolate import ( - interp1d, - ) # If we reach this point, we already know we have scipy red_mspath = full_mspath[indexes] spline = interp1d(red_mspath, red_eta.T, kind="cubic") @@ -451,7 +462,6 @@ def __call__(self, x, new_disc=True): # This forces the update of the forces self.dbeads.q[:] = x[:] self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) - self.save(full_pot, -full_forces, full_eta) return self.evaluate() @@ -643,14 +653,16 @@ class Mapper(object): def __init__(self, esum=False): self.sm = SpringMapper() - # self.gm = PesMapper() ALBERTO + self.gm = PesMapper() self.esum = esum def initialize(self, q, forces): print("\nALBERTO1 get friction from forces object\n") eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) - + for i in range(q.shape[0]): + for ii in range(q.shape[1]): + eta[i,ii,ii] = q[i,ii]+2 self.gm.save(forces.pots, -forces.f, eta) e1, g1 = self.gm.evaluate() e2, g2 = self.sm(q) @@ -695,12 +707,8 @@ def set_coef(self, coef): def set_z_friction(self, z_friction): """Sets the scaling factors corresponding to frequency dependence of the friction """ - try: - from scipy.interpolate import interp1d - except ImportError: - softexit.trigger( - "Scipy required to use friction in a instanton calculation" - ) + + from scipy.interpolate import interp1d freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) spline = interp1d( @@ -1273,7 +1281,6 @@ def step(self, step=None): self.options["hessian_asr"], ) - # d,w =np.linalg.eigh(h1) #Cartesian info( "\n@Nichols: 1st freq {} cm^-1".format( units.unit_to_user( From e160ebdd61aa631a3afb03507d4c3a22ed2ce5e7 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 15 Jan 2021 15:47:31 +0100 Subject: [PATCH 018/120] fric_hessian part I --- ipi/engine/motion/instanton.py | 105 ++++++++++++++++++++++++++------- 1 file changed, 83 insertions(+), 22 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 98cafa5a7..8386233b4 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -34,14 +34,14 @@ __all__ = ["InstantonMotion"] - +# Finish +# Friction hessian # TEST # test 1D double well with Ohmic # test 1D double well with Ohmic +SD # test 2x*1D double well with Ohmic +SD - class InstantonMotion(Motion): """Instanton motion class. @@ -201,12 +201,11 @@ def __init__( ) if self.options["friction"]: try: - from scipy.interpolate import interp1d + from scipy.interpolate import interp1d except ImportError: - softexit.trigger( - "Scipy required to use friction in a instanton calculation" - ) - + softexit.trigger( + "Scipy required to use friction in a instanton calculation" + ) def bind(self, ens, beads, nm, cell, bforce, prng, omaker): """Binds beads, cell, bforce and prng to InstantonMotion @@ -222,7 +221,7 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): super(InstantonMotion, self).bind(ens, beads, nm, cell, bforce, prng, omaker) # Redefine normal modes - self.nm = NormalModes() + self.nm = NormalModes(transform_method='matrix') if self.options["mode"] == "rate": self.nm.bind( self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads * 2) @@ -392,21 +391,83 @@ def save(self, e, g, eta=None): super(FrictionMapper, self).save(e, g) self.eta = eta + def get_fric_hessian(self, fric_hessian): + """ Creates the friction hessian from the eta derivatives """ + nphys = self.dbeads.natoms*3 + ndof = self.dbeads.nbeads*self.dbeads.natoms*3 + + z = self.z_friction / self.z_friction[1] + s = self.eta + + gq = self.obtain_g(s) + gq = np.concatenate((gq, np.flipud(gq)), axis=0) + print('gq',gq.shape) + gq_k = self.nm.transform.b2nm(gq) + z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) + print('z_k',z_k.shape) + print('gq_k',gq_k.shape) + f1 = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] + print('f1',f1.shape) + + h_fric = np.zeros((ndof,ndof)) + #Block diag: +# for i in range(self.dbeads.nbeads): +# h_fric[nphys*i:nphys*(i+1),nphys*i:nphys*(i+1)] = np.dot(fric_hessian[i] ** 0.5, f1[i]) + + #Cross-terms: + h_test_1fric = np.zeros((ndof,ndof)) + h_test_2fric = np.zeros((ndof,ndof)) + for nl in range(self.dbeads.nbeads): + for ns in range(self.dbeads.nbeads): + delta_ks = self.nm.transform._b2nm[:,ns].reshape(-1,1) + prefactor = self.nm.transform.nm2b(z_k * delta_ks)[: self.dbeads.nbeads, :][nl] + h_test_1fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)] = prefactor + + C = self.nm.transform._b2nm + for nl in range(self.dbeads.nbeads): + for ns in range(self.dbeads.nbeads): + for i in range(nphys): + for ii in range(nphys): + prefactor = 0 + for k in range(self.dbeads.nbeads): + prefactor +=z_k[k]*C[k,nl]*C[k,ns] + h_test_2fric[nphys*nl+i,nphys*ns+ii] = prefactor#*s[nl,i,ii]*s[ns,i,ii] + for nl in range(self.dbeads.nbeads): + for ns in range(self.dbeads.nbeads): + a=np.amax(h_test_2fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]-h_test_1fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]) + b=np.amin(h_test_2fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]-h_test_1fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]) + print(nl,ns,a,b) + + + g = np.zeros(f1.shape) + + print(fric_hessian.shape) + print(f1.shape) + print(s.shape) + print(s[1].shape,f1[1].shape) + print(np.dot(s[1],f1[1]).shape) + raise ValueError + def obtain_g(self, s): """ Computes g from s """ ss = s ** 0.5 from scipy.interpolate import interp1d from scipy.integrate import quad + q = self.dbeads.q.copy() gq = np.zeros(self.dbeads.q.copy().shape) - for nd in range(1,3*self.dbeads.natoms): - try: - spline = interp1d(q[:,nd], np.diag(s[:,nd,nd], kind="cubic")) #spline for each dof - for nb in range(self.dbeads.nbeads): - gq[nb,nd] = quad(spline,q[0,nd],q[nb,nd]) #Cumulative integral along the path for each dof - except: - gq[:,nd] = 0 - + for nd in range(1, 3 * self.dbeads.natoms): + try: + spline = interp1d( + q[:, nd], np.diag(ss[:, nd, nd], kind="cubic") + ) # spline for each dof + for nb in range(self.dbeads.nbeads): + gq[nb, nd] = quad( + spline, q[0, nd], q[nb, nd] + ) # Cumulative integral along the path for each dof + except: + gq[:, nd] = 0 + return gq def compute_friction_terms(self): @@ -443,7 +504,7 @@ def __call__(self, x, new_disc=True): full_q, full_mspath, get_index=True ) - # ALBERTO: The following has to be joined to the json implementation + # The following has to be joined to the json implementation print("\n ALBERTO2 get friction from forces object\n") print("pick only the tensor corresponding to the first RP frequencies") red_eta = 0.01 * np.ones( @@ -452,6 +513,7 @@ def __call__(self, x, new_disc=True): # Interpolate if necessary to get full pot and forces if self.spline: + from scipy.interpolate import interp1d red_mspath = full_mspath[indexes] spline = interp1d(red_mspath, red_eta.T, kind="cubic") @@ -653,7 +715,7 @@ class Mapper(object): def __init__(self, esum=False): self.sm = SpringMapper() - self.gm = PesMapper() + self.gm = PesMapper() self.esum = esum def initialize(self, q, forces): @@ -661,8 +723,8 @@ def initialize(self, q, forces): print("\nALBERTO1 get friction from forces object\n") eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) for i in range(q.shape[0]): - for ii in range(q.shape[1]): - eta[i,ii,ii] = q[i,ii]+2 + for ii in range(q.shape[1]): + eta[i, ii, ii] = q[i, ii] + 2 self.gm.save(forces.pots, -forces.f, eta) e1, g1 = self.gm.evaluate() e2, g2 = self.sm(q) @@ -1266,8 +1328,7 @@ def step(self, step=None): # Add friction terms to the hessian if self.options["friction"]: - # ALBERTO - h_fric = np.zeros(h.shape) + h_fric = self.mapper.gm.get_fric_hessian(activearrays["fric_hessian"]) h = np.add(h, h_fric) # Get eigenvalues and eigenvector. From 910a7cbc7dfd5568bbe64e3c86fb717c333cdbf2 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 15 Jan 2021 17:58:07 +0100 Subject: [PATCH 019/120] Finish first version --- ipi/engine/motion/instanton.py | 105 ++++++++++++++++++--------------- ipi/utils/hesstools.py | 15 ++--- 2 files changed, 63 insertions(+), 57 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 8386233b4..a61e95351 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -221,7 +221,7 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): super(InstantonMotion, self).bind(ens, beads, nm, cell, bforce, prng, omaker) # Redefine normal modes - self.nm = NormalModes(transform_method='matrix') + self.nm = NormalModes(transform_method="matrix") if self.options["mode"] == "rate": self.nm.bind( self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads * 2) @@ -393,60 +393,56 @@ def save(self, e, g, eta=None): def get_fric_hessian(self, fric_hessian): """ Creates the friction hessian from the eta derivatives """ - nphys = self.dbeads.natoms*3 - ndof = self.dbeads.nbeads*self.dbeads.natoms*3 + nphys = self.dbeads.natoms * 3 + ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 z = self.z_friction / self.z_friction[1] s = self.eta - + dgdq = s**0.5 gq = self.obtain_g(s) gq = np.concatenate((gq, np.flipud(gq)), axis=0) - print('gq',gq.shape) gq_k = self.nm.transform.b2nm(gq) z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) - print('z_k',z_k.shape) - print('gq_k',gq_k.shape) f1 = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] - print('f1',f1.shape) - h_fric = np.zeros((ndof,ndof)) - #Block diag: -# for i in range(self.dbeads.nbeads): -# h_fric[nphys*i:nphys*(i+1),nphys*i:nphys*(i+1)] = np.dot(fric_hessian[i] ** 0.5, f1[i]) + h_fric = np.zeros((ndof, ndof)) + # Block diag: + for n in range(self.dbeads.nbeads): + for i in range(nphys): + for ii in range(nphys): + aux = 0 + for iii in range(nphys): + try: + aux += 0.5 * fric_hessian[n, i, ii, iii] / dqdq[n,ii,iii] * f1[i,iii] + except: + pass + h_fric[nphys * n + i , nphys * n + ii] = aux - #Cross-terms: - h_test_1fric = np.zeros((ndof,ndof)) - h_test_2fric = np.zeros((ndof,ndof)) - for nl in range(self.dbeads.nbeads): - for ns in range(self.dbeads.nbeads): - delta_ks = self.nm.transform._b2nm[:,ns].reshape(-1,1) - prefactor = self.nm.transform.nm2b(z_k * delta_ks)[: self.dbeads.nbeads, :][nl] - h_test_1fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)] = prefactor + # Cross-terms: C = self.nm.transform._b2nm for nl in range(self.dbeads.nbeads): - for ns in range(self.dbeads.nbeads): - for i in range(nphys): - for ii in range(nphys): - prefactor = 0 - for k in range(self.dbeads.nbeads): - prefactor +=z_k[k]*C[k,nl]*C[k,ns] - h_test_2fric[nphys*nl+i,nphys*ns+ii] = prefactor#*s[nl,i,ii]*s[ns,i,ii] - for nl in range(self.dbeads.nbeads): - for ns in range(self.dbeads.nbeads): - a=np.amax(h_test_2fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]-h_test_1fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]) - b=np.amin(h_test_2fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]-h_test_1fric[nphys*nl:nphys*(nl+1),nphys*ns:nphys*(ns+1)]) - print(nl,ns,a,b) - - - g = np.zeros(f1.shape) - - print(fric_hessian.shape) - print(f1.shape) - print(s.shape) - print(s[1].shape,f1[1].shape) - print(np.dot(s[1],f1[1]).shape) - raise ValueError + for ns in range(self.dbeads.nbeads): + for i in range(nphys): + for ii in range(nphys): + prefactor = 0 + for k in range(2 * self.dbeads.nbeads): + prefactor += z_k[k] * C[k, nl] * C[k, ns] + suma = np.sum(s[nl, i, :] * s[ns, ii, :]) + h_fric[nphys * nl + i, nphys * ns + ii] = prefactor * suma + + # Alternative cross-term + # for nl in range(self.dbeads.nbeads): + # for ns in range(self.dbeads.nbeads): + # delta_bead= np.zeros((2*self.dbeads.nbeads,nphys)) + # delta_bead[ns]=1.0 + # delta_ks = self.nm.transform.b2nm(delta_bead) + # prefactor = self.nm.transform.nm2b(z_k * delta_ks)[: self.dbeads.nbeads, :][nl] + # for i in range(nphys): + # for ii in range(nphys): + # h_fric[nphys*nl+i,nphys*ns:nphys*(ns+1)] = prefactor *np.dot(s[nl,i,:],s[ns,ii,:].T) + + return h_fric def obtain_g(self, s): """ Computes g from s """ @@ -475,6 +471,7 @@ def compute_friction_terms(self): z = self.z_friction / self.z_friction[1] s = self.eta + dgdq = s**0.5 gq = self.obtain_g(s) if gq.shape != self.dbeads.q.shape: @@ -492,7 +489,7 @@ def compute_friction_terms(self): g = np.zeros(f.shape) for i in range(self.dbeads.nbeads): - g[i, :] = np.dot(s[i] ** 0.5, f[i]) + g[i, :] = np.dot(dgdq[i], f[i]) return e, g def __call__(self, x, new_disc=True): @@ -1166,11 +1163,19 @@ def bind(self, geop): if self.options["friction"]: if geop.optarrays["fric_hessian"].size != ( - self.beads.natoms * 9 * self.beads.q.size + self.beads.nbeads, + self.beads.natoms * 3, + self.beads.natoms * 3, + self.beads.natoms * 3, ): if geop.options["hessian_init"]: geop.optarrays["fric_hessian"] = np.zeros( - (self.beads.natoms * 9, self.beads.q.size) + ( + self.beads.nbeads, + self.beads.natoms * 3, + self.beads.natoms * 3, + self.beads.natoms * 3, + ) ) else: raise ValueError( @@ -1222,8 +1227,11 @@ def initialize(self, step): friction=self.options["friction"], ) if self.options["friction"]: - friction_hessian = active_hessian[1] phys_hessian = active_hessian[0] + friction_hessian = active_hessian[1] + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( + friction_hessian, 4 + ) else: phys_hessian = active_hessian @@ -1261,8 +1269,11 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): ) if self.options["friction"]: - friction_hessian = active_hessian[1] phys_hessian = active_hessian[0] + friction_hessian = active_hessian[1] + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( + friction_hessian, 4 + ) else: phys_hessian = active_hessian diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index deab423c7..995840347 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -203,7 +203,8 @@ def get_hessian( ) h = np.zeros((ii, ii * nbeads), float) - eta_h = np.zeros((ii * 3, ii * 3 * nbeads), float) + if friction: + eta_h = np.zeros((nbeads, ii , ii , ii), float) # Check if there is a temporary file: i0 = -1 @@ -230,7 +231,7 @@ def get_hessian( except IOError: pass else: - eta_h[:] = b[:] + eta_h[:] = b.reshape((nbeads, ii , ii , ii)) i0 = i print( ( @@ -239,12 +240,6 @@ def get_hessian( + ".tmp). " ) ) - if ( - b.shape == h.shape - ): # Check that the last temporary file was properly written - break - else: - continue # Start calculation: for j in range(i0 + 1, ii): @@ -268,7 +263,7 @@ def get_hessian( g = (f1 - f2) / (2 * d) if friction: - eta_h[j, :] = (eta1 - eta2).flatten() / (2 * d) + eta_h[:,j, :] = (eta1 - eta2) / (2 * d) h[j, :] = g.flatten() f = open("hessian_" + str(j) + ".tmp", "w") @@ -276,7 +271,7 @@ def get_hessian( f.close() if friction: f = open("hessianEta_" + str(j) + ".tmp", "w") - np.savetxt(f, eta_h) + np.savetxt(f, eta_h.flatten()) f.close() u, g = gm(x0) # Keep the mapper updated From a15313f6f594eb00fa0c485c010e14f68a0a63dc Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 15 Jan 2021 18:00:30 +0100 Subject: [PATCH 020/120] black --- ipi/engine/motion/instanton.py | 25 ++++++++++++++----------- ipi/utils/hesstools.py | 6 +++--- 2 files changed, 17 insertions(+), 14 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index a61e95351..5e52a3a66 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -34,8 +34,6 @@ __all__ = ["InstantonMotion"] -# Finish -# Friction hessian # TEST # test 1D double well with Ohmic # test 1D double well with Ohmic +SD @@ -398,7 +396,7 @@ def get_fric_hessian(self, fric_hessian): z = self.z_friction / self.z_friction[1] s = self.eta - dgdq = s**0.5 + dgdq = s ** 0.5 gq = self.obtain_g(s) gq = np.concatenate((gq, np.flipud(gq)), axis=0) gq_k = self.nm.transform.b2nm(gq) @@ -410,13 +408,18 @@ def get_fric_hessian(self, fric_hessian): for n in range(self.dbeads.nbeads): for i in range(nphys): for ii in range(nphys): - aux = 0 - for iii in range(nphys): - try: - aux += 0.5 * fric_hessian[n, i, ii, iii] / dqdq[n,ii,iii] * f1[i,iii] + aux = 0 + for iii in range(nphys): + try: + aux += ( + 0.5 + * fric_hessian[n, i, ii, iii] + / dgdq[n, ii, iii] + * f1[i, iii] + ) except: - pass - h_fric[nphys * n + i , nphys * n + ii] = aux + pass + h_fric[nphys * n + i, nphys * n + ii] = aux # Cross-terms: @@ -442,7 +445,7 @@ def get_fric_hessian(self, fric_hessian): # for ii in range(nphys): # h_fric[nphys*nl+i,nphys*ns:nphys*(ns+1)] = prefactor *np.dot(s[nl,i,:],s[ns,ii,:].T) - return h_fric + return h_fric def obtain_g(self, s): """ Computes g from s """ @@ -471,7 +474,7 @@ def compute_friction_terms(self): z = self.z_friction / self.z_friction[1] s = self.eta - dgdq = s**0.5 + dgdq = s ** 0.5 gq = self.obtain_g(s) if gq.shape != self.dbeads.q.shape: diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 995840347..7fab5af66 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -204,7 +204,7 @@ def get_hessian( h = np.zeros((ii, ii * nbeads), float) if friction: - eta_h = np.zeros((nbeads, ii , ii , ii), float) + eta_h = np.zeros((nbeads, ii, ii, ii), float) # Check if there is a temporary file: i0 = -1 @@ -231,7 +231,7 @@ def get_hessian( except IOError: pass else: - eta_h[:] = b.reshape((nbeads, ii , ii , ii)) + eta_h[:] = b.reshape((nbeads, ii, ii, ii)) i0 = i print( ( @@ -263,7 +263,7 @@ def get_hessian( g = (f1 - f2) / (2 * d) if friction: - eta_h[:,j, :] = (eta1 - eta2) / (2 * d) + eta_h[:, j, :] = (eta1 - eta2) / (2 * d) h[j, :] = g.flatten() f = open("hessian_" + str(j) + ".tmp", "w") From a161f2b123bb1ff5034e3b6dff853034a90783ee Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 15 Jan 2021 18:25:29 +0100 Subject: [PATCH 021/120] black and flake --- ipi/engine/motion/instanton.py | 31 ++++++++++++++++++++----------- 1 file changed, 20 insertions(+), 11 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 5e52a3a66..d17a5dfc6 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -12,6 +12,7 @@ import numpy as np import time import sys +import importlib from ipi.engine.beads import Beads from ipi.engine.normalmodes import NormalModes @@ -19,7 +20,7 @@ from ipi.utils.depend import dstrip, dobject from ipi.utils.softexit import softexit from ipi.utils.messages import verbosity, info -from ipi.utils import units, nmtransform +from ipi.utils import units from ipi.utils.mintools import nichols, Powell, L_BFGS from ipi.utils.instools import ( banded_hessian, @@ -191,18 +192,23 @@ def __init__( self.optarrays["glist"] = glist_lbfgs self.optarrays["d"] = old_direction - if self.options["opt"] == "NR": + if self.options["opt"] == "NR" or self.optimizer["opt"] == "lanczos": info( - "Note that we need scipy to use NR. If storage and diagonalization of the full hessian is not a " + "Note that we need scipy to use NR or lanczos. If storage and diagonalization of the full hessian is not a " "problem use nichols even though it may not be as efficient.", verbosity.low, ) + found = importlib.util.find_spec("scpipy") + if found is None: + softexit.trigger( + "Scipy is required to use NR or lanczos optimization but could not be found" + ) + if self.options["friction"]: - try: - from scipy.interpolate import interp1d - except ImportError: + found = importlib.util.find_spec("scpipy") + if found is None: softexit.trigger( - "Scipy required to use friction in a instanton calculation" + "Scipy is required to use friction in a instanton calculation but could not be found" ) def bind(self, ens, beads, nm, cell, bforce, prng, omaker): @@ -400,7 +406,7 @@ def get_fric_hessian(self, fric_hessian): gq = self.obtain_g(s) gq = np.concatenate((gq, np.flipud(gq)), axis=0) gq_k = self.nm.transform.b2nm(gq) - z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) + z_k = np.multiply(self.nm.get_omegak(), z).reshape(-1, 1) f1 = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] h_fric = np.zeros((ndof, ndof)) @@ -482,7 +488,7 @@ def compute_friction_terms(self): gq = np.concatenate((gq, np.flipud(gq)), axis=0) gq_k = self.nm.transform.b2nm(gq) - z_k = np.multiply(self.nm.get_omegak(), self.z_friction).reshape(-1, 1) + z_k = np.multiply(self.nm.get_omegak(), z).reshape(-1, 1) e_f = (0.5 * z_k * gq_k ** 2).sum() e = np.zeros(self.dbeads.nbeads) @@ -1011,8 +1017,9 @@ def exitstep(self, d_x_max, step): if self.options["friction"]: friction_hessian = current_hessian[1] - phys_hessian = current_hessian[0] - + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( + friction_hessian, 4 + ) print_instanton_hess( self.options["prefix"] + "fric_FINAL", step, @@ -1020,6 +1027,8 @@ def exitstep(self, d_x_max, step): self.output_maker, ) + phys_hessian = current_hessian[0] + else: phys_hessian = current_hessian From 1ce03c2874957c7c5c49de00e9e9c276bb52c5e8 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 15 Jan 2021 19:26:07 +0100 Subject: [PATCH 022/120] fixing broken thinkgs after merge with Json --- ipi/engine/motion/instanton.py | 9 +++++---- 1 file changed, 5 insertions(+), 4 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 5620b6126..cb8bf6edb 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -12,7 +12,7 @@ import numpy as np import time import sys -import importlib +from importlib import util from ipi.engine.beads import Beads from ipi.engine.normalmodes import NormalModes @@ -194,20 +194,21 @@ def __init__( self.optarrays["glist"] = glist_lbfgs self.optarrays["d"] = old_direction - if self.options["opt"] == "NR" or self.optimizer["opt"] == "lanczos": + print(self.options["opt"]) + if self.options["opt"] == "NR" or self.options["opt"] == "lanczos": info( "Note that we need scipy to use NR or lanczos. If storage and diagonalization of the full hessian is not a " "problem use nichols even though it may not be as efficient.", verbosity.low, ) - found = importlib.util.find_spec("scpipy") + found = util.find_spec("scipy") if found is None: softexit.trigger( "Scipy is required to use NR or lanczos optimization but could not be found" ) if self.options["friction"]: - found = importlib.util.find_spec("scpipy") + found = util.find_spec("scipy") if found is None: softexit.trigger( "Scipy is required to use friction in a instanton calculation but could not be found" From 21a9701ae1003067c5e082aaabb8b078f20cdcac Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 15 Jan 2021 20:08:58 +0100 Subject: [PATCH 023/120] All problems after Json merging solved --- ipi/engine/motion/instanton.py | 68 +++++++++++++++++++--------------- 1 file changed, 38 insertions(+), 30 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index cb8bf6edb..75efef04e 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -295,7 +295,7 @@ def save(self, e, g): self.pot = e self.f = -g - def interpolation(self, full_q, full_mspath, get_index=False): + def interpolation(self, full_q, full_mspath, get_all_info=False): """Creates the reduced bead object from which energy and forces will be computed and interpolates the results to the full size """ @@ -340,7 +340,6 @@ def interpolation(self, full_q, full_mspath, get_index=False): rpots = reduced_forces.pots # reduced energy rforces = reduced_forces.f # reduced gradient - if self.spline: red_mspath = full_mspath[indexes] spline = interp1d(red_mspath, rpots.T, kind="cubic") @@ -350,8 +349,8 @@ def interpolation(self, full_q, full_mspath, get_index=False): else: full_pot = rpots full_forces = rforces - if get_index: - return full_pot, full_forces, indexes + if get_all_info: + return full_pot, full_forces, indexes, reduced_forces else: return full_pot, full_forces @@ -361,27 +360,10 @@ def __call__(self, x, new_disc=True): full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) full_pot, full_forces = self.interpolation(full_q, full_mspath) -#ALBERTO[ - diction = {} - for key in reduced_forces.extras[0].listofKeys(): - if str(key) != "nothing": - rkey = np.array(reduced_forces.extras[0][key]) - if self.spline: - red_mspath = full_mspath[indexes] - spline = interp1d(red_mspath, rkey.T, kind="cubic") - full_key = spline(full_mspath).T - else: - full_key = rkey - if reduced_forces.extras[0][key]: - diction[key] = full_key - - full_extras = listDict.fromDict(diction) - if not full_extras: - full_extras = [[] for b in range(self.dbeads.nbeads)] -#ALBERTO] - # This forces the update of the forces and the extras self.dbeads.q[:] = x[:] -#ALBERTO + + full_extras = [[] for b in range(self.dbeads.nbeads)] # ALBERTO + self.dforces.transfer_forces_manual( [full_q], [full_pot], [full_forces], [full_extras] ) @@ -526,16 +508,40 @@ def compute_friction_terms(self): g[i, :] = np.dot(dgdq[i], f[i]) return e, g + def get_full_extras(self, reduced_forces, full_mspath, indexes): + """ Get the full extra strings """ # ALBERTO + diction = {} + for key in reduced_forces.extras[0].listofKeys(): + print("here", key) + if str(key) != "nothing": + rkey = np.array(reduced_forces.extras[0][key]) + if self.spline: + from scipy.interpolate import interp1d + + red_mspath = full_mspath[indexes] + spline = interp1d(red_mspath, rkey.T, kind="cubic") + full_key = spline(full_mspath).T + else: + full_key = rkey + if reduced_forces.extras[0][key]: + diction[key] = full_key + + return listDict.fromDict(diction) + def __call__(self, x, new_disc=True): """ Computes energy and gradient for optimization step""" self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) - full_pot, full_forces, indexes = self.interpolation( - full_q, full_mspath, get_index=True + full_pot, full_forces, indexes, reduced_forces = self.interpolation( + full_q, full_mspath, get_all_info=True ) # The following has to be joined to the json implementation + full_extras = self.get_full_extras(reduced_forces, full_mspath, indexes) + print("CONTINUE HERE") + print(len(full_extras["friction"])) + print(full_extras["friction"][0]) print("\n ALBERTO2 get friction from forces object\n") print("pick only the tensor corresponding to the first RP frequencies") red_eta = 0.01 * np.ones( @@ -552,9 +558,11 @@ def __call__(self, x, new_disc=True): else: full_eta = red_eta - # This forces the update of the forces + # This forces the update of the forces and the extras self.dbeads.q[:] = x[:] - self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) + self.dforces.transfer_forces_manual( + [full_q], [full_pot], [full_forces], [full_extras] + ) self.save(full_pot, -full_forces, full_eta) return self.evaluate() @@ -1123,7 +1131,7 @@ def pre_step(self, step=None, adaptative=False): self.qtime = -time.time() info("\n Instanton optimization STEP {}".format(step), verbosity.low) -#ALBERTO + # ALBERTO # Choosing the forcefield that has returned friction tensor in extras # for k in range(self.forces.nforces): # if self.forces.mforces[k].extras[0]: @@ -1156,7 +1164,7 @@ def pre_step(self, step=None, adaptative=False): # " Friction keyword hasn't been detected in extras. \n Will find the instanton without friction.", # verbosity.low, # ) -#ALBERTO + # ALBERTO activearrays = self.fix.get_active_array(self.optarrays) From 774ad327641be530c150bd7cbec3dcfe25b4c6b9 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 19 Jan 2021 11:06:22 +0100 Subject: [PATCH 024/120] Testing 1 --- drivers/driver.f90 | 61 +++++++++++++++-- drivers/pes/harmonic_bath.f90 | 43 ++++++++++++ ipi/engine/motion/instanton.py | 119 +++++++++++++++++---------------- ipi/utils/hesstools.py | 6 +- ipi/utils/instools.py | 1 + 5 files changed, 165 insertions(+), 65 deletions(-) diff --git a/drivers/driver.f90 b/drivers/driver.f90 index fd7e6045a..f9733ff6e 100644 --- a/drivers/driver.f90 +++ b/drivers/driver.f90 @@ -51,7 +51,7 @@ PROGRAM DRIVER LOGICAL :: isinit=.false., hasdata=.false. INTEGER cbuf, rid CHARACTER(LEN=4096) :: initbuffer ! it's unlikely a string this large will ever be passed... - CHARACTER(LEN=4096) :: string,string2 ! it's unlikely a string this large will ever be passed... + CHARACTER(LEN=4096) :: string,string2,string3 ! it's unlikely a string this large will ever be passed... DOUBLE PRECISION, ALLOCATABLE :: msgbuffer(:) ! PARAMETERS OF THE SYSTEM (CELL, ATOM POSITIONS, ...) @@ -156,11 +156,13 @@ PROGRAM DRIVER vstyle = 24 ELSEIF (trim(cmdbuffer) == "harmonic_bath") THEN vstyle = 26 + ELSEIF (trim(cmdbuffer) == "meanfield_bath") THEN + vstyle = 27 ELSEIF (trim(cmdbuffer) == "gas") THEN vstyle = 0 ! ideal gas ELSE WRITE(*,*) " Unrecognized potential type ", trim(cmdbuffer) - WRITE(*,*) " Use -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4pf-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D|harmonic_bath] " + WRITE(*,*) " Use -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4pf-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D|harmonic_bath|meanfield_bath] " STOP "ENDED" ENDIF ELSEIF (ccmd == 4) THEN @@ -267,6 +269,14 @@ PROGRAM DRIVER END IF vpars(3) = vpars(3) * 4.5563353e-06 !Change omega_c from invcm to a.u. isinit = .true. + ELSEIF (27 == vstyle) THEN !meanfield bath + IF (par_count /= 1) THEN ! defaults values + WRITE(*,*) "Error: parameters not initialized correctly." + WRITE(*,*) "For harmonic meanfield bath use " + STOP "ENDED" + ENDIF + vpars(1) = vpars(1) + isinit = .true. ELSEIF (22 == vstyle) THEN !ljpolymer IF (4/= par_count) THEN WRITE(*,*) "Error: parameters not initialized correctly." @@ -437,7 +447,7 @@ PROGRAM DRIVER ALLOCATE(msgbuffer(3*nat)) ALLOCATE(atoms(nat,3), datoms(nat,3)) ALLOCATE(forces(nat,3)) - ALLOCATE(friction(nat,6)) + ALLOCATE(friction(3*nat,3*nat)) atoms = 0.0d0 datoms = 0.0d0 forces = 0.0d0 @@ -600,6 +610,8 @@ PROGRAM DRIVER CALL geteckart(nat,vpars(1), vpars(2), vpars(3),vpars(4), atoms, pot, forces) ELSEIF (vstyle == 26) THEN ! harmonic_bath. CALL get_harmonic_bath(nat,vpars(1),vpars(2),vpars(3),atoms, pot, forces) + ELSEIF (vstyle == 27) THEN ! meanfield_bath. + CALL get_meanfield_harmonic_bath(nat,vpars(1),atoms, pot, forces,friction) ELSEIF (vstyle == 23) THEN ! MB. IF (nat/=1) THEN WRITE(*,*) "Expecting 1 atom for MB" @@ -672,7 +684,45 @@ PROGRAM DRIVER CALL writebuffer(socket,reshape(virial,(/9/)),9) ! Writing the virial tensor, NOT divided by the volume IF (verbose > 1) WRITE(*,*) " !write!=> strss: ", reshape(virial,(/9/)) - IF (vstyle==24 .or. vstyle==25) THEN ! returns fantasy friction + 125 format(es21.14,a,es21.14,a,es21.14,a,es21.14,a,es21.14,a,es21.14,a) + 126 format(es21.14,a,es21.14,a,es21.14,a,es21.14,a,es21.14,a) + + IF (vstyle == 27) THEN ! returns meanfield friction + WRITE(initbuffer,'(a)') "{" + WRITE(32,'(a)') '{' + WRITE(string,'(a)') '"friction": [' + WRITE(32,'(a)') '"friction": [' + + string2 = TRIM(initbuffer) // TRIM(string) + initbuffer = TRIM(string2) + DO i=1,3*nat + IF(i/=3*nat) THEN + WRITE(string,125) ( friction(i,j), "," , j=1,3*nat) + WRITE(32,125) ( friction(i,j), "," , j=1,3*nat) + ELSE + WRITE(string,126) ( friction(i,j), "," , j=1,3*nat-1) + WRITE(string2,'(es21.14)') friction(i,3*nat) + string3 = TRIM(string) // TRIM(string2) + string = string3 + WRITE(32,126) ( friction(i,j), "," , j=1,3*nat-1) + WRITE(32,'(es21.14)') friction(i,3*nat) + ENDIF + string2 = TRIM(initbuffer) // TRIM(string) + initbuffer = TRIM(string2) + END DO + string = TRIM(initbuffer) // ']}' + initbuffer = TRIM(string) + WRITE(32,'(a)') "]" + WRITE(32,'(a)') "}" + + cbuf = LEN_TRIM(initbuffer) + CALL writebuffer(socket,cbuf) + + IF (verbose > 1) WRITE(*,*) "!write!=> extra_length:", cbuf + CALL writebuffer(socket,initbuffer,cbuf) + IF (verbose > 1) WRITE(*,*) " !write!=> extra: ", initbuffer + + ELSEIF (vstyle==24 .or. vstyle==25) THEN ! returns fantasy friction WRITE(initbuffer,'(a)') "{" WRITE(string, '(a,3x,es21.14,a,es21.14,a,es21.14,& & 3x,a)') '"dipole": [',dip(1),",",dip(2),",",dip(3),"]," @@ -761,7 +811,8 @@ PROGRAM DRIVER CONTAINS SUBROUTINE helpmessage ! Help banner - WRITE(*,*) " SYNTAX: driver.x [-u] -h hostname -p port -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4p-efield|eckart|ch4hcbe|ljpolymer|MB|doublewell|doublewell_1D|harmonic_bath" + WRITE(*,*) " SYNTAX: driver.x [-u] -h hostname -p port -m [gas|lj|sg|harm|harm3d|morse|zundel|qtip4pf|pswater|lepsm1|lepsm2|qtip4p-efield|eckart|ch4hcbe|ljpolymer|..." + WRITE(*,*) "...|MB|doublewell|doublewell_1D|harmonic_bath|meanfield_bath]" WRITE(*,*) " -o 'comma_separated_parameters' [-v] " WRITE(*,*) "" WRITE(*,*) " For LJ potential use -o sigma,epsilon,cutoff " diff --git a/drivers/pes/harmonic_bath.f90 b/drivers/pes/harmonic_bath.f90 index 388163a24..339b2eb85 100644 --- a/drivers/pes/harmonic_bath.f90 +++ b/drivers/pes/harmonic_bath.f90 @@ -12,6 +12,7 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,q,pot,force) real(kind=8) :: q(nat*3),pot,force(nat*3),x(nat*3-1) real(kind=8) :: c(nat*3-1),omega(nat*3-1), omega2(nat*3-1),aux mass = 1837 + pot = 0.0 A = -0.00476705894242374 B = 0.0005980249683218661 @@ -50,3 +51,45 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,q,pot,force) return end + + SUBROUTINE get_meanfield_harmonic_bath(nat,eta,q,pot,force,friction) + IMPLICIT NONE + integer :: nat, i + real(kind=8),PARAMETER :: pi= 3.141592653589793D0 + real(kind=8) :: A,B,k,eta + real(kind=8) :: x,y,z,fx,fy,fz + real(kind=8) :: q(nat,3),pot,force(nat,3) + real(kind=8) :: friction(3*nat,3*nat) + + k = 1836*(3800.0d0/219323d0)**2 + + A = -0.00476705894242374 + B = 0.0005980249683218661 + + DO i = 1,nat + x = q(i,1) + y = q(i,2) + z = q(i,3) + + pot = 0.0 + + pot = pot+ 0.5*k*y**2 + fy = -k*y + pot = pot+ 0.5*k*z**2 + fz = -k*z + + pot = pot + A * (x ** 2) + B * (x ** 4) + + + fx = - ( 2 * A * (x) + 4 * B * (x ** 3) ) + + force(i,1) = fx + force(i,2) = fy + force(i,3) = fz + friction = eta + + ENDDO + + return + end + diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 75efef04e..e99d1a7e8 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -238,8 +238,6 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads) ) - # Binds optimizer - self.optimizer.bind(self) def step(self, step=None): @@ -286,6 +284,10 @@ def bind(self, mapper): else: self.spline = False + def initialize(self,q,forces): + """ Initialize potential and forces """ + self.save(forces.pots, -forces.f) + def set_pos(self, x): """Set the positions """ self.dbeads.q = x @@ -394,7 +396,6 @@ class FrictionMapper(PesMapper): def bind(self, mapper): - self.z_friction = mapper.z_friction super(FrictionMapper, self).bind(mapper) def save(self, e, g, eta=None): @@ -402,7 +403,27 @@ def save(self, e, g, eta=None): super(FrictionMapper, self).save(e, g) self.eta = eta - def get_fric_hessian(self, fric_hessian): + def initialize(self,q,forces): + """ Initialize potential, forces and friction """ + print("\nALBERTO1 get friction from forces object\n") + eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) + for i in range(q.shape[0]): + for ii in range(q.shape[1]): + eta[i, ii, ii] = q[i, ii] + 2 + self.save(forces.pots, -forces.f,eta) + + def set_z_friction(self, z_friction): + """Sets the scaling factors corresponding to frequency dependence of the friction """ + + from scipy.interpolate import interp1d + + freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) + spline = interp1d( + freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False + ) + self.z_friction = spline(self.nm.get_omegak()) # ALBERTO checck frequencies + + def get_fric_rp_hessian(self, fric_hessian): """ Creates the friction hessian from the eta derivatives """ nphys = self.dbeads.natoms * 3 ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 @@ -414,38 +435,38 @@ def get_fric_hessian(self, fric_hessian): gq = np.concatenate((gq, np.flipud(gq)), axis=0) gq_k = self.nm.transform.b2nm(gq) z_k = np.multiply(self.nm.get_omegak(), z).reshape(-1, 1) - f1 = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] + g = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] h_fric = np.zeros((ndof, ndof)) # Block diag: for n in range(self.dbeads.nbeads): - for i in range(nphys): - for ii in range(nphys): - aux = 0 - for iii in range(nphys): + for j in range(nphys): + for k in range(nphys): + aux_jk = 0 + for i in range(nphys): try: - aux += ( + aux_jk += ( 0.5 - * fric_hessian[n, i, ii, iii] - / dgdq[n, ii, iii] - * f1[i, iii] + * g[n, i] + * fric_hessian[n, i,j,k] + / dgdq[n, i, j] ) except: pass - h_fric[nphys * n + i, nphys * n + ii] = aux + h_fric[nphys * n + j, nphys * n + k] = aux_jk # Cross-terms: C = self.nm.transform._b2nm for nl in range(self.dbeads.nbeads): - for ns in range(self.dbeads.nbeads): - for i in range(nphys): - for ii in range(nphys): - prefactor = 0 - for k in range(2 * self.dbeads.nbeads): - prefactor += z_k[k] * C[k, nl] * C[k, ns] - suma = np.sum(s[nl, i, :] * s[ns, ii, :]) - h_fric[nphys * nl + i, nphys * ns + ii] = prefactor * suma + for ne in range(self.dbeads.nbeads): + prefactor = 0 + for alpha in range(2 * self.dbeads.nbeads): + prefactor += C[alpha, nl] * C[alpha, ne] * z_k[alpha] + for j in range(nphys): + for k in range(nphys): + suma = np.sum(s[nl, :, j] * s[ne, :,k]) + h_fric[nphys * nl + j, nphys * ne + k] = prefactor * suma # Alternative cross-term # for nl in range(self.dbeads.nbeads): @@ -499,7 +520,7 @@ def compute_friction_terms(self): e_f = (0.5 * z_k * gq_k ** 2).sum() e = np.zeros(self.dbeads.nbeads) - e[0] = e_f # We can't do a meaningfull bead assigment so we just do one + e[0] = e_f # We can't do a meaningful bead assigment so we just do one f = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] @@ -512,7 +533,7 @@ def get_full_extras(self, reduced_forces, full_mspath, indexes): """ Get the full extra strings """ # ALBERTO diction = {} for key in reduced_forces.extras[0].listofKeys(): - print("here", key) + print("here3", key) if str(key) != "nothing": rkey = np.array(reduced_forces.extras[0][key]) if self.spline: @@ -539,24 +560,15 @@ def __call__(self, x, new_disc=True): # The following has to be joined to the json implementation full_extras = self.get_full_extras(reduced_forces, full_mspath, indexes) - print("CONTINUE HERE") - print(len(full_extras["friction"])) - print(full_extras["friction"][0]) - print("\n ALBERTO2 get friction from forces object\n") - print("pick only the tensor corresponding to the first RP frequencies") - red_eta = 0.01 * np.ones( + full_eta = np.zeros( (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) ) + for n in range(self.dbeads.nbeads): + full_eta[n] = full_extras['friction'][n].reshape(self.dbeads.natoms * 3, self.dbeads.natoms * 3) + + print("ALBERTO pick only the tensor corresponding to the first RP frequencies") + CONTINUE HERE - # Interpolate if necessary to get full pot and forces - if self.spline: - from scipy.interpolate import interp1d - - red_mspath = full_mspath[indexes] - spline = interp1d(red_mspath, red_eta.T, kind="cubic") - full_eta = spline(full_mspath).T - else: - full_eta = red_eta # This forces the update of the forces and the extras self.dbeads.q[:] = x[:] @@ -759,12 +771,8 @@ def __init__(self, esum=False): def initialize(self, q, forces): - print("\nALBERTO1 get friction from forces object\n") - eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) - for i in range(q.shape[0]): - for ii in range(q.shape[1]): - eta[i, ii, ii] = q[i, ii] + 2 - self.gm.save(forces.pots, -forces.f, eta) + self.gm.initialize(q,forces) + e1, g1 = self.gm.evaluate() e2, g2 = self.sm(q) @@ -795,27 +803,20 @@ def bind(self, dumop): self.set_coef(self.options["discretization"]) self.friction = self.options["friction"] + if self.friction: - self.set_z_friction(self.options["z_friction"]) self.gm = FrictionMapper() - + self.gm.bind(self) + self.gm.set_z_friction(dumop.options["z_friction"]) + else: + self.gm.bind(self) + self.sm.bind(self) - self.gm.bind(self) def set_coef(self, coef): """ Sets coeficients for non-uniform instanton calculation """ self.coef[:] = coef.reshape(-1, 1) - def set_z_friction(self, z_friction): - """Sets the scaling factors corresponding to frequency dependence of the friction """ - - from scipy.interpolate import interp1d - - freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) - spline = interp1d( - freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False - ) - self.z_friction = spline(self.nm.get_omegak()) # ALBERTO checck frequencies def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -1418,7 +1419,7 @@ def step(self, step=None): # Add friction terms to the hessian if self.options["friction"]: - h_fric = self.mapper.gm.get_fric_hessian(activearrays["fric_hessian"]) + h_fric = self.mapper.gm.get_fric_rp_hessian(activearrays["fric_hessian"]) h = np.add(h, h_fric) # Get eigenvalues and eigenvector. diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 7fab5af66..2f5dfd1d2 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -263,7 +263,7 @@ def get_hessian( g = (f1 - f2) / (2 * d) if friction: - eta_h[:, j, :] = (eta1 - eta2) / (2 * d) + eta_h[:, :, :, j] = (eta1 - eta2) / (2 * d) h[j, :] = g.flatten() f = open("hessian_" + str(j) + ".tmp", "w") @@ -279,6 +279,10 @@ def get_hessian( for i in range(ii): try: os.remove("hessianEta_" + str(i) + ".tmp") + except OSError: + pass + + try: os.remove("hessian_" + str(i) + ".tmp") except OSError: pass diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index a08f7f8ad..8027fa799 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -238,6 +238,7 @@ def print_instanton_geo( # print_file("xyz", pos[0], cell, out, title='positions{angstrom}') unit = "angstrom" + unit = "atomic_unit" unit2 = "atomic_unit" a, b, c, alpha, beta, gamma = mt.h2abc_deg(cell.h) From 4b5bd45bfb5017313891e64a6ef6c42e760d633a Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 19 Jan 2021 15:11:26 +0100 Subject: [PATCH 025/120] testing 2 --- ipi/engine/motion/instanton.py | 51 ++++------------------------------ 1 file changed, 6 insertions(+), 45 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index e99d1a7e8..c9d9b4bbf 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -405,11 +405,7 @@ def save(self, e, g, eta=None): def initialize(self,q,forces): """ Initialize potential, forces and friction """ - print("\nALBERTO1 get friction from forces object\n") - eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) - for i in range(q.shape[0]): - for ii in range(q.shape[1]): - eta[i, ii, ii] = q[i, ii] + 2 + eta = np.array(forces.extras[0]["friction"]).reshape((q.shape[0], q.shape[1], q.shape[1])) self.save(forces.pots, -forces.f,eta) def set_z_friction(self, z_friction): @@ -421,7 +417,9 @@ def set_z_friction(self, z_friction): spline = interp1d( freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False ) - self.z_friction = spline(self.nm.get_omegak()) # ALBERTO checck frequencies + self.z_friction = spline(self.nm.get_omegak()) + + info(units.unit_to_user("frequency", "inversecm", self.nm.get_omegak()),verbosity.debug) def get_fric_rp_hessian(self, fric_hessian): """ Creates the friction hessian from the eta derivatives """ @@ -530,10 +528,9 @@ def compute_friction_terms(self): return e, g def get_full_extras(self, reduced_forces, full_mspath, indexes): - """ Get the full extra strings """ # ALBERTO + """ Get the full extra strings """ diction = {} for key in reduced_forces.extras[0].listofKeys(): - print("here3", key) if str(key) != "nothing": rkey = np.array(reduced_forces.extras[0][key]) if self.spline: @@ -566,9 +563,7 @@ def __call__(self, x, new_disc=True): for n in range(self.dbeads.nbeads): full_eta[n] = full_extras['friction'][n].reshape(self.dbeads.natoms * 3, self.dbeads.natoms * 3) - print("ALBERTO pick only the tensor corresponding to the first RP frequencies") - CONTINUE HERE - + info("We expect friction tensor evaluated at the first RP frequency",verbosity.debug) # This forces the update of the forces and the extras self.dbeads.q[:] = x[:] @@ -1132,40 +1127,6 @@ def pre_step(self, step=None, adaptative=False): self.qtime = -time.time() info("\n Instanton optimization STEP {}".format(step), verbosity.low) - # ALBERTO - # Choosing the forcefield that has returned friction tensor in extras - # for k in range(self.forces.nforces): - # if self.forces.mforces[k].extras[0]: - # if "friction" in self.forces.mforces[k].extras[0].keys(): - # extras = self.forces.mforces[k].extras - # self.friction = np.zeros((self.beads.nbeads, self.beads.natoms, 6)) - # for b in range(self.beads.nbeads): - # if "friction" in extras[b].keys(): - # for at in range(self.beads.natoms): - # self.friction[b, at, :] = extras[b]["friction"][ - # 6 * at : 6 * (at + 1) - # ] - # info( - # "FRICTION: {} {} {} {} {} {}".format( - # self.friction[b, at, 0], - # self.friction[b, at, 1], - # self.friction[b, at, 2], - # self.friction[b, at, 3], - # self.friction[b, at, 4], - # self.friction[b, at, 5], - # ), - # verbosity.debug, - # ) - # info( - # " Friction keyword detected in extras. \n Will find the instanton with friction.", - # verbosity.low, - # ) - # else: - # info( - # " Friction keyword hasn't been detected in extras. \n Will find the instanton without friction.", - # verbosity.low, - # ) - # ALBERTO activearrays = self.fix.get_active_array(self.optarrays) From a91de303562212b7a72f6db6ed4b05a502699ddb Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 22 Jan 2021 16:50:13 +0100 Subject: [PATCH 026/120] linear case working fine --- drivers/pes/harmonic_bath.f90 | 4 +- ipi/engine/motion/instanton.py | 297 ++++++++++++++++++++++----------- ipi/utils/mintools.py | 7 +- 3 files changed, 203 insertions(+), 105 deletions(-) diff --git a/drivers/pes/harmonic_bath.f90 b/drivers/pes/harmonic_bath.f90 index 339b2eb85..b4efdcb38 100644 --- a/drivers/pes/harmonic_bath.f90 +++ b/drivers/pes/harmonic_bath.f90 @@ -86,7 +86,9 @@ SUBROUTINE get_meanfield_harmonic_bath(nat,eta,q,pot,force,friction) force(i,1) = fx force(i,2) = fy force(i,3) = fz - friction = eta + friction(nat*3*(i-1)+1,nat*3*(i-1)+1) = eta + friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = eta + friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = eta ENDDO diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index c9d9b4bbf..0fbc15419 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -10,6 +10,8 @@ import numpy as np + +np.set_printoptions(suppress=True, linewidth=1000) import time import sys from importlib import util @@ -228,15 +230,18 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): super(InstantonMotion, self).bind(ens, beads, nm, cell, bforce, prng, omaker) # Redefine normal modes - self.nm = NormalModes(transform_method="matrix") + self.nm = NormalModes( + transform_method="matrix", open_paths=np.arange(self.beads.natoms) + ) + # self.nm = NormalModes(transform_method="matrix") + print("ALBERTO") + print("ALBERTO") + print("ALBERTO") + self.nm.bind(self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads)) if self.options["mode"] == "rate": - self.nm.bind( - self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads * 2) - ) + self.omegan = self.nm.omegan * 2 # ALBERTO, replace this by RP factor elif self.options["mode"] == "splitting": - self.nm.bind( - self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads) - ) + self.omegan = self.nm.omegan self.optimizer.bind(self) @@ -264,6 +269,7 @@ def bind(self, mapper): self.dcell = mapper.cell.copy() self.dforces = mapper.forces.copy(self.dbeads, self.dcell) self.nm = mapper.nm + self.omegan = mapper.omegan self.fix = mapper.fix self.coef = mapper.coef @@ -284,9 +290,9 @@ def bind(self, mapper): else: self.spline = False - def initialize(self,q,forces): + def initialize(self, q, forces): """ Initialize potential and forces """ - self.save(forces.pots, -forces.f) + self.save(forces.pots, -forces.f) def set_pos(self, x): """Set the positions """ @@ -364,11 +370,9 @@ def __call__(self, x, new_disc=True): full_pot, full_forces = self.interpolation(full_q, full_mspath) self.dbeads.q[:] = x[:] - full_extras = [[] for b in range(self.dbeads.nbeads)] # ALBERTO + # full_extras = [[] for b in range(self.dbeads.nbeads)] # ALBERTO - self.dforces.transfer_forces_manual( - [full_q], [full_pot], [full_forces], [full_extras] - ) + self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) info("UPDATE of forces and extras", verbosity.debug) self.save(full_pot, -full_forces) @@ -403,11 +407,13 @@ def save(self, e, g, eta=None): super(FrictionMapper, self).save(e, g) self.eta = eta - def initialize(self,q,forces): + def initialize(self, q, forces): """ Initialize potential, forces and friction """ - eta = np.array(forces.extras[0]["friction"]).reshape((q.shape[0], q.shape[1], q.shape[1])) - self.save(forces.pots, -forces.f,eta) - + eta = np.array(forces.extras[0]["friction"]).reshape( + (q.shape[0], q.shape[1], q.shape[1]) + ) + self.save(forces.pots, -forces.f, eta) + def set_z_friction(self, z_friction): """Sets the scaling factors corresponding to frequency dependence of the friction """ @@ -417,45 +423,99 @@ def set_z_friction(self, z_friction): spline = interp1d( freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False ) - self.z_friction = spline(self.nm.get_omegak()) - info(units.unit_to_user("frequency", "inversecm", self.nm.get_omegak()),verbosity.debug) + C = self.nm.transform._b2o_nm + new_omegak = 2*self.nm.get_o_omegak() + new_omegak2 = new_omegak**2 + + self.z_friction = spline(new_omegak) + info(units.unit_to_user("frequency", "inversecm", new_omegak), verbosity.debug) def get_fric_rp_hessian(self, fric_hessian): """ Creates the friction hessian from the eta derivatives """ nphys = self.dbeads.natoms * 3 ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 + nbeads = self.dbeads.nbeads + + C = self.nm.transform._b2o_nm + new_omegak = 2*self.nm.get_o_omegak() + new_omegak2 = new_omegak**2 + + z = self.z_friction / self.z_friction[1] + + s = self.eta + dgdq = s ** 0.5 + gq = self.obtain_g(s) + + z_k = np.multiply(new_omegak, z)[:,np.newaxis] + #factor = self.dbeads.m3[0, 0] / 1.674 # ALBERTO + #z_k_springs = factor * new_omegak2[:, np.newaxis] # ALBERTO + #z_k = z_k_1 + z_k_springs + + h_fric = np.zeros((ndof, ndof)) + + for nl in range(self.dbeads.nbeads): + for ne in range(self.dbeads.nbeads): + prefactor = 0 + for alpha in range(self.dbeads.nbeads): + prefactor += C[alpha, nl] * C[alpha, ne] * z_k[alpha] + for j in range(nphys): + for k in range(nphys): + suma = np.sum(dgdq[nl, :, j] * dgdq[ne, :, k]) + h_fric[nphys * nl + j, nphys * ne + k] = prefactor * suma + + return h_fric + + def get_fric_rp_hessian_old(self, fric_hessian): + """ Creates the friction hessian from the eta derivatives """ + nphys = self.dbeads.natoms * 3 + ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 z = self.z_friction / self.z_friction[1] s = self.eta dgdq = s ** 0.5 gq = self.obtain_g(s) gq = np.concatenate((gq, np.flipud(gq)), axis=0) + gq_k = self.nm.transform.b2nm(gq) + z_k = np.multiply(self.nm.get_omegak(), z).reshape(-1, 1) - g = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] + # z_k = (self.nm.get_omegak()**2).reshape(-1,1) #ALBERTO h_fric = np.zeros((ndof, ndof)) + # Block diag: + active_beads = np.concatenate( + ( + np.arange(self.dbeads.nbeads // 2), + -np.flip(np.arange(1, self.dbeads.nbeads // 2 + 1)), + ) + ) + g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] for n in range(self.dbeads.nbeads): for j in range(nphys): for k in range(nphys): aux_jk = 0 for i in range(nphys): - try: + if dgdq[n, i, j] != 0: aux_jk += ( - 0.5 - * g[n, i] - * fric_hessian[n, i,j,k] - / dgdq[n, i, j] + 0.5 * g[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] ) - except: - pass h_fric[nphys * n + j, nphys * n + k] = aux_jk - # Cross-terms: + print("here1", np.amax(h_fric)) + print("here2", np.amin(h_fric)) + # Cross-terms: C = self.nm.transform._b2nm + + # ALBERTO + # nbeads = self.dbeads.nbeads + # from ipi.utils import nmtransform + # new_nm=nmtransform.nm_trans(2*nbeads,open_paths=np.arange(2*nbeads)) + # C = new_nm._b2nm + # ALBERTO + for nl in range(self.dbeads.nbeads): for ne in range(self.dbeads.nbeads): prefactor = 0 @@ -463,21 +523,24 @@ def get_fric_rp_hessian(self, fric_hessian): prefactor += C[alpha, nl] * C[alpha, ne] * z_k[alpha] for j in range(nphys): for k in range(nphys): - suma = np.sum(s[nl, :, j] * s[ne, :,k]) + suma = np.sum(dgdq[nl, :, j] * dgdq[ne, :, k]) h_fric[nphys * nl + j, nphys * ne + k] = prefactor * suma + # print('CONTINUE HERE Try to reproduce the block hessian') - # Alternative cross-term - # for nl in range(self.dbeads.nbeads): - # for ns in range(self.dbeads.nbeads): - # delta_bead= np.zeros((2*self.dbeads.nbeads,nphys)) - # delta_bead[ns]=1.0 - # delta_ks = self.nm.transform.b2nm(delta_bead) - # prefactor = self.nm.transform.nm2b(z_k * delta_ks)[: self.dbeads.nbeads, :][nl] - # for i in range(nphys): - # for ii in range(nphys): - # h_fric[nphys*nl+i,nphys*ns:nphys*(ns+1)] = prefactor *np.dot(s[nl,i,:],s[ns,ii,:].T) - + # ALBERTO TEST HESSIAN at least for linear case!! + # Test ALBERTO + print("here3", np.amax(h_fric)) + print("here4", np.amin(h_fric)) + for i in range(nphys): + for j in range(nphys): + h = np.zeros(self.dbeads.nbeads) + for n1 in range(self.dbeads.nbeads): + h[n1] = h_fric[nphys * n1 + i, nphys * n1 + j] + h2 = np.concatenate((h, np.flipud(h)), axis=0) + # diag = self.nm.transform.b2nm(h2.reshape(-1,1)) + # print(i,j,h2) return h_fric + # return np.zeros(h_fric.shape) #ALBERTO def obtain_g(self, s): """ Computes g from s """ @@ -487,16 +550,18 @@ def obtain_g(self, s): q = self.dbeads.q.copy() gq = np.zeros(self.dbeads.q.copy().shape) - for nd in range(1, 3 * self.dbeads.natoms): + for nd in range(3 * self.dbeads.natoms): try: spline = interp1d( - q[:, nd], np.diag(ss[:, nd, nd], kind="cubic") + q[:, nd], ss[:, nd, nd], kind="cubic" ) # spline for each dof - for nb in range(self.dbeads.nbeads): - gq[nb, nd] = quad( - spline, q[0, nd], q[nb, nd] - ) # Cumulative integral along the path for each dof - except: + for nb in range(1, self.dbeads.nbeads): + gq[nb, nd] = quad(spline, q[0, nd], q[nb, nd])[ + 0 + ] # Cumulative integral along the path for each dof + # for i in range(self.dbeads.nbeads): + # print(q[i, nd],q[i,nd],ss[i, nd, nd],gq[i, nd]) + except ValueError: gq[:, nd] = 0 return gq @@ -504,31 +569,37 @@ def obtain_g(self, s): def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ - z = self.z_friction / self.z_friction[1] + z = self.z_friction / self.z_friction[1] #ALBERTO: DO IT ONLY ONCE + s = self.eta dgdq = s ** 0.5 - gq = self.obtain_g(s) - if gq.shape != self.dbeads.q.shape: - raise ValueError("\nproblem here\n") - gq = np.concatenate((gq, np.flipud(gq)), axis=0) - gq_k = self.nm.transform.b2nm(gq) - z_k = np.multiply(self.nm.get_omegak(), z).reshape(-1, 1) + C = self.nm.transform._b2o_nm + new_omegak = 2*self.nm.get_o_omegak() + new_omegak2 = new_omegak**2 + + z_k = np.multiply(new_omegak, z)[:,np.newaxis] + #factor = self.dbeads.m3[0] / 1.674 # ALBERTO + #z_k_spring = factor * new_omegak2[:, np.newaxis] #ALBERTO + #z_k = z_k + z_k_spring + + + - e_f = (0.5 * z_k * gq_k ** 2).sum() - e = np.zeros(self.dbeads.nbeads) - e[0] = e_f # We can't do a meaningful bead assigment so we just do one + gq_k = np.dot(C, gq) * z_k - f = self.nm.transform.nm2b(z_k * gq_k)[: self.dbeads.nbeads, :] + e = 0.5 * np.sum(gq_k ** 2) + f = np.dot(C.T, gq_k) g = np.zeros(f.shape) for i in range(self.dbeads.nbeads): g[i, :] = np.dot(dgdq[i], f[i]) + return e, g def get_full_extras(self, reduced_forces, full_mspath, indexes): - """ Get the full extra strings """ + """ Get the full extra strings """ diction = {} for key in reduced_forces.extras[0].listofKeys(): if str(key) != "nothing": @@ -561,9 +632,14 @@ def __call__(self, x, new_disc=True): (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) ) for n in range(self.dbeads.nbeads): - full_eta[n] = full_extras['friction'][n].reshape(self.dbeads.natoms * 3, self.dbeads.natoms * 3) - - info("We expect friction tensor evaluated at the first RP frequency",verbosity.debug) + full_eta[n] = full_extras["friction"][n].reshape( + self.dbeads.natoms * 3, self.dbeads.natoms * 3 + ) + + info( + "We expect friction tensor evaluated at the first RP frequency", + verbosity.debug, + ) # This forces the update of the forces and the extras self.dbeads.q[:] = x[:] @@ -585,6 +661,8 @@ def evaluate(self): e_friction, g_friction = self.compute_friction_terms() e += e_friction g += g_friction + # print('g_friction') + # print(g_friction) e = e * (self.coef[1:] + self.coef[:-1]) / 2 g = g * (self.coef[1:] + self.coef[:-1]) / 2 @@ -610,8 +688,8 @@ def bind(self, mapper): self.coef = mapper.coef self.dbeads = mapper.beads.copy() self.nm = mapper.nm - - self.omega2 = self.nm.omegan2 + self.omegan = mapper.omegan + self.omegan2 = self.omegan ** 2 # Computes the spring hessian if the optimization modes requires it if ( @@ -623,7 +701,7 @@ def bind(self, mapper): natoms=self.fix.fixbeads.natoms, nbeads=self.fix.fixbeads.nbeads, m3=self.fix.fixbeads.m3[0], - omega2=self.omega2, + omega2=self.omegan2, coef=self.coef, ) @@ -658,37 +736,49 @@ def __call__(self, x, ret=True, new_disc=True): # dq = self.dbeads.q[i + 1, :] - self.dbeads.q[i, :] # e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) # for i in range(0, self.dbeads.nbeads - 1): + # #g[i, :] += self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i + 1, :]) # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i + 1, :]) # for i in range(1, self.dbeads.nbeads): + # #g[i, :] += self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) + C = self.nm.transform._b2o_nm + omegak = 2*self.nm.get_o_omegak() + omegak2 = omegak**2 + + gq_k = np.dot(C, self.dbeads.q) + g = self.dbeads.m3[0]*np.dot(C.T,gq_k*omegak2[:, np.newaxis]) + # With new discretization - for i in range(self.dbeads.nbeads - 1): - dq = (self.dbeads.q[i + 1, :] - self.dbeads.q[i, :]) / np.sqrt( - coef[i + 1] - ) # coef[0] and coef[-1] do not enter - e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) - for i in range(0, self.dbeads.nbeads - 1): - g[i, :] += ( - self.dbeads.m3[i, :] - * self.omega2 - * ( - self.dbeads.q[i, :] / coef[i + 1] - - self.dbeads.q[i + 1, :] / coef[i + 1] + if False: # ALBERTO + for i in range(self.dbeads.nbeads - 1): + dq = (self.dbeads.q[i + 1, :] - self.dbeads.q[i, :]) / np.sqrt( + coef[i + 1] + ) # coef[0] and coef[-1] do not enter + e += self.omega2 * 0.5 * np.dot(self.dbeads.m3[0] * dq, dq) + for i in range(0, self.dbeads.nbeads - 1): + g[i, :] += ( + self.dbeads.m3[i, :] + * self.omega2 + * ( + self.dbeads.q[i, :] / coef[i + 1] + - self.dbeads.q[i + 1, :] / coef[i + 1] + ) ) - ) - for i in range(1, self.dbeads.nbeads): - g[i, :] += ( - self.dbeads.m3[i, :] - * self.omega2 - * ( - self.dbeads.q[i, :] / coef[i] - - self.dbeads.q[i - 1, :] / coef[i] + for i in range(1, self.dbeads.nbeads): + g[i, :] += ( + self.dbeads.m3[i, :] + * self.omega2 + * ( + self.dbeads.q[i, :] / coef[i] + - self.dbeads.q[i - 1, :] / coef[i] + ) ) - ) self.save(e, g) + # print('g_spring') + # print(g) if ret: return e, g @@ -766,13 +856,17 @@ def __init__(self, esum=False): def initialize(self, q, forces): - self.gm.initialize(q,forces) + self.gm.initialize(q, forces) + e1, g1 = self.gm.evaluate() e2, g2 = self.sm(q) - g = self.fix.get_active_vector(g1 + g2, 1) e = np.sum(e1 + e2) + #print('DEBUG') + #e1, g1 = self.gm.evaluate() + #g = self.fix.get_active_vector(g1, 1) + #e = np.sum(e1) self.save(e, g) @@ -787,6 +881,7 @@ def bind(self, dumop): self.forces = dumop.forces self.cell = dumop.cell self.nm = dumop.nm + self.omegan = dumop.omegan self.fixatoms = dumop.fixatoms self.fix = dumop.fix @@ -805,21 +900,25 @@ def bind(self, dumop): self.gm.set_z_friction(dumop.options["z_friction"]) else: self.gm.bind(self) - + self.sm.bind(self) def set_coef(self, coef): """ Sets coeficients for non-uniform instanton calculation """ self.coef[:] = coef.reshape(-1, 1) - def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): if mode == "all": + e1, g1 = self.sm(x, new_disc) e2, g2 = self.gm(x, new_disc) e = e1 + e2 g = np.add(g1, g2) + #print('DEBUG') + #e2, g2 = self.gm(x, new_disc) + #e = e2 + #g = g2 elif mode == "physical": e, g = self.gm(x, new_disc) @@ -870,6 +969,7 @@ def bind(self, geop): self.fix = Fix(self.fixatoms, self.beads, self.beads.nbeads) self.nm = geop.nm + self.omegan = geop.omegan self.output_maker = geop.output_maker @@ -1276,6 +1376,7 @@ def initialize(self, step): else: phys_hessian = active_hessian + print("Check phys_hessian") self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) self.update_old_pos_for() @@ -1377,6 +1478,8 @@ def step(self, step=None): # Add spring terms to the physical hessian h = np.add(self.mapper.sm.h, h0) + #print("DEBUG") + #h = h0 # Add friction terms to the hessian if self.options["friction"]: @@ -1421,14 +1524,9 @@ def step(self, step=None): # Find new movement direction if self.options["mode"] == "rate": - f = ( - activearrays["old_f"] - * (self.mapper.coef[1:] + self.mapper.coef[:-1]) - / 2 - ) + d_x = nichols( - f, - self.mapper.sm.f, + self.mapper.f, d, w, self.fix.fixbeads.m3, @@ -1436,11 +1534,10 @@ def step(self, step=None): ) elif self.options["mode"] == "splitting": d_x = nichols( - activearrays["old_f"], - self.mapper.sm.f, + self.mapper.f, d, w, - self.mapper.sm.dbeads.m3, + self.fix.fixbeads.m3, activearrays["big_step"], mode=0, ) diff --git a/ipi/utils/mintools.py b/ipi/utils/mintools.py index f2acff02a..e77db661c 100644 --- a/ipi/utils/mintools.py +++ b/ipi/utils/mintools.py @@ -1319,10 +1319,9 @@ def L_BFGS_nls( return (x, fx, xi, qlist, glist) -def nichols(f0, f1, d, dynmax, m3, big_step, mode=1): +def nichols(f0, d, dynmax, m3, big_step, mode=1): """Find new movement direction. JCP 92,340 (1990) - IN f0 = physical forces (n,) - f1 = spring forces + IN f = physical + spring forces (n,) d = dynmax eigenvalues dynmax = dynmax (n-m x n-m) with m = # external modes m3 = mass vector @@ -1342,7 +1341,7 @@ def nichols(f0, f1, d, dynmax, m3, big_step, mode=1): # Resize ndim = f0.size shape = f0.shape - f = (f0 + f1).reshape((1, ndim)) / m3.reshape( + f = f0.reshape((1, ndim)) / m3.reshape( (1, ndim) ) ** 0.5 # From cartesian base to mass-weighted base From bbc43eb93a7f011d0ce35a719f81be4ad41b4a56 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 22 Jan 2021 17:03:51 +0100 Subject: [PATCH 027/120] define rp_factor --- ipi/engine/motion/instanton.py | 15 +++++++-------- 1 file changed, 7 insertions(+), 8 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 0fbc15419..a34d15f80 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -239,9 +239,9 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): print("ALBERTO") self.nm.bind(self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads)) if self.options["mode"] == "rate": - self.omegan = self.nm.omegan * 2 # ALBERTO, replace this by RP factor + self.rp_factor = 2 elif self.options["mode"] == "splitting": - self.omegan = self.nm.omegan + self.rp_factor = 1 self.optimizer.bind(self) @@ -269,7 +269,7 @@ def bind(self, mapper): self.dcell = mapper.cell.copy() self.dforces = mapper.forces.copy(self.dbeads, self.dcell) self.nm = mapper.nm - self.omegan = mapper.omegan + self.rp_factor = mapper.rp_factor self.fix = mapper.fix self.coef = mapper.coef @@ -688,8 +688,7 @@ def bind(self, mapper): self.coef = mapper.coef self.dbeads = mapper.beads.copy() self.nm = mapper.nm - self.omegan = mapper.omegan - self.omegan2 = self.omegan ** 2 + self.rp_factor = mapper.rp_factor # Computes the spring hessian if the optimization modes requires it if ( @@ -701,7 +700,7 @@ def bind(self, mapper): natoms=self.fix.fixbeads.natoms, nbeads=self.fix.fixbeads.nbeads, m3=self.fix.fixbeads.m3[0], - omega2=self.omegan2, + omega2=(self.rp_factor*self.nm.omegan)**2, coef=self.coef, ) @@ -881,7 +880,7 @@ def bind(self, dumop): self.forces = dumop.forces self.cell = dumop.cell self.nm = dumop.nm - self.omegan = dumop.omegan + self.rp_factor = dumop.rp_factor self.fixatoms = dumop.fixatoms self.fix = dumop.fix @@ -969,7 +968,7 @@ def bind(self, geop): self.fix = Fix(self.fixatoms, self.beads, self.beads.nbeads) self.nm = geop.nm - self.omegan = geop.omegan + self.rp_factor = geop.rp_factor self.output_maker = geop.output_maker From c01830776a43bf2135388f81529d73bbfc9fdf31 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 22 Jan 2021 17:19:47 +0100 Subject: [PATCH 028/120] some cleaning --- ipi/engine/motion/instanton.py | 191 ++++++++++----------------------- 1 file changed, 59 insertions(+), 132 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index a34d15f80..44e20d725 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -239,7 +239,7 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): print("ALBERTO") self.nm.bind(self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads)) if self.options["mode"] == "rate": - self.rp_factor = 2 + self.rp_factor = 2 elif self.options["mode"] == "splitting": self.rp_factor = 1 @@ -268,8 +268,12 @@ def bind(self, mapper): self.dbeads = mapper.beads.copy() self.dcell = mapper.cell.copy() self.dforces = mapper.forces.copy(self.dbeads, self.dcell) - self.nm = mapper.nm - self.rp_factor = mapper.rp_factor + + # self.nm = mapper.nm + # self.rp_factor = mapper.rp_factor + self.C = mapper.nm.transform._b2o_nm + self.omegak = mapper.rp_factor * mapper.nm.get_o_omegak() + self.fix = mapper.fix self.coef = mapper.coef @@ -370,8 +374,6 @@ def __call__(self, x, new_disc=True): full_pot, full_forces = self.interpolation(full_q, full_mspath) self.dbeads.q[:] = x[:] - # full_extras = [[] for b in range(self.dbeads.nbeads)] # ALBERTO - self.dforces.transfer_forces_manual([full_q], [full_pot], [full_forces]) info("UPDATE of forces and extras", verbosity.debug) @@ -424,123 +426,56 @@ def set_z_friction(self, z_friction): freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False ) - C = self.nm.transform._b2o_nm - new_omegak = 2*self.nm.get_o_omegak() - new_omegak2 = new_omegak**2 - - self.z_friction = spline(new_omegak) - info(units.unit_to_user("frequency", "inversecm", new_omegak), verbosity.debug) + z_friction = spline(self.omegak) + self.z_friction = z_friction / z_friction[1] #UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY + + info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) def get_fric_rp_hessian(self, fric_hessian): """ Creates the friction hessian from the eta derivatives """ - nphys = self.dbeads.natoms * 3 - ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 - nbeads = self.dbeads.nbeads - - C = self.nm.transform._b2o_nm - new_omegak = 2*self.nm.get_o_omegak() - new_omegak2 = new_omegak**2 - - z = self.z_friction / self.z_friction[1] - - s = self.eta - dgdq = s ** 0.5 - gq = self.obtain_g(s) - - z_k = np.multiply(new_omegak, z)[:,np.newaxis] - #factor = self.dbeads.m3[0, 0] / 1.674 # ALBERTO - #z_k_springs = factor * new_omegak2[:, np.newaxis] # ALBERTO - #z_k = z_k_1 + z_k_springs - - h_fric = np.zeros((ndof, ndof)) - for nl in range(self.dbeads.nbeads): - for ne in range(self.dbeads.nbeads): - prefactor = 0 - for alpha in range(self.dbeads.nbeads): - prefactor += C[alpha, nl] * C[alpha, ne] * z_k[alpha] - for j in range(nphys): - for k in range(nphys): - suma = np.sum(dgdq[nl, :, j] * dgdq[ne, :, k]) - h_fric[nphys * nl + j, nphys * ne + k] = prefactor * suma - - return h_fric - - def get_fric_rp_hessian_old(self, fric_hessian): - """ Creates the friction hessian from the eta derivatives """ nphys = self.dbeads.natoms * 3 ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 + nbeads = self.dbeads.nbeads - z = self.z_friction / self.z_friction[1] s = self.eta dgdq = s ** 0.5 gq = self.obtain_g(s) - gq = np.concatenate((gq, np.flipud(gq)), axis=0) - gq_k = self.nm.transform.b2nm(gq) - - z_k = np.multiply(self.nm.get_omegak(), z).reshape(-1, 1) - # z_k = (self.nm.get_omegak()**2).reshape(-1,1) #ALBERTO + z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] + # factor = self.dbeads.m3[0, 0] / 1.674 # DEBUG + # z_k_springs = factor * new_omegak2[:, np.newaxis] # DEBUG + # z_k = z_k_1 + z_k_springs h_fric = np.zeros((ndof, ndof)) + #ALBERTO # Block diag: - active_beads = np.concatenate( - ( - np.arange(self.dbeads.nbeads // 2), - -np.flip(np.arange(1, self.dbeads.nbeads // 2 + 1)), - ) - ) - g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] - for n in range(self.dbeads.nbeads): - for j in range(nphys): - for k in range(nphys): - aux_jk = 0 - for i in range(nphys): - if dgdq[n, i, j] != 0: - aux_jk += ( - 0.5 * g[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] - ) - h_fric[nphys * n + j, nphys * n + k] = aux_jk - - print("here1", np.amax(h_fric)) - print("here2", np.amin(h_fric)) + #g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] + #for n in range(self.dbeads.nbeads): + # for j in range(nphys): + # for k in range(nphys): + # aux_jk = 0 + # for i in range(nphys): + # if dgdq[n, i, j] != 0: + # aux_jk += ( + # 0.5 * g[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] + # ) + # h_fric[nphys * n + j, nphys * n + k] = aux_jk + #ALBERTO # Cross-terms: - C = self.nm.transform._b2nm - - # ALBERTO - # nbeads = self.dbeads.nbeads - # from ipi.utils import nmtransform - # new_nm=nmtransform.nm_trans(2*nbeads,open_paths=np.arange(2*nbeads)) - # C = new_nm._b2nm - # ALBERTO - for nl in range(self.dbeads.nbeads): for ne in range(self.dbeads.nbeads): prefactor = 0 - for alpha in range(2 * self.dbeads.nbeads): - prefactor += C[alpha, nl] * C[alpha, ne] * z_k[alpha] + for alpha in range(self.dbeads.nbeads): + prefactor += self.C[alpha, nl] * self.C[alpha, ne] * z_k[alpha] for j in range(nphys): for k in range(nphys): suma = np.sum(dgdq[nl, :, j] * dgdq[ne, :, k]) h_fric[nphys * nl + j, nphys * ne + k] = prefactor * suma - # print('CONTINUE HERE Try to reproduce the block hessian') - - # ALBERTO TEST HESSIAN at least for linear case!! - # Test ALBERTO - print("here3", np.amax(h_fric)) - print("here4", np.amin(h_fric)) - for i in range(nphys): - for j in range(nphys): - h = np.zeros(self.dbeads.nbeads) - for n1 in range(self.dbeads.nbeads): - h[n1] = h_fric[nphys * n1 + i, nphys * n1 + j] - h2 = np.concatenate((h, np.flipud(h)), axis=0) - # diag = self.nm.transform.b2nm(h2.reshape(-1,1)) - # print(i,j,h2) + return h_fric - # return np.zeros(h_fric.shape) #ALBERTO def obtain_g(self, s): """ Computes g from s """ @@ -569,29 +504,21 @@ def obtain_g(self, s): def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ - z = self.z_friction / self.z_friction[1] #ALBERTO: DO IT ONLY ONCE s = self.eta dgdq = s ** 0.5 gq = self.obtain_g(s) - C = self.nm.transform._b2o_nm - new_omegak = 2*self.nm.get_o_omegak() - new_omegak2 = new_omegak**2 - - z_k = np.multiply(new_omegak, z)[:,np.newaxis] - #factor = self.dbeads.m3[0] / 1.674 # ALBERTO - #z_k_spring = factor * new_omegak2[:, np.newaxis] #ALBERTO - #z_k = z_k + z_k_spring - - - + z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] + # factor = self.dbeads.m3[0] / 1.674 # DEBUG + # z_k_spring = factor * new_omegak2[:, np.newaxis] #DEBUG + # z_k = z_k + z_k_spring - gq_k = np.dot(C, gq) * z_k + gq_k = np.dot(self.C, gq) * z_k e = 0.5 * np.sum(gq_k ** 2) - f = np.dot(C.T, gq_k) + f = np.dot(self.C.T, gq_k) g = np.zeros(f.shape) for i in range(self.dbeads.nbeads): g[i, :] = np.dot(dgdq[i], f[i]) @@ -687,8 +614,11 @@ def bind(self, mapper): self.fix = mapper.fix self.coef = mapper.coef self.dbeads = mapper.beads.copy() - self.nm = mapper.nm - self.rp_factor = mapper.rp_factor + # self.nm = mapper.nm + # self.rp_factor = mapper.rp_factor + self.C = mapper.nm.transform._b2o_nm + self.omegak = mapper.rp_factor * mapper.nm.get_o_omegak() + self.omegan = mapper.rp_factor * mapper.nm.omegan # Computes the spring hessian if the optimization modes requires it if ( @@ -700,7 +630,7 @@ def bind(self, mapper): natoms=self.fix.fixbeads.natoms, nbeads=self.fix.fixbeads.nbeads, m3=self.fix.fixbeads.m3[0], - omega2=(self.rp_factor*self.nm.omegan)**2, + omega2=(self.omegan) ** 2, coef=self.coef, ) @@ -741,12 +671,10 @@ def __call__(self, x, ret=True, new_disc=True): # #g[i, :] += self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) - C = self.nm.transform._b2o_nm - omegak = 2*self.nm.get_o_omegak() - omegak2 = omegak**2 - - gq_k = np.dot(C, self.dbeads.q) - g = self.dbeads.m3[0]*np.dot(C.T,gq_k*omegak2[:, np.newaxis]) + gq_k = np.dot(self.C, self.dbeads.q) + g = self.dbeads.m3[0] * np.dot( + self.C.T, gq_k * (self.omegak ** 2)[:, np.newaxis] + ) # With new discretization if False: # ALBERTO @@ -857,15 +785,14 @@ def initialize(self, q, forces): self.gm.initialize(q, forces) - e1, g1 = self.gm.evaluate() e2, g2 = self.sm(q) g = self.fix.get_active_vector(g1 + g2, 1) e = np.sum(e1 + e2) - #print('DEBUG') - #e1, g1 = self.gm.evaluate() - #g = self.fix.get_active_vector(g1, 1) - #e = np.sum(e1) + # print('DEBUG') + # e1, g1 = self.gm.evaluate() + # g = self.fix.get_active_vector(g1, 1) + # e = np.sum(e1) self.save(e, g) @@ -909,15 +836,15 @@ def set_coef(self, coef): def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): if mode == "all": - + e1, g1 = self.sm(x, new_disc) e2, g2 = self.gm(x, new_disc) e = e1 + e2 g = np.add(g1, g2) - #print('DEBUG') - #e2, g2 = self.gm(x, new_disc) - #e = e2 - #g = g2 + # print('DEBUG') + # e2, g2 = self.gm(x, new_disc) + # e = e2 + # g = g2 elif mode == "physical": e, g = self.gm(x, new_disc) @@ -1477,8 +1404,8 @@ def step(self, step=None): # Add spring terms to the physical hessian h = np.add(self.mapper.sm.h, h0) - #print("DEBUG") - #h = h0 + # print("DEBUG") + # h = h0 # Add friction terms to the hessian if self.options["friction"]: From b15c42b63c7ad2703b59d6132286d8e471b8bce0 Mon Sep 17 00:00:00 2001 From: Eszter Sarolta Pos Date: Mon, 25 Jan 2021 10:29:09 +0100 Subject: [PATCH 029/120] friction tensor printing modification: print as full symmetric tensor --- drivers/driver.f90 | 48 ++++-------------- drivers/pes/doublewell.f90 | 28 +++++------ drivers/pes/doublewell_1D.f90 | 26 +++++----- ipi/engine/motion/instanton.py | 17 ++++--- ipi/engine/outputs.py | 29 +++-------- ipi/utils/mintools.py | 6 +-- .../FRICTION_DIPOLE/files_to_check.txt | 12 ++--- .../FRICTION_DIPOLE/ref_simulation.friction_0 | 50 +++++++++++-------- .../FRICTION_DIPOLE/ref_simulation.friction_1 | 50 +++++++++++-------- .../FRICTION_DIPOLE/ref_simulation.friction_2 | 50 +++++++++++-------- .../FRICTION_DIPOLE/ref_simulation.friction_3 | 50 +++++++++++-------- .../FRICTION_DIPOLE/ref_simulation.friction_4 | 50 +++++++++++-------- .../FRICTION_DIPOLE/ref_simulation.friction_5 | 50 +++++++++++-------- 13 files changed, 240 insertions(+), 226 deletions(-) diff --git a/drivers/driver.f90 b/drivers/driver.f90 index fdb0a584d..a45543873 100644 --- a/drivers/driver.f90 +++ b/drivers/driver.f90 @@ -49,9 +49,9 @@ PROGRAM DRIVER ! SOCKET COMMUNICATION BUFFERS CHARACTER(LEN=12) :: header LOGICAL :: isinit=.false., hasdata=.false. - INTEGER cbuf, rid + INTEGER cbuf, rid, length CHARACTER(LEN=4096) :: initbuffer ! it's unlikely a string this large will ever be passed... - CHARACTER(LEN=4096) :: string,string2,string3 ! it's unlikely a string this large will ever be passed... + CHARACTER(LEN=4096) :: string,string2,string3,trimmed ! it's unlikely a string this large will ever be passed... DOUBLE PRECISION, ALLOCATABLE :: msgbuffer(:) ! PARAMETERS OF THE SYSTEM (CELL, ATOM POSITIONS, ...) @@ -389,8 +389,6 @@ PROGRAM DRIVER ENDIF ENDIF -! OPEN(UNIT=32, FILE="driver_extras.json", ACTION="write") - ! Calls the interface to the POSIX sockets library to open a communication channel CALL open_socket(socket, inet, port, host) nat = -1 @@ -716,7 +714,7 @@ PROGRAM DRIVER WRITE(32,'(a)') "}" cbuf = LEN_TRIM(initbuffer) - CALL writebuffer(socket,cbuf) + CALL writebuffer(socket,cbuf) IF (verbose > 1) WRITE(*,*) "!write!=> extra_length:", cbuf CALL writebuffer(socket,initbuffer,cbuf) @@ -728,24 +726,16 @@ PROGRAM DRIVER & 3x,a)') '"dipole": [',dip(1),",",dip(2),",",dip(3),"]," string2 = TRIM(initbuffer) // TRIM(string) initbuffer = TRIM(string2) -! WRITE(32,'(a)') '{' -! WRITE(32,'(a,3x,f15.8,a,f15.8,a,f15.8,3x,a)') & -! & '"dipole": [',dip(1),",",dip(2),",",dip(3),"] , " WRITE(string,'(a)') '"friction": [' string2 = TRIM(initbuffer) // TRIM(string) initbuffer = TRIM(string2) - DO i=1,nat - IF(i/=nat) THEN - WRITE(string,'(f15.8,a,f15.8,a,f15.8, & - & a,f15.8,a,f15.8,a,f15.8,a)') friction(i,1), & - & ",",friction(i,2),",",friction(i,3),",",friction(i,4), & - & ",",friction(i,5),",",friction(i,6),"," - ELSE - WRITE(string,'(f15.8,a,f15.8,a,f15.8, & - & a,f15.8,a,f15.8,a,f15.8)') friction(i,1),",", & - & friction(i,2),",",friction(i,3),",",friction(i,4),",", & - & friction(i,5),",",friction(i,6) + DO i=1,3*nat + WRITE(string,'(*(f15.8,","))') friction(i,:) + IF(i==3*nat) THEN + length = LEN_TRIM(string) + trimmed = TRIM(string) + string = trimmed(:length-1) ENDIF string2 = TRIM(initbuffer) // TRIM(string) initbuffer = TRIM(string2) @@ -757,22 +747,6 @@ PROGRAM DRIVER IF (verbose > 1) WRITE(*,*) "!write!=> extra_length:", & & cbuf CALL writebuffer(socket,initbuffer,cbuf) -! WRITE(32,'(a)') '"friction": [' -! DO i=1,nat -! IF(i/=nat) THEN -! WRITE(32,'(f15.8,a,f15.8,a,f15.8,a, & -! & f15.8,a,f15.8,a,f15.8,a)') friction(i,1),",", & -! & friction(i,2),",",friction(i,3),",",friction(i,4),",", & -! & friction(i,5),",",friction(i,6),"," -! ELSE -! WRITE(32,'(f15.8,a,f15.8,a,f15.8,a, & -! & f15.8,a,f15.8,a,f15.8)') friction(i,1),",", & -! & friction(i,2),",",friction(i,3),",",friction(i,4),",", & -! & friction(i,5),",",friction(i,6) -! ENDIF -! END DO -! WRITE(32,'(a)') "]" -! WRITE(32,'(a)') "}" IF (verbose > 1) WRITE(*,*) " !write!=> extra: ", & & initbuffer ELSEIF (vstyle==5 .or. vstyle==6 .or. vstyle==8) THEN ! returns the dipole through initbuffer @@ -784,10 +758,6 @@ PROGRAM DRIVER IF (verbose > 1) WRITE(*,*) & & " !write!=> extra_length: ", cbuf CALL writebuffer(socket,initbuffer,cbuf) -! WRITE(32,'(a)') "{" -! WRITE(32,'(a,3x,f15.8,a,f15.8,a,f15.8,3x,a)') & -! & '"dipole": [',dip(1),",",dip(2),",",dip(3),"]" -! WRITE(32,'(a)') "}" IF (verbose > 1) WRITE(*,*) " !write!=> extra: ", & & initbuffer ELSE diff --git a/drivers/pes/doublewell.f90 b/drivers/pes/doublewell.f90 index fdcc83adb..fbbfa8fde 100644 --- a/drivers/pes/doublewell.f90 +++ b/drivers/pes/doublewell.f90 @@ -39,23 +39,21 @@ SUBROUTINE getdoublewell(nat,q,pot,force) SUBROUTINE dw_friction(nat,q,friction) IMPLICIT NONE - integer :: nat, i - real(kind=8) :: q(nat,3),friction(nat,6) - real(kind=8) :: x,y,z - + integer :: nat, i, j, qi, qj, coori, coorj + real(kind=8),intent(in) :: q(nat,3) + real(kind=8),intent(out) :: friction(3*nat,3*nat) DO i = 1,nat - x = q(i,1) - y = q(i,2) - z = q(i,3) - - friction(i,1) = x**2 - friction(i,2) = y**2 - friction(i,3) = z**2 - friction(i,4) = x*y - friction(i,5) = x*z - friction(i,6) = y*z - ENDDO + DO j = 1,nat + DO qi = 1,3 + coori = (i-1)*nat+qi + DO qj = 1,3 + coorj = (j-1)*nat+qj + friction(coori,coorj) = q(i,qi)*q(j,qj) + END DO + END DO + END DO + END DO return end diff --git a/drivers/pes/doublewell_1D.f90 b/drivers/pes/doublewell_1D.f90 index 570009c8c..9acef2918 100644 --- a/drivers/pes/doublewell_1D.f90 +++ b/drivers/pes/doublewell_1D.f90 @@ -63,23 +63,21 @@ SUBROUTINE dw1d_dipole(nat,q,dip) SUBROUTINE dw1d_friction(nat,q,friction) IMPLICIT NONE - integer :: nat, i + integer :: nat, i, j, qi, qj, coori, coorj real(kind=8),intent(in) :: q(nat,3) - real(kind=8),intent(out) :: friction(nat,6) - real(kind=8) :: x,y,z + real(kind=8),intent(out) :: friction(3*nat,3*nat) DO i = 1,nat - x = q(i,1) - y = q(i,2) - z = q(i,3) - - friction(i,1) = x**2 - friction(i,2) = y**2 - friction(i,3) = z**2 - friction(i,4) = x*y - friction(i,5) = x*z - friction(i,6) = y*z - ENDDO + DO j = 1,nat + DO qi = 1,3 + coori = (i-1)*nat+qi + DO qj = 1,3 + coorj = (j-1)*nat+qj + friction(coori,coorj) = q(i,qi)*q(j,qj) + END DO + END DO + END DO + END DO return END diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 44e20d725..4207d6ac7 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -427,7 +427,9 @@ def set_z_friction(self, z_friction): ) z_friction = spline(self.omegak) - self.z_friction = z_friction / z_friction[1] #UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY + self.z_friction = ( + z_friction / z_friction[1] + ) # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) @@ -436,11 +438,11 @@ def get_fric_rp_hessian(self, fric_hessian): nphys = self.dbeads.natoms * 3 ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 - nbeads = self.dbeads.nbeads + # nbeads = self.dbeads.nbeads s = self.eta dgdq = s ** 0.5 - gq = self.obtain_g(s) + # gq = self.obtain_g(s) z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] # factor = self.dbeads.m3[0, 0] / 1.674 # DEBUG @@ -449,10 +451,10 @@ def get_fric_rp_hessian(self, fric_hessian): h_fric = np.zeros((ndof, ndof)) - #ALBERTO + # ALBERTO # Block diag: - #g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] - #for n in range(self.dbeads.nbeads): + # g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] + # for n in range(self.dbeads.nbeads): # for j in range(nphys): # for k in range(nphys): # aux_jk = 0 @@ -462,7 +464,7 @@ def get_fric_rp_hessian(self, fric_hessian): # 0.5 * g[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] # ) # h_fric[nphys * n + j, nphys * n + k] = aux_jk - #ALBERTO + # ALBERTO # Cross-terms: for nl in range(self.dbeads.nbeads): @@ -504,7 +506,6 @@ def obtain_g(self, s): def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ - s = self.eta dgdq = s ** 0.5 gq = self.obtain_g(s) diff --git a/ipi/engine/outputs.py b/ipi/engine/outputs.py index 9713b8adc..257d3b38b 100644 --- a/ipi/engine/outputs.py +++ b/ipi/engine/outputs.py @@ -488,31 +488,18 @@ def write_traj( index = el try: if self.xtratype == "friction": - fatom = Atoms(self.system.beads.natoms) - fatom.names[:] = self.system.beads.names - stream.write( - "# %s\n" - % " ".join( - "%15s" % el - for el in [ - "xx", - "yy", - "zz", - "xy=yx", - "xz=zx", - "yz=zy", - ] - ) - ) - for na in range(self.system.beads.natoms): + for na in range(self.system.beads.natoms * 3): stream.write( - "%3s %s\n" + "%s\n" % ( - fatom.names[na], - " ".join( + "".join( "%15.8f" % el for el in data[index][b][self.xtratype][ - na * 6 : (na + 1) * 6 + na + * (3 * self.system.beads.natoms) : ( + na + 1 + ) + * (3 * self.system.beads.natoms) ] ), ) diff --git a/ipi/utils/mintools.py b/ipi/utils/mintools.py index e77db661c..e7e7e478e 100644 --- a/ipi/utils/mintools.py +++ b/ipi/utils/mintools.py @@ -1341,9 +1341,9 @@ def nichols(f0, d, dynmax, m3, big_step, mode=1): # Resize ndim = f0.size shape = f0.shape - f = f0.reshape((1, ndim)) / m3.reshape( - (1, ndim) - ) ** 0.5 # From cartesian base to mass-weighted base + f = ( + f0.reshape((1, ndim)) / m3.reshape((1, ndim)) ** 0.5 + ) # From cartesian base to mass-weighted base # Change of basis to eigenvector space d = d[:, np.newaxis] # dimension nx1 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/files_to_check.txt b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/files_to_check.txt index 15190d7d8..0ffd94bb7 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/files_to_check.txt +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/files_to_check.txt @@ -6,9 +6,9 @@ ref_simulation.dip_1 numpy ref_simulation.dip_2 numpy ref_simulation.dip_3 numpy ref_simulation.dip_4 numpy -ref_simulation.friction_0 numpy 1 2 3 4 5 6 -ref_simulation.friction_1 numpy 1 2 3 4 5 6 -ref_simulation.friction_2 numpy 1 2 3 4 5 6 -ref_simulation.friction_3 numpy 1 2 3 4 5 6 -ref_simulation.friction_4 numpy 1 2 3 4 5 6 -ref_simulation.friction_5 numpy 1 2 3 4 5 6 +ref_simulation.friction_0 numpy 0 1 2 +ref_simulation.friction_1 numpy 0 1 2 +ref_simulation.friction_2 numpy 0 1 2 +ref_simulation.friction_3 numpy 0 1 2 +ref_simulation.friction_4 numpy 0 1 2 +ref_simulation.friction_5 numpy 0 1 2 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 index 4fb25e4ab..962641cf8 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 @@ -1,30 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 #*EXTRAS*# Step: 1 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00004977 0.00000088 0.00000024 -0.00000663 0.00000347 -0.00000046 + 0.00004977 -0.00000663 0.00000347 + -0.00000663 0.00000088 -0.00000046 + 0.00000347 -0.00000046 0.00000024 #*EXTRAS*# Step: 2 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00019880 0.00000354 0.00000096 -0.00002652 0.00001380 -0.00000184 + 0.00019880 -0.00002652 0.00001380 + -0.00002652 0.00000354 -0.00000184 + 0.00001380 -0.00000184 0.00000096 #*EXTRAS*# Step: 3 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00044627 0.00000796 0.00000213 -0.00005962 0.00003081 -0.00000412 + 0.00044627 -0.00005962 0.00003081 + -0.00005962 0.00000796 -0.00000412 + 0.00003081 -0.00000412 0.00000213 #*EXTRAS*# Step: 4 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00079081 0.00001417 0.00000371 -0.00010584 0.00005419 -0.00000725 + 0.00079081 -0.00010584 0.00005419 + -0.00010584 0.00001417 -0.00000725 + 0.00005419 -0.00000725 0.00000371 #*EXTRAS*# Step: 5 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00123051 0.00002215 0.00000566 -0.00016508 0.00008349 -0.00001120 + 0.00123051 -0.00016508 0.00008349 + -0.00016508 0.00002215 -0.00001120 + 0.00008349 -0.00001120 0.00000566 #*EXTRAS*# Step: 6 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00176295 0.00003191 0.00000792 -0.00023719 0.00011817 -0.00001590 + 0.00176295 -0.00023719 0.00011817 + -0.00023719 0.00003191 -0.00001590 + 0.00011817 -0.00001590 0.00000792 #*EXTRAS*# Step: 7 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00238519 0.00004346 0.00001041 -0.00032195 0.00015758 -0.00002127 + 0.00238519 -0.00032195 0.00015758 + -0.00032195 0.00004346 -0.00002127 + 0.00015758 -0.00002127 0.00001041 #*EXTRAS*# Step: 8 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00309383 0.00005678 0.00001306 -0.00041911 0.00020099 -0.00002723 + 0.00309383 -0.00041911 0.00020099 + -0.00041911 0.00005678 -0.00002723 + 0.00020099 -0.00002723 0.00001306 #*EXTRAS*# Step: 9 Bead: 0 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00388499 0.00007186 0.00001578 -0.00052836 0.00024758 -0.00003367 + 0.00388499 -0.00052836 0.00024758 + -0.00052836 0.00007186 -0.00003367 + 0.00024758 -0.00003367 0.00001578 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 index fd81e667e..b8a9b739f 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 @@ -1,30 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 #*EXTRAS*# Step: 1 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00001032 0.00010345 0.00000431 -0.00003268 -0.00000667 0.00002112 + 0.00001032 -0.00003268 -0.00000667 + -0.00003268 0.00010345 0.00002112 + -0.00000667 0.00002112 0.00000431 #*EXTRAS*# Step: 2 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00004141 0.00041117 0.00001711 -0.00013049 -0.00002662 0.00008387 + 0.00004141 -0.00013049 -0.00002662 + -0.00013049 0.00041117 0.00008387 + -0.00002662 0.00008387 0.00001711 #*EXTRAS*# Step: 3 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00009361 0.00091534 0.00003795 -0.00029272 -0.00005960 0.00018637 + 0.00009361 -0.00029272 -0.00005960 + -0.00029272 0.00091534 0.00018637 + -0.00005960 0.00018637 0.00003795 #*EXTRAS*# Step: 4 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00016752 0.00160312 0.00006613 -0.00051822 -0.00010525 0.00032559 + 0.00016752 -0.00051822 -0.00010525 + -0.00051822 0.00160312 0.00032559 + -0.00010525 0.00032559 0.00006613 #*EXTRAS*# Step: 5 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00026395 0.00245702 0.00010068 -0.00080531 -0.00016302 0.00049737 + 0.00026395 -0.00080531 -0.00016302 + -0.00080531 0.00245702 0.00049737 + -0.00016302 0.00049737 0.00010068 #*EXTRAS*# Step: 6 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00038398 0.00345531 0.00014044 -0.00115185 -0.00023222 0.00069661 + 0.00038398 -0.00115185 -0.00023222 + -0.00115185 0.00345531 0.00069661 + -0.00023222 0.00069661 0.00014044 #*EXTRAS*# Step: 7 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00052891 0.00457262 0.00018405 -0.00155515 -0.00031200 0.00091738 + 0.00052891 -0.00155515 -0.00031200 + -0.00155515 0.00457262 0.00091738 + -0.00031200 0.00091738 0.00018405 #*EXTRAS*# Step: 8 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00070031 0.00578053 0.00023001 -0.00201200 -0.00040135 0.00115308 + 0.00070031 -0.00201200 -0.00040135 + -0.00201200 0.00578053 0.00115308 + -0.00040135 0.00115308 0.00023001 #*EXTRAS*# Step: 9 Bead: 1 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00089998 0.00704833 0.00027676 -0.00251860 -0.00049907 0.00139666 + 0.00089998 -0.00251860 -0.00049907 + -0.00251860 0.00704833 0.00139666 + -0.00049907 0.00139666 0.00027676 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 index 8a7fdd87c..2fc186ac2 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 @@ -1,30 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 #*EXTRAS*# Step: 1 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00023275 0.00001162 0.00006410 0.00005200 0.00012215 0.00002729 + 0.00023275 0.00005200 0.00012215 + 0.00005200 0.00001162 0.00002729 + 0.00012215 0.00002729 0.00006410 #*EXTRAS*# Step: 2 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00093031 0.00004617 0.00025480 0.00020724 0.00048687 0.00010846 + 0.00093031 0.00020724 0.00048687 + 0.00020724 0.00004617 0.00010846 + 0.00048687 0.00010846 0.00025480 #*EXTRAS*# Step: 3 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00209060 0.00010275 0.00056729 0.00046347 0.00108902 0.00024143 + 0.00209060 0.00046347 0.00108902 + 0.00046347 0.00010275 0.00024143 + 0.00108902 0.00024143 0.00056729 #*EXTRAS*# Step: 4 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00371017 0.00017989 0.00099371 0.00081696 0.00192012 0.00042280 + 0.00371017 0.00081696 0.00192012 + 0.00081696 0.00017989 0.00042280 + 0.00192012 0.00042280 0.00099371 #*EXTRAS*# Step: 5 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00578423 0.00027559 0.00152336 0.00126256 0.00296841 0.00064793 + 0.00578423 0.00126256 0.00296841 + 0.00126256 0.00027559 0.00064793 + 0.00296841 0.00064793 0.00152336 #*EXTRAS*# Step: 6 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00830663 0.00038735 0.00214290 0.00179376 0.00421904 0.00091107 + 0.00830663 0.00179376 0.00421904 + 0.00179376 0.00038735 0.00091107 + 0.00421904 0.00091107 0.00214290 #*EXTRAS*# Step: 7 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.01126993 0.00051227 0.00283678 0.00240276 0.00565423 0.00120549 + 0.01126993 0.00240276 0.00565423 + 0.00240276 0.00051227 0.00120549 + 0.00565423 0.00120549 0.00283678 #*EXTRAS*# Step: 8 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.01466540 0.00064710 0.00358756 0.00308057 0.00725349 0.00152365 + 0.01466540 0.00308057 0.00725349 + 0.00308057 0.00064710 0.00152365 + 0.00725349 0.00152365 0.00358756 #*EXTRAS*# Step: 9 Bead: 2 -# xx yy zz xy=yx xz=zx yz=zy - H 0.01848308 0.00078832 0.00437639 0.00381715 0.00899385 0.00185742 + 0.01848308 0.00381715 0.00899385 + 0.00381715 0.00078832 0.00185742 + 0.00899385 0.00185742 0.00437639 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 index 0f5c6ad9b..88dc6882c 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 @@ -1,30 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 #*EXTRAS*# Step: 1 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00001956 0.00007178 0.00000142 0.00003747 0.00000527 0.00001010 + 0.00001956 0.00003747 0.00000527 + 0.00003747 0.00007178 0.00001010 + 0.00000527 0.00001010 0.00000142 #*EXTRAS*# Step: 2 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00007836 0.00028525 0.00000568 0.00014950 0.00002109 0.00004024 + 0.00007836 0.00014950 0.00002109 + 0.00014950 0.00028525 0.00004024 + 0.00002109 0.00004024 0.00000568 #*EXTRAS*# Step: 3 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00017675 0.00063489 0.00001273 0.00033499 0.00004743 0.00008990 + 0.00017675 0.00033499 0.00004743 + 0.00033499 0.00063489 0.00008990 + 0.00004743 0.00008990 0.00001273 #*EXTRAS*# Step: 4 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00031534 0.00111167 0.00002252 0.00059207 0.00008427 0.00015822 + 0.00031534 0.00059207 0.00008427 + 0.00059207 0.00111167 0.00015822 + 0.00008427 0.00015822 0.00002252 #*EXTRAS*# Step: 5 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00049496 0.00170324 0.00003497 0.00091817 0.00013156 0.00024405 + 0.00049496 0.00091817 0.00013156 + 0.00091817 0.00170324 0.00024405 + 0.00013156 0.00024405 0.00003497 #*EXTRAS*# Step: 6 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00071669 0.00239433 0.00004997 0.00130996 0.00018924 0.00034589 + 0.00071669 0.00130996 0.00018924 + 0.00130996 0.00239433 0.00034589 + 0.00018924 0.00034589 0.00004997 #*EXTRAS*# Step: 7 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00098184 0.00316704 0.00006739 0.00176339 0.00025723 0.00046198 + 0.00098184 0.00176339 0.00025723 + 0.00176339 0.00316704 0.00046198 + 0.00025723 0.00046198 0.00006739 #*EXTRAS*# Step: 8 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00129197 0.00400142 0.00008707 0.00227370 0.00033541 0.00059027 + 0.00129197 0.00227370 0.00033541 + 0.00227370 0.00400142 0.00059027 + 0.00033541 0.00059027 0.00008707 #*EXTRAS*# Step: 9 Bead: 3 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00164887 0.00487588 0.00010885 0.00283544 0.00042364 0.00072851 + 0.00164887 0.00283544 0.00042364 + 0.00283544 0.00487588 0.00072851 + 0.00042364 0.00072851 0.00010885 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 index e46363a68..374e637dc 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 @@ -1,30 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 #*EXTRAS*# Step: 1 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00002557 0.00004994 0.00000101 -0.00003573 0.00000507 -0.00000709 + 0.00002557 -0.00003573 0.00000507 + -0.00003573 0.00004994 -0.00000709 + 0.00000507 -0.00000709 0.00000101 #*EXTRAS*# Step: 2 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00010212 0.00019841 0.00000401 -0.00014234 0.00002023 -0.00002820 + 0.00010212 -0.00014234 0.00002023 + -0.00014234 0.00019841 -0.00002820 + 0.00002023 -0.00002820 0.00000401 #*EXTRAS*# Step: 3 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00022924 0.00044134 0.00000894 -0.00031808 0.00004526 -0.00006281 + 0.00022924 -0.00031808 0.00004526 + -0.00031808 0.00044134 -0.00006281 + 0.00004526 -0.00006281 0.00000894 #*EXTRAS*# Step: 4 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00040621 0.00077212 0.00001570 -0.00056004 0.00007985 -0.00011009 + 0.00040621 -0.00056004 0.00007985 + -0.00056004 0.00077212 -0.00011009 + 0.00007985 -0.00011009 0.00001570 #*EXTRAS*# Step: 5 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00063204 0.00118172 0.00002414 -0.00086423 0.00012352 -0.00016890 + 0.00063204 -0.00086423 0.00012352 + -0.00086423 0.00118172 -0.00016890 + 0.00012352 -0.00016890 0.00002414 #*EXTRAS*# Step: 6 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00090550 0.00165896 0.00003409 -0.00122563 0.00017570 -0.00023782 + 0.00090550 -0.00122563 0.00017570 + -0.00122563 0.00165896 -0.00023782 + 0.00017570 -0.00023782 0.00003409 #*EXTRAS*# Step: 7 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00122505 0.00219082 0.00004535 -0.00163825 0.00023570 -0.00031520 + 0.00122505 -0.00163825 0.00023570 + -0.00163825 0.00219082 -0.00031520 + 0.00023570 -0.00031520 0.00004535 #*EXTRAS*# Step: 8 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00158894 0.00276279 0.00005767 -0.00209521 0.00030272 -0.00039917 + 0.00158894 -0.00209521 0.00030272 + -0.00209521 0.00276279 -0.00039917 + 0.00030272 -0.00039917 0.00005767 #*EXTRAS*# Step: 9 Bead: 4 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00199517 0.00335926 0.00007081 -0.00258888 0.00037587 -0.00048772 + 0.00199517 -0.00258888 0.00037587 + -0.00258888 0.00335926 -0.00048772 + 0.00037587 -0.00048772 0.00007081 diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 index 50ab31329..0f331ab72 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 @@ -1,30 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 + 0.00000000 0.00000000 0.00000000 #*EXTRAS*# Step: 1 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00006157 0.00000075 0.00000038 0.00000678 -0.00000484 -0.00000053 + 0.00006157 0.00000678 -0.00000484 + 0.00000678 0.00000075 -0.00000053 + -0.00000484 -0.00000053 0.00000038 #*EXTRAS*# Step: 2 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00024582 0.00000299 0.00000151 0.00002709 -0.00001928 -0.00000213 + 0.00024582 0.00002709 -0.00001928 + 0.00002709 0.00000299 -0.00000213 + -0.00001928 -0.00000213 0.00000151 #*EXTRAS*# Step: 3 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00055136 0.00000671 0.00000337 0.00006081 -0.00004314 -0.00000476 + 0.00055136 0.00006081 -0.00004314 + 0.00006081 0.00000671 -0.00000476 + -0.00004314 -0.00000476 0.00000337 #*EXTRAS*# Step: 4 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00097590 0.00001189 0.00000593 0.00010773 -0.00007608 -0.00000840 + 0.00097590 0.00010773 -0.00007608 + 0.00010773 0.00001189 -0.00000840 + -0.00007608 -0.00000840 0.00000593 #*EXTRAS*# Step: 5 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00151625 0.00001852 0.00000913 0.00016756 -0.00011767 -0.00001300 + 0.00151625 0.00016756 -0.00011767 + 0.00016756 0.00001852 -0.00001300 + -0.00011767 -0.00001300 0.00000913 #*EXTRAS*# Step: 6 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00216834 0.00002655 0.00001291 0.00023994 -0.00016734 -0.00001852 + 0.00216834 0.00023994 -0.00016734 + 0.00023994 0.00002655 -0.00001852 + -0.00016734 -0.00001852 0.00001291 #*EXTRAS*# Step: 7 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00292727 0.00003595 0.00001720 0.00032441 -0.00022440 -0.00002487 + 0.00292727 0.00032441 -0.00022440 + 0.00032441 0.00003595 -0.00002487 + -0.00022440 -0.00002487 0.00001720 #*EXTRAS*# Step: 8 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00378732 0.00004667 0.00002191 0.00042041 -0.00028809 -0.00003198 + 0.00378732 0.00042041 -0.00028809 + 0.00042041 0.00004667 -0.00003198 + -0.00028809 -0.00003198 0.00002191 #*EXTRAS*# Step: 9 Bead: 5 -# xx yy zz xy=yx xz=zx yz=zy - H 0.00474201 0.00005864 0.00002696 0.00052731 -0.00035753 -0.00003976 + 0.00474201 0.00052731 -0.00035753 + 0.00052731 0.00005864 -0.00003976 + -0.00035753 -0.00003976 0.00002696 From bc7805edafb621d36a84778d4f53662af91b26be Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 25 Jan 2021 11:11:47 +0100 Subject: [PATCH 030/120] deactive z normalization for now --- ipi/engine/motion/instanton.py | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 4207d6ac7..5bf9f4f02 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -427,9 +427,7 @@ def set_z_friction(self, z_friction): ) z_friction = spline(self.omegak) - self.z_friction = ( - z_friction / z_friction[1] - ) # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY + self.z_friction = z_friction # / z_friction[1] ) # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) From 58f3ed4f7e6285f87f3bb0d9d209db008758a9ad Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 26 Jan 2021 11:53:59 +0100 Subject: [PATCH 031/120] Add SD capabilities to harmonic baths --- drivers/driver.f90 | 27 +++++++++------ drivers/pes/harmonic_bath.f90 | 63 +++++++++++++++++++++++++---------- 2 files changed, 63 insertions(+), 27 deletions(-) diff --git a/drivers/driver.f90 b/drivers/driver.f90 index ab9ccc4c1..fc20a02f5 100644 --- a/drivers/driver.f90 +++ b/drivers/driver.f90 @@ -45,14 +45,14 @@ PROGRAM DRIVER INTEGER, ALLOCATABLE :: seed(:) INTEGER verbose INTEGER commas(4), par_count ! stores the index of commas in the parameter string - DOUBLE PRECISION vpars(4) ! array to store the parameters of the potential + DOUBLE PRECISION vpars(6) ! array to store the parameters of the potential ! SOCKET COMMUNICATION BUFFERS CHARACTER(LEN=12) :: header LOGICAL :: isinit=.false., hasdata=.false. - INTEGER cbuf, rid, length + INTEGER cbuf, rid CHARACTER(LEN=4096) :: initbuffer ! it's unlikely a string this large will ever be passed... - CHARACTER(LEN=4096) :: string,string2,string3,trimmed ! it's unlikely a string this large will ever be passed... + CHARACTER(LEN=4096) :: string,string2,string3 ! it's unlikely a string this large will ever be passed... DOUBLE PRECISION, ALLOCATABLE :: msgbuffer(:) ! PARAMETERS OF THE SYSTEM (CELL, ATOM POSITIONS, ...) @@ -269,9 +269,13 @@ PROGRAM DRIVER ENDIF isinit = .true. ELSEIF (26 == vstyle) THEN !harmonic_bath - IF (par_count /= 3) THEN ! defaults values + IF (par_count == 3) THEN ! defaults values + vpars(4) = 0 + vpars(5) = 0 + vpars(6) = 1 + ELSEIF (par_count /= 6) THEN WRITE(*,*) "Error: parameters not initialized correctly." - WRITE(*,*) "For harmonic bath use " + WRITE(*,*) "For harmonic bath use eps(a.u.) delta (a.u.) deltaQ(a.u.)" WRITE(*,*) "Available bath_type are: " WRITE(*,*) "1 = Ohmic " STOP "ENDED" @@ -283,12 +287,15 @@ PROGRAM DRIVER vpars(3) = vpars(3) * 4.5563353e-06 !Change omega_c from invcm to a.u. isinit = .true. ELSEIF (27 == vstyle) THEN !meanfield bath - IF (par_count /= 1) THEN ! defaults values + IF (par_count == 3) THEN ! defaults values + vpars(2) = 0 + vpars(3) = 0 + vpars(4) = 1 + ELSEIF (par_count /= 4) THEN WRITE(*,*) "Error: parameters not initialized correctly." - WRITE(*,*) "For harmonic meanfield bath use " + WRITE(*,*) "For harmonic meanfield bath use eps(a.u.) delta (a.u.) deltaQ(a.u.)" STOP "ENDED" ENDIF - vpars(1) = vpars(1) isinit = .true. ELSEIF (22 == vstyle) THEN !ljpolymer IF (4/= par_count) THEN @@ -633,9 +640,9 @@ PROGRAM DRIVER ELSEIF (vstyle == 20) THEN ! eckart potential. CALL geteckart(nat,vpars(1), vpars(2), vpars(3),vpars(4), atoms, pot, forces) ELSEIF (vstyle == 26) THEN ! harmonic_bath. - CALL get_harmonic_bath(nat,vpars(1),vpars(2),vpars(3),atoms, pot, forces) + CALL get_harmonic_bath(nat,vpars(1),vpars(2),vpars(3),vpars(4),vpars(5),vpars(6),atoms, pot, forces) ELSEIF (vstyle == 27) THEN ! meanfield_bath. - CALL get_meanfield_harmonic_bath(nat,vpars(1),atoms, pot, forces,friction) + CALL get_meanfield_harmonic_bath(nat,vpars(1),vpars(2),vpars(3),vpars(4),atoms, pot, forces,friction) ELSEIF (vstyle == 23) THEN ! MB. IF (nat/=1) THEN WRITE(*,*) "Expecting 1 atom for MB" diff --git a/drivers/pes/harmonic_bath.f90 b/drivers/pes/harmonic_bath.f90 index b4efdcb38..cebcd569c 100644 --- a/drivers/pes/harmonic_bath.f90 +++ b/drivers/pes/harmonic_bath.f90 @@ -1,13 +1,17 @@ !Harmonic bath -!JCP 122, 084106(2005) -! V(q,x1,..,xn) = sum_1^(nat-1) [ 0.5 m omega_i^2(q - (c_i q)/m omega_i)^2 ] +! V(q,x1,..,xn) = sum_1^(nat-1) [ 0.5 m omega_i^2(q - (c_i s(q))/(m omega_i)^2)^2 ] +! s(q) = q *sd(q) +! sd(q) = [1+eps exp( (q-0)^2 / (2deltaQ^2) ) ] + delta tanh(q/deltaQ) +! If eps=delta=0 then sd(q) =1 and s(q) = q - SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,q,pot,force) + + SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,eps,delta,deltaQ,q,pot,force) IMPLICIT NONE integer :: nat, i real(kind=8),PARAMETER :: pi= 3.141592653589793D0 real(kind=8) :: bath_type,friction,omega_c,mass + real(kind=8) :: eps,delta,deltaQ,S,dSD_dq real(kind=8) :: A,B real(kind=8) :: q(nat*3),pot,force(nat*3),x(nat*3-1) real(kind=8) :: c(nat*3-1),omega(nat*3-1), omega2(nat*3-1),aux @@ -19,12 +23,14 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,q,pot,force) DO i = 1, 3*nat -1 x(i) = q(i+1) ENDDO + + !Get omega and c_i IF (IDINT(bath_type) .EQ. 1 ) THEN !Ohmic DO i = 1, 3*nat -1 omega(i) = - omega_c * LOG( (i - 0.5 ) / (3*nat-1) ) omega2(i) = omega(i)**2 c(i) = omega(i) * ( ( 2 * friction * mass *omega_c) / ( (3*nat-1) * pi ) )**0.5 - !write(6,*)'Ohmic',i,omega(i),c(i) + ENDDO END IF @@ -34,29 +40,51 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,q,pot,force) !BATH DO i = 1,3*nat-1 - aux = x(i) - c(i)*q(1) / ( mass*omega2(i) ) + aux = x(i) - ( c(i)*S(q(1),eps,delta,deltaQ) / ( mass*omega2(i) ) ) pot = pot + 0.5 * mass * omega2(i) * aux **2 - force(1) = force(1) + aux * c(i) + force(1) = force(1) + aux * c(i)*dSD_dq(q(1),eps,delta,deltaQ) force(i+1) = -mass * omega2(i) * aux - !WRITE(6,*)i,mass,omega2(i),aux - !WRITE(6,*)i ,x(i), c(i),q(1) , mass, omega2(i) + + ENDDO - DO i = 1,3*nat - WRITE(6,*) i, q(i), force(i) - !WRITE(6,*) i, force(i),x(i) - (c(i)*q(1)) / ( mass*omega2(i) ),x(i+1) - (c(i+1)*q(1)) / ( mass*omega2(i+1) ) - ENDDO return end + REAL*8 FUNCTION SD(q,eps,delta,deltaQ) + IMPLICIT NONE + real(kind=8), intent(in) :: q,eps,delta,deltaQ ! q system position + real(kind=8) :: dx + + dx = q / deltaQ + SD = 1.0 + eps*DEXP(-0.5 * (dx**2) ) + delta*DTANH(dx) + END FUNCTION SD - SUBROUTINE get_meanfield_harmonic_bath(nat,eta,q,pot,force,friction) + REAL*8 FUNCTION S(q,eps,delta,deltaQ) + IMPLICIT NONE + real(kind=8), intent(in) :: q,eps,delta,deltaQ + real(kind=8) :: SD + S = q* SD(q,eps,delta,deltaQ) + END FUNCTION S + + REAL*8 FUNCTION dSD_dq(q,eps,delta,deltaQ) + IMPLICIT NONE + real(kind=8), intent(in) :: q,eps,delta,deltaQ + real(kind=8) :: dx,dsddq1,dsddq2,SD + dx = q / deltaQ + dsddq1 = eps*DEXP(-0.5 * (dx**2))*(-dx/deltaQ) + dsddq2 = delta* (1- DTANH(DX)**2) / deltaQ + dSD_dq = q *(dsddq1 + dsddq2) + SD(q,eps,delta,deltaQ) + + END FUNCTION dSD_dq + + SUBROUTINE get_meanfield_harmonic_bath(nat,eta,eps,delta,deltaQ,q,pot,force,friction) IMPLICIT NONE integer :: nat, i - real(kind=8),PARAMETER :: pi= 3.141592653589793D0 real(kind=8) :: A,B,k,eta + real(kind=8) :: eps,delta,deltaQ,dSD_dq real(kind=8) :: x,y,z,fx,fy,fz real(kind=8) :: q(nat,3),pot,force(nat,3) real(kind=8) :: friction(3*nat,3*nat) @@ -86,9 +114,10 @@ SUBROUTINE get_meanfield_harmonic_bath(nat,eta,q,pot,force,friction) force(i,1) = fx force(i,2) = fy force(i,3) = fz - friction(nat*3*(i-1)+1,nat*3*(i-1)+1) = eta - friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = eta - friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = eta + + friction(nat*3*(i-1)+1,nat*3*(i-1)+1) = eta * (dSD_dq(x,eps,delta,deltaQ) )**2 + friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = eta * (dSD_dq(y,eps,delta,deltaQ) )**2 + friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = eta * (dSD_dq(z,eps,delta,deltaQ) )**2 ENDDO From 188aeca0b8a5f08ff9816663f7a7fa4c77cb487c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 26 Jan 2021 12:57:31 +0100 Subject: [PATCH 032/120] update references for XTRA-JSON/FRICTION_DIPOLE test --- .../FRICTION_DIPOLE/ref_simulation.friction_0 | 38 +++++++++---------- .../FRICTION_DIPOLE/ref_simulation.friction_1 | 38 +++++++++---------- .../FRICTION_DIPOLE/ref_simulation.friction_2 | 38 +++++++++---------- .../FRICTION_DIPOLE/ref_simulation.friction_3 | 38 +++++++++---------- .../FRICTION_DIPOLE/ref_simulation.friction_4 | 38 +++++++++---------- .../FRICTION_DIPOLE/ref_simulation.friction_5 | 38 +++++++++---------- 6 files changed, 114 insertions(+), 114 deletions(-) diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 index 962641cf8..a43dd6a64 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_0 @@ -1,40 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 0 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 - 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 1 Bead: 0 0.00004977 -0.00000663 0.00000347 - -0.00000663 0.00000088 -0.00000046 - 0.00000347 -0.00000046 0.00000024 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 2 Bead: 0 0.00019880 -0.00002652 0.00001380 - -0.00002652 0.00000354 -0.00000184 - 0.00001380 -0.00000184 0.00000096 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 3 Bead: 0 0.00044627 -0.00005962 0.00003081 - -0.00005962 0.00000796 -0.00000412 - 0.00003081 -0.00000412 0.00000213 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 4 Bead: 0 0.00079081 -0.00010584 0.00005419 - -0.00010584 0.00001417 -0.00000725 - 0.00005419 -0.00000725 0.00000371 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 5 Bead: 0 0.00123051 -0.00016508 0.00008349 - -0.00016508 0.00002215 -0.00001120 - 0.00008349 -0.00001120 0.00000566 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 6 Bead: 0 0.00176295 -0.00023719 0.00011817 - -0.00023719 0.00003191 -0.00001590 - 0.00011817 -0.00001590 0.00000792 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 7 Bead: 0 0.00238519 -0.00032195 0.00015758 - -0.00032195 0.00004346 -0.00002127 - 0.00015758 -0.00002127 0.00001041 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 8 Bead: 0 0.00309383 -0.00041911 0.00020099 - -0.00041911 0.00005678 -0.00002723 - 0.00020099 -0.00002723 0.00001306 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 9 Bead: 0 0.00388499 -0.00052836 0.00024758 - -0.00052836 0.00007186 -0.00003367 - 0.00024758 -0.00003367 0.00001578 + 0.00000000 0.00000000 0.00000000 + diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 index b8a9b739f..ebf2ec1fa 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_1 @@ -1,40 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 1 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 - 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 1 Bead: 1 0.00001032 -0.00003268 -0.00000667 - -0.00003268 0.00010345 0.00002112 - -0.00000667 0.00002112 0.00000431 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 2 Bead: 1 0.00004141 -0.00013049 -0.00002662 - -0.00013049 0.00041117 0.00008387 - -0.00002662 0.00008387 0.00001711 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 3 Bead: 1 0.00009361 -0.00029272 -0.00005960 - -0.00029272 0.00091534 0.00018637 - -0.00005960 0.00018637 0.00003795 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 4 Bead: 1 0.00016752 -0.00051822 -0.00010525 - -0.00051822 0.00160312 0.00032559 - -0.00010525 0.00032559 0.00006613 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 5 Bead: 1 0.00026395 -0.00080531 -0.00016302 - -0.00080531 0.00245702 0.00049737 - -0.00016302 0.00049737 0.00010068 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 6 Bead: 1 0.00038398 -0.00115185 -0.00023222 - -0.00115185 0.00345531 0.00069661 - -0.00023222 0.00069661 0.00014044 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 7 Bead: 1 0.00052891 -0.00155515 -0.00031200 - -0.00155515 0.00457262 0.00091738 - -0.00031200 0.00091738 0.00018405 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 8 Bead: 1 0.00070031 -0.00201200 -0.00040135 - -0.00201200 0.00578053 0.00115308 - -0.00040135 0.00115308 0.00023001 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 9 Bead: 1 0.00089998 -0.00251860 -0.00049907 - -0.00251860 0.00704833 0.00139666 - -0.00049907 0.00139666 0.00027676 + 0.00000000 0.00000000 0.00000000 + diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 index 2fc186ac2..2fbb8475a 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_2 @@ -1,40 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 2 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 - 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 1 Bead: 2 0.00023275 0.00005200 0.00012215 - 0.00005200 0.00001162 0.00002729 - 0.00012215 0.00002729 0.00006410 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 2 Bead: 2 0.00093031 0.00020724 0.00048687 - 0.00020724 0.00004617 0.00010846 - 0.00048687 0.00010846 0.00025480 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 3 Bead: 2 0.00209060 0.00046347 0.00108902 - 0.00046347 0.00010275 0.00024143 - 0.00108902 0.00024143 0.00056729 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 4 Bead: 2 0.00371017 0.00081696 0.00192012 - 0.00081696 0.00017989 0.00042280 - 0.00192012 0.00042280 0.00099371 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 5 Bead: 2 0.00578423 0.00126256 0.00296841 - 0.00126256 0.00027559 0.00064793 - 0.00296841 0.00064793 0.00152336 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 6 Bead: 2 0.00830663 0.00179376 0.00421904 - 0.00179376 0.00038735 0.00091107 - 0.00421904 0.00091107 0.00214290 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 7 Bead: 2 0.01126993 0.00240276 0.00565423 - 0.00240276 0.00051227 0.00120549 - 0.00565423 0.00120549 0.00283678 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 8 Bead: 2 0.01466540 0.00308057 0.00725349 - 0.00308057 0.00064710 0.00152365 - 0.00725349 0.00152365 0.00358756 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 9 Bead: 2 0.01848308 0.00381715 0.00899385 - 0.00381715 0.00078832 0.00185742 - 0.00899385 0.00185742 0.00437639 + 0.00000000 0.00000000 0.00000000 + diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 index 88dc6882c..8bad1d920 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_3 @@ -1,40 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 3 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 - 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 1 Bead: 3 0.00001956 0.00003747 0.00000527 - 0.00003747 0.00007178 0.00001010 - 0.00000527 0.00001010 0.00000142 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 2 Bead: 3 0.00007836 0.00014950 0.00002109 - 0.00014950 0.00028525 0.00004024 - 0.00002109 0.00004024 0.00000568 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 3 Bead: 3 0.00017675 0.00033499 0.00004743 - 0.00033499 0.00063489 0.00008990 - 0.00004743 0.00008990 0.00001273 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 4 Bead: 3 0.00031534 0.00059207 0.00008427 - 0.00059207 0.00111167 0.00015822 - 0.00008427 0.00015822 0.00002252 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 5 Bead: 3 0.00049496 0.00091817 0.00013156 - 0.00091817 0.00170324 0.00024405 - 0.00013156 0.00024405 0.00003497 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 6 Bead: 3 0.00071669 0.00130996 0.00018924 - 0.00130996 0.00239433 0.00034589 - 0.00018924 0.00034589 0.00004997 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 7 Bead: 3 0.00098184 0.00176339 0.00025723 - 0.00176339 0.00316704 0.00046198 - 0.00025723 0.00046198 0.00006739 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 8 Bead: 3 0.00129197 0.00227370 0.00033541 - 0.00227370 0.00400142 0.00059027 - 0.00033541 0.00059027 0.00008707 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 9 Bead: 3 0.00164887 0.00283544 0.00042364 - 0.00283544 0.00487588 0.00072851 - 0.00042364 0.00072851 0.00010885 + 0.00000000 0.00000000 0.00000000 + diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 index 374e637dc..9b86d4863 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_4 @@ -1,40 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 4 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 - 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 1 Bead: 4 0.00002557 -0.00003573 0.00000507 - -0.00003573 0.00004994 -0.00000709 - 0.00000507 -0.00000709 0.00000101 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 2 Bead: 4 0.00010212 -0.00014234 0.00002023 - -0.00014234 0.00019841 -0.00002820 - 0.00002023 -0.00002820 0.00000401 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 3 Bead: 4 0.00022924 -0.00031808 0.00004526 - -0.00031808 0.00044134 -0.00006281 - 0.00004526 -0.00006281 0.00000894 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 4 Bead: 4 0.00040621 -0.00056004 0.00007985 - -0.00056004 0.00077212 -0.00011009 - 0.00007985 -0.00011009 0.00001570 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 5 Bead: 4 0.00063204 -0.00086423 0.00012352 - -0.00086423 0.00118172 -0.00016890 - 0.00012352 -0.00016890 0.00002414 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 6 Bead: 4 0.00090550 -0.00122563 0.00017570 - -0.00122563 0.00165896 -0.00023782 - 0.00017570 -0.00023782 0.00003409 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 7 Bead: 4 0.00122505 -0.00163825 0.00023570 - -0.00163825 0.00219082 -0.00031520 - 0.00023570 -0.00031520 0.00004535 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 8 Bead: 4 0.00158894 -0.00209521 0.00030272 - -0.00209521 0.00276279 -0.00039917 - 0.00030272 -0.00039917 0.00005767 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 9 Bead: 4 0.00199517 -0.00258888 0.00037587 - -0.00258888 0.00335926 -0.00048772 - 0.00037587 -0.00048772 0.00007081 + 0.00000000 0.00000000 0.00000000 + diff --git a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 index 0f331ab72..83225f146 100644 --- a/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 +++ b/ipi_tests/regression_tests/tests/XTRA-JSON/FRICTION_DIPOLE/ref_simulation.friction_5 @@ -1,40 +1,40 @@ #*EXTRAS*# Step: 0 Bead: 5 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 - 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 1 Bead: 5 0.00006157 0.00000678 -0.00000484 - 0.00000678 0.00000075 -0.00000053 - -0.00000484 -0.00000053 0.00000038 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 2 Bead: 5 0.00024582 0.00002709 -0.00001928 - 0.00002709 0.00000299 -0.00000213 - -0.00001928 -0.00000213 0.00000151 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 3 Bead: 5 0.00055136 0.00006081 -0.00004314 - 0.00006081 0.00000671 -0.00000476 - -0.00004314 -0.00000476 0.00000337 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 4 Bead: 5 0.00097590 0.00010773 -0.00007608 - 0.00010773 0.00001189 -0.00000840 - -0.00007608 -0.00000840 0.00000593 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 5 Bead: 5 0.00151625 0.00016756 -0.00011767 - 0.00016756 0.00001852 -0.00001300 - -0.00011767 -0.00001300 0.00000913 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 6 Bead: 5 0.00216834 0.00023994 -0.00016734 - 0.00023994 0.00002655 -0.00001852 - -0.00016734 -0.00001852 0.00001291 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 7 Bead: 5 0.00292727 0.00032441 -0.00022440 - 0.00032441 0.00003595 -0.00002487 - -0.00022440 -0.00002487 0.00001720 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 8 Bead: 5 0.00378732 0.00042041 -0.00028809 - 0.00042041 0.00004667 -0.00003198 - -0.00028809 -0.00003198 0.00002191 + 0.00000000 0.00000000 0.00000000 + #*EXTRAS*# Step: 9 Bead: 5 0.00474201 0.00052731 -0.00035753 - 0.00052731 0.00005864 -0.00003976 - -0.00035753 -0.00003976 0.00002696 + 0.00000000 0.00000000 0.00000000 + From 7466559174d13457df74dba06af5d9220ad590bf Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 26 Jan 2021 13:07:33 +0100 Subject: [PATCH 033/120] Update instanton 070K_D reference --- ipi/utils/instools.py | 2 +- .../ref_simulation.instanton_FINAL.hess_14 | 2 +- .../ref_simulation.instanton_FINAL_14.ener | 16 +++++++-------- .../ref_simulation.instanton_FINAL_14.xyz | 20 +++++++++---------- ...f_simulation.instanton_FINAL_forces_14.xyz | 20 +++++++++---------- 5 files changed, 30 insertions(+), 30 deletions(-) diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 8027fa799..8a1bc0708 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -238,7 +238,7 @@ def print_instanton_geo( # print_file("xyz", pos[0], cell, out, title='positions{angstrom}') unit = "angstrom" - unit = "atomic_unit" + #unit = "atomic_unit" unit2 = "atomic_unit" a, b, c, alpha, beta, gamma = mt.h2abc_deg(cell.h) diff --git a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL.hess_14 b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL.hess_14 index e9e209358..2699e01f2 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL.hess_14 +++ b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL.hess_14 @@ -1 +1 @@ --1.511234567911148852e-05 0.000000000000000000e+00 0.000000000000000000e+00 -1.619234579671238738e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.369546144417611744e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.326578116922596862e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.265946602777011196e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.265946602777011196e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.326578116923030543e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.369546144416310701e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.619234579671238738e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.511234567911148852e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 +-1.511234568041253112e-05 0.000000000000000000e+00 0.000000000000000000e+00 -1.619234579671238738e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.369546144417611744e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.326578116923030543e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.265946602777228036e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.265946602777120483e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.326578116922596862e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.369546144416310701e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.619234579671238738e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.511234567911148852e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.ener b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.ener index 7e9b26ace..d927ccf20 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.ener +++ b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.ener @@ -1,11 +1,11 @@ #Bead Energy (eV) -0 -0.14343279483760368 +0 -0.14343279483760363 1 -0.12327370894308376 -2 -0.08492613091085341 -3 -0.0383634079802178 -4 -0.00482467493457088 -5 -0.00482467493457088 -6 -0.038363407980217784 -7 -0.08492613091085341 -8 -0.12327370894308376 +2 -0.08492613091085355 +3 -0.038363407980217715 +4 -0.004824674934570903 +5 -0.004824674934570893 +6 -0.03836340798021765 +7 -0.08492613091085349 +8 -0.12327370894308373 9 -0.14343279483760368 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.xyz b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.xyz index e39b9b577..cbc9e7db6 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.xyz +++ b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_14.xyz @@ -1,30 +1,30 @@ 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 0 -D -0.609461931780188 1.1137272420846299e-22 8.427362054271108e-25 +D -0.6094619317801879 1.6104827368065263e-24 1.1081815923000925e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 1 -D -0.5557417708222971 7.027009839661728e-23 1.7600434456498942e-24 +D -0.5557417708222971 1.677696855769233e-23 1.7841995300134962e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 2 -D -0.4489189134472901 2.3684782380085104e-22 -1.712791619837993e-22 +D -0.4489189134472904 3.7784273216144975e-23 2.384135693720897e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 3 -D -0.2934978149735784 6.232130434045628e-23 -3.1057983364618696e-23 +D -0.2934978149735781 1.1035337119296778e-22 1.9138820804253295e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 4 -D -0.10229512847387665 -1.9787292636983076e-22 -6.492967661431954e-24 +D -0.1022951284738769 -1.6980250362903467e-22 -4.1282364039520153e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 5 -D 0.10229512847387665 -3.7372451036208094e-22 -7.353460260048473e-24 +D 0.10229512847387678 -5.199646493634632e-22 -9.71280838771004e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 6 -D 0.29349781497357835 4.271027195739947e-22 7.271784610416283e-24 +D 0.29349781497357785 5.575634135558346e-22 9.288624159859659e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 7 -D 0.44891891344729007 -1.715579770485968e-22 -1.9224052584379088e-24 +D 0.44891891344729024 -2.1876152337489973e-22 -3.31414797715082e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 8 -D 0.5557417708222971 3.488328449660741e-23 6.113442806680771e-25 +D 0.555741770822297 4.2618728081645054e-23 6.097192636298886e-23 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 9 -D 0.609461931780188 -3.9073314759327645e-24 -1.4768502469056048e-25 +D 0.609461931780188 -4.3411928409946874e-24 -6.6060611595870926e-24 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_forces_14.xyz b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_forces_14.xyz index 54d90239f..bb0c37f12 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_forces_14.xyz +++ b/ipi_tests/regression_tests/tests/INSTANTON/070K_D/ref_simulation.instanton_FINAL_forces_14.xyz @@ -1,30 +1,30 @@ 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D -0.007326200706006197 -1.159976574373843e-22 -8.777321948616472e-25 +D -0.007326200706006197 -1.6773606476863848e-24 -1.1542006324765216e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D -0.007241992673455008 -7.318817834288647e-23 -1.8331321078334203e-24 +D -0.007241992673455008 -1.7473659420868177e-23 -1.8582913128268517e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D -0.006627688043190179 -2.4668331429710506e-22 1.783918073223289e-22 +D -0.006627688043190184 -3.935332651864748e-23 -2.4831407999577545e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D -0.004879789840997951 -6.49092977056396e-23 3.234771655833539e-23 +D -0.0048797898409979465 -1.1493597413261158e-22 -1.993359141733699e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D -0.0018257582707856108 2.0608992095962627e-22 6.762598687386389e-24 +D -0.0018257582707856153 1.768538283314637e-22 4.299668124395013e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D 0.0018257582707856108 3.8924402753938085e-22 7.65882463849892e-24 +D 0.0018257582707856134 5.415570257895285e-22 1.011614852846465e-21 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D 0.00487978984099795 -4.448388535687337e-22 -7.573757274884134e-24 +D 0.004879789840997943 -5.807171397209454e-22 -9.674349361727637e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D 0.006627688043190179 1.7868220063545488e-22 2.002236258553886e-24 +D 0.006627688043190182 2.278459508759479e-22 3.4517733536873345e-22 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D 0.007241992673455008 -3.633186953166768e-23 -6.367313446738073e-25 +D 0.007241992673455008 -4.438853997302181e-23 -6.35038846164272e-23 1 CELL(abcABC): 200.000000 200.000000 200.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D 0.007326200706006197 4.069589760516221e-24 1.5381788516389292e-25 +D 0.007326200706006197 4.5214679233020116e-24 6.880388576702918e-24 From 476743bfdcd006a4d5500469fe3cdb144ada6e6f Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 26 Jan 2021 13:11:41 +0100 Subject: [PATCH 034/120] Update instanton 200K references --- .../ref_simulation.instanton_FINAL.hess_21 | 2 +- .../ref_simulation.instanton_FINAL_21.ener | 20 +++++++++---------- .../ref_simulation.instanton_FINAL_21.xyz | 20 +++++++++---------- ...f_simulation.instanton_FINAL_forces_21.xyz | 20 +++++++++---------- 4 files changed, 31 insertions(+), 31 deletions(-) diff --git a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL.hess_21 b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL.hess_21 index 912d12b64..bcb4fbf30 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL.hess_21 +++ b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL.hess_21 @@ -1 +1 @@ --9.534115366002663197e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115367378071665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115369652405164e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115371973701097e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115373427723764e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115373427723764e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115371973701097e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115369652406899e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115367378071665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115366002663197e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.646977960169688560e-20 5.511521610893899137e-01 0.000000000000000000e+00 1.323488980084844280e-20 5.511521610893899137e-01 0.000000000000000000e+00 9.926167350636332098e-21 5.511521610893899137e-01 0.000000000000000000e+00 3.308722450212110699e-21 5.511521610893899137e-01 0.000000000000000000e+00 1.323488980084844280e-20 5.511521610893899137e-01 0.000000000000000000e+00 -2.646977960169688560e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.646977960169688560e-20 5.511521610893899137e-01 0.000000000000000000e+00 -5.293955920339377119e-20 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.504632769052528010e-33 5.511521610893899137e-01 -2.646977960169688560e-20 4.513898307157584031e-33 5.511521610893899137e-01 1.323488980084844280e-20 0.000000000000000000e+00 5.511521610893899137e-01 9.926167350636332098e-21 0.000000000000000000e+00 5.511521610893899137e-01 3.308722450212110699e-21 0.000000000000000000e+00 5.511521610893899137e-01 1.323488980084844280e-20 0.000000000000000000e+00 5.511521610893899137e-01 -2.646977960169688560e-20 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.314894069318850772e-33 5.511521610893899137e-01 -2.646977960169688560e-20 0.000000000000000000e+00 5.511521610893899137e-01 +-9.534115366002663197e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115367378071665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115369652403429e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115371973701097e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115373427723764e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115373427723764e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115371973701097e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115369652405164e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115367378071665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.534115366002663197e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.646977960169688560e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 9.926167350636332098e-21 5.511521610893899137e-01 0.000000000000000000e+00 3.308722450212110699e-21 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.646977960169688560e-20 5.511521610893899137e-01 0.000000000000000000e+00 -2.646977960169688560e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 -2.646977960169688560e-20 3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.504632769052528010e-33 5.511521610893899137e-01 9.926167350636332098e-21 0.000000000000000000e+00 5.511521610893899137e-01 3.308722450212110699e-21 3.317098121226642562e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.291384182302405022e-33 5.511521610893899137e-01 -2.646977960169688560e-20 3.338403956335296523e-33 5.511521610893899137e-01 -2.646977960169688560e-20 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.ener b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.ener index 3b930ba2e..644becc1e 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.ener +++ b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.ener @@ -1,11 +1,11 @@ #Bead Energy (eV) -0 -1.37775780453328e-10 -1 -1.1291396788390895e-10 -2 -7.180330689960257e-11 -3 -2.984375243802154e-11 -4 -3.560944706496713e-12 -5 -3.560944706523794e-12 -6 -2.9843752438100254e-11 -7 -7.180330689972532e-11 -8 -1.1291396788406124e-10 -9 -1.3777578045349552e-10 +0 -1.3777578045348474e-10 +1 -1.1291396788404651e-10 +2 -7.180330689970496e-11 +3 -2.9843752438082974e-11 +4 -3.5609447065153647e-12 +5 -3.5609447065071947e-12 +6 -2.9843752438059936e-11 +7 -7.180330689966972e-11 +8 -1.1291396788400027e-10 +9 -1.377757804534353e-10 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.xyz b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.xyz index fc91e499a..ea2a29cd5 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.xyz +++ b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_21.xyz @@ -1,30 +1,30 @@ 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 0 -H 1.7245945508553164e-05 -8.797105230493507e-22 -1.109431413432702e-21 +H 1.7245945508562973e-05 -4.8505189472921303e-20 3.497798895077511e-20 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 1 -H 1.5612570201308098e-05 6.935858496458954e-21 5.210024734691156e-21 +H 1.5612570201317605e-05 -2.5876442277918504e-20 5.84880880140846e-21 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 2 -H 1.2450098651039954e-05 -1.3945570013874437e-20 4.307906330033176e-22 +H 1.2450098651048833e-05 -3.360024561683441e-20 -5.703252382784133e-21 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 3 -H 8.026519848285962e-06 -6.49187560895709e-22 5.1319016204125034e-21 +H 8.026519848294224e-06 -1.2534953859766837e-20 1.5063115489477572e-21 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 4 -H 2.7725742448389058e-06 7.295941581435332e-23 1.3522620020588455e-21 +H 2.7725742448461674e-06 -2.7792197572053768e-21 -2.0742840156055837e-22 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 5 -H -2.7725742448494484e-06 5.839840733113506e-23 2.176123847568938e-22 +H -2.7725742448429868e-06 1.027862707680397e-23 5.369068990669338e-23 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 6 -H -8.026519848296546e-06 -4.567849494778858e-22 -3.1117761906564286e-23 +H -8.026519848291125e-06 -7.618778479042584e-22 -1.2519762182879548e-22 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 7 -H -1.2450098651050598e-05 -4.832189020918363e-22 5.839242732417421e-22 +H -1.2450098651045779e-05 -8.307544958648226e-22 -4.402621557423354e-23 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 8 -H -1.5612570201318625e-05 1.5433374478105e-22 7.61170144868019e-22 +H -1.5612570201314407e-05 6.272469662180323e-22 1.1201898155452909e-22 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 9 -H -1.7245945508563647e-05 -3.615824627480722e-22 -5.524538296088231e-22 +H -1.7245945508559876e-05 -5.6007087099999715e-22 -7.261150279686813e-22 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_forces_21.xyz b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_forces_21.xyz index 9143664dc..dd2d9f7b0 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_forces_21.xyz +++ b/ipi_tests/regression_tests/tests/INSTANTON/200K/ref_simulation.instanton_FINAL_forces_21.xyz @@ -1,30 +1,30 @@ 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 3.107179785628627e-07 9.162419310650803e-22 1.1555023544612248e-21 +H 3.1071797856303947e-07 5.0519446232489647e-20 -3.6430506742083563e-20 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.812896660811435e-07 -7.223881283540349e-21 -5.4263794722647206e-21 +H 2.812896660813148e-07 2.6951003563798544e-20 -6.0916900846624245e-21 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.243118235723528e-07 1.4524682454661044e-20 -4.486799135919456e-22 +H 2.2431182357251274e-07 3.499555037890833e-20 5.94008919938827e-21 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.4461277414090507e-07 6.761461285659141e-22 -5.345012168802926e-21 +H 1.446127741410539e-07 1.3055488174079909e-20 -1.568863582090061e-21 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 4.9953113012457476e-08 -7.59891740335282e-23 -1.4084168776082968e-21 +H 4.99531130125883e-08 2.894631370748336e-21 2.1604220277461325e-22 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -4.995311301264743e-08 -6.082349602768438e-23 -2.2664909241076375e-22 +H -4.9953113012531e-08 -1.0705463757446002e-23 -5.592028299241505e-23 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -1.4461277414109578e-07 4.757536862698236e-22 3.240997750130857e-23 +H -1.4461277414099808e-07 7.935160627382248e-22 1.3039665638140384e-22 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -2.243118235725445e-07 5.03285351691689e-22 -6.081726769122365e-22 +H -2.2431182357245769e-07 8.652529253529023e-22 4.585447566933367e-23 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -2.8128966608133317e-07 -1.6074270415287703e-22 -7.927789711841795e-22 +H -2.812896660812572e-07 -6.532944150653096e-22 -1.1667075166919147e-22 1 CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -3.1071797856305164e-07 3.765977616809475e-22 5.753953720031728e-22 +H -3.107179785629837e-07 5.83328723407292e-22 7.562681336302224e-22 From f93fc18bc9e65d7d80537e726802af434edc07ee Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 26 Jan 2021 13:14:44 +0100 Subject: [PATCH 035/120] make it pretty --- ipi/utils/instools.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 8a1bc0708..f4571e584 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -238,7 +238,7 @@ def print_instanton_geo( # print_file("xyz", pos[0], cell, out, title='positions{angstrom}') unit = "angstrom" - #unit = "atomic_unit" + # unit = "atomic_unit" unit2 = "atomic_unit" a, b, c, alpha, beta, gamma = mt.h2abc_deg(cell.h) From 560f26be94e18d697b576bfc49668ee8fe22b3c9 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 26 Jan 2021 14:01:24 +0100 Subject: [PATCH 036/120] add some examples for harmonic baths --- .../double_well/explicit_harmonic_bath/README | 6 + .../explicit_harmonic_bath/init.xyz | 60 + .../explicit_harmonic_bath/input.xml | 38 + .../double_well/meanfield_bath/README | 7 + .../double_well/meanfield_bath/init.xyz | 96 ++ .../double_well/meanfield_bath/input.xml | 40 + .../double_well/meanfield_bath/z_friction.dat | 1003 +++++++++++++++++ 7 files changed, 1250 insertions(+) create mode 100644 examples/pes/instanton/double_well/explicit_harmonic_bath/README create mode 100644 examples/pes/instanton/double_well/explicit_harmonic_bath/init.xyz create mode 100644 examples/pes/instanton/double_well/explicit_harmonic_bath/input.xml create mode 100644 examples/pes/instanton/double_well/meanfield_bath/README create mode 100644 examples/pes/instanton/double_well/meanfield_bath/init.xyz create mode 100644 examples/pes/instanton/double_well/meanfield_bath/input.xml create mode 100644 examples/pes/instanton/double_well/meanfield_bath/z_friction.dat diff --git a/examples/pes/instanton/double_well/explicit_harmonic_bath/README b/examples/pes/instanton/double_well/explicit_harmonic_bath/README new file mode 100644 index 000000000..de867b8e3 --- /dev/null +++ b/examples/pes/instanton/double_well/explicit_harmonic_bath/README @@ -0,0 +1,6 @@ +Commands: + [i-pi] + i-pi input.xml + [driver] + i-pi-driver -u -m harmonic_bath -o 1,1.674,500 + diff --git a/examples/pes/instanton/double_well/explicit_harmonic_bath/init.xyz b/examples/pes/instanton/double_well/explicit_harmonic_bath/init.xyz new file mode 100644 index 000000000..322a4c670 --- /dev/null +++ b/examples/pes/instanton/double_well/explicit_harmonic_bath/init.xyz @@ -0,0 +1,60 @@ +4 + +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +4 + +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +4 + +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +4 + +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +4 + +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +4 + +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +4 + +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +4 + +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +4 + +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +4 + +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 diff --git a/examples/pes/instanton/double_well/explicit_harmonic_bath/input.xml b/examples/pes/instanton/double_well/explicit_harmonic_bath/input.xml new file mode 100644 index 000000000..8cca98ffb --- /dev/null +++ b/examples/pes/instanton/double_well/explicit_harmonic_bath/input.xml @@ -0,0 +1,38 @@ + + + [ step, potential{electronvolt}] + + 100 + +
localhost
+
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + powell + none + true + true + 0.05 + + + +
diff --git a/examples/pes/instanton/double_well/meanfield_bath/README b/examples/pes/instanton/double_well/meanfield_bath/README new file mode 100644 index 000000000..de34452dc --- /dev/null +++ b/examples/pes/instanton/double_well/meanfield_bath/README @@ -0,0 +1,7 @@ + +Commands: + [i-pi] + i-pi input.xml + [driver] + i-pi-driver -u -m meanfield_bath -o 1.67432,0.05,0.00,0.5 + diff --git a/examples/pes/instanton/double_well/meanfield_bath/init.xyz b/examples/pes/instanton/double_well/meanfield_bath/init.xyz new file mode 100644 index 000000000..f0097d823 --- /dev/null +++ b/examples/pes/instanton/double_well/meanfield_bath/init.xyz @@ -0,0 +1,96 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8925581 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8772773 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8548895 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7471555 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6984112 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6435957 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.3712966 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2926568 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2111588 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2111588 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2926568 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.3712966 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6435957 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6984112 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7471555 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8548895 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8772773 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8925581 -0.0000000 -0.0000000 diff --git a/examples/pes/instanton/double_well/meanfield_bath/input.xml b/examples/pes/instanton/double_well/meanfield_bath/input.xml new file mode 100644 index 000000000..1baf21372 --- /dev/null +++ b/examples/pes/instanton/double_well/meanfield_bath/input.xml @@ -0,0 +1,40 @@ + + + [ step, potential{electronvolt}] + + 35 + +
localhost
+
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + true + z_friction.dat + powell + none + true + true + 0.05 + + + +
diff --git a/examples/pes/instanton/double_well/meanfield_bath/z_friction.dat b/examples/pes/instanton/double_well/meanfield_bath/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/examples/pes/instanton/double_well/meanfield_bath/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 From 6cfb13106e212ae3e983f3024585f96653fc8938 Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Tue, 26 Jan 2021 14:46:48 +0100 Subject: [PATCH 037/120] Linting... --- drivers/driver.py | 169 ++++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 169 insertions(+) create mode 100755 drivers/driver.py diff --git a/drivers/driver.py b/drivers/driver.py new file mode 100755 index 000000000..fe36473f0 --- /dev/null +++ b/drivers/driver.py @@ -0,0 +1,169 @@ +#!/usr/bin/env python3 +import socket +import argparse +import numpy as np + +description = """ +Minimal example of a Python driver connecting to i-PI and exchanging energy, forces, etc. +""" + + +def recv_data(sock, data): + """ Fetches binary data from i-PI socket. """ + blen = data.itemsize * data.size + buf = np.zeros(blen, np.byte) + + bpos = 0 + while bpos < blen: + timeout = False + try: + bpart = 1 + bpart = sock.recv_into(buf[bpos:], blen - bpos) + except socket.timeout: + print(" @SOCKET: Timeout in status recvall, trying again!") + timeout = True + pass + if not timeout and bpart == 0: + raise RuntimeError("Socket disconnected!") + bpos += bpart + if np.isscalar(data): + return np.frombuffer(buf[0:blen], data.dtype)[0] + else: + return np.frombuffer(buf[0:blen], data.dtype).reshape(data.shape) + + +def send_data(sock, data): + """ Sends binary data to i-PI socket. """ + + if np.isscalar(data): + data = np.array([data], data.dtype) + buf = data.tobytes() + sock.send(buf) + + +HDRLEN = 12 # number of characters of the default message strings + + +def Message(mystr): + """Returns a header of standard length HDRLEN.""" + + # convert to bytestream since we'll be sending this over a socket + return str.ljust(str.upper(mystr), HDRLEN).encode() + + +def dummy_driver(cell, pos): + """ Does nothing, but returns properties that can be used by the driver loop.""" + pot = 0.0 + force = pos * 0.0 # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + return pot, force, vir, extras + + +def driver(unix=False, address="", port=12345, driver=dummy_driver): + """Minimal socket client for i-PI.""" + + # Opens a socket to i-PI + if unix: + sock = socket.socket(socket.AF_UNIX, socket.SOCK_STREAM) + sock.connect("/tmp/ipi_" + address) + else: + sock = socket.socket(socket.AF_INET, socket.SOCK_STREAM) + raise ValueError("We haven't yet implemented the mf") + + f_init = False + f_data = False + f_verbose = False + + # initializes structure arrays + cell = np.zeros((3, 3), float) + icell = np.zeros((3, 3), float) + pos = np.zeros(0, float) + + # initializes return arrays + pot = 0.0 + force = np.zeros(0, float) + vir = np.zeros((3, 3), float) + while True: # ah the infinite loop! + header = sock.recv(HDRLEN) + + if header == Message("STATUS"): + # responds to a status request + if not f_init: + sock.sendall(Message("NEEDINIT")) + elif f_data: + sock.sendall(Message("HAVEDATA")) + else: + sock.sendall(Message("READY")) + elif header == Message("INIT"): + # initialization + rid = recv_data(sock, np.int32()) + initlen = recv_data(sock, np.int32()) + initstr = recv_data(sock, np.chararray(initlen)) + if f_verbose: + print(rid, initstr) + f_init = True # we are initialized now + elif header == Message("POSDATA"): + # receives structural information + cell = recv_data(sock, cell) + icell = recv_data( + sock, icell + ) # inverse of the cell. mostly useless legacy stuff + nat = recv_data(sock, np.int32()) + if len(pos) == 0: + # shapes up the position array + pos.resize((nat, 3)) + force.resize((nat, 3)) + else: + if len(pos) != nat: + raise RuntimeError("Atom number changed during i-PI run") + pos = recv_data(sock, pos) + + ##### THIS IS THE TIME TO DO SOMETHING WITH THE POSITIONS! + pot, force, vir, extras = driver(cell, pos) + f_data = True + elif header == Message("GETFORCE"): + sock.sendall(Message("FORCEREADY")) + + send_data(sock, np.float64(pot)) + send_data(sock, np.int32(nat)) + send_data(sock, force) + send_data(sock, vir) + print(len(extras)) + send_data(sock, np.int32(len(extras))) + sock.sendall(extras.encode("utf-8")) + + f_data = False + elif header == Message("EXIT"): + print("Received exit message from i-PI. Bye bye!") + return + + +if __name__ == "__main__": + + parser = argparse.ArgumentParser(description=description) + + parser.add_argument( + "-u", + "--unix", + action="store_true", + default=False, + help="Use a UNIX domain socket.", + ) + parser.add_argument( + "-a", + "--address", + type=str, + default="localhost", + help="Host name (for INET sockets) or name of the UNIX domain socket to connect to.", + ) + parser.add_argument( + "-p", + "--port", + type=int, + default=12345, + help="TCP/IP port number. Ignored when using UNIX domain sockets.", + ) + + args = parser.parse_args() + driver(unix=args.unix, address=args.address, port=args.port, driver=dummy_driver) From 501b607fa92b5aa94847b35970a61849f78c28f7 Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Tue, 26 Jan 2021 15:27:40 +0100 Subject: [PATCH 038/120] Cleaned-up driver --- drivers/driver.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/drivers/driver.py b/drivers/driver.py index fe36473f0..537353ef2 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -60,7 +60,7 @@ def dummy_driver(cell, pos): return pot, force, vir, extras -def driver(unix=False, address="", port=12345, driver=dummy_driver): +def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver): """Minimal socket client for i-PI.""" # Opens a socket to i-PI @@ -69,7 +69,7 @@ def driver(unix=False, address="", port=12345, driver=dummy_driver): sock.connect("/tmp/ipi_" + address) else: sock = socket.socket(socket.AF_INET, socket.SOCK_STREAM) - raise ValueError("We haven't yet implemented the mf") + sock.connect((address, port)) f_init = False f_data = False @@ -166,4 +166,4 @@ def driver(unix=False, address="", port=12345, driver=dummy_driver): ) args = parser.parse_args() - driver(unix=args.unix, address=args.address, port=args.port, driver=dummy_driver) + run_driver(unix=args.unix, address=args.address, port=args.port, driver_function=dummy_driver) From abcc0f5b36719bbe4f53b2012f1aba06ea4e84a3 Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Tue, 26 Jan 2021 15:40:21 +0100 Subject: [PATCH 039/120] Bug! --- drivers/driver.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/drivers/driver.py b/drivers/driver.py index 537353ef2..5c6ed3e71 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -120,7 +120,7 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) pos = recv_data(sock, pos) ##### THIS IS THE TIME TO DO SOMETHING WITH THE POSITIONS! - pot, force, vir, extras = driver(cell, pos) + pot, force, vir, extras = driver_function(cell, pos) f_data = True elif header == Message("GETFORCE"): sock.sendall(Message("FORCEREADY")) From e32a4ad65a383e3c049646ed7881910917dc05ec Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Tue, 26 Jan 2021 16:05:45 +0100 Subject: [PATCH 040/120] lint --- drivers/driver.py | 7 ++++++- 1 file changed, 6 insertions(+), 1 deletion(-) diff --git a/drivers/driver.py b/drivers/driver.py index 5c6ed3e71..6e71ad895 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -166,4 +166,9 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) ) args = parser.parse_args() - run_driver(unix=args.unix, address=args.address, port=args.port, driver_function=dummy_driver) + run_driver( + unix=args.unix, + address=args.address, + port=args.port, + driver_function=dummy_driver, + ) From 93a75378426e5afc7565f63e958c41269ecedca8 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 9 Feb 2021 13:31:31 +0100 Subject: [PATCH 041/120] fixes after the merge --- ipi/engine/forces.py | 16 ++++++---------- ipi/engine/motion/instanton.py | 24 ++++++++++++------------ 2 files changed, 18 insertions(+), 22 deletions(-) diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index 3cfa1fc9d..8ac13a5bb 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -935,7 +935,7 @@ def transfer_forces(self, refforce): dfkbself.ufvx.taint(taintme=False) def transfer_forces_manual( - self, new_q, new_v, new_forces, new_x=None, vir=np.zeros((3, 3)) + self, new_q, new_v, new_forces, new_extra={}, vir=np.zeros((3, 3)) ): """Manual (and flexible) version of the transfer forces function. Instead of passing a force object, list with vectors are passed @@ -949,29 +949,25 @@ def transfer_forces_manual( assert len(self.mforces) == len(new_q), msg assert len(self.mforces) == len(new_v), msg assert len(self.mforces) == len(new_forces), msg - if new_x == None: - new_x = [[None] * self.nbeads] * len(self.mforces) - info("WARNING: No extras information has been passed.", verbosity.debug) - - assert len(self.mforces) == len(new_x), msg for k in range(len(self.mforces)): mv = new_v[k] mf = new_forces[k] mq = new_q[k] - mextra = new_x[k] + mextra = new_extra[k] mself = self.mforces[k] assert mq.shape == mf.shape, msg assert mq.shape[0] == mv.shape[0], msg assert mself.nbeads == mv.shape[0], msg assert mself.nbeads == mq.shape[0], msg - assert mself.nbeads == len(mextra), msg - mxlist = mextra[:] dd(mself.beads).q.set(mq, manual=False) for b in range(mself.nbeads): - ufvx = [mv[b], mf[b], vir, mxlist[b]] + mx = {} + for key in mextra.keys(): + mx[key]=mextra[key][b] + ufvx = [mv[b], mf[b], vir, mx] dfkbself = dd(mself._forces[b]) dfkbself.ufvx.set(ufvx, manual=False) dfkbself.ufvx.taint(taintme=False) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 5bf9f4f02..25a86d49f 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -35,7 +35,6 @@ ) from ipi.utils.instools import print_instanton_hess, diag_banded, ms_pathway from ipi.utils.hesstools import get_hessian, clean_hessian, get_dynmat -from ipi.utils.xtratools import listDict __all__ = ["InstantonMotion"] @@ -411,9 +410,10 @@ def save(self, e, g, eta=None): def initialize(self, q, forces): """ Initialize potential, forces and friction """ - eta = np.array(forces.extras[0]["friction"]).reshape( + eta = np.array(forces.extras["friction"]).reshape( (q.shape[0], q.shape[1], q.shape[1]) ) + self.save(forces.pots, -forces.f, eta) def set_z_friction(self, z_friction): @@ -527,21 +527,22 @@ def compute_friction_terms(self): def get_full_extras(self, reduced_forces, full_mspath, indexes): """ Get the full extra strings """ diction = {} - for key in reduced_forces.extras[0].listofKeys(): - if str(key) != "nothing": - rkey = np.array(reduced_forces.extras[0][key]) + for key in reduced_forces.extras.keys(): + if str(key) != "raw": + red_data = np.array(reduced_forces.extras[key]) if self.spline: from scipy.interpolate import interp1d red_mspath = full_mspath[indexes] - spline = interp1d(red_mspath, rkey.T, kind="cubic") - full_key = spline(full_mspath).T + spline = interp1d(red_mspath, red_data.T, kind="cubic") + full_data = spline(full_mspath).T else: - full_key = rkey - if reduced_forces.extras[0][key]: - diction[key] = full_key + full_data = red_data + else: + full_data = reduced_forces.extras[key] + diction[key] = full_data - return listDict.fromDict(diction) + return diction def __call__(self, x, new_disc=True): """ Computes energy and gradient for optimization step""" @@ -552,7 +553,6 @@ def __call__(self, x, new_disc=True): full_q, full_mspath, get_all_info=True ) - # The following has to be joined to the json implementation full_extras = self.get_full_extras(reduced_forces, full_mspath, indexes) full_eta = np.zeros( (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) From 3ec1ebab20469492cbec5c926a57d8ab156e0ffb Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 9 Feb 2021 13:32:25 +0100 Subject: [PATCH 042/120] pretty --- ipi/engine/forces.py | 2 +- ipi/engine/motion/instanton.py | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index 8ac13a5bb..d20a7761c 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -966,7 +966,7 @@ def transfer_forces_manual( for b in range(mself.nbeads): mx = {} for key in mextra.keys(): - mx[key]=mextra[key][b] + mx[key] = mextra[key][b] ufvx = [mv[b], mf[b], vir, mx] dfkbself = dd(mself._forces[b]) dfkbself.ufvx.set(ufvx, manual=False) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 25a86d49f..f39c165b6 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -539,7 +539,7 @@ def get_full_extras(self, reduced_forces, full_mspath, indexes): else: full_data = red_data else: - full_data = reduced_forces.extras[key] + full_data = reduced_forces.extras[key] diction[key] = full_data return diction From bf3b862d54ca093d0e53109cf9285238f313bd9b Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Wed, 10 Feb 2021 09:36:39 +0100 Subject: [PATCH 043/120] Added 3D harmonic potential test for the python driver --- drivers/driver.py | 26 ++++++++++++++++++++++++-- examples/harmonic/README | 8 ++++++++ 2 files changed, 32 insertions(+), 2 deletions(-) diff --git a/drivers/driver.py b/drivers/driver.py index 6e71ad895..9639405ce 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -59,6 +59,14 @@ def dummy_driver(cell, pos): extras = "nada" return pot, force, vir, extras +def harm_driver(cell, pos): + """ Silly harmonic potential, with unit frequency in a.u.""" + pot = (pos**2).sum()*0.5 + force = -pos # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + return pot, force, vir, extras + def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver): """Minimal socket client for i-PI.""" @@ -129,7 +137,6 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) send_data(sock, np.int32(nat)) send_data(sock, force) send_data(sock, vir) - print(len(extras)) send_data(sock, np.int32(len(extras))) sock.sendall(extras.encode("utf-8")) @@ -164,11 +171,26 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) default=12345, help="TCP/IP port number. Ignored when using UNIX domain sockets.", ) + parser.add_argument( + "-m", + "--mode", + type=str, + default="dummy", + help="""Type of potential to be used to compute the potential and its derivatives. + Currently implemented: [dummy, harmonic] + """, + ) args = parser.parse_args() + + if args.mode == "harmonic": + d_f = harm_driver + else: + d_f = dummy_driver + run_driver( unix=args.unix, address=args.address, port=args.port, - driver_function=dummy_driver, + driver_function=d_f, ) diff --git a/examples/harmonic/README b/examples/harmonic/README index 16b15d995..4dff7399d 100644 --- a/examples/harmonic/README +++ b/examples/harmonic/README @@ -63,3 +63,11 @@ $ i-pi-driver -u -h harmonic -m harm -o 1 then run the driver as: $ i-pi-driver -h harmonic -m harm -o 1 -p port_no + + * You can also compare the Fortran and Python drivers, running the same i-PI input but using respectively + +$ i-pi-driver -u -h harmonic -m harm3d -o 1 + +or + +$ driver.py -u -a harmonic -m harmonic From c5ac40c0917805f2ac1022dfc31e045fbbde3a64 Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Wed, 10 Feb 2021 09:37:36 +0100 Subject: [PATCH 044/120] pretty --- drivers/driver.py | 7 ++++--- 1 file changed, 4 insertions(+), 3 deletions(-) diff --git a/drivers/driver.py b/drivers/driver.py index 9639405ce..1f2ee476e 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -59,9 +59,10 @@ def dummy_driver(cell, pos): extras = "nada" return pot, force, vir, extras + def harm_driver(cell, pos): """ Silly harmonic potential, with unit frequency in a.u.""" - pot = (pos**2).sum()*0.5 + pot = (pos ** 2).sum() * 0.5 force = -pos # makes a zero force with same shape as pos vir = cell * 0.0 # makes a zero virial with same shape as cell extras = "nada" @@ -182,12 +183,12 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) ) args = parser.parse_args() - + if args.mode == "harmonic": d_f = harm_driver else: d_f = dummy_driver - + run_driver( unix=args.unix, address=args.address, From 7940f7246fbeb551d9c79f90ac2f63cde1ccb992 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 10 Feb 2021 10:39:56 +0100 Subject: [PATCH 045/120] bugfix --- ipi/engine/forces.py | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index d20a7761c..768c8d048 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -935,7 +935,7 @@ def transfer_forces(self, refforce): dfkbself.ufvx.taint(taintme=False) def transfer_forces_manual( - self, new_q, new_v, new_forces, new_extra={}, vir=np.zeros((3, 3)) + self, new_q, new_v, new_forces, new_extra=None, vir=np.zeros((3, 3)) ): """Manual (and flexible) version of the transfer forces function. Instead of passing a force object, list with vectors are passed @@ -949,7 +949,8 @@ def transfer_forces_manual( assert len(self.mforces) == len(new_q), msg assert len(self.mforces) == len(new_v), msg assert len(self.mforces) == len(new_forces), msg - + if new_extra is None: + new_extra = [{} for i in range(len(self.mforces))] for k in range(len(self.mforces)): mv = new_v[k] mf = new_forces[k] From e037cbce5ee367c201220de498828f9f68221670 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 10 Feb 2021 10:42:45 +0100 Subject: [PATCH 046/120] pretty --- ipi/engine/forces.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index 768c8d048..9377c4625 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -950,7 +950,7 @@ def transfer_forces_manual( assert len(self.mforces) == len(new_v), msg assert len(self.mforces) == len(new_forces), msg if new_extra is None: - new_extra = [{} for i in range(len(self.mforces))] + new_extra = [{} for i in range(len(self.mforces))] for k in range(len(self.mforces)): mv = new_v[k] mf = new_forces[k] From 40a4af49db278bc7acd546c5d0b7fbc47900d8d2 Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Wed, 10 Feb 2021 11:53:08 +0100 Subject: [PATCH 047/120] Separated driver functions in drivers/ --- drivers/driver.py | 19 ++++++------------- drivers/drivers/__init__.py | 10 ++++++++++ drivers/drivers/harmonic.py | 9 +++++++++ 3 files changed, 25 insertions(+), 13 deletions(-) create mode 100644 drivers/drivers/__init__.py create mode 100644 drivers/drivers/harmonic.py diff --git a/drivers/driver.py b/drivers/driver.py index 1f2ee476e..deefa6a7a 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -2,6 +2,7 @@ import socket import argparse import numpy as np +from drivers import * description = """ Minimal example of a Python driver connecting to i-PI and exchanging energy, forces, etc. @@ -59,16 +60,6 @@ def dummy_driver(cell, pos): extras = "nada" return pot, force, vir, extras - -def harm_driver(cell, pos): - """ Silly harmonic potential, with unit frequency in a.u.""" - pot = (pos ** 2).sum() * 0.5 - force = -pos # makes a zero force with same shape as pos - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "nada" - return pot, force, vir, extras - - def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver): """Minimal socket client for i-PI.""" @@ -184,10 +175,12 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) args = parser.parse_args() - if args.mode == "harmonic": - d_f = harm_driver - else: + if args.mode in __drivers__: + d_f = __drivers__[args.mode] + elif args.mode == "dummy": d_f = dummy_driver + else: + raise ValueError("Unsupported driver mode ", args.mode) run_driver( unix=args.unix, diff --git a/drivers/drivers/__init__.py b/drivers/drivers/__init__.py new file mode 100644 index 000000000..7a83895c0 --- /dev/null +++ b/drivers/drivers/__init__.py @@ -0,0 +1,10 @@ +""" Small functions/classes providing access to driver PES to be called from driver.py """ + +from .harmonic import harm_driver + +__all__ = ["__drivers__", "harm_driver" ] + +# dictionary linking strings +__drivers__ = { + "harmonic" : harm_driver + } diff --git a/drivers/drivers/harmonic.py b/drivers/drivers/harmonic.py new file mode 100644 index 000000000..33e95c0b5 --- /dev/null +++ b/drivers/drivers/harmonic.py @@ -0,0 +1,9 @@ +""" Harmonic potential """ + +def harm_driver(cell, pos): + """ Silly harmonic potential, with unit frequency in a.u.""" + pot = (pos ** 2).sum() * 0.5 + force = -pos # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + return pot, force, vir, extras From 0ed316a0b5aa4bcea237a742c71ce198aa6953b2 Mon Sep 17 00:00:00 2001 From: Michele Ceriotti Date: Wed, 10 Feb 2021 11:58:12 +0100 Subject: [PATCH 048/120] make pretty (and renamed Makefile.style since we have just one makefile) Just lowering my (and I suspect others') barrier to make pretty before committing --- Makefile.style => Makefile | 0 README.rst | 4 ++-- drivers/driver.py | 1 + drivers/drivers/__init__.py | 8 +++----- drivers/drivers/harmonic.py | 1 + 5 files changed, 7 insertions(+), 7 deletions(-) rename Makefile.style => Makefile (100%) diff --git a/Makefile.style b/Makefile similarity index 100% rename from Makefile.style rename to Makefile diff --git a/README.rst b/README.rst index 2cafeb22e..b8ac671e5 100644 --- a/README.rst +++ b/README.rst @@ -114,8 +114,8 @@ BEFORE proceeding to a pull request, the minimal requirement is that you run :: - $ make -f Makefile.style lint - $ make -f Makefile.style pretty + $ make lint + $ make pretty This will ensure the formatting and linting requirement are applied in the whole directory tree. Please resolve any warnings or errors that may appear. Your diff --git a/drivers/driver.py b/drivers/driver.py index deefa6a7a..59eb0a003 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -60,6 +60,7 @@ def dummy_driver(cell, pos): extras = "nada" return pot, force, vir, extras + def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver): """Minimal socket client for i-PI.""" diff --git a/drivers/drivers/__init__.py b/drivers/drivers/__init__.py index 7a83895c0..70d85e425 100644 --- a/drivers/drivers/__init__.py +++ b/drivers/drivers/__init__.py @@ -2,9 +2,7 @@ from .harmonic import harm_driver -__all__ = ["__drivers__", "harm_driver" ] +__all__ = ["__drivers__", "harm_driver"] -# dictionary linking strings -__drivers__ = { - "harmonic" : harm_driver - } +# dictionary linking strings +__drivers__ = {"harmonic": harm_driver} diff --git a/drivers/drivers/harmonic.py b/drivers/drivers/harmonic.py index 33e95c0b5..898717cf3 100644 --- a/drivers/drivers/harmonic.py +++ b/drivers/drivers/harmonic.py @@ -1,5 +1,6 @@ """ Harmonic potential """ + def harm_driver(cell, pos): """ Silly harmonic potential, with unit frequency in a.u.""" pot = (pos ** 2).sum() * 0.5 From 5b2a20fb8cedb0d7ebd2fdea23d669cd6b021830 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 10 Feb 2021 13:07:55 +0100 Subject: [PATCH 049/120] bugfix --- ipi/engine/motion/instanton.py | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index f39c165b6..712b32e3e 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -410,6 +410,8 @@ def save(self, e, g, eta=None): def initialize(self, q, forces): """ Initialize potential, forces and friction """ + print('ALBERTO-friction') + print(forces.extras["friction"].shape) eta = np.array(forces.extras["friction"]).reshape( (q.shape[0], q.shape[1], q.shape[1]) ) @@ -1227,8 +1229,7 @@ def bind(self, geop): self.optarrays["hessian"] = geop.optarrays["hessian"] if self.options["friction"]: - - if geop.optarrays["fric_hessian"].size != ( + if geop.optarrays["fric_hessian"].shape != ( self.beads.nbeads, self.beads.natoms * 3, self.beads.natoms * 3, From f9f5c0c3a4f58434768a2cb47ce133a0bc1d5b48 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 10 Feb 2021 20:10:43 +0100 Subject: [PATCH 050/120] resolve sign problems. need cleaning --- ipi/engine/motion/instanton.py | 24 +++++++++++++++++++++--- 1 file changed, 21 insertions(+), 3 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 712b32e3e..eb3337b9b 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -441,7 +441,13 @@ def get_fric_rp_hessian(self, fric_hessian): # nbeads = self.dbeads.nbeads s = self.eta - dgdq = s ** 0.5 + #ALBERTO + print('#ALBERTO') + from scipy.linalg import sqrtm + dgdq = np.zeros(s.shape) + for i in range(self.dbeads.nbeads): + dgdq[i]=sqrtm(s[i]) + #dgdq = s ** 0.5 -> won't work for multiD # gq = self.obtain_g(s) z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] @@ -451,6 +457,7 @@ def get_fric_rp_hessian(self, fric_hessian): h_fric = np.zeros((ndof, ndof)) + print('#ALBERTO-check this') # ALBERTO # Block diag: # g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] @@ -481,7 +488,13 @@ def get_fric_rp_hessian(self, fric_hessian): def obtain_g(self, s): """ Computes g from s """ - ss = s ** 0.5 + print('#ALBERTO') + from scipy.linalg import sqrtm + ss = np.zeros(s.shape) + for i in range(self.dbeads.nbeads): + ss[i]=sqrtm(s[i]) + #ss = s ** 0.5 -> won't work for multiD + from scipy.interpolate import interp1d from scipy.integrate import quad @@ -507,7 +520,12 @@ def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ s = self.eta - dgdq = s ** 0.5 + print('#ALBERTO') + from scipy.linalg import sqrtm + dgdq = np.zeros(s.shape) + for i in range(self.dbeads.nbeads): + dgdq[i]=sqrtm(s[i]) + #dgdq = s ** 0.5 -> won't work for multiD gq = self.obtain_g(s) z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] From e2e028bb548d15ff2c4b9bf7b8a07f262194a00f Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 11 Feb 2021 11:46:20 +0100 Subject: [PATCH 051/120] bugfix restart hessian calculation --- ipi/utils/hesstools.py | 4 ++++ 1 file changed, 4 insertions(+) diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 2f5dfd1d2..f76b778a4 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -240,6 +240,10 @@ def get_hessian( + ".tmp). " ) ) + if ( b.shape == eta_h.shape ): # Check that the last temporary file was properly written + break + else: + continue # Start calculation: for j in range(i0 + 1, ii): From a91d0b98934ad2bf2bfb5d9035002a22134b453f Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 11 Feb 2021 13:11:24 +0100 Subject: [PATCH 052/120] Add the capability of handling arguments to the dummy driver and upgrade it to a class --- drivers/driver.py | 27 +++++++++++++-------------- drivers/drivers/__init__.py | 7 ++++--- drivers/drivers/harmonic.py | 36 +++++++++++++++++++++++++++++------- 3 files changed, 46 insertions(+), 24 deletions(-) diff --git a/drivers/driver.py b/drivers/driver.py index 59eb0a003..20aed5b77 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -52,16 +52,7 @@ def Message(mystr): return str.ljust(str.upper(mystr), HDRLEN).encode() -def dummy_driver(cell, pos): - """ Does nothing, but returns properties that can be used by the driver loop.""" - pot = 0.0 - force = pos * 0.0 # makes a zero force with same shape as pos - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "nada" - return pot, force, vir, extras - - -def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver): +def run_driver(unix=False, address="", port=12345, driver=Dummy_driver()): """Minimal socket client for i-PI.""" # Opens a socket to i-PI @@ -121,7 +112,7 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) pos = recv_data(sock, pos) ##### THIS IS THE TIME TO DO SOMETHING WITH THE POSITIONS! - pot, force, vir, extras = driver_function(cell, pos) + pot, force, vir, extras = driver(cell, pos) f_data = True elif header == Message("GETFORCE"): sock.sendall(Message("FORCEREADY")) @@ -173,13 +164,21 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) Currently implemented: [dummy, harmonic] """, ) + parser.add_argument( + "-o", + "--param", + type=str, + default=None, + help="""Paramenters required to run the driver + """, + ) args = parser.parse_args() if args.mode in __drivers__: - d_f = __drivers__[args.mode] + d_f = __drivers__[args.mode](args.param) elif args.mode == "dummy": - d_f = dummy_driver + d_f = Dummy_driver(args.param) else: raise ValueError("Unsupported driver mode ", args.mode) @@ -187,5 +186,5 @@ def run_driver(unix=False, address="", port=12345, driver_function=dummy_driver) unix=args.unix, address=args.address, port=args.port, - driver_function=d_f, + driver=d_f, ) diff --git a/drivers/drivers/__init__.py b/drivers/drivers/__init__.py index 70d85e425..f46e6b7a5 100644 --- a/drivers/drivers/__init__.py +++ b/drivers/drivers/__init__.py @@ -1,8 +1,9 @@ """ Small functions/classes providing access to driver PES to be called from driver.py """ -from .harmonic import harm_driver +from .harmonic import Harmonic_driver +from .dummy import Dummy_driver -__all__ = ["__drivers__", "harm_driver"] +__all__ = ["__drivers__", "Dummy_driver", "Harmonic_driver"] # dictionary linking strings -__drivers__ = {"harmonic": harm_driver} +__drivers__ = {"dummy": Dummy_driver, "harmonic": Harmonic_driver} diff --git a/drivers/drivers/harmonic.py b/drivers/drivers/harmonic.py index 898717cf3..ac1aab4ce 100644 --- a/drivers/drivers/harmonic.py +++ b/drivers/drivers/harmonic.py @@ -1,10 +1,32 @@ """ Harmonic potential """ +import numpy as np +import sys +from .dummy import Dummy_driver -def harm_driver(cell, pos): - """ Silly harmonic potential, with unit frequency in a.u.""" - pot = (pos ** 2).sum() * 0.5 - force = -pos # makes a zero force with same shape as pos - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "nada" - return pot, force, vir, extras + +class Harmonic_driver(Dummy_driver): + def __init__(self, args=None): + + self.error_msg = """\nHarmonic driver requires specification of force constant.\nExample: python driver.py -m harmonic -u -o 1.3\n""" + super(Harmonic_driver, self).__init__(args) + + def check_arguments(self): + """ Function that checks the arguments required to run the driver """ + try: + k = list(map(float, self.args.split())) + except ValueError: + sys.exit(self.error_msg) + + if len(k) == 1: + self.k = k[0] + else: + sys.exit(self.error_msg) + + def __call__(self, cell, pos): + """ Silly harmonic potential, with unit frequency in a.u.""" + pot = 0.5 * self.k * (pos ** 2).sum() * 0.5 + force = -self.k * pos # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + return pot, force, vir, extras From b6860286aeec557d5e0fa57eba69336678c6eaa3 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 11 Feb 2021 13:15:36 +0100 Subject: [PATCH 053/120] forgot one file in the previous commit --- drivers/drivers/dummy.py | 17 +++++++++++++++++ 1 file changed, 17 insertions(+) create mode 100644 drivers/drivers/dummy.py diff --git a/drivers/drivers/dummy.py b/drivers/drivers/dummy.py new file mode 100644 index 000000000..c75ab4361 --- /dev/null +++ b/drivers/drivers/dummy.py @@ -0,0 +1,17 @@ +class Dummy_driver(object): + def __init__(self, args=None): + """ Initialized dummy drivers """ + self.args = args + self.check_arguments() + + def check_arguments(self): + """ Dummy function that checks the arguments required to run the driver """ + pass + + def __call__(self, cell, pos): + """ Does nothing, but returns properties that can be used by the driver loop.""" + pot = 0.0 + force = pos * 0.0 # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + return pot, force, vir, extras From f1f7e85ec918d84bf42bf349d29c3af85cbc7241 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 11 Feb 2021 17:30:20 +0100 Subject: [PATCH 054/120] bugfix for lanczos and fixatoms --- ipi/engine/motion/instanton.py | 18 ++++++++++-------- ipi/utils/hesstools.py | 4 +++- ipi/utils/instools.py | 4 ++-- 3 files changed, 15 insertions(+), 11 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index eb3337b9b..ad0df010f 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -168,7 +168,8 @@ def __init__( self.options["hessian_asr"] = hessian_asr self.options["hessian_init"] = hessian_init self.optarrays["hessian"] = hessian - self.optarrays["fric_hessian"] = fric_hessian + if self.options['friction']: + self.optarrays["fric_hessian"] = fric_hessian if self.options["opt"] == "nichols": self.optimizer = NicholsOptimizer() @@ -1088,12 +1089,11 @@ def exitstep(self, d_x_max, step): fixatoms=self.fixatoms, friction=self.options["friction"], ) - + if self.options["friction"]: friction_hessian = current_hessian[1] - self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( - friction_hessian, 4 - ) + #self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) + self.optarrays["fric_hessian"][:] = friction_hessian print_instanton_hess( self.options["prefix"] + "fric_FINAL", step, @@ -1106,7 +1106,8 @@ def exitstep(self, d_x_max, step): else: phys_hessian = current_hessian - self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + self.optarrays["hessian"][:] = phys_hessian print_instanton_hess( self.options["prefix"] + "_FINAL", @@ -1268,7 +1269,7 @@ def bind(self, geop): 'Hessian_init' is false, 'friction' is true so an initial fric_hessian (of the proper size) must be provided. """ ) - self.optarrays["fric_hessian"] = geop.optarrays["fric_hessian"] + self.optarrays["fric_hessian"] = geop.optarrays["fric_hessian"] def initialize(self, step): @@ -1321,7 +1322,8 @@ def initialize(self, step): phys_hessian = active_hessian print("Check phys_hessian") - self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + self.optarrays["hessian"][:] = phys_hessian self.update_old_pos_for() diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index f76b778a4..149a99a50 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -196,6 +196,7 @@ def get_hessian( for i in fixatoms: fixdofs.extend([3 * i, 3 * i + 1, 3 * i + 2]) ii = natoms * 3 + activedof = np.delete(np.arange(ii),fixdofs) ncalc = ii - len(fixdofs) if x0.size != natoms * 3 * nbeads: raise ValueError( @@ -250,8 +251,9 @@ def get_hessian( if j in fixdofs: continue else: + ndone = len(activedof[activedof Date: Thu, 11 Feb 2021 17:32:01 +0100 Subject: [PATCH 055/120] lint --- drivers/drivers/harmonic.py | 1 - ipi/engine/motion/instanton.py | 37 ++++++++++++++++++---------------- ipi/utils/hesstools.py | 14 +++++++------ ipi/utils/instools.py | 2 +- 4 files changed, 29 insertions(+), 25 deletions(-) diff --git a/drivers/drivers/harmonic.py b/drivers/drivers/harmonic.py index ac1aab4ce..ad8451c83 100644 --- a/drivers/drivers/harmonic.py +++ b/drivers/drivers/harmonic.py @@ -1,6 +1,5 @@ """ Harmonic potential """ -import numpy as np import sys from .dummy import Dummy_driver diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index ad0df010f..7aad3f95e 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -168,7 +168,7 @@ def __init__( self.options["hessian_asr"] = hessian_asr self.options["hessian_init"] = hessian_init self.optarrays["hessian"] = hessian - if self.options['friction']: + if self.options["friction"]: self.optarrays["fric_hessian"] = fric_hessian if self.options["opt"] == "nichols": @@ -411,7 +411,7 @@ def save(self, e, g, eta=None): def initialize(self, q, forces): """ Initialize potential, forces and friction """ - print('ALBERTO-friction') + print("ALBERTO-friction") print(forces.extras["friction"].shape) eta = np.array(forces.extras["friction"]).reshape( (q.shape[0], q.shape[1], q.shape[1]) @@ -442,13 +442,14 @@ def get_fric_rp_hessian(self, fric_hessian): # nbeads = self.dbeads.nbeads s = self.eta - #ALBERTO - print('#ALBERTO') + # ALBERTO + print("#ALBERTO") from scipy.linalg import sqrtm + dgdq = np.zeros(s.shape) for i in range(self.dbeads.nbeads): - dgdq[i]=sqrtm(s[i]) - #dgdq = s ** 0.5 -> won't work for multiD + dgdq[i] = sqrtm(s[i]) + # dgdq = s ** 0.5 -> won't work for multiD # gq = self.obtain_g(s) z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] @@ -458,7 +459,7 @@ def get_fric_rp_hessian(self, fric_hessian): h_fric = np.zeros((ndof, ndof)) - print('#ALBERTO-check this') + print("#ALBERTO-check this") # ALBERTO # Block diag: # g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] @@ -489,12 +490,13 @@ def get_fric_rp_hessian(self, fric_hessian): def obtain_g(self, s): """ Computes g from s """ - print('#ALBERTO') + print("#ALBERTO") from scipy.linalg import sqrtm + ss = np.zeros(s.shape) for i in range(self.dbeads.nbeads): - ss[i]=sqrtm(s[i]) - #ss = s ** 0.5 -> won't work for multiD + ss[i] = sqrtm(s[i]) + # ss = s ** 0.5 -> won't work for multiD from scipy.interpolate import interp1d from scipy.integrate import quad @@ -521,12 +523,13 @@ def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ s = self.eta - print('#ALBERTO') + print("#ALBERTO") from scipy.linalg import sqrtm + dgdq = np.zeros(s.shape) for i in range(self.dbeads.nbeads): - dgdq[i]=sqrtm(s[i]) - #dgdq = s ** 0.5 -> won't work for multiD + dgdq[i] = sqrtm(s[i]) + # dgdq = s ** 0.5 -> won't work for multiD gq = self.obtain_g(s) z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] @@ -1089,10 +1092,10 @@ def exitstep(self, d_x_max, step): fixatoms=self.fixatoms, friction=self.options["friction"], ) - + if self.options["friction"]: friction_hessian = current_hessian[1] - #self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) + # self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) self.optarrays["fric_hessian"][:] = friction_hessian print_instanton_hess( self.options["prefix"] + "fric_FINAL", @@ -1106,7 +1109,7 @@ def exitstep(self, d_x_max, step): else: phys_hessian = current_hessian - #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + # self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) self.optarrays["hessian"][:] = phys_hessian print_instanton_hess( @@ -1322,7 +1325,7 @@ def initialize(self, step): phys_hessian = active_hessian print("Check phys_hessian") - #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + # self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) self.optarrays["hessian"][:] = phys_hessian self.update_old_pos_for() diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 149a99a50..785d7d826 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -196,7 +196,7 @@ def get_hessian( for i in fixatoms: fixdofs.extend([3 * i, 3 * i + 1, 3 * i + 2]) ii = natoms * 3 - activedof = np.delete(np.arange(ii),fixdofs) + activedof = np.delete(np.arange(ii), fixdofs) ncalc = ii - len(fixdofs) if x0.size != natoms * 3 * nbeads: raise ValueError( @@ -241,19 +241,21 @@ def get_hessian( + ".tmp). " ) ) - if ( b.shape == eta_h.shape ): # Check that the last temporary file was properly written - break + if ( + b.shape == eta_h.shape + ): # Check that the last temporary file was properly written + break else: - continue + continue # Start calculation: for j in range(i0 + 1, ii): if j in fixdofs: continue else: - ndone = len(activedof[activedof Date: Fri, 12 Feb 2021 10:43:49 +0100 Subject: [PATCH 056/120] typo --- ipi/engine/motion/instanton.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 7aad3f95e..306f7cf9c 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1163,7 +1163,7 @@ def pre_step(self, step=None, adaptative=False): """ General tasks that have to be performed before actual step""" if self.exit: - softexit.trigger("Geometry optimzation converged. Exiting simulation") + softexit.trigger("Geometry optimization converged. Exiting simulation") if not self.init: self.initialize(step) From c80b9a50631db382c9c13aa04eeda04fa904399e Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 12 Feb 2021 13:18:56 +0100 Subject: [PATCH 057/120] bugfix nichols nbeads=1 --- ipi/engine/motion/instanton.py | 11 +++++++++-- 1 file changed, 9 insertions(+), 2 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 306f7cf9c..e8339ac2d 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -271,7 +271,11 @@ def bind(self, mapper): # self.nm = mapper.nm # self.rp_factor = mapper.rp_factor - self.C = mapper.nm.transform._b2o_nm + if self.dbeads.nbeads>1: + self.C = mapper.nm.transform._b2o_nm + else: + self.C = 1 + self.omegak = mapper.rp_factor * mapper.nm.get_o_omegak() self.fix = mapper.fix @@ -639,7 +643,10 @@ def bind(self, mapper): self.dbeads = mapper.beads.copy() # self.nm = mapper.nm # self.rp_factor = mapper.rp_factor - self.C = mapper.nm.transform._b2o_nm + if self.dbeads.nbeads >1: + self.C = mapper.nm.transform._b2o_nm + else: + self.C = 1 self.omegak = mapper.rp_factor * mapper.nm.get_o_omegak() self.omegan = mapper.rp_factor * mapper.nm.omegan From b1c31efaae6fb11f4972b50d8214c6cf3e813093 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 17 Feb 2021 18:48:55 +0100 Subject: [PATCH 058/120] bugfix friciton with fixatoms --- drivers/drivers/harmonic.py | 4 +- ipi/engine/motion/instanton.py | 138 +++++++++++++++++---------------- ipi/utils/instools.py | 34 ++++++-- 3 files changed, 104 insertions(+), 72 deletions(-) diff --git a/drivers/drivers/harmonic.py b/drivers/drivers/harmonic.py index ad8451c83..c3a6023cc 100644 --- a/drivers/drivers/harmonic.py +++ b/drivers/drivers/harmonic.py @@ -23,8 +23,8 @@ def check_arguments(self): sys.exit(self.error_msg) def __call__(self, cell, pos): - """ Silly harmonic potential, with unit frequency in a.u.""" - pot = 0.5 * self.k * (pos ** 2).sum() * 0.5 + """ Silly harmonic potential""" + pot = 0.5 * self.k * (pos ** 2).sum() force = -self.k * pos # makes a zero force with same shape as pos vir = cell * 0.0 # makes a zero virial with same shape as cell extras = "nada" diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 7aad3f95e..14ca8bb4c 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -10,7 +10,7 @@ import numpy as np - +import warnings np.set_printoptions(suppress=True, linewidth=1000) import time import sys @@ -36,6 +36,7 @@ from ipi.utils.instools import print_instanton_hess, diag_banded, ms_pathway from ipi.utils.hesstools import get_hessian, clean_hessian, get_dynmat + __all__ = ["InstantonMotion"] # TEST @@ -196,7 +197,7 @@ def __init__( self.optarrays["glist"] = glist_lbfgs self.optarrays["d"] = old_direction - print(self.options["opt"]) + if self.options["opt"] == "NR" or self.options["opt"] == "lanczos": info( "Note that we need scipy to use NR or lanczos. If storage and diagonalization of the full hessian is not a " @@ -210,6 +211,7 @@ def __init__( ) if self.options["friction"]: + found = util.find_spec("scipy") if found is None: softexit.trigger( @@ -233,10 +235,7 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): self.nm = NormalModes( transform_method="matrix", open_paths=np.arange(self.beads.natoms) ) - # self.nm = NormalModes(transform_method="matrix") - print("ALBERTO") - print("ALBERTO") - print("ALBERTO") + self.nm.bind(self.ensemble, self, Beads(self.beads.natoms, self.beads.nbeads)) if self.options["mode"] == "rate": self.rp_factor = 2 @@ -403,6 +402,12 @@ class FrictionMapper(PesMapper): def bind(self, mapper): super(FrictionMapper, self).bind(mapper) + from scipy.interpolate import interp1d + from scipy.linalg import sqrtm + from scipy.integrate import quad + self.sqrtm = sqrtm + self.quad = quad + self.interp1d = interp1d def save(self, e, g, eta=None): """ Stores potential and forces in this class for convenience """ @@ -411,21 +416,35 @@ def save(self, e, g, eta=None): def initialize(self, q, forces): """ Initialize potential, forces and friction """ - print("ALBERTO-friction") - print(forces.extras["friction"].shape) + + eta = np.array(forces.extras["friction"]).reshape( (q.shape[0], q.shape[1], q.shape[1]) ) + self.check_eta(eta) + self.save(forces.pots, -forces.f, eta) + def check_eta(self,eta): + + for i in range(self.dbeads.nbeads): + assert (eta[i] - eta[i].T == np.zeros((self.dbeads.natoms*3,self.dbeads.natoms*3))).all() + with warnings.catch_warnings(): + warnings.filterwarnings('error') + try: + self.sqrtm(eta[i]+np.eye(self.dbeads.natoms*3)*0.0001) # dgdq = s ** 0.5 -> won't work for multiD + except Warning as e: + print(s[i]) + softexit.trigger("The provided friction is not positive definite") + def set_z_friction(self, z_friction): """Sets the scaling factors corresponding to frequency dependence of the friction """ - from scipy.interpolate import interp1d + #from scipy.interpolate import interp1d freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) - spline = interp1d( + spline = self.interp1d( freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False ) @@ -434,52 +453,44 @@ def set_z_friction(self, z_friction): info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) - def get_fric_rp_hessian(self, fric_hessian): - """ Creates the friction hessian from the eta derivatives """ - - nphys = self.dbeads.natoms * 3 - ndof = self.dbeads.nbeads * self.dbeads.natoms * 3 - # nbeads = self.dbeads.nbeads - - s = self.eta - # ALBERTO - print("#ALBERTO") - from scipy.linalg import sqrtm + def get_fric_rp_hessian(self, fric_hessian, eta ): + """ Creates the friction hessian from the eta derivatives + THIS IS ONLY DONE FOR THE ACTIVE MODES """ + + nphys = self.fix.nactive * 3 + ndof = self.dbeads.nbeads * self.fix.nactive * 3 + nbeads = self.dbeads.nbeads + s = eta + z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] + dgdq = np.zeros(s.shape) - for i in range(self.dbeads.nbeads): - dgdq[i] = sqrtm(s[i]) - # dgdq = s ** 0.5 -> won't work for multiD - # gq = self.obtain_g(s) + for i in range(nbeads): + dgdq[i] = self.sqrtm(s[i]+np.eye(nphys)*0.0001) - z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] - # factor = self.dbeads.m3[0, 0] / 1.674 # DEBUG - # z_k_springs = factor * new_omegak2[:, np.newaxis] # DEBUG - # z_k = z_k_1 + z_k_springs h_fric = np.zeros((ndof, ndof)) - print("#ALBERTO-check this") - # ALBERTO - # Block diag: - # g = self.nm.transform.nm2b(z_k * gq_k)[active_beads] - # for n in range(self.dbeads.nbeads): + #Block diag: + #gq = self.obtain_g(s) + #gq_k = np.dot(self.C,gq) + #prefactor = np.dot(self.C.T, z_k*gq_k) + #for n in range(self.dbeads.nbeads): # for j in range(nphys): # for k in range(nphys): # aux_jk = 0 # for i in range(nphys): # if dgdq[n, i, j] != 0: # aux_jk += ( - # 0.5 * g[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] + # 0.5 * prefactor[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] # ) # h_fric[nphys * n + j, nphys * n + k] = aux_jk - # ALBERTO # Cross-terms: - for nl in range(self.dbeads.nbeads): - for ne in range(self.dbeads.nbeads): + for nl in range(nbeads): + for ne in range(nbeads): prefactor = 0 - for alpha in range(self.dbeads.nbeads): + for alpha in range(nbeads): prefactor += self.C[alpha, nl] * self.C[alpha, ne] * z_k[alpha] for j in range(nphys): for k in range(nphys): @@ -490,26 +501,23 @@ def get_fric_rp_hessian(self, fric_hessian): def obtain_g(self, s): """ Computes g from s """ - print("#ALBERTO") - from scipy.linalg import sqrtm + + nphys = self.dbeads.natoms * 3 ss = np.zeros(s.shape) - for i in range(self.dbeads.nbeads): - ss[i] = sqrtm(s[i]) - # ss = s ** 0.5 -> won't work for multiD - from scipy.interpolate import interp1d - from scipy.integrate import quad + for i in range(self.dbeads.nbeads): + ss[i] = self.sqrtm(s[i] + np.eye(nphys)*0.0001) # ss = s ** 0.5 -> won't work for multiD q = self.dbeads.q.copy() gq = np.zeros(self.dbeads.q.copy().shape) for nd in range(3 * self.dbeads.natoms): try: - spline = interp1d( + spline = self.interp1d( q[:, nd], ss[:, nd, nd], kind="cubic" ) # spline for each dof for nb in range(1, self.dbeads.nbeads): - gq[nb, nd] = quad(spline, q[0, nd], q[nb, nd])[ + gq[nb, nd] = self.quad(spline, q[0, nd], q[nb, nd])[ 0 ] # Cumulative integral along the path for each dof # for i in range(self.dbeads.nbeads): @@ -523,13 +531,18 @@ def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ s = self.eta - print("#ALBERTO") - from scipy.linalg import sqrtm + nphys = self.dbeads.natoms * 3 dgdq = np.zeros(s.shape) for i in range(self.dbeads.nbeads): - dgdq[i] = sqrtm(s[i]) - # dgdq = s ** 0.5 -> won't work for multiD + with warnings.catch_warnings(): + warnings.filterwarnings('error') + try: + dgdq[i] = self.sqrtm(s[i]+np.eye(nphys)*0.0001) # dgdq = s ** 0.5 -> won't work for multiD + except Warning as e: + print(s[i]) + softexit.trigger("The provided friction is not positive definite") + gq = self.obtain_g(s) z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] @@ -546,7 +559,7 @@ def compute_friction_terms(self): for i in range(self.dbeads.nbeads): g[i, :] = np.dot(dgdq[i], f[i]) - return e, g + return e, g def get_full_extras(self, reduced_forces, full_mspath, indexes): """ Get the full extra strings """ @@ -555,10 +568,9 @@ def get_full_extras(self, reduced_forces, full_mspath, indexes): if str(key) != "raw": red_data = np.array(reduced_forces.extras[key]) if self.spline: - from scipy.interpolate import interp1d red_mspath = full_mspath[indexes] - spline = interp1d(red_mspath, red_data.T, kind="cubic") + spline = self.interp1d(red_mspath, red_data.T, kind="cubic") full_data = spline(full_mspath).T else: full_data = red_data @@ -611,8 +623,6 @@ def evaluate(self): e_friction, g_friction = self.compute_friction_terms() e += e_friction g += g_friction - # print('g_friction') - # print(g_friction) e = e * (self.coef[1:] + self.coef[:-1]) / 2 g = g * (self.coef[1:] + self.coef[:-1]) / 2 @@ -699,8 +709,8 @@ def __call__(self, x, ret=True, new_disc=True): self.C.T, gq_k * (self.omegak ** 2)[:, np.newaxis] ) - # With new discretization - if False: # ALBERTO + # With new discretization #This can be expressed as matrix multp + if False: #ALBERTO for i in range(self.dbeads.nbeads - 1): dq = (self.dbeads.q[i + 1, :] - self.dbeads.q[i, :]) / np.sqrt( coef[i + 1] @@ -727,8 +737,6 @@ def __call__(self, x, ret=True, new_disc=True): self.save(e, g) - # print('g_spring') - # print(g) if ret: return e, g @@ -1318,9 +1326,7 @@ def initialize(self, step): if self.options["friction"]: phys_hessian = active_hessian[0] friction_hessian = active_hessian[1] - self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( - friction_hessian, 4 - ) + self.optarrays["fric_hessian"][:] = friction_hessian[:] else: phys_hessian = active_hessian @@ -1432,7 +1438,9 @@ def step(self, step=None): # Add friction terms to the hessian if self.options["friction"]: - h_fric = self.mapper.gm.get_fric_rp_hessian(activearrays["fric_hessian"]) + print('ALBERTO clean here gm call') + eta_active = self.fix.get_active_vector(self.mapper.gm.eta,5) + h_fric = self.mapper.gm.get_fric_rp_hessian(activearrays["fric_hessian"],eta_active) h = np.add(h, h_fric) # Get eigenvalues and eigenvector. diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 32401ae89..daddf119d 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -308,7 +308,7 @@ class Fix(object): def __init__(self, fixatoms, beads, nbeads=None): - self.natoms = beads.natoms + self.natoms = beads.natoms if nbeads is None: self.nbeads = beads.nbeads else: @@ -317,6 +317,7 @@ def __init__(self, fixatoms, beads, nbeads=None): self.fixatoms = fixatoms self.mask0 = np.delete(np.arange(self.natoms), self.fixatoms) + self.nactive = len(self.mask0) mask1 = np.ones(3 * self.natoms, dtype=bool) for i in range(3): @@ -367,7 +368,7 @@ def get_active_array(self, arrays): t = -1 elif key == "old_x" or key == "old_f" or key == "d": t = 1 - elif key == "hessian" or key == "eta": + elif key == "hessian": t = 2 elif key == "qlist" or key == "glist": t = 3 @@ -393,7 +394,8 @@ def get_full_vector(self, vector, t): type=1 : pos , force or m3 (nbeads,dof) type=2 : hessian (dof, nbeads*dof) type=3 : qlist or glist (corrections, nbeads*dof) - type=4 : fric_hessian + type=4 : fric_hessian(nbeads,dof,dof,dof) + type=5 : eta(nbeads,dof,dof) OUT: clean_vector reduced vector """ @@ -426,12 +428,28 @@ def get_full_vector(self, vector, t): return full_vector elif t == 4: - full_vector = np.zeros((9 * self.natoms, 9 * self.natoms * self.nbeads)) + full_vector = np.zeros((self.nbeads, 3 * self.natoms, 3 * self.natoms, 3*self.natoms)) ii = 0 + jj = 0 + kk = 0 for i in self.get_mask(1): - full_vector[i, self.get_mask(3)] = vector[ii] + for j in self.get_mask(1): + for k in self.get_mask(1): + full_vector[:,i,j,k] = vector[:,ii,jj,kk] #Yes, this can be improved + kk += 1 + jj += 1 ii += 1 + return full_vector + elif t == 5: + full_vector = np.zeros((self.nbeads, 3 * self.natoms, 3 * self.natoms)) + ii = 0 + jj = 0 + for i in self.get_mask(1): + for j in self.get_mask(1): + full_vector[:,i,j] = vector[:,ii,jj] #Yes, this can be improved + jj += 1 + ii += 1 return full_vector else: @@ -449,6 +467,8 @@ def get_active_vector(self, vector, t): type=1 : pos , force or m3 (nbeads,dof) type=2 : hessian (dof, nbeads*dof) type=3 : qlist or glist (corrections, nbeads*dof) + type=4 : fric_hessian(nbeads,dof,dof,dof) + type=5 : eta(nbeads,dof,dof) OUT: clean_vector reduced vector """ @@ -463,5 +483,9 @@ def get_active_vector(self, vector, t): return aux[:, self.mask2] elif t == 3: return vector[:, self.mask2] + elif t == 4: + return vector[:,self.mask1][:,:,self.mask1][:,:,:,self.mask1] + elif t == 5: + return vector[:,self.mask1][:,:,self.mask1] else: raise ValueError("@apply_fix_atoms: type number {} is not valid".format(t)) From 346710964cd2a756cc64bc48d95ecf2f1bf1a975 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 23 Feb 2021 16:18:09 +0100 Subject: [PATCH 059/120] take out the mass scale inside ipi --- drivers/pes/harmonic_bath.f90 | 5 ++--- ipi/engine/motion/instanton.py | 14 +++++++++++--- tools/py/Instanton_postproc.py | 14 +++++++------- 3 files changed, 20 insertions(+), 13 deletions(-) diff --git a/drivers/pes/harmonic_bath.f90 b/drivers/pes/harmonic_bath.f90 index cebcd569c..5edb0a24c 100644 --- a/drivers/pes/harmonic_bath.f90 +++ b/drivers/pes/harmonic_bath.f90 @@ -15,7 +15,7 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,eps,delta,deltaQ,q,p real(kind=8) :: A,B real(kind=8) :: q(nat*3),pot,force(nat*3),x(nat*3-1) real(kind=8) :: c(nat*3-1),omega(nat*3-1), omega2(nat*3-1),aux - mass = 1837 + mass = 1837.36223469 pot = 0.0 A = -0.00476705894242374 B = 0.0005980249683218661 @@ -30,10 +30,9 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,eps,delta,deltaQ,q,p omega(i) = - omega_c * LOG( (i - 0.5 ) / (3*nat-1) ) omega2(i) = omega(i)**2 c(i) = omega(i) * ( ( 2 * friction * mass *omega_c) / ( (3*nat-1) * pi ) )**0.5 - ENDDO END IF - + !SYSTEM pot = A * (q(1) ** 2) + B * (q(1) ** 4) force(1) = - ( 2 * A * (q(1)) + 4 * B * (q(1) ** 3) ) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 28ee3d2fd..0eb90cb51 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -416,7 +416,14 @@ def bind(self, mapper): def save(self, e, g, eta=None): """ Stores potential and forces in this class for convenience """ super(FrictionMapper, self).save(e, g) - self.eta = eta + # ALBERTO: CLEAN THE MASS UNSCALING + self.eta = eta + print('mass scaling ALBERTO') + #for e in self.eta: + # m=self.dbeads.m3[0][:,np.newaxis] + # e[:] =(e/m**-0.5)/m.T**-0.5 #Mass unscale + #ALBERTO + print(self.eta[0]) def initialize(self, q, forces): """ Initialize potential, forces and friction """ @@ -425,6 +432,8 @@ def initialize(self, q, forces): eta = np.array(forces.extras["friction"]).reshape( (q.shape[0], q.shape[1], q.shape[1]) ) + + self.check_eta(eta) @@ -627,7 +636,7 @@ def evaluate(self): e_friction, g_friction = self.compute_friction_terms() e += e_friction g += g_friction - + e = e * (self.coef[1:] + self.coef[:-1]) / 2 g = g * (self.coef[1:] + self.coef[:-1]) / 2 @@ -710,7 +719,6 @@ def __call__(self, x, ret=True, new_disc=True): # for i in range(1, self.dbeads.nbeads): # #g[i, :] += self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) - gq_k = np.dot(self.C, self.dbeads.q) g = self.dbeads.m3[0] * np.dot( self.C.T, gq_k * (self.omegak ** 2)[:, np.newaxis] diff --git a/tools/py/Instanton_postproc.py b/tools/py/Instanton_postproc.py index 9ceffd769..6451cc692 100755 --- a/tools/py/Instanton_postproc.py +++ b/tools/py/Instanton_postproc.py @@ -134,6 +134,12 @@ "We can not indentify asr case. The valid cases are: 'poly', 'crystal' , 'linear' and 'none'" ) +if asr == "poly": + nzeros = 6 +elif asr == "crystal": + nzeros = 3 +else: + nzeros = 0 if asr == "linear": raise NotImplementedError("Sum rules for linear molecules is not implemented") @@ -390,12 +396,6 @@ def get_rp_freq(w0, nbeads, temp, mode="rate"): Qrot = 1.0 outfile = open("freq.dat", "w") - if asr == "poly": - nzeros = 6 - elif asr == "crystal": - nzeros = 3 - else: - nzeros = 0 aux = np.zeros(nzeros) dd = np.concatenate((aux, d)) np.savetxt(outfile, dd.reshape(1, dd.size)) @@ -461,7 +461,7 @@ def get_rp_freq(w0, nbeads, temp, mode="rate"): ) logQvib = ( -np.sum(np.log(betaP * hbar * np.sqrt(np.absolute(np.delete(d, 1))))) - + 6 * np.log(nbeads) + + nzeros * np.log(nbeads) + np.log(nbeads) ) else: From d6e9507e4050fc21eff85abf2fe61f091e462145 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 23 Feb 2021 16:20:08 +0100 Subject: [PATCH 060/120] add spline driver --- drivers/drivers/__init__.py | 9 +++++++-- 1 file changed, 7 insertions(+), 2 deletions(-) diff --git a/drivers/drivers/__init__.py b/drivers/drivers/__init__.py index f46e6b7a5..d9e5cfa53 100644 --- a/drivers/drivers/__init__.py +++ b/drivers/drivers/__init__.py @@ -1,9 +1,14 @@ """ Small functions/classes providing access to driver PES to be called from driver.py """ from .harmonic import Harmonic_driver +from .spline import Spline_driver from .dummy import Dummy_driver -__all__ = ["__drivers__", "Dummy_driver", "Harmonic_driver"] +__all__ = ["__drivers__", "Dummy_driver", "Harmonic_driver", "Spline_driver"] # dictionary linking strings -__drivers__ = {"dummy": Dummy_driver, "harmonic": Harmonic_driver} +__drivers__ = { + "dummy": Dummy_driver, + "harmonic": Harmonic_driver, + "spline": Spline_driver, +} From cb866cf4cbdff4b37fe27991126b40d3b679a84c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 25 Feb 2021 20:15:54 +0100 Subject: [PATCH 061/120] add some debug flags --- ipi/engine/motion/instanton.py | 91 +++++++++++++++++----------------- 1 file changed, 46 insertions(+), 45 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 0eb90cb51..a5eded13e 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -3,7 +3,9 @@ Algorithms implemented by Yair Litman and Mariana Rossi, 2017 """ - +debug=True +debug=False +test_factor =1 # This file is part of i-PI. # i-PI Copyright (C) 2014-2015 i-PI developers # See the "licenses" directory for full license information. @@ -417,13 +419,16 @@ def save(self, e, g, eta=None): """ Stores potential and forces in this class for convenience """ super(FrictionMapper, self).save(e, g) # ALBERTO: CLEAN THE MASS UNSCALING - self.eta = eta - print('mass scaling ALBERTO') + self.eta = eta * test_factor + if debug: + for i in range(self.dbeads.nbeads): + self.eta[i]=np.eye(self.dbeads.natoms*3) + #print('mass scaling ALBERTO') #for e in self.eta: # m=self.dbeads.m3[0][:,np.newaxis] # e[:] =(e/m**-0.5)/m.T**-0.5 #Mass unscale #ALBERTO - print(self.eta[0]) + #print(self.eta[0]) def initialize(self, q, forces): """ Initialize potential, forces and friction """ @@ -462,8 +467,11 @@ def set_z_friction(self, z_friction): ) z_friction = spline(self.omegak) - self.z_friction = z_friction # / z_friction[1] ) # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY - + #z_friction = z_friction /1.6743276# / z_friction[1] # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY + if debug: + z_friction = self.dbeads.m3[0,0]*self.omegak + self.z_k = np.multiply(self.omegak, z_friction)[:, np.newaxis]/test_factor + info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) def get_fric_rp_hessian(self, fric_hessian, eta ): @@ -475,46 +483,45 @@ def get_fric_rp_hessian(self, fric_hessian, eta ): nbeads = self.dbeads.nbeads s = eta - z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] - + dgdq = np.zeros(s.shape) for i in range(nbeads): dgdq[i] = self.sqrtm(s[i]+np.eye(nphys)*0.0001) - h_fric = np.zeros((ndof, ndof)) #Block diag: - #gq = self.obtain_g(s) - #gq_k = np.dot(self.C,gq) - #prefactor = np.dot(self.C.T, z_k*gq_k) - #for n in range(self.dbeads.nbeads): - # for j in range(nphys): - # for k in range(nphys): - # aux_jk = 0 - # for i in range(nphys): - # if dgdq[n, i, j] != 0: - # aux_jk += ( - # 0.5 * prefactor[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] - # ) - # h_fric[nphys * n + j, nphys * n + k] = aux_jk - + gq = self.obtain_g(s) + gq_k = np.dot(self.C,gq) + prefactor = np.dot(self.C.T, self.z_k*gq_k) + for n in range(self.dbeads.nbeads): + for j in range(nphys): + for k in range(nphys): + aux_jk = 0 + for i in range(nphys): + if dgdq[n, i, j] != 0: + aux_jk += ( + 0.5 * prefactor[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] + ) + h_fric[nphys * n + j, nphys * n + k] = aux_jk # Cross-terms: for nl in range(nbeads): for ne in range(nbeads): prefactor = 0 for alpha in range(nbeads): - prefactor += self.C[alpha, nl] * self.C[alpha, ne] * z_k[alpha] + prefactor += self.C[alpha, nl] * self.C[alpha, ne] * self.z_k[alpha] for j in range(nphys): for k in range(nphys): suma = np.sum(dgdq[nl, :, j] * dgdq[ne, :, k]) h_fric[nphys * nl + j, nphys * ne + k] = prefactor * suma - return h_fric def obtain_g(self, s): """ Computes g from s """ + if debug: + return self.dbeads.q.copy() + nphys = self.dbeads.natoms * 3 ss = np.zeros(s.shape) @@ -538,6 +545,7 @@ def obtain_g(self, s): except ValueError: gq[:, nd] = 0 + return gq def compute_friction_terms(self): @@ -558,20 +566,14 @@ def compute_friction_terms(self): gq = self.obtain_g(s) - z_k = np.multiply(self.omegak, self.z_friction)[:, np.newaxis] - # factor = self.dbeads.m3[0] / 1.674 # DEBUG - # z_k_spring = factor * new_omegak2[:, np.newaxis] #DEBUG - # z_k = z_k + z_k_spring + gq_k = np.dot(self.C, gq) + e = 0.5 * np.sum(self.z_k * gq_k ** 2 ) - gq_k = np.dot(self.C, gq) * z_k - - e = 0.5 * np.sum(gq_k ** 2) - - f = np.dot(self.C.T, gq_k) + f = np.dot(self.C.T, self.z_k * gq_k) g = np.zeros(f.shape) for i in range(self.dbeads.nbeads): g[i, :] = np.dot(dgdq[i], f[i]) - + #raise softexit.trigger('ACA') return e, g def get_full_extras(self, reduced_forces, full_mspath, indexes): @@ -835,10 +837,9 @@ def initialize(self, q, forces): e2, g2 = self.sm(q) g = self.fix.get_active_vector(g1 + g2, 1) e = np.sum(e1 + e2) - # print('DEBUG') - # e1, g1 = self.gm.evaluate() - # g = self.fix.get_active_vector(g1, 1) - # e = np.sum(e1) + if debug: + g = self.fix.get_active_vector(g1, 1) + e = np.sum(e1) self.save(e, g) @@ -887,10 +888,9 @@ def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): e2, g2 = self.gm(x, new_disc) e = e1 + e2 g = np.add(g1, g2) - # print('DEBUG') - # e2, g2 = self.gm(x, new_disc) - # e = e2 - # g = g2 + if debug: + e = e2 + g = g2 elif mode == "physical": e, g = self.gm(x, new_disc) @@ -1448,8 +1448,9 @@ def step(self, step=None): # Add spring terms to the physical hessian h = np.add(self.mapper.sm.h, h0) - # print("DEBUG") - # h = h0 + + if debug: + h = h0 # Add friction terms to the hessian if self.options["friction"]: From c1c0f91bd51894293898b287d399bcedf376d358 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 1 Mar 2021 20:49:16 +0100 Subject: [PATCH 062/120] add the possiblity to run SI calculations without needed on the fly friction calculations --- drivers/driver.py | 4 +- drivers/drivers/harmonic.py | 29 +++- drivers/drivers/spline.py | 119 ++++++++++++++ ipi/engine/motion/instanton.py | 290 +++++++++++++++++++-------------- ipi/inputs/motion/instanton.py | 18 +- ipi/utils/instools.py | 28 ++-- tools/py/Instanton_postproc.py | 6 +- 7 files changed, 354 insertions(+), 140 deletions(-) create mode 100644 drivers/drivers/spline.py diff --git a/drivers/driver.py b/drivers/driver.py index 83f6f4a45..238c2d76f 100755 --- a/drivers/driver.py +++ b/drivers/driver.py @@ -168,9 +168,9 @@ def run_driver(unix=False, address="", port=12345, driver=Dummy_driver()): "-o", "--param", type=str, + nargs="+", default="", - help="""Paramenters required to run the driver - """, + help="""Paramenters required to run the driver """, ) args = parser.parse_args() diff --git a/drivers/drivers/harmonic.py b/drivers/drivers/harmonic.py index c3a6023cc..c4cd28a54 100644 --- a/drivers/drivers/harmonic.py +++ b/drivers/drivers/harmonic.py @@ -2,6 +2,7 @@ import sys from .dummy import Dummy_driver +import numpy as np class Harmonic_driver(Dummy_driver): @@ -13,19 +14,37 @@ def __init__(self, args=None): def check_arguments(self): """ Function that checks the arguments required to run the driver """ try: - k = list(map(float, self.args.split())) + k = list(map(float, self.args)) except ValueError: sys.exit(self.error_msg) if len(k) == 1: self.k = k[0] + self.type = "isotropic" + elif len(k) == 3: + self.k = k + self.type = "non-isotropic" else: sys.exit(self.error_msg) def __call__(self, cell, pos): """ Silly harmonic potential""" - pot = 0.5 * self.k * (pos ** 2).sum() - force = -self.k * pos # makes a zero force with same shape as pos - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "nada" + if self.type == "isotropic": + pot = 0.5 * self.k * (pos ** 2).sum() + force = -self.k * pos # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + else: + pot = 0 + pos3 = pos.reshape(-1, 3) + force3 = np.zeros(pos.shape) + for i in range(3): + pot += 0.5 * self.k[i] * (pos3[:, i] ** 2).sum() + force3[:, i] = ( + -self.k[i] * pos3[:, i] + ) # makes a zero force with same shape as pos + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + pos = pos3.reshape(pos.shape) + force = force3.reshape(pos.shape) return pot, force, vir, extras diff --git a/drivers/drivers/spline.py b/drivers/drivers/spline.py new file mode 100644 index 000000000..0e7608aa7 --- /dev/null +++ b/drivers/drivers/spline.py @@ -0,0 +1,119 @@ +""" spline potential """ + +import numpy as np +import sys +from .dummy import Dummy_driver +from toolkit.tools.units import convert as c +from scipy import interpolate +import json + +"""Spline driver. This is not a serious interpolation, use it if you know what you are doing. """ +factor_coord = 5 +mass = 1836 +friction = True +SI = True +fric_value = 0.165 + + +class Spline_driver(Dummy_driver): + def __init__(self, args=None): + + self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" + super(Spline_driver, self).__init__(args) + self.get_spline() + if friction and not SI: + self.get_spline_fric() + self.k = 1836 * (3800.0 / 219323.0) ** 2 + + def check_arguments(self): + """ Function that checks the arguments required to run the driver """ + + try: + data = np.loadtxt(self.args[0]).reshape(-1, 5) + except ValueError: + sys.exit(self.error_msg) + self.data = data + + def get_spline(self): + """Function that creates the 1D spline and its derivative """ + + self.spline_f = [] + for i in range(3): + self.spline_f.append( + interpolate.interp1d(self.data[:, 0], self.data[:, i + 1], kind="cubic") + ) + + self.spline_e = interpolate.interp1d( + factor_coord * self.data[:, 0], self.data[:, 4], kind="cubic" + ) + + def get_spline_fric(self): + """Function that creates the 1D spline for the friction """ + data = np.loadtxt(self.args[1]).reshape(-1, 10) + self.spline_fric = [] + for i in range(9): + self.spline_fric.append( + interpolate.interp1d( + factor_coord * data[:, 0], mass * data[:, i + 1], kind="cubic" + ) + ) + + def get_energy(self, pos): + x = self.full2oneD(pos) + + pot = self.spline_e(x) + pot += 0.5 * self.k * (pos[0, 1] ** 2 + pos[0, 2] ** 2) + return pot + + def get_forces(self, pos): + x = self.full2oneD(pos) + force = np.zeros(pos.shape) + d = 0.001 + force[0, 0] = -(self.spline_e(x + d) - self.spline_e(x - d)) / (2 * d) + # force[0, 0] = self.spline_f[0](x) #+ self.spline_f[1](x) + self.spline_f[2](x) + force[0, 1] = -self.k * pos[0, 1] + force[0, 2] = -self.k * pos[0, 2] + + return force + + def get_friction(self, pos): + + x = self.full2oneD(pos) + + friction_tensor = np.zeros(9) + + if SI: + friction_tensor = np.eye(3) * fric_value + else: + for i in range(9): + friction_tensor[i] = self.spline_fric[i](x) + friction_tensor = friction_tensor.reshape((3, 3)) + + w = np.linalg.eigvals(friction_tensor) + assert (w >= 0).all() + assert (friction_tensor - friction_tensor.T == np.zeros((3, 3))).all() + return friction_tensor + + def full2oneD(self, pos): + """Function that gets the 1D coordinates from the pos vector""" + return factor_coord * pos[0, 0] + + def check_dimensions(self, pos): + """ Functions that checks dimensions of the received position """ + assert pos.shape == (1, 3) + + def __call__(self, cell, pos): + """ Evaluate energy, forces and friction""" + self.check_dimensions(pos) + vir = cell * 0.0 # makes a zero virial with same shape as cell + + pot = self.get_energy(pos) + force = self.get_forces(pos) + + if friction: + friction_tensor = self.get_friction(pos) + extras = json.dumps({"friction": friction_tensor.tolist()}) + else: + extras = "" + + return pot, force, vir, extras diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index a5eded13e..7f52f4111 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -3,9 +3,9 @@ Algorithms implemented by Yair Litman and Mariana Rossi, 2017 """ -debug=True -debug=False -test_factor =1 +debug = True +debug = False +test_factor = 1 # This file is part of i-PI. # i-PI Copyright (C) 2014-2015 i-PI developers # See the "licenses" directory for full license information. @@ -13,6 +13,7 @@ import numpy as np import warnings + np.set_printoptions(suppress=True, linewidth=1000) import time import sys @@ -117,6 +118,8 @@ def __init__( hessian_final="False", energy_shift=np.zeros(0, float), friction=False, + frictionSD=True, + eta=np.eye(0, 0, 0, float), z_friction=np.zeros(0, float), ): """Initialises InstantonMotion.""" @@ -124,7 +127,6 @@ def __init__( super(InstantonMotion, self).__init__(fixcom=fixcom, fixatoms=fixatoms) self.options = {} # Optimization options - self.optarrays = {} # Optimization arrays # Optimization mode self.options["mode"] = mode @@ -142,7 +144,14 @@ def __init__( self.options["max_ms"] = max_ms self.options["discretization"] = discretization self.options["friction"] = friction + if not friction: + self.options["frictionSD"] = False + else: + self.options["frictionSD"] = frictionSD + self.options["z_friction"] = z_friction + + self.optarrays = {} # Optimization arrays self.optarrays["big_step"] = biggest_step self.optarrays["energy_shift"] = energy_shift self.optarrays["delta"] = delta @@ -167,11 +176,14 @@ def __init__( or self.options["opt"] == "lanczos" ): + if self.options["friction"]: # and not self.options["frictionSD"]: + self.options["eta0"] = eta + self.options["hessian_update"] = hessian_update self.options["hessian_asr"] = hessian_asr self.options["hessian_init"] = hessian_init self.optarrays["hessian"] = hessian - if self.options["friction"]: + if self.options["friction"] and self.options["frictionSD"]: self.optarrays["fric_hessian"] = fric_hessian if self.options["opt"] == "nichols": @@ -199,7 +211,6 @@ def __init__( self.optarrays["glist"] = glist_lbfgs self.optarrays["d"] = old_direction - if self.options["opt"] == "NR" or self.options["opt"] == "lanczos": info( "Note that we need scipy to use NR or lanczos. If storage and diagonalization of the full hessian is not a " @@ -272,10 +283,10 @@ def bind(self, mapper): # self.nm = mapper.nm # self.rp_factor = mapper.rp_factor - if self.dbeads.nbeads>1: - self.C = mapper.nm.transform._b2o_nm - else: - self.C = 1 + if self.dbeads.nbeads > 1: + self.C = mapper.nm.transform._b2o_nm + else: + self.C = 1 self.omegak = mapper.rp_factor * mapper.nm.get_o_omegak() @@ -405,12 +416,19 @@ class FrictionMapper(PesMapper): """Creation of the multi-dimensional function to compute the physical potential and forces, as well as the friction terms""" + def __init__(self, frictionSD, eta0): + + super(FrictionMapper, self).__init__() + self.frictionSD = frictionSD + self.eta0 = eta0 + def bind(self, mapper): super(FrictionMapper, self).bind(mapper) from scipy.interpolate import interp1d from scipy.linalg import sqrtm from scipy.integrate import quad + self.sqrtm = sqrtm self.quad = quad self.interp1d = interp1d @@ -419,47 +437,54 @@ def save(self, e, g, eta=None): """ Stores potential and forces in this class for convenience """ super(FrictionMapper, self).save(e, g) # ALBERTO: CLEAN THE MASS UNSCALING - self.eta = eta * test_factor + self.eta = eta * test_factor if debug: - for i in range(self.dbeads.nbeads): - self.eta[i]=np.eye(self.dbeads.natoms*3) - #print('mass scaling ALBERTO') - #for e in self.eta: + for i in range(self.dbeads.nbeads): + self.eta[i] = np.eye(self.dbeads.natoms * 3) + # print('mass scaling ALBERTO') + # for e in self.eta: # m=self.dbeads.m3[0][:,np.newaxis] # e[:] =(e/m**-0.5)/m.T**-0.5 #Mass unscale - #ALBERTO - #print(self.eta[0]) + # ALBERTO + # print(self.eta[0]) def initialize(self, q, forces): """ Initialize potential, forces and friction """ - - eta = np.array(forces.extras["friction"]).reshape( - (q.shape[0], q.shape[1], q.shape[1]) - ) - + if self.frictionSD: + eta = np.array(forces.extras["friction"]).reshape( + (q.shape[0], q.shape[1], q.shape[1]) + ) + else: + eta = np.zeros((q.shape[0], q.shape[1], q.shape[1])) + for i in range(self.dbeads.nbeads): + eta[i] = self.eta0 self.check_eta(eta) - self.save(forces.pots, -forces.f, eta) - def check_eta(self,eta): - - for i in range(self.dbeads.nbeads): - assert (eta[i] - eta[i].T == np.zeros((self.dbeads.natoms*3,self.dbeads.natoms*3))).all() + def check_eta(self, eta): + + for i in range(self.dbeads.nbeads): + assert ( + eta[i] - eta[i].T + == np.zeros((self.dbeads.natoms * 3, self.dbeads.natoms * 3)) + ).all() with warnings.catch_warnings(): - warnings.filterwarnings('error') - try: - self.sqrtm(eta[i]+np.eye(self.dbeads.natoms*3)*0.0001) # dgdq = s ** 0.5 -> won't work for multiD - except Warning as e: + warnings.filterwarnings("error") + try: + self.sqrtm( + eta[i] + np.eye(self.dbeads.natoms * 3) * 0.0001 + ) # dgdq = s ** 0.5 -> won't work for multiD + except Warning as e: print(s[i]) softexit.trigger("The provided friction is not positive definite") - + def set_z_friction(self, z_friction): """Sets the scaling factors corresponding to frequency dependence of the friction """ - #from scipy.interpolate import interp1d + # from scipy.interpolate import interp1d freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) spline = self.interp1d( @@ -467,17 +492,17 @@ def set_z_friction(self, z_friction): ) z_friction = spline(self.omegak) - #z_friction = z_friction /1.6743276# / z_friction[1] # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY - if debug: - z_friction = self.dbeads.m3[0,0]*self.omegak - self.z_k = np.multiply(self.omegak, z_friction)[:, np.newaxis]/test_factor - + # z_friction = z_friction /1.6743276# / z_friction[1] # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY + if debug: + z_friction = self.dbeads.m3[0, 0] * self.omegak + self.z_k = np.multiply(self.omegak, z_friction)[:, np.newaxis] / test_factor + info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) - def get_fric_rp_hessian(self, fric_hessian, eta ): - """ Creates the friction hessian from the eta derivatives - THIS IS ONLY DONE FOR THE ACTIVE MODES """ - + def get_fric_rp_hessian(self, fric_hessian, eta, SD): + """Creates the friction hessian from the eta derivatives + THIS IS ONLY DONE FOR THE ACTIVE MODES""" + nphys = self.fix.nactive * 3 ndof = self.dbeads.nbeads * self.fix.nactive * 3 nbeads = self.dbeads.nbeads @@ -486,24 +511,28 @@ def get_fric_rp_hessian(self, fric_hessian, eta ): dgdq = np.zeros(s.shape) for i in range(nbeads): - dgdq[i] = self.sqrtm(s[i]+np.eye(nphys)*0.0001) + dgdq[i] = self.sqrtm(s[i] + np.eye(nphys) * 0.0001) h_fric = np.zeros((ndof, ndof)) - #Block diag: - gq = self.obtain_g(s) - gq_k = np.dot(self.C,gq) - prefactor = np.dot(self.C.T, self.z_k*gq_k) - for n in range(self.dbeads.nbeads): - for j in range(nphys): - for k in range(nphys): - aux_jk = 0 - for i in range(nphys): - if dgdq[n, i, j] != 0: - aux_jk += ( - 0.5 * prefactor[n, i] * fric_hessian[n, i, j, k] / dgdq[n, i, j] - ) - h_fric[nphys * n + j, nphys * n + k] = aux_jk + # Block diag: + if SD: + gq = self.obtain_g(s) + gq_k = np.dot(self.C, gq) + prefactor = np.dot(self.C.T, self.z_k * gq_k) + for n in range(self.dbeads.nbeads): + for j in range(nphys): + for k in range(nphys): + aux_jk = 0 + for i in range(nphys): + if dgdq[n, i, j] != 0: + aux_jk += ( + 0.5 + * prefactor[n, i] + * fric_hessian[n, i, j, k] + / dgdq[n, i, j] + ) + h_fric[nphys * n + j, nphys * n + k] = aux_jk # Cross-terms: for nl in range(nbeads): for ne in range(nbeads): @@ -520,14 +549,16 @@ def obtain_g(self, s): """ Computes g from s """ if debug: - return self.dbeads.q.copy() + return self.dbeads.q.copy() nphys = self.dbeads.natoms * 3 ss = np.zeros(s.shape) for i in range(self.dbeads.nbeads): - ss[i] = self.sqrtm(s[i] + np.eye(nphys)*0.0001) # ss = s ** 0.5 -> won't work for multiD + ss[i] = self.sqrtm( + s[i] + np.eye(nphys) * 0.0001 + ) # ss = s ** 0.5 -> won't work for multiD q = self.dbeads.q.copy() gq = np.zeros(self.dbeads.q.copy().shape) @@ -545,36 +576,37 @@ def obtain_g(self, s): except ValueError: gq[:, nd] = 0 - return gq def compute_friction_terms(self): """ Computes friction component of the energy and gradient """ s = self.eta + nphys = self.dbeads.natoms * 3 dgdq = np.zeros(s.shape) for i in range(self.dbeads.nbeads): - with warnings.catch_warnings(): - warnings.filterwarnings('error') - try: - dgdq[i] = self.sqrtm(s[i]+np.eye(nphys)*0.0001) # dgdq = s ** 0.5 -> won't work for multiD - except Warning as e: - print(s[i]) - softexit.trigger("The provided friction is not positive definite") - - gq = self.obtain_g(s) + with warnings.catch_warnings(): + warnings.filterwarnings("error") + try: + dgdq[i] = self.sqrtm( + s[i] + np.eye(nphys) * 0.0001 + ) # dgdq = s ** 0.5 -> won't work for multiD + except Warning as e: + print(s[i]) + softexit.trigger("The provided friction is not positive definite") - gq_k = np.dot(self.C, gq) - e = 0.5 * np.sum(self.z_k * gq_k ** 2 ) + gq = self.obtain_g(s) + gq_k = np.dot(self.C, gq) + e = 0.5 * np.sum(self.z_k * gq_k ** 2) f = np.dot(self.C.T, self.z_k * gq_k) g = np.zeros(f.shape) for i in range(self.dbeads.nbeads): g[i, :] = np.dot(dgdq[i], f[i]) - #raise softexit.trigger('ACA') - return e, g + + return e, g def get_full_extras(self, reduced_forces, full_mspath, indexes): """ Get the full extra strings """ @@ -605,13 +637,16 @@ def __call__(self, x, new_disc=True): ) full_extras = self.get_full_extras(reduced_forces, full_mspath, indexes) - full_eta = np.zeros( - (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) - ) - for n in range(self.dbeads.nbeads): - full_eta[n] = full_extras["friction"][n].reshape( - self.dbeads.natoms * 3, self.dbeads.natoms * 3 + if self.frictionSD: + full_eta = np.zeros( + (self.dbeads.nbeads, self.dbeads.natoms * 3, self.dbeads.natoms * 3) ) + for n in range(self.dbeads.nbeads): + full_eta[n] = full_extras["friction"][n].reshape( + self.dbeads.natoms * 3, self.dbeads.natoms * 3 + ) + else: + full_eta = self.eta info( "We expect friction tensor evaluated at the first RP frequency", @@ -638,7 +673,7 @@ def evaluate(self): e_friction, g_friction = self.compute_friction_terms() e += e_friction g += g_friction - + e = e * (self.coef[1:] + self.coef[:-1]) / 2 g = g * (self.coef[1:] + self.coef[:-1]) / 2 @@ -664,7 +699,7 @@ def bind(self, mapper): self.dbeads = mapper.beads.copy() # self.nm = mapper.nm # self.rp_factor = mapper.rp_factor - if self.dbeads.nbeads >1: + if self.dbeads.nbeads > 1: self.C = mapper.nm.transform._b2o_nm else: self.C = 1 @@ -727,7 +762,7 @@ def __call__(self, x, ret=True, new_disc=True): ) # With new discretization #This can be expressed as matrix multp - if False: #ALBERTO + if False: # ALBERTO for i in range(self.dbeads.nbeads - 1): dq = (self.dbeads.q[i + 1, :] - self.dbeads.q[i, :]) / np.sqrt( coef[i + 1] @@ -838,8 +873,8 @@ def initialize(self, q, forces): g = self.fix.get_active_vector(g1 + g2, 1) e = np.sum(e1 + e2) if debug: - g = self.fix.get_active_vector(g1, 1) - e = np.sum(e1) + g = self.fix.get_active_vector(g1, 1) + e = np.sum(e1) self.save(e, g) @@ -866,9 +901,9 @@ def bind(self, dumop): self.set_coef(self.options["discretization"]) self.friction = self.options["friction"] - if self.friction: - self.gm = FrictionMapper() + self.frictionSD = self.options["frictionSD"] + self.gm = FrictionMapper(self.frictionSD, self.options["eta0"]) self.gm.bind(self) self.gm.set_z_friction(dumop.options["z_friction"]) else: @@ -889,8 +924,8 @@ def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): e = e1 + e2 g = np.add(g1, g2) if debug: - e = e2 - g = g2 + e = e2 + g = g2 elif mode == "physical": e, g = self.gm(x, new_disc) @@ -992,13 +1027,13 @@ def bind(self, geop): self.options["max_e"] = geop.options["max_e"] self.options["discretization"] = geop.options["discretization"] self.options["friction"] = geop.options["friction"] - + self.options["frictionSD"] = geop.options["frictionSD"] if self.options["friction"]: + self.options["eta0"] = geop.options["eta0"] if len(geop.options["z_friction"]) == 0: geop.options["z_friction"] = np.ones((1000, 2)) geop.options["z_friction"][:, 0] = np.arange(1000) self.options["z_friction"] = geop.options["z_friction"] - self.options["tolerances"] = geop.options["tolerances"] self.optarrays["big_step"] = geop.optarrays["big_step"] self.optarrays["old_x"] = geop.optarrays["old_x"] @@ -1113,10 +1148,10 @@ def exitstep(self, d_x_max, step): natoms=self.beads.natoms, nbeads=self.beads.nbeads, fixatoms=self.fixatoms, - friction=self.options["friction"], + friction=self.options["frictionSD"], ) - if self.options["friction"]: + if self.options["friction"] and self.options["frictionSD"]: friction_hessian = current_hessian[1] # self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) self.optarrays["fric_hessian"][:] = friction_hessian @@ -1274,28 +1309,40 @@ def bind(self, geop): self.optarrays["hessian"] = geop.optarrays["hessian"] if self.options["friction"]: - if geop.optarrays["fric_hessian"].shape != ( - self.beads.nbeads, - self.beads.natoms * 3, + + if geop.options["eta0"].shape == (0, 0): + geop.options["eta0"] = np.zeros( + (self.beads.natoms * 3, self.beads.natoms * 3) + ) + assert geop.options["eta0"].shape == ( self.beads.natoms * 3, self.beads.natoms * 3, - ): - if geop.options["hessian_init"]: - geop.optarrays["fric_hessian"] = np.zeros( - ( - self.beads.nbeads, - self.beads.natoms * 3, - self.beads.natoms * 3, - self.beads.natoms * 3, + ), "Please provide a friction tensor with the appropiate shape" + self.options["eta0"] = geop.options["eta0"] + + if self.options["frictionSD"]: + if geop.optarrays["fric_hessian"].shape != ( + self.beads.nbeads, + self.beads.natoms * 3, + self.beads.natoms * 3, + self.beads.natoms * 3, + ): + if geop.options["hessian_init"]: + geop.optarrays["fric_hessian"] = np.zeros( + ( + self.beads.nbeads, + self.beads.natoms * 3, + self.beads.natoms * 3, + self.beads.natoms * 3, + ) ) - ) - else: - raise ValueError( - """ + else: + raise ValueError( + """ 'Hessian_init' is false, 'friction' is true so an initial fric_hessian (of the proper size) must be provided. """ - ) - self.optarrays["fric_hessian"] = geop.optarrays["fric_hessian"] + ) + self.optarrays["fric_hessian"] = geop.optarrays["fric_hessian"] def initialize(self, step): @@ -1336,9 +1383,9 @@ def initialize(self, step): natoms=self.beads.natoms, nbeads=self.beads.nbeads, fixatoms=self.fixatoms, - friction=self.options["friction"], + friction=self.options["frictionSD"], ) - if self.options["friction"]: + if self.options["friction"] and self.options["frictionSD"]: phys_hessian = active_hessian[0] friction_hessian = active_hessian[1] self.optarrays["fric_hessian"][:] = friction_hessian[:] @@ -1377,10 +1424,10 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): natoms=self.beads.natoms, nbeads=self.beads.nbeads, fixatoms=self.fixatoms, - friction=self.options["friction"], + friction=self.options["frictionSD"], ) - if self.options["friction"]: + if self.options["friction"] and self.options["frictionSD"]: phys_hessian = active_hessian[0] friction_hessian = active_hessian[1] self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( @@ -1449,14 +1496,21 @@ def step(self, step=None): # Add spring terms to the physical hessian h = np.add(self.mapper.sm.h, h0) - if debug: - h = h0 + if debug: + h = h0 # Add friction terms to the hessian if self.options["friction"]: - print('ALBERTO clean here gm call') - eta_active = self.fix.get_active_vector(self.mapper.gm.eta,5) - h_fric = self.mapper.gm.get_fric_rp_hessian(activearrays["fric_hessian"],eta_active) + print("ALBERTO clean here gm call") + eta_active = self.fix.get_active_vector(self.mapper.gm.eta, 5) + if self.options["frictionSD"]: + h_fric = self.mapper.gm.get_fric_rp_hessian( + activearrays["fric_hessian"], eta_active, self.options["frictionSD"] + ) + else: + h_fric = self.mapper.gm.get_fric_rp_hessian( + None, eta_active, self.options["frictionSD"] + ) h = np.add(h, h_fric) # Get eigenvalues and eigenvector. diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 11808e6c7..40b67ffb6 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -135,6 +135,10 @@ class InputInst(InputDictionary): InputValue, {"dtype": bool, "default": False, "help": "Activates Friction."}, ), + "frictionSD": ( + InputValue, + {"dtype": bool, "default": True, "help": "Activates SD Friction."}, + ), "z_friction": ( InputArray, { @@ -143,6 +147,14 @@ class InputInst(InputDictionary): "help": "Normalized frequency dependence of the friction tensor (z). A two column data is expected. First column: omega (cm^-1). Second column: z(omega). ", }, ), + "eta": ( + InputArray, + { + "dtype": float, + "default": input_default(factory=np.eye, args=(0,)), + "help": "Friction Tensor. Only to be used when frictionSD is disabled.", + }, + ), "alt_out": ( InputValue, { @@ -323,6 +335,7 @@ def store(self, geop): self.max_ms.store(options["max_ms"]) self.discretization.store(options["discretization"]) self.friction.store(options["friction"]) + self.frictionSD.store(options["frictionSD"]) if options["friction"]: self.z_friction.store(options["z_friction"]) self.alt_out.store(options["save"]) @@ -343,7 +356,10 @@ def store(self, geop): self.hessian_update.store(options["hessian_update"]) self.hessian_asr.store(options["hessian_asr"]) if options["friction"]: - self.fric_hessian.store(optarrays["fric_hessian"]) + if options["frictionSD"]: + self.fric_hessian.store(optarrays["fric_hessian"]) + else: + self.fric_hessian.store(options["eta0"]) elif geop.options["opt"] == "lbfgs": self.qlist_lbfgs.store(optarrays["qlist"]) self.glist_lbfgs.store(optarrays["glist"]) diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index daddf119d..d7ff92f6f 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -308,7 +308,7 @@ class Fix(object): def __init__(self, fixatoms, beads, nbeads=None): - self.natoms = beads.natoms + self.natoms = beads.natoms if nbeads is None: self.nbeads = beads.nbeads else: @@ -368,7 +368,7 @@ def get_active_array(self, arrays): t = -1 elif key == "old_x" or key == "old_f" or key == "d": t = 1 - elif key == "hessian": + elif key == "hessian" or "eta0": t = 2 elif key == "qlist" or key == "glist": t = 3 @@ -428,16 +428,20 @@ def get_full_vector(self, vector, t): return full_vector elif t == 4: - full_vector = np.zeros((self.nbeads, 3 * self.natoms, 3 * self.natoms, 3*self.natoms)) + full_vector = np.zeros( + (self.nbeads, 3 * self.natoms, 3 * self.natoms, 3 * self.natoms) + ) ii = 0 jj = 0 kk = 0 for i in self.get_mask(1): for j in self.get_mask(1): - for k in self.get_mask(1): - full_vector[:,i,j,k] = vector[:,ii,jj,kk] #Yes, this can be improved - kk += 1 - jj += 1 + for k in self.get_mask(1): + full_vector[:, i, j, k] = vector[ + :, ii, jj, kk + ] # Yes, this can be improved + kk += 1 + jj += 1 ii += 1 return full_vector @@ -447,8 +451,10 @@ def get_full_vector(self, vector, t): jj = 0 for i in self.get_mask(1): for j in self.get_mask(1): - full_vector[:,i,j] = vector[:,ii,jj] #Yes, this can be improved - jj += 1 + full_vector[:, i, j] = vector[ + :, ii, jj + ] # Yes, this can be improved + jj += 1 ii += 1 return full_vector @@ -484,8 +490,8 @@ def get_active_vector(self, vector, t): elif t == 3: return vector[:, self.mask2] elif t == 4: - return vector[:,self.mask1][:,:,self.mask1][:,:,:,self.mask1] + return vector[:, self.mask1][:, :, self.mask1][:, :, :, self.mask1] elif t == 5: - return vector[:,self.mask1][:,:,self.mask1] + return vector[:, self.mask1][:, :, self.mask1] else: raise ValueError("@apply_fix_atoms: type number {} is not valid".format(t)) diff --git a/tools/py/Instanton_postproc.py b/tools/py/Instanton_postproc.py index 6451cc692..ef533e698 100755 --- a/tools/py/Instanton_postproc.py +++ b/tools/py/Instanton_postproc.py @@ -135,11 +135,11 @@ ) if asr == "poly": - nzeros = 6 + nzeros = 6 elif asr == "crystal": - nzeros = 3 + nzeros = 3 else: - nzeros = 0 + nzeros = 0 if asr == "linear": raise NotImplementedError("Sum rules for linear molecules is not implemented") From f157725b76f5ee49d1cb7355a0ec02e7b8e831ed Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 1 Mar 2021 20:51:51 +0100 Subject: [PATCH 063/120] lint --- drivers/drivers/spline.py | 1 - ipi/engine/motion/instanton.py | 6 +++--- 2 files changed, 3 insertions(+), 4 deletions(-) diff --git a/drivers/drivers/spline.py b/drivers/drivers/spline.py index 0e7608aa7..9242dd9aa 100644 --- a/drivers/drivers/spline.py +++ b/drivers/drivers/spline.py @@ -3,7 +3,6 @@ import numpy as np import sys from .dummy import Dummy_driver -from toolkit.tools.units import convert as c from scipy import interpolate import json diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 7f52f4111..48db8c40c 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -477,8 +477,8 @@ def check_eta(self, eta): self.sqrtm( eta[i] + np.eye(self.dbeads.natoms * 3) * 0.0001 ) # dgdq = s ** 0.5 -> won't work for multiD - except Warning as e: - print(s[i]) + except Warning: + print(eta[i]) softexit.trigger("The provided friction is not positive definite") def set_z_friction(self, z_friction): @@ -593,7 +593,7 @@ def compute_friction_terms(self): dgdq[i] = self.sqrtm( s[i] + np.eye(nphys) * 0.0001 ) # dgdq = s ** 0.5 -> won't work for multiD - except Warning as e: + except Warning: print(s[i]) softexit.trigger("The provided friction is not positive definite") From 96af34d53c8e0906f15536af949207cd4db7515b Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 2 Mar 2021 19:49:04 +0100 Subject: [PATCH 064/120] add DW to pydriver --- drivers/drivers/__init__.py | 10 +++++++++- drivers/drivers/spline.py | 2 +- 2 files changed, 10 insertions(+), 2 deletions(-) diff --git a/drivers/drivers/__init__.py b/drivers/drivers/__init__.py index d9e5cfa53..d83e267c9 100644 --- a/drivers/drivers/__init__.py +++ b/drivers/drivers/__init__.py @@ -3,12 +3,20 @@ from .harmonic import Harmonic_driver from .spline import Spline_driver from .dummy import Dummy_driver +from .doublewell import DoubleWell_driver -__all__ = ["__drivers__", "Dummy_driver", "Harmonic_driver", "Spline_driver"] +__all__ = [ + "__drivers__", + "Dummy_driver", + "Harmonic_driver", + "Spline_driver", + "DoubleWell_driver", +] # dictionary linking strings __drivers__ = { "dummy": Dummy_driver, "harmonic": Harmonic_driver, + "DoubleWell": DoubleWell_driver, "spline": Spline_driver, } diff --git a/drivers/drivers/spline.py b/drivers/drivers/spline.py index 9242dd9aa..4a0b24a2d 100644 --- a/drivers/drivers/spline.py +++ b/drivers/drivers/spline.py @@ -9,7 +9,7 @@ """Spline driver. This is not a serious interpolation, use it if you know what you are doing. """ factor_coord = 5 mass = 1836 -friction = True +friction = False SI = True fric_value = 0.165 From 9d7b6654f8f07b9e4078604a5a31bf2fa0e1461d Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 2 Mar 2021 19:49:27 +0100 Subject: [PATCH 065/120] add DW to pydriver --- drivers/drivers/doublewell.py | 74 +++++++++++++++++++++++++++++++++++ 1 file changed, 74 insertions(+) create mode 100644 drivers/drivers/doublewell.py diff --git a/drivers/drivers/doublewell.py b/drivers/drivers/doublewell.py new file mode 100644 index 000000000..9fd4f2fbb --- /dev/null +++ b/drivers/drivers/doublewell.py @@ -0,0 +1,74 @@ +""" Harmonic potential """ + +import sys +from .dummy import Dummy_driver +import numpy as np +from ipi.utils import units + +# np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) + +invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) + +# ------------DOUBLE WELL POTENTIAL----------------------------- +# +# m^2*w_b^4 +# V(x,w_b,v0) = - 0.5 *m*w_b^2*(x-delta)^2 + ---------- x^4 +# 16V0 +# +# --------------------------------------------------------- + + +class DoubleWell_driver(Dummy_driver): + def __init__(self, args=None): + + self.error_msg = """\nDW driver excepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -u \n + python driver.py -m DoubleWell -o 500 2085 1837 0.00\n""" + super(DoubleWell_driver, self).__init__(args) + + def check_arguments(self): + """ Function that checks the arguments required to run the driver """ + self.k = 1836 * (3800.0 / 219323.0) ** 2 + if self.args == "": + # We used Craig's values (J. Chem. Phys. 122, 084106, 2005) + w_b = 500 * invcm2au # Tc = 115K + v0 = 2085 * invcm2au + m = 1837 + self.delta = 00 + else: + try: + param = list(map(float, self.args)) + assert len(param) == 4 + w_b = param[0] * invcm2au + v0 = param[1] * invcm2au + m = param[2] + self.delta = param[3] + except: + sys.exit(self.error_msg) + + self.A = -0.5 * m * (w_b) ** 2 + self.B = ((m ** 2) * (w_b) ** 4) / (16 * v0) + + def __call__(self, cell, pos): + """ DoubleWell potential l""" + pot = 0 + pos3 = pos.reshape(-1, 3) + force3 = np.zeros(pos.shape) + + # DW + pot += self.A * (pos3[:, 0] - self.delta) ** 2 + self.B * (pos3[:, 0] ** 4) + force3[:, 0] = -2.0 * self.A * (pos3[:, 0] - self.delta) - 4.0 * self.B * ( + pos3[:, 0] ** 3 + ) + + # Harmonic + pot += 0.5 * self.k * (pos3[:, 1] ** 2).sum() + pot += 0.5 * self.k * (pos3[:, 2] ** 2).sum() + force3[:, 1] = -self.k * pos3[:, 1] + force3[:, 2] = -self.k * pos3[:, 2] + + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + pos = pos3.reshape(pos.shape) + force = force3.reshape(pos.shape) + + return pot, force, vir, extras From 91700d5231f7ed519d84b94c54422dd1af897523 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 3 Mar 2021 09:53:22 +0100 Subject: [PATCH 066/120] store eta0 if required --- ipi/inputs/motion/instanton.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 40b67ffb6..bbc1e3a5f 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -359,7 +359,7 @@ def store(self, geop): if options["frictionSD"]: self.fric_hessian.store(optarrays["fric_hessian"]) else: - self.fric_hessian.store(options["eta0"]) + self.eta.store(options["eta0"]) elif geop.options["opt"] == "lbfgs": self.qlist_lbfgs.store(optarrays["qlist"]) self.glist_lbfgs.store(optarrays["glist"]) From d2b1cad687a60f60b9c77ae548122da9549f6d8a Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 28 Apr 2021 15:38:50 +0200 Subject: [PATCH 067/120] add python potentials --- drivers/py/pes/doublewell.py | 74 ++++++++++++++++++++++ drivers/py/pes/spline.py | 118 +++++++++++++++++++++++++++++++++++ 2 files changed, 192 insertions(+) create mode 100644 drivers/py/pes/doublewell.py create mode 100644 drivers/py/pes/spline.py diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py new file mode 100644 index 000000000..9fd4f2fbb --- /dev/null +++ b/drivers/py/pes/doublewell.py @@ -0,0 +1,74 @@ +""" Harmonic potential """ + +import sys +from .dummy import Dummy_driver +import numpy as np +from ipi.utils import units + +# np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) + +invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) + +# ------------DOUBLE WELL POTENTIAL----------------------------- +# +# m^2*w_b^4 +# V(x,w_b,v0) = - 0.5 *m*w_b^2*(x-delta)^2 + ---------- x^4 +# 16V0 +# +# --------------------------------------------------------- + + +class DoubleWell_driver(Dummy_driver): + def __init__(self, args=None): + + self.error_msg = """\nDW driver excepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -u \n + python driver.py -m DoubleWell -o 500 2085 1837 0.00\n""" + super(DoubleWell_driver, self).__init__(args) + + def check_arguments(self): + """ Function that checks the arguments required to run the driver """ + self.k = 1836 * (3800.0 / 219323.0) ** 2 + if self.args == "": + # We used Craig's values (J. Chem. Phys. 122, 084106, 2005) + w_b = 500 * invcm2au # Tc = 115K + v0 = 2085 * invcm2au + m = 1837 + self.delta = 00 + else: + try: + param = list(map(float, self.args)) + assert len(param) == 4 + w_b = param[0] * invcm2au + v0 = param[1] * invcm2au + m = param[2] + self.delta = param[3] + except: + sys.exit(self.error_msg) + + self.A = -0.5 * m * (w_b) ** 2 + self.B = ((m ** 2) * (w_b) ** 4) / (16 * v0) + + def __call__(self, cell, pos): + """ DoubleWell potential l""" + pot = 0 + pos3 = pos.reshape(-1, 3) + force3 = np.zeros(pos.shape) + + # DW + pot += self.A * (pos3[:, 0] - self.delta) ** 2 + self.B * (pos3[:, 0] ** 4) + force3[:, 0] = -2.0 * self.A * (pos3[:, 0] - self.delta) - 4.0 * self.B * ( + pos3[:, 0] ** 3 + ) + + # Harmonic + pot += 0.5 * self.k * (pos3[:, 1] ** 2).sum() + pot += 0.5 * self.k * (pos3[:, 2] ** 2).sum() + force3[:, 1] = -self.k * pos3[:, 1] + force3[:, 2] = -self.k * pos3[:, 2] + + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "nada" + pos = pos3.reshape(pos.shape) + force = force3.reshape(pos.shape) + + return pot, force, vir, extras diff --git a/drivers/py/pes/spline.py b/drivers/py/pes/spline.py new file mode 100644 index 000000000..4a0b24a2d --- /dev/null +++ b/drivers/py/pes/spline.py @@ -0,0 +1,118 @@ +""" spline potential """ + +import numpy as np +import sys +from .dummy import Dummy_driver +from scipy import interpolate +import json + +"""Spline driver. This is not a serious interpolation, use it if you know what you are doing. """ +factor_coord = 5 +mass = 1836 +friction = False +SI = True +fric_value = 0.165 + + +class Spline_driver(Dummy_driver): + def __init__(self, args=None): + + self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" + super(Spline_driver, self).__init__(args) + self.get_spline() + if friction and not SI: + self.get_spline_fric() + self.k = 1836 * (3800.0 / 219323.0) ** 2 + + def check_arguments(self): + """ Function that checks the arguments required to run the driver """ + + try: + data = np.loadtxt(self.args[0]).reshape(-1, 5) + except ValueError: + sys.exit(self.error_msg) + self.data = data + + def get_spline(self): + """Function that creates the 1D spline and its derivative """ + + self.spline_f = [] + for i in range(3): + self.spline_f.append( + interpolate.interp1d(self.data[:, 0], self.data[:, i + 1], kind="cubic") + ) + + self.spline_e = interpolate.interp1d( + factor_coord * self.data[:, 0], self.data[:, 4], kind="cubic" + ) + + def get_spline_fric(self): + """Function that creates the 1D spline for the friction """ + data = np.loadtxt(self.args[1]).reshape(-1, 10) + self.spline_fric = [] + for i in range(9): + self.spline_fric.append( + interpolate.interp1d( + factor_coord * data[:, 0], mass * data[:, i + 1], kind="cubic" + ) + ) + + def get_energy(self, pos): + x = self.full2oneD(pos) + + pot = self.spline_e(x) + pot += 0.5 * self.k * (pos[0, 1] ** 2 + pos[0, 2] ** 2) + return pot + + def get_forces(self, pos): + x = self.full2oneD(pos) + force = np.zeros(pos.shape) + d = 0.001 + force[0, 0] = -(self.spline_e(x + d) - self.spline_e(x - d)) / (2 * d) + # force[0, 0] = self.spline_f[0](x) #+ self.spline_f[1](x) + self.spline_f[2](x) + force[0, 1] = -self.k * pos[0, 1] + force[0, 2] = -self.k * pos[0, 2] + + return force + + def get_friction(self, pos): + + x = self.full2oneD(pos) + + friction_tensor = np.zeros(9) + + if SI: + friction_tensor = np.eye(3) * fric_value + else: + for i in range(9): + friction_tensor[i] = self.spline_fric[i](x) + friction_tensor = friction_tensor.reshape((3, 3)) + + w = np.linalg.eigvals(friction_tensor) + assert (w >= 0).all() + assert (friction_tensor - friction_tensor.T == np.zeros((3, 3))).all() + return friction_tensor + + def full2oneD(self, pos): + """Function that gets the 1D coordinates from the pos vector""" + return factor_coord * pos[0, 0] + + def check_dimensions(self, pos): + """ Functions that checks dimensions of the received position """ + assert pos.shape == (1, 3) + + def __call__(self, cell, pos): + """ Evaluate energy, forces and friction""" + self.check_dimensions(pos) + vir = cell * 0.0 # makes a zero virial with same shape as cell + + pot = self.get_energy(pos) + force = self.get_forces(pos) + + if friction: + friction_tensor = self.get_friction(pos) + extras = json.dumps({"friction": friction_tensor.tolist()}) + else: + extras = "" + + return pot, force, vir, extras From 9368b34aac93701d02ffa90eed680afa386e2afb Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 28 Apr 2021 15:49:39 +0200 Subject: [PATCH 068/120] black it --- drivers/py/pes/__init__.py | 5 +---- 1 file changed, 1 insertion(+), 4 deletions(-) diff --git a/drivers/py/pes/__init__.py b/drivers/py/pes/__init__.py index 56415c6a0..0753a3ad9 100644 --- a/drivers/py/pes/__init__.py +++ b/drivers/py/pes/__init__.py @@ -3,7 +3,6 @@ from .dummy import Dummy_driver from .harmonic import Harmonic_driver from .spline import Spline_driver -from .dummy import Dummy_driver from .doublewell import DoubleWell_driver from .rascal import Rascal_driver @@ -11,10 +10,8 @@ "__drivers__", "Dummy_driver", "Harmonic_driver", - "Rascal_driver" - "Spline_driver", + "Rascal_driver" "Spline_driver", "DoubleWell_driver", - ] # dictionary linking strings From 8bc7afd95ea67498c3bdb0d13fc828f22ca166a0 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 28 Apr 2021 16:06:12 +0200 Subject: [PATCH 069/120] latest black --- drivers/drivers/doublewell.py | 4 +- drivers/drivers/spline.py | 10 +- drivers/py/driver.py | 4 +- drivers/py/pes/.doublewell.py.swp | Bin 0 -> 12288 bytes drivers/py/pes/doublewell.py | 4 +- drivers/py/pes/dummy.py | 6 +- .../frictionD/test_friction_80K_D/MEP.dat | 0 .../frictionD/test_friction_80K_D/RESTART | 1064 ++++++++++++ .../frictionD/test_friction_80K_D/clean.sh | 4 + .../frictionD/test_friction_80K_D/get1D.sh | 6 + .../frictionD/test_friction_80K_D/init.xyz | 192 +++ .../frictionD/test_friction_80K_D/input.xml | 45 + .../test_friction_80K_D/inst.fric_00 | 48 + .../test_friction_80K_D/inst.fric_01 | 48 + .../test_friction_80K_D/inst.fric_02 | 48 + .../test_friction_80K_D/inst.fric_03 | 48 + .../test_friction_80K_D/inst.fric_04 | 48 + .../test_friction_80K_D/inst.fric_05 | 48 + .../test_friction_80K_D/inst.fric_06 | 48 + .../test_friction_80K_D/inst.fric_07 | 48 + .../test_friction_80K_D/inst.fric_08 | 48 + .../test_friction_80K_D/inst.fric_09 | 48 + .../test_friction_80K_D/inst.fric_10 | 48 + .../test_friction_80K_D/inst.fric_11 | 48 + .../test_friction_80K_D/inst.fric_12 | 48 + .../test_friction_80K_D/inst.fric_13 | 48 + .../test_friction_80K_D/inst.fric_14 | 48 + .../test_friction_80K_D/inst.fric_15 | 48 + .../test_friction_80K_D/inst.fric_16 | 48 + .../test_friction_80K_D/inst.fric_17 | 48 + .../test_friction_80K_D/inst.fric_18 | 48 + .../test_friction_80K_D/inst.fric_19 | 48 + .../test_friction_80K_D/inst.fric_20 | 48 + .../test_friction_80K_D/inst.fric_21 | 48 + .../test_friction_80K_D/inst.fric_22 | 48 + .../test_friction_80K_D/inst.fric_23 | 48 + .../test_friction_80K_D/inst.fric_24 | 48 + .../test_friction_80K_D/inst.fric_25 | 48 + .../test_friction_80K_D/inst.fric_26 | 48 + .../test_friction_80K_D/inst.fric_27 | 48 + .../test_friction_80K_D/inst.fric_28 | 48 + .../test_friction_80K_D/inst.fric_29 | 48 + .../test_friction_80K_D/inst.fric_30 | 48 + .../test_friction_80K_D/inst.fric_31 | 48 + .../test_friction_80K_D/inst.fric_32 | 48 + .../test_friction_80K_D/inst.fric_33 | 48 + .../test_friction_80K_D/inst.fric_34 | 48 + .../test_friction_80K_D/inst.fric_35 | 48 + .../test_friction_80K_D/inst.fric_36 | 48 + .../test_friction_80K_D/inst.fric_37 | 48 + .../test_friction_80K_D/inst.fric_38 | 48 + .../test_friction_80K_D/inst.fric_39 | 48 + .../test_friction_80K_D/inst.fric_40 | 48 + .../test_friction_80K_D/inst.fric_41 | 48 + .../test_friction_80K_D/inst.fric_42 | 48 + .../test_friction_80K_D/inst.fric_43 | 48 + .../test_friction_80K_D/inst.fric_44 | 48 + .../test_friction_80K_D/inst.fric_45 | 48 + .../test_friction_80K_D/inst.fric_46 | 48 + .../test_friction_80K_D/inst.fric_47 | 48 + .../test_friction_80K_D/inst.fric_48 | 48 + .../test_friction_80K_D/inst.fric_49 | 48 + .../test_friction_80K_D/inst.fric_50 | 48 + .../test_friction_80K_D/inst.fric_51 | 48 + .../test_friction_80K_D/inst.fric_52 | 48 + .../test_friction_80K_D/inst.fric_53 | 48 + .../test_friction_80K_D/inst.fric_54 | 48 + .../test_friction_80K_D/inst.fric_55 | 48 + .../test_friction_80K_D/inst.fric_56 | 48 + .../test_friction_80K_D/inst.fric_57 | 48 + .../test_friction_80K_D/inst.fric_58 | 48 + .../test_friction_80K_D/inst.fric_59 | 48 + .../test_friction_80K_D/inst.fric_60 | 48 + .../test_friction_80K_D/inst.fric_61 | 48 + .../test_friction_80K_D/inst.fric_62 | 48 + .../test_friction_80K_D/inst.fric_63 | 48 + .../test_friction_80K_D/inst.instanton.hess_0 | 1 + .../inst.instanton.hess_10 | 1 + .../test_friction_80K_D/inst.instanton_0.ener | 65 + .../test_friction_80K_D/inst.instanton_0.xyz | 192 +++ .../inst.instanton_10.ener | 65 + .../test_friction_80K_D/inst.instanton_10.xyz | 192 +++ .../inst.instanton_FINAL.hess_10 | 1 + .../inst.instanton_FINAL_10.ener | 65 + .../inst.instanton_FINAL_10.xyz | 192 +++ .../inst.instanton_FINAL_forces_10.xyz | 192 +++ .../inst.instanton_forces_0.xyz | 192 +++ .../inst.instanton_forces_10.xyz | 192 +++ .../inst.instantonfric_FINAL.hess_10 | 1 + .../frictionD/test_friction_80K_D/inst.raw_00 | 24 + .../frictionD/test_friction_80K_D/inst.raw_01 | 24 + .../frictionD/test_friction_80K_D/inst.raw_02 | 24 + .../frictionD/test_friction_80K_D/inst.raw_03 | 24 + .../frictionD/test_friction_80K_D/inst.raw_04 | 24 + .../frictionD/test_friction_80K_D/inst.raw_05 | 24 + .../frictionD/test_friction_80K_D/inst.raw_06 | 24 + .../frictionD/test_friction_80K_D/inst.raw_07 | 24 + .../frictionD/test_friction_80K_D/inst.raw_08 | 24 + .../frictionD/test_friction_80K_D/inst.raw_09 | 24 + .../frictionD/test_friction_80K_D/inst.raw_10 | 24 + .../frictionD/test_friction_80K_D/inst.raw_11 | 24 + .../frictionD/test_friction_80K_D/inst.raw_12 | 24 + .../frictionD/test_friction_80K_D/inst.raw_13 | 24 + .../frictionD/test_friction_80K_D/inst.raw_14 | 24 + .../frictionD/test_friction_80K_D/inst.raw_15 | 24 + .../frictionD/test_friction_80K_D/inst.raw_16 | 24 + .../frictionD/test_friction_80K_D/inst.raw_17 | 24 + .../frictionD/test_friction_80K_D/inst.raw_18 | 24 + .../frictionD/test_friction_80K_D/inst.raw_19 | 24 + .../frictionD/test_friction_80K_D/inst.raw_20 | 24 + .../frictionD/test_friction_80K_D/inst.raw_21 | 24 + .../frictionD/test_friction_80K_D/inst.raw_22 | 24 + .../frictionD/test_friction_80K_D/inst.raw_23 | 24 + .../frictionD/test_friction_80K_D/inst.raw_24 | 24 + .../frictionD/test_friction_80K_D/inst.raw_25 | 24 + .../frictionD/test_friction_80K_D/inst.raw_26 | 24 + .../frictionD/test_friction_80K_D/inst.raw_27 | 24 + .../frictionD/test_friction_80K_D/inst.raw_28 | 24 + .../frictionD/test_friction_80K_D/inst.raw_29 | 24 + .../frictionD/test_friction_80K_D/inst.raw_30 | 24 + .../frictionD/test_friction_80K_D/inst.raw_31 | 24 + .../frictionD/test_friction_80K_D/inst.raw_32 | 24 + .../frictionD/test_friction_80K_D/inst.raw_33 | 24 + .../frictionD/test_friction_80K_D/inst.raw_34 | 24 + .../frictionD/test_friction_80K_D/inst.raw_35 | 24 + .../frictionD/test_friction_80K_D/inst.raw_36 | 24 + .../frictionD/test_friction_80K_D/inst.raw_37 | 24 + .../frictionD/test_friction_80K_D/inst.raw_38 | 24 + .../frictionD/test_friction_80K_D/inst.raw_39 | 24 + .../frictionD/test_friction_80K_D/inst.raw_40 | 24 + .../frictionD/test_friction_80K_D/inst.raw_41 | 24 + .../frictionD/test_friction_80K_D/inst.raw_42 | 24 + .../frictionD/test_friction_80K_D/inst.raw_43 | 24 + .../frictionD/test_friction_80K_D/inst.raw_44 | 24 + .../frictionD/test_friction_80K_D/inst.raw_45 | 24 + .../frictionD/test_friction_80K_D/inst.raw_46 | 24 + .../frictionD/test_friction_80K_D/inst.raw_47 | 24 + .../frictionD/test_friction_80K_D/inst.raw_48 | 24 + .../frictionD/test_friction_80K_D/inst.raw_49 | 24 + .../frictionD/test_friction_80K_D/inst.raw_50 | 24 + .../frictionD/test_friction_80K_D/inst.raw_51 | 24 + .../frictionD/test_friction_80K_D/inst.raw_52 | 24 + .../frictionD/test_friction_80K_D/inst.raw_53 | 24 + .../frictionD/test_friction_80K_D/inst.raw_54 | 24 + .../frictionD/test_friction_80K_D/inst.raw_55 | 24 + .../frictionD/test_friction_80K_D/inst.raw_56 | 24 + .../frictionD/test_friction_80K_D/inst.raw_57 | 24 + .../frictionD/test_friction_80K_D/inst.raw_58 | 24 + .../frictionD/test_friction_80K_D/inst.raw_59 | 24 + .../frictionD/test_friction_80K_D/inst.raw_60 | 24 + .../frictionD/test_friction_80K_D/inst.raw_61 | 24 + .../frictionD/test_friction_80K_D/inst.raw_62 | 24 + .../frictionD/test_friction_80K_D/inst.raw_63 | 24 + .../frictionD/test_friction_80K_D/inst1D.dat | 64 + .../test_friction_80K_D/z_friction.dat | 1003 +++++++++++ .../py/pes/friction/frictionH/060K/MEP.dat | 0 .../py/pes/friction/frictionH/060K/RESTART | 1063 ++++++++++++ .../py/pes/friction/frictionH/060K/clean.sh | 4 + .../py/pes/friction/frictionH/060K/get1D.sh | 6 + .../py/pes/friction/frictionH/060K/init.xyz | 192 +++ .../py/pes/friction/frictionH/060K/input.xml | 45 + .../pes/friction/frictionH/060K/inst.fric_00 | 68 + .../pes/friction/frictionH/060K/inst.fric_01 | 68 + .../pes/friction/frictionH/060K/inst.fric_02 | 68 + .../pes/friction/frictionH/060K/inst.fric_03 | 68 + .../pes/friction/frictionH/060K/inst.fric_04 | 68 + .../pes/friction/frictionH/060K/inst.fric_05 | 68 + .../pes/friction/frictionH/060K/inst.fric_06 | 68 + .../pes/friction/frictionH/060K/inst.fric_07 | 68 + .../pes/friction/frictionH/060K/inst.fric_08 | 68 + .../pes/friction/frictionH/060K/inst.fric_09 | 68 + .../pes/friction/frictionH/060K/inst.fric_10 | 68 + .../pes/friction/frictionH/060K/inst.fric_11 | 68 + .../pes/friction/frictionH/060K/inst.fric_12 | 68 + .../pes/friction/frictionH/060K/inst.fric_13 | 68 + .../pes/friction/frictionH/060K/inst.fric_14 | 68 + .../pes/friction/frictionH/060K/inst.fric_15 | 68 + .../pes/friction/frictionH/060K/inst.fric_16 | 68 + .../pes/friction/frictionH/060K/inst.fric_17 | 68 + .../pes/friction/frictionH/060K/inst.fric_18 | 68 + .../pes/friction/frictionH/060K/inst.fric_19 | 68 + .../pes/friction/frictionH/060K/inst.fric_20 | 68 + .../pes/friction/frictionH/060K/inst.fric_21 | 68 + .../pes/friction/frictionH/060K/inst.fric_22 | 68 + .../pes/friction/frictionH/060K/inst.fric_23 | 68 + .../pes/friction/frictionH/060K/inst.fric_24 | 68 + .../pes/friction/frictionH/060K/inst.fric_25 | 68 + .../pes/friction/frictionH/060K/inst.fric_26 | 68 + .../pes/friction/frictionH/060K/inst.fric_27 | 68 + .../pes/friction/frictionH/060K/inst.fric_28 | 68 + .../pes/friction/frictionH/060K/inst.fric_29 | 68 + .../pes/friction/frictionH/060K/inst.fric_30 | 68 + .../pes/friction/frictionH/060K/inst.fric_31 | 68 + .../pes/friction/frictionH/060K/inst.fric_32 | 68 + .../pes/friction/frictionH/060K/inst.fric_33 | 68 + .../pes/friction/frictionH/060K/inst.fric_34 | 68 + .../pes/friction/frictionH/060K/inst.fric_35 | 68 + .../pes/friction/frictionH/060K/inst.fric_36 | 68 + .../pes/friction/frictionH/060K/inst.fric_37 | 68 + .../pes/friction/frictionH/060K/inst.fric_38 | 68 + .../pes/friction/frictionH/060K/inst.fric_39 | 68 + .../pes/friction/frictionH/060K/inst.fric_40 | 68 + .../pes/friction/frictionH/060K/inst.fric_41 | 68 + .../pes/friction/frictionH/060K/inst.fric_42 | 68 + .../pes/friction/frictionH/060K/inst.fric_43 | 68 + .../pes/friction/frictionH/060K/inst.fric_44 | 68 + .../pes/friction/frictionH/060K/inst.fric_45 | 68 + .../pes/friction/frictionH/060K/inst.fric_46 | 68 + .../pes/friction/frictionH/060K/inst.fric_47 | 68 + .../pes/friction/frictionH/060K/inst.fric_48 | 68 + .../pes/friction/frictionH/060K/inst.fric_49 | 68 + .../pes/friction/frictionH/060K/inst.fric_50 | 68 + .../pes/friction/frictionH/060K/inst.fric_51 | 68 + .../pes/friction/frictionH/060K/inst.fric_52 | 68 + .../pes/friction/frictionH/060K/inst.fric_53 | 68 + .../pes/friction/frictionH/060K/inst.fric_54 | 68 + .../pes/friction/frictionH/060K/inst.fric_55 | 68 + .../pes/friction/frictionH/060K/inst.fric_56 | 68 + .../pes/friction/frictionH/060K/inst.fric_57 | 68 + .../pes/friction/frictionH/060K/inst.fric_58 | 68 + .../pes/friction/frictionH/060K/inst.fric_59 | 68 + .../pes/friction/frictionH/060K/inst.fric_60 | 68 + .../pes/friction/frictionH/060K/inst.fric_61 | 68 + .../pes/friction/frictionH/060K/inst.fric_62 | 68 + .../pes/friction/frictionH/060K/inst.fric_63 | 68 + .../frictionH/060K/inst.instanton.hess_0 | 1 + .../frictionH/060K/inst.instanton.hess_1 | 1 + .../frictionH/060K/inst.instanton.hess_10 | 1 + .../frictionH/060K/inst.instanton.hess_11 | 1 + .../frictionH/060K/inst.instanton.hess_12 | 1 + .../frictionH/060K/inst.instanton.hess_13 | 1 + .../frictionH/060K/inst.instanton.hess_14 | 1 + .../frictionH/060K/inst.instanton.hess_15 | 1 + .../frictionH/060K/inst.instanton.hess_2 | 1 + .../frictionH/060K/inst.instanton.hess_3 | 1 + .../frictionH/060K/inst.instanton.hess_4 | 1 + .../frictionH/060K/inst.instanton.hess_5 | 1 + .../frictionH/060K/inst.instanton.hess_6 | 1 + .../frictionH/060K/inst.instanton.hess_7 | 1 + .../frictionH/060K/inst.instanton.hess_8 | 1 + .../frictionH/060K/inst.instanton.hess_9 | 1 + .../frictionH/060K/inst.instanton_0.ener | 65 + .../frictionH/060K/inst.instanton_0.xyz | 192 +++ .../frictionH/060K/inst.instanton_1.ener | 65 + .../frictionH/060K/inst.instanton_1.xyz | 192 +++ .../frictionH/060K/inst.instanton_10.ener | 65 + .../frictionH/060K/inst.instanton_10.xyz | 192 +++ .../frictionH/060K/inst.instanton_11.ener | 65 + .../frictionH/060K/inst.instanton_11.xyz | 192 +++ .../frictionH/060K/inst.instanton_12.ener | 65 + .../frictionH/060K/inst.instanton_12.xyz | 192 +++ .../frictionH/060K/inst.instanton_13.ener | 65 + .../frictionH/060K/inst.instanton_13.xyz | 192 +++ .../frictionH/060K/inst.instanton_14.ener | 65 + .../frictionH/060K/inst.instanton_14.xyz | 192 +++ .../frictionH/060K/inst.instanton_15.ener | 65 + .../frictionH/060K/inst.instanton_15.xyz | 192 +++ .../frictionH/060K/inst.instanton_2.ener | 65 + .../frictionH/060K/inst.instanton_2.xyz | 192 +++ .../frictionH/060K/inst.instanton_3.ener | 65 + .../frictionH/060K/inst.instanton_3.xyz | 192 +++ .../frictionH/060K/inst.instanton_4.ener | 65 + .../frictionH/060K/inst.instanton_4.xyz | 192 +++ .../frictionH/060K/inst.instanton_5.ener | 65 + .../frictionH/060K/inst.instanton_5.xyz | 192 +++ .../frictionH/060K/inst.instanton_6.ener | 65 + .../frictionH/060K/inst.instanton_6.xyz | 192 +++ .../frictionH/060K/inst.instanton_7.ener | 65 + .../frictionH/060K/inst.instanton_7.xyz | 192 +++ .../frictionH/060K/inst.instanton_8.ener | 65 + .../frictionH/060K/inst.instanton_8.xyz | 192 +++ .../frictionH/060K/inst.instanton_9.ener | 65 + .../frictionH/060K/inst.instanton_9.xyz | 192 +++ .../060K/inst.instanton_FINAL.hess_15 | 1 + .../060K/inst.instanton_FINAL_15.ener | 65 + .../060K/inst.instanton_FINAL_15.xyz | 192 +++ .../060K/inst.instanton_FINAL_forces_15.xyz | 192 +++ .../060K/inst.instanton_forces_0.xyz | 192 +++ .../060K/inst.instanton_forces_1.xyz | 192 +++ .../060K/inst.instanton_forces_10.xyz | 192 +++ .../060K/inst.instanton_forces_11.xyz | 192 +++ .../060K/inst.instanton_forces_12.xyz | 192 +++ .../060K/inst.instanton_forces_13.xyz | 192 +++ .../060K/inst.instanton_forces_14.xyz | 192 +++ .../060K/inst.instanton_forces_15.xyz | 192 +++ .../060K/inst.instanton_forces_2.xyz | 192 +++ .../060K/inst.instanton_forces_3.xyz | 192 +++ .../060K/inst.instanton_forces_4.xyz | 192 +++ .../060K/inst.instanton_forces_5.xyz | 192 +++ .../060K/inst.instanton_forces_6.xyz | 192 +++ .../060K/inst.instanton_forces_7.xyz | 192 +++ .../060K/inst.instanton_forces_8.xyz | 192 +++ .../060K/inst.instanton_forces_9.xyz | 192 +++ .../060K/inst.instantonfric_FINAL.hess_15 | 1 + .../pes/friction/frictionH/060K/inst.raw_00 | 34 + .../pes/friction/frictionH/060K/inst.raw_01 | 34 + .../pes/friction/frictionH/060K/inst.raw_02 | 34 + .../pes/friction/frictionH/060K/inst.raw_03 | 34 + .../pes/friction/frictionH/060K/inst.raw_04 | 34 + .../pes/friction/frictionH/060K/inst.raw_05 | 34 + .../pes/friction/frictionH/060K/inst.raw_06 | 34 + .../pes/friction/frictionH/060K/inst.raw_07 | 34 + .../pes/friction/frictionH/060K/inst.raw_08 | 34 + .../pes/friction/frictionH/060K/inst.raw_09 | 34 + .../pes/friction/frictionH/060K/inst.raw_10 | 34 + .../pes/friction/frictionH/060K/inst.raw_11 | 34 + .../pes/friction/frictionH/060K/inst.raw_12 | 34 + .../pes/friction/frictionH/060K/inst.raw_13 | 34 + .../pes/friction/frictionH/060K/inst.raw_14 | 34 + .../pes/friction/frictionH/060K/inst.raw_15 | 34 + .../pes/friction/frictionH/060K/inst.raw_16 | 34 + .../pes/friction/frictionH/060K/inst.raw_17 | 34 + .../pes/friction/frictionH/060K/inst.raw_18 | 34 + .../pes/friction/frictionH/060K/inst.raw_19 | 34 + .../pes/friction/frictionH/060K/inst.raw_20 | 34 + .../pes/friction/frictionH/060K/inst.raw_21 | 34 + .../pes/friction/frictionH/060K/inst.raw_22 | 34 + .../pes/friction/frictionH/060K/inst.raw_23 | 34 + .../pes/friction/frictionH/060K/inst.raw_24 | 34 + .../pes/friction/frictionH/060K/inst.raw_25 | 34 + .../pes/friction/frictionH/060K/inst.raw_26 | 34 + .../pes/friction/frictionH/060K/inst.raw_27 | 34 + .../pes/friction/frictionH/060K/inst.raw_28 | 34 + .../pes/friction/frictionH/060K/inst.raw_29 | 34 + .../pes/friction/frictionH/060K/inst.raw_30 | 34 + .../pes/friction/frictionH/060K/inst.raw_31 | 34 + .../pes/friction/frictionH/060K/inst.raw_32 | 34 + .../pes/friction/frictionH/060K/inst.raw_33 | 34 + .../pes/friction/frictionH/060K/inst.raw_34 | 34 + .../pes/friction/frictionH/060K/inst.raw_35 | 34 + .../pes/friction/frictionH/060K/inst.raw_36 | 34 + .../pes/friction/frictionH/060K/inst.raw_37 | 34 + .../pes/friction/frictionH/060K/inst.raw_38 | 34 + .../pes/friction/frictionH/060K/inst.raw_39 | 34 + .../pes/friction/frictionH/060K/inst.raw_40 | 34 + .../pes/friction/frictionH/060K/inst.raw_41 | 34 + .../pes/friction/frictionH/060K/inst.raw_42 | 34 + .../pes/friction/frictionH/060K/inst.raw_43 | 34 + .../pes/friction/frictionH/060K/inst.raw_44 | 34 + .../pes/friction/frictionH/060K/inst.raw_45 | 34 + .../pes/friction/frictionH/060K/inst.raw_46 | 34 + .../pes/friction/frictionH/060K/inst.raw_47 | 34 + .../pes/friction/frictionH/060K/inst.raw_48 | 34 + .../pes/friction/frictionH/060K/inst.raw_49 | 34 + .../pes/friction/frictionH/060K/inst.raw_50 | 34 + .../pes/friction/frictionH/060K/inst.raw_51 | 34 + .../pes/friction/frictionH/060K/inst.raw_52 | 34 + .../pes/friction/frictionH/060K/inst.raw_53 | 34 + .../pes/friction/frictionH/060K/inst.raw_54 | 34 + .../pes/friction/frictionH/060K/inst.raw_55 | 34 + .../pes/friction/frictionH/060K/inst.raw_56 | 34 + .../pes/friction/frictionH/060K/inst.raw_57 | 34 + .../pes/friction/frictionH/060K/inst.raw_58 | 34 + .../pes/friction/frictionH/060K/inst.raw_59 | 34 + .../pes/friction/frictionH/060K/inst.raw_60 | 34 + .../pes/friction/frictionH/060K/inst.raw_61 | 34 + .../pes/friction/frictionH/060K/inst.raw_62 | 34 + .../pes/friction/frictionH/060K/inst.raw_63 | 34 + .../py/pes/friction/frictionH/060K/inst1D.dat | 64 + .../friction/frictionH/060K/z_friction.dat | 1003 +++++++++++ .../py/pes/friction/frictionH/080K/RESTART | 612 +++++++ .../py/pes/friction/frictionH/080K/clean.sh | 4 + .../py/pes/friction/frictionH/080K/get1D.sh | 6 + .../py/pes/friction/frictionH/080K/init.xyz | 48 + .../py/pes/friction/frictionH/080K/input.xml | 45 + .../pes/friction/frictionH/080K/inst.fric_00 | 36 + .../pes/friction/frictionH/080K/inst.fric_01 | 36 + .../pes/friction/frictionH/080K/inst.fric_02 | 36 + .../pes/friction/frictionH/080K/inst.fric_03 | 36 + .../pes/friction/frictionH/080K/inst.fric_04 | 36 + .../pes/friction/frictionH/080K/inst.fric_05 | 36 + .../pes/friction/frictionH/080K/inst.fric_06 | 36 + .../pes/friction/frictionH/080K/inst.fric_07 | 36 + .../pes/friction/frictionH/080K/inst.fric_08 | 36 + .../pes/friction/frictionH/080K/inst.fric_09 | 36 + .../pes/friction/frictionH/080K/inst.fric_10 | 36 + .../pes/friction/frictionH/080K/inst.fric_11 | 36 + .../pes/friction/frictionH/080K/inst.fric_12 | 36 + .../pes/friction/frictionH/080K/inst.fric_13 | 36 + .../pes/friction/frictionH/080K/inst.fric_14 | 36 + .../pes/friction/frictionH/080K/inst.fric_15 | 36 + .../frictionH/080K/inst.instanton.hess_0 | 1 + .../frictionH/080K/inst.instanton.hess_1 | 1 + .../frictionH/080K/inst.instanton.hess_2 | 1 + .../frictionH/080K/inst.instanton.hess_3 | 1 + .../frictionH/080K/inst.instanton.hess_4 | 1 + .../frictionH/080K/inst.instanton.hess_5 | 1 + .../frictionH/080K/inst.instanton.hess_6 | 1 + .../frictionH/080K/inst.instanton.hess_7 | 1 + .../frictionH/080K/inst.instanton_0.ener | 17 + .../frictionH/080K/inst.instanton_0.xyz | 48 + .../frictionH/080K/inst.instanton_1.ener | 17 + .../frictionH/080K/inst.instanton_1.xyz | 48 + .../frictionH/080K/inst.instanton_2.ener | 17 + .../frictionH/080K/inst.instanton_2.xyz | 48 + .../frictionH/080K/inst.instanton_3.ener | 17 + .../frictionH/080K/inst.instanton_3.xyz | 48 + .../frictionH/080K/inst.instanton_4.ener | 17 + .../frictionH/080K/inst.instanton_4.xyz | 48 + .../frictionH/080K/inst.instanton_5.ener | 17 + .../frictionH/080K/inst.instanton_5.xyz | 48 + .../frictionH/080K/inst.instanton_6.ener | 17 + .../frictionH/080K/inst.instanton_6.xyz | 48 + .../frictionH/080K/inst.instanton_7.ener | 17 + .../frictionH/080K/inst.instanton_7.xyz | 48 + .../080K/inst.instanton_FINAL.hess_7 | 1 + .../080K/inst.instanton_FINAL_7.ener | 17 + .../frictionH/080K/inst.instanton_FINAL_7.xyz | 48 + .../080K/inst.instanton_FINAL_forces_7.xyz | 48 + .../080K/inst.instanton_forces_0.xyz | 48 + .../080K/inst.instanton_forces_1.xyz | 48 + .../080K/inst.instanton_forces_2.xyz | 48 + .../080K/inst.instanton_forces_3.xyz | 48 + .../080K/inst.instanton_forces_4.xyz | 48 + .../080K/inst.instanton_forces_5.xyz | 48 + .../080K/inst.instanton_forces_6.xyz | 48 + .../080K/inst.instanton_forces_7.xyz | 48 + .../080K/inst.instantonfric_FINAL.hess_7 | 1 + .../pes/friction/frictionH/080K/inst.raw_00 | 18 + .../pes/friction/frictionH/080K/inst.raw_01 | 18 + .../pes/friction/frictionH/080K/inst.raw_02 | 18 + .../pes/friction/frictionH/080K/inst.raw_03 | 18 + .../pes/friction/frictionH/080K/inst.raw_04 | 18 + .../pes/friction/frictionH/080K/inst.raw_05 | 18 + .../pes/friction/frictionH/080K/inst.raw_06 | 18 + .../pes/friction/frictionH/080K/inst.raw_07 | 18 + .../pes/friction/frictionH/080K/inst.raw_08 | 18 + .../pes/friction/frictionH/080K/inst.raw_09 | 18 + .../pes/friction/frictionH/080K/inst.raw_10 | 18 + .../pes/friction/frictionH/080K/inst.raw_11 | 18 + .../pes/friction/frictionH/080K/inst.raw_12 | 18 + .../pes/friction/frictionH/080K/inst.raw_13 | 18 + .../pes/friction/frictionH/080K/inst.raw_14 | 18 + .../pes/friction/frictionH/080K/inst.raw_15 | 18 + .../py/pes/friction/frictionH/080K/inst1D.dat | 16 + .../friction/frictionH/080K/z_friction.dat | 1003 +++++++++++ .../py/pes/friction/frictionH/100K/MEP.dat | 0 .../py/pes/friction/frictionH/100K/RESTART | 612 +++++++ .../py/pes/friction/frictionH/100K/clean.sh | 4 + .../py/pes/friction/frictionH/100K/get1D.sh | 5 + .../py/pes/friction/frictionH/100K/init.xyz | 48 + .../py/pes/friction/frictionH/100K/input.xml | 45 + .../pes/friction/frictionH/100K/inst.fric_00 | 16 + .../pes/friction/frictionH/100K/inst.fric_01 | 16 + .../pes/friction/frictionH/100K/inst.fric_02 | 16 + .../pes/friction/frictionH/100K/inst.fric_03 | 16 + .../pes/friction/frictionH/100K/inst.fric_04 | 16 + .../pes/friction/frictionH/100K/inst.fric_05 | 16 + .../pes/friction/frictionH/100K/inst.fric_06 | 16 + .../pes/friction/frictionH/100K/inst.fric_07 | 16 + .../pes/friction/frictionH/100K/inst.fric_08 | 16 + .../pes/friction/frictionH/100K/inst.fric_09 | 16 + .../pes/friction/frictionH/100K/inst.fric_10 | 16 + .../pes/friction/frictionH/100K/inst.fric_11 | 16 + .../pes/friction/frictionH/100K/inst.fric_12 | 16 + .../pes/friction/frictionH/100K/inst.fric_13 | 16 + .../pes/friction/frictionH/100K/inst.fric_14 | 16 + .../pes/friction/frictionH/100K/inst.fric_15 | 16 + .../frictionH/100K/inst.instanton.hess_0 | 1 + .../frictionH/100K/inst.instanton.hess_1 | 1 + .../frictionH/100K/inst.instanton.hess_2 | 1 + .../frictionH/100K/inst.instanton_0.ener | 17 + .../frictionH/100K/inst.instanton_0.xyz | 48 + .../frictionH/100K/inst.instanton_1.ener | 17 + .../frictionH/100K/inst.instanton_1.xyz | 48 + .../frictionH/100K/inst.instanton_2.ener | 17 + .../frictionH/100K/inst.instanton_2.xyz | 48 + .../100K/inst.instanton_FINAL.hess_2 | 1 + .../100K/inst.instanton_FINAL_2.ener | 17 + .../frictionH/100K/inst.instanton_FINAL_2.xyz | 48 + .../100K/inst.instanton_FINAL_forces_2.xyz | 48 + .../100K/inst.instanton_forces_0.xyz | 48 + .../100K/inst.instanton_forces_1.xyz | 48 + .../100K/inst.instanton_forces_2.xyz | 48 + .../100K/inst.instantonfric_FINAL.hess_2 | 1 + .../pes/friction/frictionH/100K/inst.raw_00 | 8 + .../pes/friction/frictionH/100K/inst.raw_01 | 8 + .../pes/friction/frictionH/100K/inst.raw_02 | 8 + .../pes/friction/frictionH/100K/inst.raw_03 | 8 + .../pes/friction/frictionH/100K/inst.raw_04 | 8 + .../pes/friction/frictionH/100K/inst.raw_05 | 8 + .../pes/friction/frictionH/100K/inst.raw_06 | 8 + .../pes/friction/frictionH/100K/inst.raw_07 | 8 + .../pes/friction/frictionH/100K/inst.raw_08 | 8 + .../pes/friction/frictionH/100K/inst.raw_09 | 8 + .../pes/friction/frictionH/100K/inst.raw_10 | 8 + .../pes/friction/frictionH/100K/inst.raw_11 | 8 + .../pes/friction/frictionH/100K/inst.raw_12 | 8 + .../pes/friction/frictionH/100K/inst.raw_13 | 8 + .../pes/friction/frictionH/100K/inst.raw_14 | 8 + .../pes/friction/frictionH/100K/inst.raw_15 | 8 + .../py/pes/friction/frictionH/100K/inst1D.dat | 16 + .../friction/frictionH/100K/z_friction.dat | 1003 +++++++++++ .../py/pes/friction/frictionH/120K/RESTART | 612 +++++++ .../py/pes/friction/frictionH/120K/clean.sh | 4 + .../py/pes/friction/frictionH/120K/get1D.sh | 5 + .../py/pes/friction/frictionH/120K/init.xyz | 48 + .../py/pes/friction/frictionH/120K/input.xml | 45 + .../pes/friction/frictionH/120K/inst.fric_00 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_01 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_02 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_03 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_04 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_05 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_06 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_07 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_08 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_09 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_10 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_11 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_12 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_13 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_14 | 124 ++ .../pes/friction/frictionH/120K/inst.fric_15 | 124 ++ .../frictionH/120K/inst.instanton.hess_0 | 1 + .../frictionH/120K/inst.instanton.hess_1 | 1 + .../frictionH/120K/inst.instanton.hess_10 | 1 + .../frictionH/120K/inst.instanton.hess_11 | 1 + .../frictionH/120K/inst.instanton.hess_12 | 1 + .../frictionH/120K/inst.instanton.hess_13 | 1 + .../frictionH/120K/inst.instanton.hess_14 | 1 + .../frictionH/120K/inst.instanton.hess_15 | 1 + .../frictionH/120K/inst.instanton.hess_16 | 1 + .../frictionH/120K/inst.instanton.hess_17 | 1 + .../frictionH/120K/inst.instanton.hess_18 | 1 + .../frictionH/120K/inst.instanton.hess_19 | 1 + .../frictionH/120K/inst.instanton.hess_2 | 1 + .../frictionH/120K/inst.instanton.hess_20 | 1 + .../frictionH/120K/inst.instanton.hess_21 | 1 + .../frictionH/120K/inst.instanton.hess_22 | 1 + .../frictionH/120K/inst.instanton.hess_23 | 1 + .../frictionH/120K/inst.instanton.hess_24 | 1 + .../frictionH/120K/inst.instanton.hess_25 | 1 + .../frictionH/120K/inst.instanton.hess_26 | 1 + .../frictionH/120K/inst.instanton.hess_27 | 1 + .../frictionH/120K/inst.instanton.hess_28 | 1 + .../frictionH/120K/inst.instanton.hess_29 | 1 + .../frictionH/120K/inst.instanton.hess_3 | 1 + .../frictionH/120K/inst.instanton.hess_4 | 1 + .../frictionH/120K/inst.instanton.hess_5 | 1 + .../frictionH/120K/inst.instanton.hess_6 | 1 + .../frictionH/120K/inst.instanton.hess_7 | 1 + .../frictionH/120K/inst.instanton.hess_8 | 1 + .../frictionH/120K/inst.instanton.hess_9 | 1 + .../frictionH/120K/inst.instanton_0.ener | 17 + .../frictionH/120K/inst.instanton_0.xyz | 48 + .../frictionH/120K/inst.instanton_1.ener | 17 + .../frictionH/120K/inst.instanton_1.xyz | 48 + .../frictionH/120K/inst.instanton_10.ener | 17 + .../frictionH/120K/inst.instanton_10.xyz | 48 + .../frictionH/120K/inst.instanton_11.ener | 17 + .../frictionH/120K/inst.instanton_11.xyz | 48 + .../frictionH/120K/inst.instanton_12.ener | 17 + .../frictionH/120K/inst.instanton_12.xyz | 48 + .../frictionH/120K/inst.instanton_13.ener | 17 + .../frictionH/120K/inst.instanton_13.xyz | 48 + .../frictionH/120K/inst.instanton_14.ener | 17 + .../frictionH/120K/inst.instanton_14.xyz | 48 + .../frictionH/120K/inst.instanton_15.ener | 17 + .../frictionH/120K/inst.instanton_15.xyz | 48 + .../frictionH/120K/inst.instanton_16.ener | 17 + .../frictionH/120K/inst.instanton_16.xyz | 48 + .../frictionH/120K/inst.instanton_17.ener | 17 + .../frictionH/120K/inst.instanton_17.xyz | 48 + .../frictionH/120K/inst.instanton_18.ener | 17 + .../frictionH/120K/inst.instanton_18.xyz | 48 + .../frictionH/120K/inst.instanton_19.ener | 17 + .../frictionH/120K/inst.instanton_19.xyz | 48 + .../frictionH/120K/inst.instanton_2.ener | 17 + .../frictionH/120K/inst.instanton_2.xyz | 48 + .../frictionH/120K/inst.instanton_20.ener | 17 + .../frictionH/120K/inst.instanton_20.xyz | 48 + .../frictionH/120K/inst.instanton_21.ener | 17 + .../frictionH/120K/inst.instanton_21.xyz | 48 + .../frictionH/120K/inst.instanton_22.ener | 17 + .../frictionH/120K/inst.instanton_22.xyz | 48 + .../frictionH/120K/inst.instanton_23.ener | 17 + .../frictionH/120K/inst.instanton_23.xyz | 48 + .../frictionH/120K/inst.instanton_24.ener | 17 + .../frictionH/120K/inst.instanton_24.xyz | 48 + .../frictionH/120K/inst.instanton_25.ener | 17 + .../frictionH/120K/inst.instanton_25.xyz | 48 + .../frictionH/120K/inst.instanton_26.ener | 17 + .../frictionH/120K/inst.instanton_26.xyz | 48 + .../frictionH/120K/inst.instanton_27.ener | 17 + .../frictionH/120K/inst.instanton_27.xyz | 48 + .../frictionH/120K/inst.instanton_28.ener | 17 + .../frictionH/120K/inst.instanton_28.xyz | 48 + .../frictionH/120K/inst.instanton_29.ener | 17 + .../frictionH/120K/inst.instanton_29.xyz | 48 + .../frictionH/120K/inst.instanton_3.ener | 17 + .../frictionH/120K/inst.instanton_3.xyz | 48 + .../frictionH/120K/inst.instanton_4.ener | 17 + .../frictionH/120K/inst.instanton_4.xyz | 48 + .../frictionH/120K/inst.instanton_5.ener | 17 + .../frictionH/120K/inst.instanton_5.xyz | 48 + .../frictionH/120K/inst.instanton_6.ener | 17 + .../frictionH/120K/inst.instanton_6.xyz | 48 + .../frictionH/120K/inst.instanton_7.ener | 17 + .../frictionH/120K/inst.instanton_7.xyz | 48 + .../frictionH/120K/inst.instanton_8.ener | 17 + .../frictionH/120K/inst.instanton_8.xyz | 48 + .../frictionH/120K/inst.instanton_9.ener | 17 + .../frictionH/120K/inst.instanton_9.xyz | 48 + .../120K/inst.instanton_FINAL.hess_29 | 1 + .../120K/inst.instanton_FINAL_29.ener | 17 + .../120K/inst.instanton_FINAL_29.xyz | 48 + .../120K/inst.instanton_FINAL_forces_29.xyz | 48 + .../120K/inst.instanton_forces_0.xyz | 48 + .../120K/inst.instanton_forces_1.xyz | 48 + .../120K/inst.instanton_forces_10.xyz | 48 + .../120K/inst.instanton_forces_11.xyz | 48 + .../120K/inst.instanton_forces_12.xyz | 48 + .../120K/inst.instanton_forces_13.xyz | 48 + .../120K/inst.instanton_forces_14.xyz | 48 + .../120K/inst.instanton_forces_15.xyz | 48 + .../120K/inst.instanton_forces_16.xyz | 48 + .../120K/inst.instanton_forces_17.xyz | 48 + .../120K/inst.instanton_forces_18.xyz | 48 + .../120K/inst.instanton_forces_19.xyz | 48 + .../120K/inst.instanton_forces_2.xyz | 48 + .../120K/inst.instanton_forces_20.xyz | 48 + .../120K/inst.instanton_forces_21.xyz | 48 + .../120K/inst.instanton_forces_22.xyz | 48 + .../120K/inst.instanton_forces_23.xyz | 48 + .../120K/inst.instanton_forces_24.xyz | 48 + .../120K/inst.instanton_forces_25.xyz | 48 + .../120K/inst.instanton_forces_26.xyz | 48 + .../120K/inst.instanton_forces_27.xyz | 48 + .../120K/inst.instanton_forces_28.xyz | 48 + .../120K/inst.instanton_forces_29.xyz | 48 + .../120K/inst.instanton_forces_3.xyz | 48 + .../120K/inst.instanton_forces_4.xyz | 48 + .../120K/inst.instanton_forces_5.xyz | 48 + .../120K/inst.instanton_forces_6.xyz | 48 + .../120K/inst.instanton_forces_7.xyz | 48 + .../120K/inst.instanton_forces_8.xyz | 48 + .../120K/inst.instanton_forces_9.xyz | 48 + .../120K/inst.instantonfric_FINAL.hess_29 | 1 + .../pes/friction/frictionH/120K/inst.raw_00 | 62 + .../pes/friction/frictionH/120K/inst.raw_01 | 62 + .../pes/friction/frictionH/120K/inst.raw_02 | 62 + .../pes/friction/frictionH/120K/inst.raw_03 | 62 + .../pes/friction/frictionH/120K/inst.raw_04 | 62 + .../pes/friction/frictionH/120K/inst.raw_05 | 62 + .../pes/friction/frictionH/120K/inst.raw_06 | 62 + .../pes/friction/frictionH/120K/inst.raw_07 | 62 + .../pes/friction/frictionH/120K/inst.raw_08 | 62 + .../pes/friction/frictionH/120K/inst.raw_09 | 62 + .../pes/friction/frictionH/120K/inst.raw_10 | 62 + .../pes/friction/frictionH/120K/inst.raw_11 | 62 + .../pes/friction/frictionH/120K/inst.raw_12 | 62 + .../pes/friction/frictionH/120K/inst.raw_13 | 62 + .../pes/friction/frictionH/120K/inst.raw_14 | 62 + .../pes/friction/frictionH/120K/inst.raw_15 | 62 + .../py/pes/friction/frictionH/120K/inst1D.dat | 16 + .../friction/frictionH/120K/z_friction.dat | 1003 +++++++++++ drivers/py/pes/friction/onheH/060K/RESTART | 309 ++++ drivers/py/pes/friction/onheH/060K/clean.sh | 4 + drivers/py/pes/friction/onheH/060K/control.in | 181 ++ .../py/pes/friction/onheH/060K/geometry.in | 11 + drivers/py/pes/friction/onheH/060K/get1D.sh | 5 + .../py/pes/friction/onheH/060K/hessian.dat | 1 + drivers/py/pes/friction/onheH/060K/init.xyz | 192 +++ drivers/py/pes/friction/onheH/060K/input.xml | 37 + .../friction/onheH/060K/inst.instanton.hess_0 | 1 + .../friction/onheH/060K/inst.instanton.hess_1 | 1 + .../onheH/060K/inst.instanton.hess_10 | 1 + .../onheH/060K/inst.instanton.hess_11 | 1 + .../onheH/060K/inst.instanton.hess_12 | 1 + .../friction/onheH/060K/inst.instanton.hess_2 | 1 + .../friction/onheH/060K/inst.instanton.hess_3 | 1 + .../friction/onheH/060K/inst.instanton.hess_4 | 1 + .../friction/onheH/060K/inst.instanton.hess_5 | 1 + .../friction/onheH/060K/inst.instanton.hess_6 | 1 + .../friction/onheH/060K/inst.instanton.hess_7 | 1 + .../friction/onheH/060K/inst.instanton.hess_8 | 1 + .../friction/onheH/060K/inst.instanton.hess_9 | 1 + .../friction/onheH/060K/inst.instanton_0.ener | 65 + .../friction/onheH/060K/inst.instanton_0.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_1.ener | 65 + .../friction/onheH/060K/inst.instanton_1.xyz | 192 +++ .../onheH/060K/inst.instanton_10.ener | 65 + .../friction/onheH/060K/inst.instanton_10.xyz | 192 +++ .../onheH/060K/inst.instanton_11.ener | 65 + .../friction/onheH/060K/inst.instanton_11.xyz | 192 +++ .../onheH/060K/inst.instanton_12.ener | 65 + .../friction/onheH/060K/inst.instanton_12.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_2.ener | 65 + .../friction/onheH/060K/inst.instanton_2.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_3.ener | 65 + .../friction/onheH/060K/inst.instanton_3.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_4.ener | 65 + .../friction/onheH/060K/inst.instanton_4.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_5.ener | 65 + .../friction/onheH/060K/inst.instanton_5.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_6.ener | 65 + .../friction/onheH/060K/inst.instanton_6.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_7.ener | 65 + .../friction/onheH/060K/inst.instanton_7.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_8.ener | 65 + .../friction/onheH/060K/inst.instanton_8.xyz | 192 +++ .../friction/onheH/060K/inst.instanton_9.ener | 65 + .../friction/onheH/060K/inst.instanton_9.xyz | 192 +++ .../onheH/060K/inst.instanton_FINAL.hess_12 | 1 + .../onheH/060K/inst.instanton_FINAL_12.ener | 65 + .../onheH/060K/inst.instanton_FINAL_12.xyz | 192 +++ .../060K/inst.instanton_FINAL_forces_12.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_0.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_1.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_10.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_11.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_12.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_2.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_3.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_4.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_5.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_6.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_7.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_8.xyz | 192 +++ .../onheH/060K/inst.instanton_forces_9.xyz | 192 +++ drivers/py/pes/friction/onheH/060K/inst1D.dat | 64 + drivers/py/pes/friction/onheH/080K/RESTART | 309 ++++ drivers/py/pes/friction/onheH/080K/clean.sh | 4 + drivers/py/pes/friction/onheH/080K/control.in | 181 ++ .../py/pes/friction/onheH/080K/geometry.in | 11 + drivers/py/pes/friction/onheH/080K/get1D.sh | 5 + .../py/pes/friction/onheH/080K/hessian.dat | 1 + drivers/py/pes/friction/onheH/080K/init.xyz | 192 +++ drivers/py/pes/friction/onheH/080K/input.xml | 37 + .../friction/onheH/080K/inst.instanton.hess_0 | 1 + .../friction/onheH/080K/inst.instanton.hess_1 | 1 + .../friction/onheH/080K/inst.instanton.hess_2 | 1 + .../friction/onheH/080K/inst.instanton.hess_3 | 1 + .../friction/onheH/080K/inst.instanton.hess_4 | 1 + .../friction/onheH/080K/inst.instanton.hess_5 | 1 + .../friction/onheH/080K/inst.instanton.hess_6 | 1 + .../friction/onheH/080K/inst.instanton.hess_7 | 1 + .../friction/onheH/080K/inst.instanton.hess_8 | 1 + .../friction/onheH/080K/inst.instanton_0.ener | 65 + .../friction/onheH/080K/inst.instanton_0.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_1.ener | 65 + .../friction/onheH/080K/inst.instanton_1.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_2.ener | 65 + .../friction/onheH/080K/inst.instanton_2.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_3.ener | 65 + .../friction/onheH/080K/inst.instanton_3.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_4.ener | 65 + .../friction/onheH/080K/inst.instanton_4.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_5.ener | 65 + .../friction/onheH/080K/inst.instanton_5.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_6.ener | 65 + .../friction/onheH/080K/inst.instanton_6.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_7.ener | 65 + .../friction/onheH/080K/inst.instanton_7.xyz | 192 +++ .../friction/onheH/080K/inst.instanton_8.ener | 65 + .../friction/onheH/080K/inst.instanton_8.xyz | 192 +++ .../onheH/080K/inst.instanton_FINAL.hess_8 | 1 + .../onheH/080K/inst.instanton_FINAL_8.ener | 65 + .../onheH/080K/inst.instanton_FINAL_8.xyz | 192 +++ .../080K/inst.instanton_FINAL_forces_8.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_0.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_1.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_2.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_3.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_4.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_5.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_6.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_7.xyz | 192 +++ .../onheH/080K/inst.instanton_forces_8.xyz | 192 +++ drivers/py/pes/friction/onheH/080K/inst1D.dat | 64 + drivers/py/pes/friction/onheH/100K/RESTART | 117 ++ drivers/py/pes/friction/onheH/100K/control.in | 181 ++ .../py/pes/friction/onheH/100K/geometry.in | 11 + drivers/py/pes/friction/onheH/100K/get1D.sh | 6 + .../py/pes/friction/onheH/100K/hessian.dat | 1 + drivers/py/pes/friction/onheH/100K/init.xyz | 48 + drivers/py/pes/friction/onheH/100K/input.xml | 37 + .../friction/onheH/100K/inst.instanton.hess_0 | 1 + .../friction/onheH/100K/inst.instanton.hess_1 | 1 + .../friction/onheH/100K/inst.instanton.hess_2 | 1 + .../friction/onheH/100K/inst.instanton_0.ener | 17 + .../friction/onheH/100K/inst.instanton_0.xyz | 48 + .../friction/onheH/100K/inst.instanton_1.ener | 17 + .../friction/onheH/100K/inst.instanton_1.xyz | 48 + .../friction/onheH/100K/inst.instanton_2.ener | 17 + .../friction/onheH/100K/inst.instanton_2.xyz | 48 + .../onheH/100K/inst.instanton_FINAL.hess_2 | 1 + .../onheH/100K/inst.instanton_FINAL_2.ener | 17 + .../onheH/100K/inst.instanton_FINAL_2.xyz | 48 + .../100K/inst.instanton_FINAL_forces_2.xyz | 48 + .../onheH/100K/inst.instanton_forces_0.xyz | 48 + .../onheH/100K/inst.instanton_forces_1.xyz | 48 + .../onheH/100K/inst.instanton_forces_2.xyz | 48 + drivers/py/pes/friction/onheH/100K/inst1D.dat | 16 + drivers/py/pes/friction/onheH/120K/RESTART | 117 ++ drivers/py/pes/friction/onheH/120K/clean.sh | 4 + drivers/py/pes/friction/onheH/120K/control.in | 181 ++ .../py/pes/friction/onheH/120K/geometry.in | 11 + drivers/py/pes/friction/onheH/120K/get1D.sh | 6 + drivers/py/pes/friction/onheH/120K/init.xyz | 48 + drivers/py/pes/friction/onheH/120K/input.xml | 37 + .../friction/onheH/120K/inst.instanton.hess_0 | 1 + .../friction/onheH/120K/inst.instanton.hess_1 | 1 + .../onheH/120K/inst.instanton.hess_10 | 1 + .../onheH/120K/inst.instanton.hess_11 | 1 + .../onheH/120K/inst.instanton.hess_12 | 1 + .../onheH/120K/inst.instanton.hess_13 | 1 + .../friction/onheH/120K/inst.instanton.hess_2 | 1 + .../friction/onheH/120K/inst.instanton.hess_3 | 1 + .../friction/onheH/120K/inst.instanton.hess_4 | 1 + .../friction/onheH/120K/inst.instanton.hess_5 | 1 + .../friction/onheH/120K/inst.instanton.hess_6 | 1 + .../friction/onheH/120K/inst.instanton.hess_7 | 1 + .../friction/onheH/120K/inst.instanton.hess_8 | 1 + .../friction/onheH/120K/inst.instanton.hess_9 | 1 + .../friction/onheH/120K/inst.instanton_0.ener | 17 + .../friction/onheH/120K/inst.instanton_0.xyz | 48 + .../friction/onheH/120K/inst.instanton_1.ener | 17 + .../friction/onheH/120K/inst.instanton_1.xyz | 48 + .../onheH/120K/inst.instanton_10.ener | 17 + .../friction/onheH/120K/inst.instanton_10.xyz | 48 + .../onheH/120K/inst.instanton_11.ener | 17 + .../friction/onheH/120K/inst.instanton_11.xyz | 48 + .../onheH/120K/inst.instanton_12.ener | 17 + .../friction/onheH/120K/inst.instanton_12.xyz | 48 + .../onheH/120K/inst.instanton_13.ener | 17 + .../friction/onheH/120K/inst.instanton_13.xyz | 48 + .../friction/onheH/120K/inst.instanton_2.ener | 17 + .../friction/onheH/120K/inst.instanton_2.xyz | 48 + .../friction/onheH/120K/inst.instanton_3.ener | 17 + .../friction/onheH/120K/inst.instanton_3.xyz | 48 + .../friction/onheH/120K/inst.instanton_4.ener | 17 + .../friction/onheH/120K/inst.instanton_4.xyz | 48 + .../friction/onheH/120K/inst.instanton_5.ener | 17 + .../friction/onheH/120K/inst.instanton_5.xyz | 48 + .../friction/onheH/120K/inst.instanton_6.ener | 17 + .../friction/onheH/120K/inst.instanton_6.xyz | 48 + .../friction/onheH/120K/inst.instanton_7.ener | 17 + .../friction/onheH/120K/inst.instanton_7.xyz | 48 + .../friction/onheH/120K/inst.instanton_8.ener | 17 + .../friction/onheH/120K/inst.instanton_8.xyz | 48 + .../friction/onheH/120K/inst.instanton_9.ener | 17 + .../friction/onheH/120K/inst.instanton_9.xyz | 48 + .../onheH/120K/inst.instanton_FINAL.hess_13 | 1 + .../onheH/120K/inst.instanton_FINAL_13.ener | 17 + .../onheH/120K/inst.instanton_FINAL_13.xyz | 48 + .../120K/inst.instanton_FINAL_forces_13.xyz | 48 + .../onheH/120K/inst.instanton_forces_0.xyz | 48 + .../onheH/120K/inst.instanton_forces_1.xyz | 48 + .../onheH/120K/inst.instanton_forces_10.xyz | 48 + .../onheH/120K/inst.instanton_forces_11.xyz | 48 + .../onheH/120K/inst.instanton_forces_12.xyz | 48 + .../onheH/120K/inst.instanton_forces_13.xyz | 48 + .../onheH/120K/inst.instanton_forces_2.xyz | 48 + .../onheH/120K/inst.instanton_forces_3.xyz | 48 + .../onheH/120K/inst.instanton_forces_4.xyz | 48 + .../onheH/120K/inst.instanton_forces_5.xyz | 48 + .../onheH/120K/inst.instanton_forces_6.xyz | 48 + .../onheH/120K/inst.instanton_forces_7.xyz | 48 + .../onheH/120K/inst.instanton_forces_8.xyz | 48 + .../onheH/120K/inst.instanton_forces_9.xyz | 48 + drivers/py/pes/friction/onheH/120K/inst1D.dat | 16 + drivers/py/pes/friction/template.agr | 1502 +++++++++++++++++ drivers/py/pes/friction/test-ohne80/RESTART | 117 ++ .../py/pes/friction/test-ohne80/control.in | 181 ++ .../py/pes/friction/test-ohne80/geometry.in | 11 + drivers/py/pes/friction/test-ohne80/get1D.sh | 6 + .../py/pes/friction/test-ohne80/hessian.dat | 1 + drivers/py/pes/friction/test-ohne80/init.xyz | 48 + drivers/py/pes/friction/test-ohne80/input.xml | 37 + .../test-ohne80/inst.instanton.hess_0 | 1 + .../test-ohne80/inst.instanton.hess_1 | 1 + .../test-ohne80/inst.instanton.hess_2 | 1 + .../test-ohne80/inst.instanton.hess_3 | 1 + .../test-ohne80/inst.instanton.hess_4 | 1 + .../test-ohne80/inst.instanton.hess_5 | 1 + .../test-ohne80/inst.instanton.hess_6 | 1 + .../test-ohne80/inst.instanton.hess_7 | 1 + .../test-ohne80/inst.instanton.hess_8 | 1 + .../test-ohne80/inst.instanton_0.ener | 17 + .../friction/test-ohne80/inst.instanton_0.xyz | 48 + .../test-ohne80/inst.instanton_1.ener | 17 + .../friction/test-ohne80/inst.instanton_1.xyz | 48 + .../test-ohne80/inst.instanton_2.ener | 17 + .../friction/test-ohne80/inst.instanton_2.xyz | 48 + .../test-ohne80/inst.instanton_3.ener | 17 + .../friction/test-ohne80/inst.instanton_3.xyz | 48 + .../test-ohne80/inst.instanton_4.ener | 17 + .../friction/test-ohne80/inst.instanton_4.xyz | 48 + .../test-ohne80/inst.instanton_5.ener | 17 + .../friction/test-ohne80/inst.instanton_5.xyz | 48 + .../test-ohne80/inst.instanton_6.ener | 17 + .../friction/test-ohne80/inst.instanton_6.xyz | 48 + .../test-ohne80/inst.instanton_7.ener | 17 + .../friction/test-ohne80/inst.instanton_7.xyz | 48 + .../test-ohne80/inst.instanton_8.ener | 17 + .../friction/test-ohne80/inst.instanton_8.xyz | 48 + .../test-ohne80/inst.instanton_FINAL.hess_8 | 1 + .../test-ohne80/inst.instanton_FINAL_8.ener | 17 + .../test-ohne80/inst.instanton_FINAL_8.xyz | 48 + .../inst.instanton_FINAL_forces_8.xyz | 48 + .../test-ohne80/inst.instanton_forces_0.xyz | 48 + .../test-ohne80/inst.instanton_forces_1.xyz | 48 + .../test-ohne80/inst.instanton_forces_2.xyz | 48 + .../test-ohne80/inst.instanton_forces_3.xyz | 48 + .../test-ohne80/inst.instanton_forces_4.xyz | 48 + .../test-ohne80/inst.instanton_forces_5.xyz | 48 + .../test-ohne80/inst.instanton_forces_6.xyz | 48 + .../test-ohne80/inst.instanton_forces_7.xyz | 48 + .../test-ohne80/inst.instanton_forces_8.xyz | 48 + .../py/pes/friction/test-ohne80/inst1D.dat | 16 + drivers/py/pes/friction/test2/clean.sh | 4 + drivers/py/pes/friction/test2/init.xyz | 48 + drivers/py/pes/friction/test2/input.xml | 45 + drivers/py/pes/friction/test2/z_friction.dat | 1003 +++++++++++ drivers/py/pes/harmonic.py | 4 +- drivers/py/pes/spline.py | 10 +- drivers/py/pes/test.dat | 200 +++ ipi/engine/forcefields.py | 16 +- ipi/engine/forces.py | 14 +- ipi/engine/motion/constrained_dynamics.py | 2 +- ipi/engine/motion/dynamics.py | 10 +- ipi/engine/motion/geop.py | 10 +- ipi/engine/motion/instanton.py | 60 +- ipi/engine/motion/phonons.py | 12 +- ipi/engine/motion/planetary.py | 2 +- ipi/engine/motion/scphonons.py | 4 +- ipi/engine/motion/vscf.py | 10 +- ipi/engine/outputs.py | 8 +- ipi/inputs/forcefields.py | 4 +- ipi/inputs/motion/motion.py | 2 +- ipi/inputs/normalmodes.py | 2 +- ipi/inputs/smotion/smotion.py | 2 +- ipi/inputs/thermostats.py | 2 +- ipi/utils/constrtools.py | 4 +- ipi/utils/depend.py | 10 +- ipi/utils/inputvalue.py | 2 +- ipi/utils/instools.py | 6 +- ipi/utils/io/io_units.py | 2 +- ipi/utils/mathtools.py | 2 +- ipi/utils/nmtransform.py | 4 +- ipi/utils/softexit.py | 2 +- ipi_tests/examples/exampletools.py | 2 +- ipi_tests/test_tools.py | 2 +- 945 files changed, 59225 insertions(+), 119 deletions(-) create mode 100644 drivers/py/pes/.doublewell.py.swp create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/MEP.dat create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/RESTART create mode 100755 drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh create mode 100755 drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat create mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat create mode 100644 drivers/py/pes/friction/frictionH/060K/MEP.dat create mode 100644 drivers/py/pes/friction/frictionH/060K/RESTART create mode 100755 drivers/py/pes/friction/frictionH/060K/clean.sh create mode 100755 drivers/py/pes/friction/frictionH/060K/get1D.sh create mode 100644 drivers/py/pes/friction/frictionH/060K/init.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/input.xml create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_00 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_01 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_02 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_03 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_04 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_05 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_06 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_07 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_08 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_09 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_10 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_11 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_12 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_13 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_14 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_15 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_16 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_17 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_18 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_19 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_20 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_21 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_22 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_23 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_24 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_25 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_26 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_27 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_28 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_29 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_30 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_31 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_32 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_33 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_34 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_35 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_36 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_37 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_38 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_39 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_40 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_41 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_42 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_43 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_44 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_45 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_46 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_47 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_48 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_49 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_50 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_51 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_52 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_53 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_54 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_55 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_56 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_57 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_58 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_59 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_60 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_61 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_62 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_63 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_00 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_01 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_02 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_03 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_04 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_05 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_06 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_07 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_08 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_09 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_10 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_11 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_12 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_13 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_14 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_15 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_16 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_17 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_18 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_19 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_20 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_21 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_22 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_23 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_24 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_25 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_26 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_27 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_28 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_29 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_30 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_31 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_32 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_33 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_34 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_35 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_36 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_37 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_38 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_39 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_40 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_41 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_42 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_43 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_44 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_45 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_46 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_47 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_48 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_49 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_50 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_51 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_52 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_53 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_54 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_55 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_56 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_57 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_58 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_59 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_60 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_61 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_62 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_63 create mode 100644 drivers/py/pes/friction/frictionH/060K/inst1D.dat create mode 100644 drivers/py/pes/friction/frictionH/060K/z_friction.dat create mode 100644 drivers/py/pes/friction/frictionH/080K/RESTART create mode 100755 drivers/py/pes/friction/frictionH/080K/clean.sh create mode 100755 drivers/py/pes/friction/frictionH/080K/get1D.sh create mode 100644 drivers/py/pes/friction/frictionH/080K/init.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/input.xml create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_00 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_01 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_02 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_03 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_04 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_05 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_06 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_07 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_08 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_09 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_10 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_11 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_12 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_13 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_14 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_15 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_00 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_01 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_02 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_03 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_04 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_05 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_06 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_07 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_08 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_09 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_10 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_11 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_12 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_13 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_14 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_15 create mode 100644 drivers/py/pes/friction/frictionH/080K/inst1D.dat create mode 100644 drivers/py/pes/friction/frictionH/080K/z_friction.dat create mode 100644 drivers/py/pes/friction/frictionH/100K/MEP.dat create mode 100644 drivers/py/pes/friction/frictionH/100K/RESTART create mode 100755 drivers/py/pes/friction/frictionH/100K/clean.sh create mode 100755 drivers/py/pes/friction/frictionH/100K/get1D.sh create mode 100644 drivers/py/pes/friction/frictionH/100K/init.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/input.xml create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_00 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_01 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_02 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_03 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_04 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_05 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_06 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_07 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_08 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_09 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_10 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_11 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_12 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_13 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_14 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_15 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_00 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_01 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_02 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_03 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_04 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_05 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_06 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_07 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_08 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_09 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_10 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_11 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_12 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_13 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_14 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_15 create mode 100644 drivers/py/pes/friction/frictionH/100K/inst1D.dat create mode 100644 drivers/py/pes/friction/frictionH/100K/z_friction.dat create mode 100644 drivers/py/pes/friction/frictionH/120K/RESTART create mode 100755 drivers/py/pes/friction/frictionH/120K/clean.sh create mode 100755 drivers/py/pes/friction/frictionH/120K/get1D.sh create mode 100644 drivers/py/pes/friction/frictionH/120K/init.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/input.xml create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_00 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_01 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_02 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_03 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_04 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_05 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_06 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_07 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_08 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_09 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_10 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_11 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_12 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_13 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_14 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_15 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_00 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_01 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_02 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_03 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_04 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_05 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_06 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_07 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_08 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_09 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_10 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_11 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_12 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_13 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_14 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_15 create mode 100644 drivers/py/pes/friction/frictionH/120K/inst1D.dat create mode 100644 drivers/py/pes/friction/frictionH/120K/z_friction.dat create mode 100644 drivers/py/pes/friction/onheH/060K/RESTART create mode 100755 drivers/py/pes/friction/onheH/060K/clean.sh create mode 100644 drivers/py/pes/friction/onheH/060K/control.in create mode 100644 drivers/py/pes/friction/onheH/060K/geometry.in create mode 100755 drivers/py/pes/friction/onheH/060K/get1D.sh create mode 100644 drivers/py/pes/friction/onheH/060K/hessian.dat create mode 100644 drivers/py/pes/friction/onheH/060K/init.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/input.xml create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz create mode 100644 drivers/py/pes/friction/onheH/060K/inst1D.dat create mode 100644 drivers/py/pes/friction/onheH/080K/RESTART create mode 100755 drivers/py/pes/friction/onheH/080K/clean.sh create mode 100644 drivers/py/pes/friction/onheH/080K/control.in create mode 100644 drivers/py/pes/friction/onheH/080K/geometry.in create mode 100755 drivers/py/pes/friction/onheH/080K/get1D.sh create mode 100644 drivers/py/pes/friction/onheH/080K/hessian.dat create mode 100644 drivers/py/pes/friction/onheH/080K/init.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/input.xml create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz create mode 100644 drivers/py/pes/friction/onheH/080K/inst1D.dat create mode 100644 drivers/py/pes/friction/onheH/100K/RESTART create mode 100644 drivers/py/pes/friction/onheH/100K/control.in create mode 100644 drivers/py/pes/friction/onheH/100K/geometry.in create mode 100755 drivers/py/pes/friction/onheH/100K/get1D.sh create mode 100644 drivers/py/pes/friction/onheH/100K/hessian.dat create mode 100644 drivers/py/pes/friction/onheH/100K/init.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/input.xml create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/onheH/100K/inst1D.dat create mode 100644 drivers/py/pes/friction/onheH/120K/RESTART create mode 100755 drivers/py/pes/friction/onheH/120K/clean.sh create mode 100644 drivers/py/pes/friction/onheH/120K/control.in create mode 100644 drivers/py/pes/friction/onheH/120K/geometry.in create mode 100755 drivers/py/pes/friction/onheH/120K/get1D.sh create mode 100644 drivers/py/pes/friction/onheH/120K/init.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/input.xml create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz create mode 100644 drivers/py/pes/friction/onheH/120K/inst1D.dat create mode 100644 drivers/py/pes/friction/template.agr create mode 100644 drivers/py/pes/friction/test-ohne80/RESTART create mode 100644 drivers/py/pes/friction/test-ohne80/control.in create mode 100644 drivers/py/pes/friction/test-ohne80/geometry.in create mode 100755 drivers/py/pes/friction/test-ohne80/get1D.sh create mode 100644 drivers/py/pes/friction/test-ohne80/hessian.dat create mode 100644 drivers/py/pes/friction/test-ohne80/init.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/input.xml create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz create mode 100644 drivers/py/pes/friction/test-ohne80/inst1D.dat create mode 100755 drivers/py/pes/friction/test2/clean.sh create mode 100644 drivers/py/pes/friction/test2/init.xyz create mode 100644 drivers/py/pes/friction/test2/input.xml create mode 100644 drivers/py/pes/friction/test2/z_friction.dat create mode 100644 drivers/py/pes/test.dat diff --git a/drivers/drivers/doublewell.py b/drivers/drivers/doublewell.py index 9fd4f2fbb..0b7547016 100644 --- a/drivers/drivers/doublewell.py +++ b/drivers/drivers/doublewell.py @@ -26,7 +26,7 @@ def __init__(self, args=None): super(DoubleWell_driver, self).__init__(args) def check_arguments(self): - """ Function that checks the arguments required to run the driver """ + """Function that checks the arguments required to run the driver""" self.k = 1836 * (3800.0 / 219323.0) ** 2 if self.args == "": # We used Craig's values (J. Chem. Phys. 122, 084106, 2005) @@ -49,7 +49,7 @@ def check_arguments(self): self.B = ((m ** 2) * (w_b) ** 4) / (16 * v0) def __call__(self, cell, pos): - """ DoubleWell potential l""" + """DoubleWell potential l""" pot = 0 pos3 = pos.reshape(-1, 3) force3 = np.zeros(pos.shape) diff --git a/drivers/drivers/spline.py b/drivers/drivers/spline.py index 4a0b24a2d..f5ed5408e 100644 --- a/drivers/drivers/spline.py +++ b/drivers/drivers/spline.py @@ -25,7 +25,7 @@ def __init__(self, args=None): self.k = 1836 * (3800.0 / 219323.0) ** 2 def check_arguments(self): - """ Function that checks the arguments required to run the driver """ + """Function that checks the arguments required to run the driver""" try: data = np.loadtxt(self.args[0]).reshape(-1, 5) @@ -34,7 +34,7 @@ def check_arguments(self): self.data = data def get_spline(self): - """Function that creates the 1D spline and its derivative """ + """Function that creates the 1D spline and its derivative""" self.spline_f = [] for i in range(3): @@ -47,7 +47,7 @@ def get_spline(self): ) def get_spline_fric(self): - """Function that creates the 1D spline for the friction """ + """Function that creates the 1D spline for the friction""" data = np.loadtxt(self.args[1]).reshape(-1, 10) self.spline_fric = [] for i in range(9): @@ -98,11 +98,11 @@ def full2oneD(self, pos): return factor_coord * pos[0, 0] def check_dimensions(self, pos): - """ Functions that checks dimensions of the received position """ + """Functions that checks dimensions of the received position""" assert pos.shape == (1, 3) def __call__(self, cell, pos): - """ Evaluate energy, forces and friction""" + """Evaluate energy, forces and friction""" self.check_dimensions(pos) vir = cell * 0.0 # makes a zero virial with same shape as cell diff --git a/drivers/py/driver.py b/drivers/py/driver.py index 3921181da..6b615628f 100755 --- a/drivers/py/driver.py +++ b/drivers/py/driver.py @@ -15,7 +15,7 @@ def recv_data(sock, data): - """ Fetches binary data from i-PI socket. """ + """Fetches binary data from i-PI socket.""" blen = data.itemsize * data.size buf = np.zeros(blen, np.byte) @@ -39,7 +39,7 @@ def recv_data(sock, data): def send_data(sock, data): - """ Sends binary data to i-PI socket. """ + """Sends binary data to i-PI socket.""" if np.isscalar(data): data = np.array([data], data.dtype) diff --git a/drivers/py/pes/.doublewell.py.swp b/drivers/py/pes/.doublewell.py.swp new file mode 100644 index 0000000000000000000000000000000000000000..e73b77d4c2c14e9ba0aa23477a320011ad46795d GIT binary patch literal 12288 zcmeHN&2Jk;6rWb5d=^kS!r@^bx=!uQ`Xgx?$%mu~q9wGINE1-gx*L03ud-k4>?Sq` z;DjjR!U6t-UJwV=3kA{MLE_E@5CS23284u=_|2?$H)+!#ax0pVe%_sVZ{EE3oA+jI zdDpF#(=XGEX)&~?8N0!+U77vrV|M5YW3Cf>wm-6^Xs;%0H{MI0$==KiPM!*STueH( z(3yN?ZvOOKdfSVfO&*EKa5Nc0+zXO*mv3>`HN#P6Ltixmnt}Z?aD+7*bye!+()0Ap z(F^-Eq~~b{Gy|Fe&46Y=GoTsJ3}^;40}mhrad?2e1-}oDeLpk49=Pi|?&^zXKr^5j z&Gy|Fe&46Y=GoTsJ3}^;40}mhrc8{?;hZr*t!+HGwpZ)&-`6f-SNydHyZUCPG2`~lxeT1>UfZM<=;7i~mKmZYN0J!}GYys~A4)82+=W)iq z0p0;#1x^4Z;4tv#V~qU*+yLGO)`642bHE>uGWH{I6Zj1H09XSq0yDr-;2`kBBaD3k zd=7j9yaqf3{Q59s-vi$PUjrWk9iRz33>*e-fuHNZ+rSEN0g#;40NpeLngPwg|DORG zw}{6{2B@x+T6BE>^m?H6v z?WF8E3(M{{t4uH2kr((*w}`8-Nod)!mNL-Hy(}Vv1kpFZ;T1%toaW}Rr z=(P&fd8wM)97nEV-rIKLnl^_m^_Mt zsN;#Ng+Zyuhg}}Vvur#kzo^C3UP_Ma$o4Kai{#DJyj)ZED?PP|0A@bwq4HeMDQM+ifrfVF+rQQo8Txj&X{y+z&(@B53t!(Z#1f8&9v&)G>$9FnkvF{`bG4T zv{I>vQN_2B1|pNrXwF#j$eg4`{baMzG%b~ujoc|&2rndlH+BM_;(;Agcfh+F0{5K2 zZ{nda1V#My#EIZ`98i=y;!~|7&W((PgCi-qgaxVM@CV2ozzCUofWgwaeOC6 zy{V1OeGEtO0N$m#cwLxk-uB|H1tjTLn6+gKU1|8uKPuUMG3VhpQD>nctxP=)hf9a7!|#x6G|jA1Q(FkF@gI$Gf) z4KKI$v91TJ(l+Ma74yQm3-e2hw7R&oMCZ>fFP>dKJ-1Y>x62)VaE{L=xSk-JgegBe zae&;4dF0!!QR>Td=6-ins!|F1crTrIJ#^}*56L?oHiE~UFv6T5l(m89PQ<&8z-_zU zLc%5?283uYM+vXS1NrSIaC_}zzU?2Yx{lAcoL)R=*DXt$>_>q|PUx6P?6`s)FAQ+_ sDgW5G<0l?c8(&)dFjY5uG9fbE?b(q{!D9hGqEW%wcY + + [ step, potential{electronvolt} ] + extras + extras + + 11 + 30 + + + + + + [ friction ] + + + + 2.53345216e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 4.90385829e-03, 4.90625462e-03, 4.91102409e-03, 4.91812052e-03, 4.92747508e-03, + 4.93899681e-03, 4.95257338e-03, 4.96807192e-03, 4.98534016e-03, 5.00420762e-03, + 5.02448708e-03, 5.04597614e-03, 5.06845903e-03, 5.09170852e-03, 5.11548797e-03, + 5.13955360e-03, 5.16365681e-03, 5.18754660e-03, 5.21097190e-03, 5.23368044e-03, + 5.25542127e-03, 5.27594988e-03, 5.29503094e-03, 5.31244102e-03, 5.32797115e-03, + 5.34142936e-03, 5.35264299e-03, 5.36146086e-03, 5.36775515e-03, 5.37142307e-03, + 5.37238812e-03, 5.37060494e-03, 5.36611363e-03, 5.35902652e-03, 5.34948199e-03, + 5.33764028e-03, 5.32368042e-03, 5.30779711e-03, 5.29019746e-03, 5.27109795e-03, + 5.25072130e-03, 5.22929365e-03, 5.20704181e-03, 5.18419079e-03, 5.16096154e-03, + 5.13756901e-03, 5.11422040e-03, 5.09110619e-03, 5.06837947e-03, 5.04618568e-03, + 5.02467041e-03, 5.00397781e-03, 4.98424917e-03, 4.96562136e-03, 4.94822548e-03, + 4.93218542e-03, 4.91761660e-03, 4.90462479e-03, 4.89330501e-03, 4.88374057e-03, + 4.87600221e-03, 4.87014740e-03, 4.86621973e-03, 4.86424853e-03 ] + + + [ -1.86605187e-03, 3.62281246e-05, 3.60194726e-05, -1.86204436e-03, 3.61488376e-05, + 3.59423494e-05, -1.85402475e-03, 3.59902112e-05, 3.57880221e-05, -1.84198418e-03, + 3.57521448e-05, 3.55563287e-05, -1.82591006e-03, 3.54345062e-05, 3.52470401e-05, + -1.80578693e-03, 3.50371546e-05, 3.48598813e-05, -1.78159758e-03, 3.45599725e-05, + 3.43945572e-05, -1.75332438e-03, 3.40029023e-05, 3.38507842e-05, -1.72095087e-03, + 3.33659849e-05, 3.32283259e-05, -1.68446349e-03, 3.26494000e-05, 3.25270323e-05, + -1.64385345e-03, 3.18535050e-05, 3.17468814e-05, -1.59911884e-03, 3.09788720e-05, + 3.08880220e-05, -1.55026659e-03, 3.00263180e-05, 2.99508153e-05, -1.49731470e-03, + 2.89969292e-05, 2.89358754e-05, -1.44029426e-03, 2.78920753e-05, 2.78441061e-05, + -1.37925151e-03, 2.67134124e-05, 2.66767334e-05, -1.31424973e-03, 2.54628739e-05, + 2.54353306e-05, -1.24537099e-03, 2.41426459e-05, 2.41218371e-05, -1.17271904e-03, + 2.27551288e-05, 2.27385675e-05, -1.09644028e-03, 2.13028851e-05, 2.12882113e-05, + -1.01672523e-03, 1.97886422e-05, 1.97738361e-05, -9.33796096e-04, 1.82153281e-05, + 1.81988871e-05, -8.47906049e-04, 1.65861416e-05, 1.65671910e-05, -7.59338194e-04, + 1.49046177e-05, 1.48829539e-05, -6.68403813e-04, 1.31746812e-05, 1.31507529e-05, + -5.75439973e-04, 1.14006895e-05, 1.13755214e-05, -4.80806502e-04, 9.58747177e-06, + 9.56253032e-06, -3.84882385e-04, 7.74034218e-06, 7.71736085e-06, -2.88061673e-04, + 5.86507734e-06, 5.84586648e-06, -1.90748969e-04, 3.96787623e-06, 3.95412873e-06, + -9.33546152e-05, 2.05529975e-06, 2.04840652e-06, 3.71417025e-06, 1.34185630e-07, + 1.35079651e-07, 1.00113455e-04, -1.78846546e-06, -1.77941339e-06, 1.95553580e-04, + -3.70563164e-06, -3.68864231e-06, 2.89756403e-04, -5.61040099e-06, -5.58625078e-06, + 3.82455758e-04, -7.49607953e-06, -7.46601794e-06, 4.73398965e-04, -9.35627924e-06, + -9.32191491e-06, 5.62348155e-04, -1.11849845e-05, -1.11481550e-05, 6.49081380e-04, + -1.29765974e-05, -1.29392371e-05, 7.33393496e-04, -1.47259672e-05, -1.46899815e-05, + 8.15096815e-04, -1.64284054e-05, -1.63955582e-05, 8.94021512e-04, -1.80796860e-05, + -1.80515076e-05, 9.70015786e-04, -1.96760354e-05, -1.96537533e-05, 1.04294579e-03, + -2.12141105e-05, -2.11986077e-05, 1.11269531e-03, -2.26909720e-05, -2.26827684e-05, + 1.17916529e-03, -2.41040488e-05, -2.41033095e-05, 1.24227306e-03, -2.54510972e-05, + -2.54576683e-05, 1.30194694e-03, -2.67301559e-05, -2.67436274e-05, 1.35811356e-03, + -2.79395059e-05, -2.79592933e-05, 1.41071501e-03, -2.90776593e-05, -2.91030736e-05, + 1.45971263e-03, -3.01433485e-05, -3.01736528e-05, 1.50508497e-03, -3.11355124e-05, + -3.11699657e-05, 1.54682564e-03, -3.20532797e-05, -3.20911696e-05, 1.58494096e-03, + -3.28959500e-05, -3.29366168e-05, 1.61944756e-03, -3.36629739e-05, -3.37058265e-05, + 1.65036997e-03, -3.43539327e-05, -3.43984580e-05, 1.67773822e-03, -3.49685190e-05, + -3.50142851e-05, 1.70158558e-03, -3.55065170e-05, -3.55531714e-05, 1.72194635e-03, + -3.59677834e-05, -3.60150483e-05, 1.73885391e-03, -3.63522303e-05, -3.63998952e-05, + 1.75233895e-03, -3.66598097e-05, -3.67077223e-05, 1.76242789e-03, -3.68904993e-05, + -3.69385551e-05, 1.76914171e-03, -3.70442924e-05, -3.70924232e-05, 1.77249490e-03, + -3.71211887e-05, -3.71693509e-05 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] + + True + + [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, + 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, + 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, + 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, + 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, + 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, + 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, + 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, + 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, + 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, + 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, + 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, + 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, + 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, + 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, + 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, + 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, + 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, + 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, + 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, + 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, + 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, + 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, + 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, + 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, + 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, + 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, + 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, + 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, + 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, + 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, + 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, + 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, + 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, + 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, + 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, + 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, + 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, + 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, + 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, + 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, + 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, + 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, + 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, + 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, + 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, + 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, + 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, + 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, + 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, + 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, + 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, + 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, + 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, + 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, + 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, + 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, + 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, + 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, + 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, + 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, + 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, + 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, + 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, + 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, + 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, + 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, + 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, + 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, + 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, + 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, + 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, + 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, + 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, + 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, + 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, + 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, + 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, + 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, + 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, + 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, + 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, + 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, + 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, + 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, + 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, + 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, + 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, + 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, + 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, + 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, + 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, + 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, + 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, + 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, + 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, + 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, + 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, + 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, + 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, + 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, + 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, + 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, + 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, + 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, + 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, + 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, + 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, + 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, + 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, + 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, + 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, + 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, + 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, + 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, + 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, + 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, + 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, + 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, + 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, + 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, + 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, + 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, + 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, + 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, + 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, + 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, + 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, + 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, + 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, + 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, + 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, + 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, + 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, + 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, + 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, + 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, + 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, + 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, + 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, + 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, + 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, + 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, + 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, + 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, + 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, + 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, + 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, + 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, + 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, + 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, + 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, + 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, + 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, + 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, + 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, + 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, + 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, + 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, + 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, + 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, + 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, + 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, + 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, + 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, + 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, + 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, + 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, + 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, + 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, + 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, + 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, + 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, + 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, + 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, + 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, + 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, + 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, + 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, + 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, + 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, + 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, + 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, + 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, + 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, + 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, + 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, + 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, + 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, + 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, + 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, + 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, + 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, + 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, + 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, + 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, + 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, + 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, + 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, + 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, + 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, + 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, + 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, + 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, + 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, + 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, + 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, + 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, + 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, + 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, + 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, + 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, + 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, + 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, + 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, + 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, + 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, + 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, + 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, + 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, + 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, + 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, + 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, + 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, + 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, + 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, + 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, + 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, + 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, + 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, + 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, + 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, + 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, + 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, + 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, + 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, + 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, + 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, + 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, + 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, + 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, + 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, + 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, + 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, + 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, + 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, + 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, + 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, + 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, + 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, + 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, + 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, + 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, + 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, + 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, + 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, + 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, + 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, + 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, + 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, + 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, + 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, + 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, + 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, + 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, + 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, + 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, + 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, + 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, + 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, + 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, + 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, + 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, + 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, + 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, + 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, + 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, + 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, + 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, + 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, + 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, + 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, + 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, + 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, + 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, + 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, + 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, + 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, + 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, + 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, + 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, + 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, + 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, + 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, + 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, + 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, + 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, + 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, + 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, + 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, + 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, + 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, + 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, + 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, + 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, + 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, + 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, + 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, + 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, + 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, + 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, + 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, + 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, + 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, + 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, + 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, + 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, + 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, + 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, + 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, + 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, + 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, + 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, + 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, + 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, + 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, + 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, + 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, + 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, + 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, + 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, + 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, + 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, + 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, + 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, + 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, + 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, + 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, + 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, + 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, + 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, + 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, + 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, + 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, + 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, + 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, + 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, + 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, + 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, + 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, + 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, + 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, + 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, + 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, + 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, + 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, + 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, + 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, + 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, + 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, + 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, + 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, + 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, + 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, + 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, + 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, + 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, + 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, + 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, + 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, + 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, + 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, + 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, + 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, + 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, + 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, + 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, + 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, + 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, + 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, + 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, + 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, + 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, + 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, + 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, + 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, + 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, + 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, + 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, + 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, + 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, + 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, + 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, + 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, + 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, + 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, + 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, + 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, + 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, + 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] + + 10 + + [ -9.06185538e-03, 2.66454093e-05, 3.09875724e-05, -9.07205353e-03, 2.64830393e-05, + 3.08218407e-05, -9.09236222e-03, 2.61616867e-05, 3.04924098e-05, -9.12260692e-03, + 2.56880480e-05, 3.00033276e-05, -9.16252758e-03, 2.50719726e-05, 2.93606226e-05, + -9.21178072e-03, 2.43262301e-05, 2.85722484e-05, -9.26994220e-03, 2.34662022e-05, + 2.76480059e-05, -9.33651075e-03, 2.25095026e-05, 2.65994400e-05, -9.41091206e-03, + 2.14755282e-05, 2.54397065e-05, -9.49250372e-03, 2.03849470e-05, 2.41834068e-05, + -9.58058069e-03, 1.92591300e-05, 2.28463884e-05, -9.67438149e-03, 1.81195366e-05, + 2.14455084e-05, -9.77309502e-03, 1.69870632e-05, 1.99983623e-05, -9.87586792e-03, + 1.58813705e-05, 1.85229780e-05, -9.98181250e-03, 1.48202042e-05, 1.70374800e-05, + -1.00900152e-02, 1.38187256e-05, 1.55597298e-05, -1.01995452e-02, 1.28888722e-05, + 1.41069502e-05, -1.03094640e-02, 1.20387663e-05, 1.26953430e-05, -1.04178973e-02, + 1.12422854e-05, 1.13338055e-05, -1.05199860e-02, 1.03863608e-05, 1.00123680e-05, + -1.06138305e-02, 9.46773782e-06, 8.74062853e-06, -1.06979801e-02, 8.49951861e-06, + 7.53032784e-06, -1.07710604e-02, 7.49804740e-06, 6.39279450e-06, -1.08317902e-02, + 6.48286888e-06, 5.33893146e-06, -1.08789974e-02, 5.47659609e-06, 4.37920048e-06, + -1.09116336e-02, 4.50467851e-06, 3.52359627e-06, -1.09287873e-02, 3.59506240e-06, + 2.78160195e-06, -1.09296960e-02, 2.77773763e-06, 2.16211815e-06, -1.09137564e-02, + 2.08416931e-06, 1.67335901e-06, -1.08805317e-02, 1.54661755e-06, 1.32271117e-06, + -1.08297588e-02, 1.19735520e-06, 1.11655532e-06, -1.07635385e-02, 1.06800647e-06, + 1.06008055e-06, -1.06909953e-02, 1.16990685e-06, 1.15459987e-06, -1.06133728e-02, + 1.48629510e-06, 1.39623149e-06, -1.05309349e-02, 1.99650449e-06, 1.77893677e-06, + -1.04439954e-02, 2.67789048e-06, 2.29487874e-06, -1.03529154e-02, 3.50642907e-06, + 2.93464749e-06, -1.02581000e-02, 4.45732197e-06, 3.68751293e-06, -1.01599950e-02, + 5.50558792e-06, 4.54169338e-06, -1.00590830e-02, 6.62662136e-06, 5.48462865e-06, + -9.95587859e-03, 7.79670230e-06, 6.50324721e-06, -9.85092462e-03, 8.99344451e-06, + 7.58421879e-06, -9.74478692e-03, 1.01961725e-05, 8.71418507e-06, -9.63804973e-03, + 1.13862219e-05, 9.87996380e-06, -9.53131072e-03, 1.25471601e-05, 1.10687231e-05, + -9.42517610e-03, 1.36649294e-05, 1.22681248e-05, -9.32024888e-03, 1.47279909e-05, + 1.34664427e-05, -9.21501335e-03, 1.57526606e-05, 1.46542469e-05, -9.10826221e-03, + 1.67584712e-05, 1.58228548e-05, -9.00119532e-03, 1.77390165e-05, 1.69625538e-05, + -8.89500729e-03, 1.86878584e-05, 1.80643010e-05, -8.79086547e-03, 1.95987114e-05, + 1.91197564e-05, -8.68989932e-03, 2.04654986e-05, 2.01212943e-05, -8.59319040e-03, + 2.12824044e-05, 2.10620029e-05, -8.50176308e-03, 2.20439227e-05, 2.19356737e-05, + -8.41657593e-03, 2.27449018e-05, 2.27367839e-05, -8.33851390e-03, 2.33805854e-05, + 2.34604732e-05, -8.26838124e-03, 2.39466496e-05, 2.41025171e-05, -8.20689523e-03, + 2.44392364e-05, 2.46592987e-05, -8.15468078e-03, 2.48549831e-05, 2.51277805e-05, + -8.11226570e-03, 2.51910482e-05, 2.55054776e-05, -8.08007685e-03, 2.54451319e-05, + 2.57904337e-05, -8.05843708e-03, 2.56154944e-05, 2.59812005e-05, -8.04756287e-03, + 2.57009686e-05, 2.60768215e-05, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, + 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, + 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.32348898e-20, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.11758237e-19, + 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, + 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, + 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, + 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, -6.77626358e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, + 5.51152161e-01 ] + + + [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] + + True + + + + + [ 2.37277310e+00, -6.57316204e-05, -6.53530460e-05, 2.37321115e+00, -6.55877636e-05, + -6.52131152e-05, 2.37408634e+00, -6.52999548e-05, -6.49331068e-05, 2.37539682e+00, + -6.48680117e-05, -6.45127266e-05, 2.37713984e+00, -6.42916942e-05, -6.39515592e-05, + 2.37931171e+00, -6.35707470e-05, -6.32491056e-05, 2.38190782e+00, -6.27049569e-05, + -6.24048306e-05, 2.38492261e+00, -6.16942193e-05, -6.14182192e-05, 2.38834957e+00, + -6.05386085e-05, -6.02888426e-05, 2.39218126e+00, -5.92384504e-05, -5.90164288e-05, + 2.39640924e+00, -5.77943938e-05, -5.76009379e-05, 2.40102415e+00, -5.62074763e-05, + -5.60426398e-05, 2.40601562e+00, -5.44791804e-05, -5.43421898e-05, 2.41137234e+00, + -5.26114770e-05, -5.25007021e-05, 2.41708200e+00, -5.06068510e-05, -5.05198167e-05, + 2.42313133e+00, -4.84683075e-05, -4.84017577e-05, 2.42950611e+00, -4.61993541e-05, + -4.61493801e-05, 2.43619116e+00, -4.38039576e-05, -4.37662025e-05, 2.44317037e+00, + -4.12864729e-05, -4.12564244e-05, 2.45042670e+00, -3.86515496e-05, -3.86249257e-05, + 2.45794224e+00, -3.59041361e-05, -3.58772721e-05, 2.46569826e+00, -3.30495449e-05, + -3.30197146e-05, 2.47367522e+00, -3.00935800e-05, -3.00591963e-05, 2.48185286e+00, + -2.70426550e-05, -2.70033486e-05, 2.49021027e+00, -2.39038911e-05, -2.38604759e-05, + 2.49872594e+00, -2.06851943e-05, -2.06395297e-05, 2.50737788e+00, -1.73953265e-05, + -1.73500732e-05, 2.51614366e+00, -1.40439297e-05, -1.40022328e-05, 2.52500055e+00, + -1.06414848e-05, -1.06066290e-05, 2.53392557e+00, -7.19923918e-06, -7.17429598e-06, + 2.54289563e+00, -3.72909677e-06, -3.71658984e-06, 2.55188761e+00, -2.43463856e-07, + -2.45085950e-07, 2.56087847e+00, 3.24495771e-06, 3.22853381e-06, 2.56984532e+00, + 6.72342758e-06, 6.69260246e-06, 2.57876549e+00, 1.01794049e-05, 1.01355872e-05, + 2.58761664e+00, 1.36007442e-05, 1.35462010e-05, 2.59637677e+00, 1.69758551e-05, + 1.69135051e-05, 2.60502429e+00, 2.02938232e-05, 2.02270005e-05, 2.61353812e+00, + 2.35444916e-05, 2.34767058e-05, 2.62189771e+00, 2.67185149e-05, 2.66532231e-05, + 2.63008306e+00, 2.98073863e-05, 2.97477890e-05, 2.63807486e+00, 3.28034385e-05, + 3.27523121e-05, 2.64585440e+00, 3.56998244e-05, 3.56593962e-05, 2.65340374e+00, + 3.84904787e-05, 3.84623507e-05, 2.66070563e+00, 4.11700681e-05, 4.11551836e-05, + 2.66774361e+00, 4.37339277e-05, 4.37325863e-05, 2.67450200e+00, 4.61779868e-05, + 4.61899092e-05, 2.68096592e+00, 4.84986865e-05, 4.85231290e-05, 2.68712132e+00, + 5.06929082e-05, 5.07288100e-05, 2.69295499e+00, 5.27579521e-05, 5.28040632e-05, + 2.69845456e+00, 5.46915183e-05, 5.47465018e-05, 2.70360853e+00, 5.64916817e-05, + 5.65541930e-05, 2.70840625e+00, 5.81568612e-05, 5.82256079e-05, 2.71283795e+00, + 5.96857861e-05, 5.97595711e-05, 2.71689470e+00, 6.10774597e-05, 6.11552106e-05, + 2.72056845e+00, 6.23311222e-05, 6.24119081e-05, 2.72385195e+00, 6.34462159e-05, + 6.35292531e-05, 2.72673884e+00, 6.44223492e-05, 6.45069981e-05, 2.72922354e+00, + 6.52592621e-05, 6.53450187e-05, 2.73130132e+00, 6.59567954e-05, 6.60432777e-05, + 2.73296825e+00, 6.65148615e-05, 6.66017932e-05, 2.73422117e+00, 6.69334204e-05, + 6.70206119e-05, 2.73505776e+00, 6.72124597e-05, 6.72997873e-05, 2.73547644e+00, + 6.73519789e-05, 6.74393635e-05 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] +

+ [ 3.67147973e+03 ] + [ D ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+ diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh b/drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh b/drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh new file mode 100755 index 000000000..a76591d7b --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh @@ -0,0 +1,6 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep D inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 +xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz new file mode 100644 index 000000000..730791a08 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1441466 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1448613 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1460477 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1477077 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1498430 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1524556 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1555471 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1591193 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1631742 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1677134 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1727363 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1782411 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1842257 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1906879 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.1976222 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2050185 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2128665 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2211559 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2298731 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2389979 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2485087 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2583844 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2686011 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2791254 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.2899215 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3009534 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3121847 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3235746 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3350802 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3466586 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3582672 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3698644 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3814100 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.3928638 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4041854 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4153390 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4262942 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4370210 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4474895 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4576725 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4675494 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4771003 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4863054 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.4951464 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5036114 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5116899 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5193718 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5266471 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5335107 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5399597 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5459909 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5516014 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5567903 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5615583 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5659063 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5698349 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5733452 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5764386 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5791165 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5813803 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5832315 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5846716 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5857018 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +D 1.5863237 0.0000000 0.0000000 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml b/drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml new file mode 100644 index 000000000..c386426bd --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml @@ -0,0 +1,45 @@ + + + [ step, potential{electronvolt}] + extras + extras + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + ['friction'] + + + + 80 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 10 + powell + true + + z_friction.dat + true + true + none + 0.1 + + + +
diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 new file mode 100644 index 000000000..58a3da761 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 0 + 0.00013194 -0.00003135 -0.00003130 + -0.00003135 0.00013218 -0.00003131 + -0.00003130 -0.00003131 0.00013173 + #*EXTRAS*# Step: 1 Bead: 0 + 0.00012935 -0.00003618 -0.00003590 + -0.00003618 0.00012952 -0.00003622 + -0.00003590 -0.00003622 0.00012901 + #*EXTRAS*# Step: 2 Bead: 0 + 0.00012681 -0.00003950 -0.00003898 + -0.00003950 0.00012690 -0.00003958 + -0.00003898 -0.00003958 0.00012646 + #*EXTRAS*# Step: 3 Bead: 0 + 0.00012527 -0.00004109 -0.00004054 + -0.00004109 0.00012534 -0.00004119 + -0.00004054 -0.00004119 0.00012497 + #*EXTRAS*# Step: 4 Bead: 0 + 0.00012453 -0.00004176 -0.00004126 + -0.00004176 0.00012459 -0.00004186 + -0.00004126 -0.00004186 0.00012426 + #*EXTRAS*# Step: 5 Bead: 0 + 0.00012411 -0.00004211 -0.00004167 + -0.00004211 0.00012417 -0.00004221 + -0.00004167 -0.00004221 0.00012386 + #*EXTRAS*# Step: 6 Bead: 0 + 0.00012386 -0.00004230 -0.00004190 + -0.00004230 0.00012392 -0.00004240 + -0.00004190 -0.00004240 0.00012363 + #*EXTRAS*# Step: 7 Bead: 0 + 0.00012370 -0.00004241 -0.00004204 + -0.00004241 0.00012377 -0.00004251 + -0.00004204 -0.00004251 0.00012348 + #*EXTRAS*# Step: 8 Bead: 0 + 0.00012360 -0.00004248 -0.00004212 + -0.00004248 0.00012367 -0.00004258 + -0.00004212 -0.00004258 0.00012339 + #*EXTRAS*# Step: 9 Bead: 0 + 0.00012354 -0.00004253 -0.00004218 + -0.00004253 0.00012361 -0.00004262 + -0.00004218 -0.00004262 0.00012333 + #*EXTRAS*# Step: 10 Bead: 0 + 0.00012350 -0.00004256 -0.00004222 + -0.00004256 0.00012357 -0.00004265 + -0.00004222 -0.00004265 0.00012329 + #*EXTRAS*# Step: 11 Bead: 0 + 0.00012347 -0.00004258 -0.00004224 + -0.00004258 0.00012354 -0.00004267 + -0.00004224 -0.00004267 0.00012326 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 new file mode 100644 index 000000000..c2d1696ff --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 1 + 0.00013190 -0.00003145 -0.00003140 + -0.00003145 0.00013214 -0.00003142 + -0.00003140 -0.00003142 0.00013168 + #*EXTRAS*# Step: 1 Bead: 1 + 0.00012930 -0.00003624 -0.00003596 + -0.00003624 0.00012948 -0.00003628 + -0.00003596 -0.00003628 0.00012896 + #*EXTRAS*# Step: 2 Bead: 1 + 0.00012678 -0.00003953 -0.00003901 + -0.00003953 0.00012687 -0.00003961 + -0.00003901 -0.00003961 0.00012643 + #*EXTRAS*# Step: 3 Bead: 1 + 0.00012525 -0.00004111 -0.00004056 + -0.00004111 0.00012531 -0.00004121 + -0.00004056 -0.00004121 0.00012495 + #*EXTRAS*# Step: 4 Bead: 1 + 0.00012451 -0.00004178 -0.00004128 + -0.00004178 0.00012457 -0.00004188 + -0.00004128 -0.00004188 0.00012425 + #*EXTRAS*# Step: 5 Bead: 1 + 0.00012409 -0.00004212 -0.00004168 + -0.00004212 0.00012415 -0.00004222 + -0.00004168 -0.00004222 0.00012385 + #*EXTRAS*# Step: 6 Bead: 1 + 0.00012384 -0.00004231 -0.00004191 + -0.00004231 0.00012391 -0.00004241 + -0.00004191 -0.00004241 0.00012361 + #*EXTRAS*# Step: 7 Bead: 1 + 0.00012369 -0.00004242 -0.00004205 + -0.00004242 0.00012375 -0.00004252 + -0.00004205 -0.00004252 0.00012347 + #*EXTRAS*# Step: 8 Bead: 1 + 0.00012359 -0.00004250 -0.00004214 + -0.00004250 0.00012365 -0.00004259 + -0.00004214 -0.00004259 0.00012337 + #*EXTRAS*# Step: 9 Bead: 1 + 0.00012352 -0.00004254 -0.00004219 + -0.00004254 0.00012359 -0.00004263 + -0.00004219 -0.00004263 0.00012331 + #*EXTRAS*# Step: 10 Bead: 1 + 0.00012348 -0.00004257 -0.00004223 + -0.00004257 0.00012355 -0.00004266 + -0.00004223 -0.00004266 0.00012328 + #*EXTRAS*# Step: 11 Bead: 1 + 0.00012345 -0.00004259 -0.00004225 + -0.00004259 0.00012352 -0.00004268 + -0.00004225 -0.00004268 0.00012325 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 new file mode 100644 index 000000000..51ecc8a36 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 2 + 0.00013182 -0.00003163 -0.00003158 + -0.00003163 0.00013207 -0.00003160 + -0.00003158 -0.00003160 0.00013160 + #*EXTRAS*# Step: 1 Bead: 2 + 0.00012923 -0.00003635 -0.00003606 + -0.00003635 0.00012940 -0.00003639 + -0.00003606 -0.00003639 0.00012889 + #*EXTRAS*# Step: 2 Bead: 2 + 0.00012672 -0.00003959 -0.00003907 + -0.00003959 0.00012681 -0.00003967 + -0.00003907 -0.00003967 0.00012638 + #*EXTRAS*# Step: 3 Bead: 2 + 0.00012521 -0.00004115 -0.00004061 + -0.00004115 0.00012527 -0.00004125 + -0.00004061 -0.00004125 0.00012491 + #*EXTRAS*# Step: 4 Bead: 2 + 0.00012447 -0.00004181 -0.00004132 + -0.00004181 0.00012454 -0.00004191 + -0.00004132 -0.00004191 0.00012421 + #*EXTRAS*# Step: 5 Bead: 2 + 0.00012406 -0.00004215 -0.00004171 + -0.00004215 0.00012412 -0.00004225 + -0.00004171 -0.00004225 0.00012381 + #*EXTRAS*# Step: 6 Bead: 2 + 0.00012381 -0.00004234 -0.00004194 + -0.00004234 0.00012387 -0.00004243 + -0.00004194 -0.00004243 0.00012358 + #*EXTRAS*# Step: 7 Bead: 2 + 0.00012365 -0.00004245 -0.00004208 + -0.00004245 0.00012372 -0.00004254 + -0.00004208 -0.00004254 0.00012344 + #*EXTRAS*# Step: 8 Bead: 2 + 0.00012356 -0.00004252 -0.00004216 + -0.00004252 0.00012362 -0.00004261 + -0.00004216 -0.00004261 0.00012335 + #*EXTRAS*# Step: 9 Bead: 2 + 0.00012349 -0.00004256 -0.00004222 + -0.00004256 0.00012356 -0.00004265 + -0.00004222 -0.00004265 0.00012329 + #*EXTRAS*# Step: 10 Bead: 2 + 0.00012345 -0.00004259 -0.00004226 + -0.00004259 0.00012352 -0.00004268 + -0.00004226 -0.00004268 0.00012325 + #*EXTRAS*# Step: 11 Bead: 2 + 0.00012342 -0.00004261 -0.00004228 + -0.00004261 0.00012349 -0.00004270 + -0.00004228 -0.00004270 0.00012322 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 new file mode 100644 index 000000000..842276674 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 3 + 0.00013172 -0.00003187 -0.00003181 + -0.00003187 0.00013196 -0.00003184 + -0.00003181 -0.00003184 0.00013149 + #*EXTRAS*# Step: 1 Bead: 3 + 0.00012912 -0.00003651 -0.00003621 + -0.00003651 0.00012929 -0.00003655 + -0.00003621 -0.00003655 0.00012878 + #*EXTRAS*# Step: 2 Bead: 3 + 0.00012664 -0.00003969 -0.00003915 + -0.00003969 0.00012672 -0.00003977 + -0.00003915 -0.00003977 0.00012630 + #*EXTRAS*# Step: 3 Bead: 3 + 0.00012514 -0.00004122 -0.00004067 + -0.00004122 0.00012520 -0.00004132 + -0.00004067 -0.00004132 0.00012484 + #*EXTRAS*# Step: 4 Bead: 3 + 0.00012442 -0.00004186 -0.00004137 + -0.00004186 0.00012448 -0.00004196 + -0.00004137 -0.00004196 0.00012416 + #*EXTRAS*# Step: 5 Bead: 3 + 0.00012400 -0.00004219 -0.00004176 + -0.00004219 0.00012407 -0.00004229 + -0.00004176 -0.00004229 0.00012376 + #*EXTRAS*# Step: 6 Bead: 3 + 0.00012376 -0.00004237 -0.00004198 + -0.00004237 0.00012382 -0.00004247 + -0.00004198 -0.00004247 0.00012354 + #*EXTRAS*# Step: 7 Bead: 3 + 0.00012361 -0.00004248 -0.00004212 + -0.00004248 0.00012367 -0.00004258 + -0.00004212 -0.00004258 0.00012339 + #*EXTRAS*# Step: 8 Bead: 3 + 0.00012351 -0.00004255 -0.00004221 + -0.00004255 0.00012358 -0.00004264 + -0.00004221 -0.00004264 0.00012330 + #*EXTRAS*# Step: 9 Bead: 3 + 0.00012345 -0.00004259 -0.00004226 + -0.00004259 0.00012352 -0.00004269 + -0.00004226 -0.00004269 0.00012324 + #*EXTRAS*# Step: 10 Bead: 3 + 0.00012341 -0.00004262 -0.00004229 + -0.00004262 0.00012347 -0.00004271 + -0.00004229 -0.00004271 0.00012320 + #*EXTRAS*# Step: 11 Bead: 3 + 0.00012338 -0.00004264 -0.00004232 + -0.00004264 0.00012345 -0.00004273 + -0.00004232 -0.00004273 0.00012318 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 new file mode 100644 index 000000000..95d0021dd --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 4 + 0.00013158 -0.00003218 -0.00003211 + -0.00003218 0.00013182 -0.00003215 + -0.00003211 -0.00003215 0.00013134 + #*EXTRAS*# Step: 1 Bead: 4 + 0.00012898 -0.00003672 -0.00003640 + -0.00003672 0.00012914 -0.00003676 + -0.00003640 -0.00003676 0.00012864 + #*EXTRAS*# Step: 2 Bead: 4 + 0.00012653 -0.00003981 -0.00003927 + -0.00003981 0.00012661 -0.00003989 + -0.00003927 -0.00003989 0.00012619 + #*EXTRAS*# Step: 3 Bead: 4 + 0.00012505 -0.00004130 -0.00004076 + -0.00004130 0.00012511 -0.00004140 + -0.00004076 -0.00004140 0.00012476 + #*EXTRAS*# Step: 4 Bead: 4 + 0.00012434 -0.00004192 -0.00004144 + -0.00004192 0.00012441 -0.00004202 + -0.00004144 -0.00004202 0.00012409 + #*EXTRAS*# Step: 5 Bead: 4 + 0.00012394 -0.00004224 -0.00004182 + -0.00004224 0.00012400 -0.00004234 + -0.00004182 -0.00004234 0.00012370 + #*EXTRAS*# Step: 6 Bead: 4 + 0.00012369 -0.00004242 -0.00004204 + -0.00004242 0.00012376 -0.00004252 + -0.00004204 -0.00004252 0.00012347 + #*EXTRAS*# Step: 7 Bead: 4 + 0.00012354 -0.00004253 -0.00004218 + -0.00004253 0.00012361 -0.00004262 + -0.00004218 -0.00004262 0.00012333 + #*EXTRAS*# Step: 8 Bead: 4 + 0.00012345 -0.00004259 -0.00004226 + -0.00004259 0.00012352 -0.00004268 + -0.00004226 -0.00004268 0.00012324 + #*EXTRAS*# Step: 9 Bead: 4 + 0.00012339 -0.00004263 -0.00004231 + -0.00004263 0.00012345 -0.00004273 + -0.00004231 -0.00004273 0.00012319 + #*EXTRAS*# Step: 10 Bead: 4 + 0.00012335 -0.00004266 -0.00004235 + -0.00004266 0.00012341 -0.00004275 + -0.00004235 -0.00004275 0.00012315 + #*EXTRAS*# Step: 11 Bead: 4 + 0.00012332 -0.00004268 -0.00004237 + -0.00004268 0.00012339 -0.00004277 + -0.00004237 -0.00004277 0.00012312 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 new file mode 100644 index 000000000..3ffbedbe0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 5 + 0.00013141 -0.00003255 -0.00003248 + -0.00003255 0.00013164 -0.00003253 + -0.00003248 -0.00003253 0.00013115 + #*EXTRAS*# Step: 1 Bead: 5 + 0.00012881 -0.00003697 -0.00003663 + -0.00003697 0.00012896 -0.00003701 + -0.00003663 -0.00003701 0.00012846 + #*EXTRAS*# Step: 2 Bead: 5 + 0.00012639 -0.00003996 -0.00003942 + -0.00003996 0.00012647 -0.00004004 + -0.00003942 -0.00004004 0.00012605 + #*EXTRAS*# Step: 3 Bead: 5 + 0.00012495 -0.00004140 -0.00004086 + -0.00004140 0.00012501 -0.00004150 + -0.00004086 -0.00004150 0.00012466 + #*EXTRAS*# Step: 4 Bead: 5 + 0.00012425 -0.00004199 -0.00004153 + -0.00004199 0.00012431 -0.00004209 + -0.00004153 -0.00004209 0.00012400 + #*EXTRAS*# Step: 5 Bead: 5 + 0.00012385 -0.00004230 -0.00004190 + -0.00004230 0.00012392 -0.00004240 + -0.00004190 -0.00004240 0.00012362 + #*EXTRAS*# Step: 6 Bead: 5 + 0.00012361 -0.00004248 -0.00004211 + -0.00004248 0.00012368 -0.00004257 + -0.00004211 -0.00004257 0.00012340 + #*EXTRAS*# Step: 7 Bead: 5 + 0.00012347 -0.00004258 -0.00004224 + -0.00004258 0.00012353 -0.00004267 + -0.00004224 -0.00004267 0.00012326 + #*EXTRAS*# Step: 8 Bead: 5 + 0.00012337 -0.00004264 -0.00004232 + -0.00004264 0.00012344 -0.00004273 + -0.00004232 -0.00004273 0.00012317 + #*EXTRAS*# Step: 9 Bead: 5 + 0.00012331 -0.00004268 -0.00004238 + -0.00004268 0.00012338 -0.00004277 + -0.00004238 -0.00004277 0.00012312 + #*EXTRAS*# Step: 10 Bead: 5 + 0.00012327 -0.00004271 -0.00004241 + -0.00004271 0.00012334 -0.00004280 + -0.00004241 -0.00004280 0.00012308 + #*EXTRAS*# Step: 11 Bead: 5 + 0.00012324 -0.00004273 -0.00004243 + -0.00004273 0.00012331 -0.00004282 + -0.00004243 -0.00004282 0.00012305 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 new file mode 100644 index 000000000..c65256e90 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 6 + 0.00013120 -0.00003298 -0.00003290 + -0.00003298 0.00013143 -0.00003297 + -0.00003290 -0.00003297 0.00013093 + #*EXTRAS*# Step: 1 Bead: 6 + 0.00012860 -0.00003726 -0.00003690 + -0.00003726 0.00012875 -0.00003731 + -0.00003690 -0.00003731 0.00012825 + #*EXTRAS*# Step: 2 Bead: 6 + 0.00012623 -0.00004013 -0.00003958 + -0.00004013 0.00012630 -0.00004022 + -0.00003958 -0.00004022 0.00012590 + #*EXTRAS*# Step: 3 Bead: 6 + 0.00012482 -0.00004151 -0.00004099 + -0.00004151 0.00012488 -0.00004161 + -0.00004099 -0.00004161 0.00012454 + #*EXTRAS*# Step: 4 Bead: 6 + 0.00012414 -0.00004208 -0.00004163 + -0.00004208 0.00012420 -0.00004218 + -0.00004163 -0.00004218 0.00012390 + #*EXTRAS*# Step: 5 Bead: 6 + 0.00012375 -0.00004238 -0.00004199 + -0.00004238 0.00012382 -0.00004248 + -0.00004199 -0.00004248 0.00012353 + #*EXTRAS*# Step: 6 Bead: 6 + 0.00012352 -0.00004254 -0.00004220 + -0.00004254 0.00012359 -0.00004264 + -0.00004220 -0.00004264 0.00012331 + #*EXTRAS*# Step: 7 Bead: 6 + 0.00012337 -0.00004264 -0.00004232 + -0.00004264 0.00012344 -0.00004273 + -0.00004232 -0.00004273 0.00012317 + #*EXTRAS*# Step: 8 Bead: 6 + 0.00012328 -0.00004270 -0.00004240 + -0.00004270 0.00012335 -0.00004279 + -0.00004240 -0.00004279 0.00012309 + #*EXTRAS*# Step: 9 Bead: 6 + 0.00012322 -0.00004274 -0.00004245 + -0.00004274 0.00012329 -0.00004283 + -0.00004245 -0.00004283 0.00012303 + #*EXTRAS*# Step: 10 Bead: 6 + 0.00012318 -0.00004277 -0.00004248 + -0.00004277 0.00012325 -0.00004286 + -0.00004248 -0.00004286 0.00012299 + #*EXTRAS*# Step: 11 Bead: 6 + 0.00012316 -0.00004278 -0.00004250 + -0.00004278 0.00012322 -0.00004287 + -0.00004250 -0.00004287 0.00012297 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 new file mode 100644 index 000000000..c20f150b1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 7 + 0.00013094 -0.00003348 -0.00003337 + -0.00003348 0.00013117 -0.00003348 + -0.00003337 -0.00003348 0.00013066 + #*EXTRAS*# Step: 1 Bead: 7 + 0.00012836 -0.00003759 -0.00003720 + -0.00003759 0.00012849 -0.00003764 + -0.00003720 -0.00003764 0.00012800 + #*EXTRAS*# Step: 2 Bead: 7 + 0.00012604 -0.00004033 -0.00003978 + -0.00004033 0.00012611 -0.00004042 + -0.00003978 -0.00004042 0.00012571 + #*EXTRAS*# Step: 3 Bead: 7 + 0.00012467 -0.00004164 -0.00004113 + -0.00004164 0.00012473 -0.00004174 + -0.00004113 -0.00004174 0.00012440 + #*EXTRAS*# Step: 4 Bead: 7 + 0.00012402 -0.00004218 -0.00004175 + -0.00004218 0.00012408 -0.00004228 + -0.00004175 -0.00004228 0.00012378 + #*EXTRAS*# Step: 5 Bead: 7 + 0.00012363 -0.00004246 -0.00004210 + -0.00004246 0.00012370 -0.00004256 + -0.00004210 -0.00004256 0.00012342 + #*EXTRAS*# Step: 6 Bead: 7 + 0.00012341 -0.00004262 -0.00004229 + -0.00004262 0.00012348 -0.00004271 + -0.00004229 -0.00004271 0.00012321 + #*EXTRAS*# Step: 7 Bead: 7 + 0.00012327 -0.00004271 -0.00004241 + -0.00004271 0.00012333 -0.00004280 + -0.00004241 -0.00004280 0.00012307 + #*EXTRAS*# Step: 8 Bead: 7 + 0.00012317 -0.00004277 -0.00004249 + -0.00004277 0.00012324 -0.00004286 + -0.00004249 -0.00004286 0.00012299 + #*EXTRAS*# Step: 9 Bead: 7 + 0.00012312 -0.00004281 -0.00004254 + -0.00004281 0.00012319 -0.00004289 + -0.00004254 -0.00004289 0.00012293 + #*EXTRAS*# Step: 10 Bead: 7 + 0.00012308 -0.00004283 -0.00004257 + -0.00004283 0.00012315 -0.00004292 + -0.00004257 -0.00004292 0.00012290 + #*EXTRAS*# Step: 11 Bead: 7 + 0.00012305 -0.00004285 -0.00004259 + -0.00004285 0.00012312 -0.00004293 + -0.00004259 -0.00004293 0.00012287 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 new file mode 100644 index 000000000..d507f6da1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 8 + 0.00013065 -0.00003403 -0.00003390 + -0.00003403 0.00013086 -0.00003404 + -0.00003390 -0.00003404 0.00013035 + #*EXTRAS*# Step: 1 Bead: 8 + 0.00012808 -0.00003795 -0.00003754 + -0.00003795 0.00012821 -0.00003801 + -0.00003754 -0.00003801 0.00012773 + #*EXTRAS*# Step: 2 Bead: 8 + 0.00012583 -0.00004055 -0.00003999 + -0.00004055 0.00012590 -0.00004064 + -0.00003999 -0.00004064 0.00012551 + #*EXTRAS*# Step: 3 Bead: 8 + 0.00012451 -0.00004178 -0.00004129 + -0.00004178 0.00012457 -0.00004188 + -0.00004129 -0.00004188 0.00012424 + #*EXTRAS*# Step: 4 Bead: 8 + 0.00012387 -0.00004229 -0.00004188 + -0.00004229 0.00012394 -0.00004239 + -0.00004188 -0.00004239 0.00012364 + #*EXTRAS*# Step: 5 Bead: 8 + 0.00012350 -0.00004255 -0.00004221 + -0.00004255 0.00012357 -0.00004265 + -0.00004221 -0.00004265 0.00012330 + #*EXTRAS*# Step: 6 Bead: 8 + 0.00012328 -0.00004270 -0.00004240 + -0.00004270 0.00012335 -0.00004279 + -0.00004240 -0.00004279 0.00012309 + #*EXTRAS*# Step: 7 Bead: 8 + 0.00012314 -0.00004279 -0.00004251 + -0.00004279 0.00012321 -0.00004288 + -0.00004251 -0.00004288 0.00012296 + #*EXTRAS*# Step: 8 Bead: 8 + 0.00012306 -0.00004285 -0.00004259 + -0.00004285 0.00012312 -0.00004293 + -0.00004259 -0.00004293 0.00012288 + #*EXTRAS*# Step: 9 Bead: 8 + 0.00012300 -0.00004288 -0.00004263 + -0.00004288 0.00012307 -0.00004296 + -0.00004263 -0.00004296 0.00012282 + #*EXTRAS*# Step: 10 Bead: 8 + 0.00012296 -0.00004291 -0.00004266 + -0.00004291 0.00012303 -0.00004299 + -0.00004266 -0.00004299 0.00012279 + #*EXTRAS*# Step: 11 Bead: 8 + 0.00012294 -0.00004292 -0.00004268 + -0.00004292 0.00012300 -0.00004300 + -0.00004268 -0.00004300 0.00012276 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 new file mode 100644 index 000000000..407ff2c4e --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 9 + 0.00013031 -0.00003464 -0.00003447 + -0.00003464 0.00013051 -0.00003465 + -0.00003447 -0.00003465 0.00012999 + #*EXTRAS*# Step: 1 Bead: 9 + 0.00012777 -0.00003835 -0.00003790 + -0.00003835 0.00012789 -0.00003841 + -0.00003790 -0.00003841 0.00012742 + #*EXTRAS*# Step: 2 Bead: 9 + 0.00012560 -0.00004078 -0.00004022 + -0.00004078 0.00012566 -0.00004088 + -0.00004022 -0.00004088 0.00012528 + #*EXTRAS*# Step: 3 Bead: 9 + 0.00012433 -0.00004193 -0.00004146 + -0.00004193 0.00012439 -0.00004203 + -0.00004146 -0.00004203 0.00012407 + #*EXTRAS*# Step: 4 Bead: 9 + 0.00012372 -0.00004240 -0.00004202 + -0.00004240 0.00012378 -0.00004250 + -0.00004202 -0.00004250 0.00012350 + #*EXTRAS*# Step: 5 Bead: 9 + 0.00012336 -0.00004265 -0.00004234 + -0.00004265 0.00012343 -0.00004274 + -0.00004234 -0.00004274 0.00012316 + #*EXTRAS*# Step: 6 Bead: 9 + 0.00012314 -0.00004279 -0.00004252 + -0.00004279 0.00012321 -0.00004288 + -0.00004252 -0.00004288 0.00012296 + #*EXTRAS*# Step: 7 Bead: 9 + 0.00012301 -0.00004288 -0.00004262 + -0.00004288 0.00012308 -0.00004296 + -0.00004262 -0.00004296 0.00012283 + #*EXTRAS*# Step: 8 Bead: 9 + 0.00012292 -0.00004293 -0.00004269 + -0.00004293 0.00012299 -0.00004301 + -0.00004269 -0.00004301 0.00012275 + #*EXTRAS*# Step: 9 Bead: 9 + 0.00012287 -0.00004296 -0.00004274 + -0.00004296 0.00012293 -0.00004304 + -0.00004274 -0.00004304 0.00012270 + #*EXTRAS*# Step: 10 Bead: 9 + 0.00012283 -0.00004298 -0.00004276 + -0.00004298 0.00012290 -0.00004306 + -0.00004276 -0.00004306 0.00012267 + #*EXTRAS*# Step: 11 Bead: 9 + 0.00012280 -0.00004300 -0.00004278 + -0.00004300 0.00012287 -0.00004307 + -0.00004278 -0.00004307 0.00012264 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 new file mode 100644 index 000000000..f633b9b74 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 10 + 0.00012992 -0.00003529 -0.00003508 + -0.00003529 0.00013011 -0.00003531 + -0.00003508 -0.00003531 0.00012959 + #*EXTRAS*# Step: 1 Bead: 10 + 0.00012743 -0.00003877 -0.00003830 + -0.00003877 0.00012753 -0.00003884 + -0.00003830 -0.00003884 0.00012707 + #*EXTRAS*# Step: 2 Bead: 10 + 0.00012534 -0.00004103 -0.00004047 + -0.00004103 0.00012541 -0.00004112 + -0.00004047 -0.00004112 0.00012504 + #*EXTRAS*# Step: 3 Bead: 10 + 0.00012413 -0.00004209 -0.00004164 + -0.00004209 0.00012419 -0.00004219 + -0.00004164 -0.00004219 0.00012388 + #*EXTRAS*# Step: 4 Bead: 10 + 0.00012355 -0.00004252 -0.00004217 + -0.00004252 0.00012361 -0.00004262 + -0.00004217 -0.00004262 0.00012334 + #*EXTRAS*# Step: 5 Bead: 10 + 0.00012320 -0.00004276 -0.00004247 + -0.00004276 0.00012327 -0.00004284 + -0.00004247 -0.00004284 0.00012301 + #*EXTRAS*# Step: 6 Bead: 10 + 0.00012299 -0.00004289 -0.00004264 + -0.00004289 0.00012306 -0.00004297 + -0.00004264 -0.00004297 0.00012282 + #*EXTRAS*# Step: 7 Bead: 10 + 0.00012286 -0.00004297 -0.00004274 + -0.00004297 0.00012293 -0.00004304 + -0.00004274 -0.00004304 0.00012269 + #*EXTRAS*# Step: 8 Bead: 10 + 0.00012277 -0.00004301 -0.00004281 + -0.00004301 0.00012284 -0.00004309 + -0.00004281 -0.00004309 0.00012261 + #*EXTRAS*# Step: 9 Bead: 10 + 0.00012272 -0.00004305 -0.00004285 + -0.00004305 0.00012279 -0.00004312 + -0.00004285 -0.00004312 0.00012256 + #*EXTRAS*# Step: 10 Bead: 10 + 0.00012268 -0.00004307 -0.00004287 + -0.00004307 0.00012275 -0.00004314 + -0.00004287 -0.00004314 0.00012253 + #*EXTRAS*# Step: 11 Bead: 10 + 0.00012266 -0.00004308 -0.00004289 + -0.00004308 0.00012273 -0.00004315 + -0.00004289 -0.00004315 0.00012251 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 new file mode 100644 index 000000000..fadd4bea4 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 11 + 0.00012948 -0.00003598 -0.00003572 + -0.00003598 0.00012966 -0.00003601 + -0.00003572 -0.00003601 0.00012914 + #*EXTRAS*# Step: 1 Bead: 11 + 0.00012705 -0.00003921 -0.00003871 + -0.00003921 0.00012715 -0.00003929 + -0.00003871 -0.00003929 0.00012671 + #*EXTRAS*# Step: 2 Bead: 11 + 0.00012507 -0.00004128 -0.00004074 + -0.00004128 0.00012513 -0.00004138 + -0.00004074 -0.00004138 0.00012478 + #*EXTRAS*# Step: 3 Bead: 11 + 0.00012392 -0.00004225 -0.00004184 + -0.00004225 0.00012398 -0.00004235 + -0.00004184 -0.00004235 0.00012369 + #*EXTRAS*# Step: 4 Bead: 11 + 0.00012336 -0.00004265 -0.00004233 + -0.00004265 0.00012343 -0.00004274 + -0.00004233 -0.00004274 0.00012316 + #*EXTRAS*# Step: 5 Bead: 11 + 0.00012302 -0.00004287 -0.00004261 + -0.00004287 0.00012309 -0.00004295 + -0.00004261 -0.00004295 0.00012285 + #*EXTRAS*# Step: 6 Bead: 11 + 0.00012282 -0.00004299 -0.00004277 + -0.00004299 0.00012289 -0.00004306 + -0.00004277 -0.00004306 0.00012266 + #*EXTRAS*# Step: 7 Bead: 11 + 0.00012270 -0.00004306 -0.00004286 + -0.00004306 0.00012276 -0.00004313 + -0.00004286 -0.00004313 0.00012254 + #*EXTRAS*# Step: 8 Bead: 11 + 0.00012261 -0.00004310 -0.00004292 + -0.00004310 0.00012268 -0.00004317 + -0.00004292 -0.00004317 0.00012246 + #*EXTRAS*# Step: 9 Bead: 11 + 0.00012256 -0.00004313 -0.00004296 + -0.00004313 0.00012263 -0.00004320 + -0.00004296 -0.00004320 0.00012242 + #*EXTRAS*# Step: 10 Bead: 11 + 0.00012253 -0.00004315 -0.00004299 + -0.00004315 0.00012259 -0.00004322 + -0.00004299 -0.00004322 0.00012238 + #*EXTRAS*# Step: 11 Bead: 11 + 0.00012250 -0.00004317 -0.00004300 + -0.00004317 0.00012257 -0.00004323 + -0.00004300 -0.00004323 0.00012236 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 new file mode 100644 index 000000000..5b5e45b66 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 12 + 0.00012899 -0.00003670 -0.00003639 + -0.00003670 0.00012915 -0.00003675 + -0.00003639 -0.00003675 0.00012865 + #*EXTRAS*# Step: 1 Bead: 12 + 0.00012665 -0.00003967 -0.00003914 + -0.00003967 0.00012674 -0.00003975 + -0.00003914 -0.00003975 0.00012631 + #*EXTRAS*# Step: 2 Bead: 12 + 0.00012479 -0.00004153 -0.00004101 + -0.00004153 0.00012485 -0.00004164 + -0.00004101 -0.00004164 0.00012451 + #*EXTRAS*# Step: 3 Bead: 12 + 0.00012369 -0.00004242 -0.00004204 + -0.00004242 0.00012376 -0.00004252 + -0.00004204 -0.00004252 0.00012347 + #*EXTRAS*# Step: 4 Bead: 12 + 0.00012316 -0.00004278 -0.00004250 + -0.00004278 0.00012323 -0.00004287 + -0.00004250 -0.00004287 0.00012297 + #*EXTRAS*# Step: 5 Bead: 12 + 0.00012284 -0.00004298 -0.00004276 + -0.00004298 0.00012291 -0.00004305 + -0.00004276 -0.00004305 0.00012267 + #*EXTRAS*# Step: 6 Bead: 12 + 0.00012264 -0.00004309 -0.00004290 + -0.00004309 0.00012271 -0.00004316 + -0.00004290 -0.00004316 0.00012249 + #*EXTRAS*# Step: 7 Bead: 12 + 0.00012252 -0.00004316 -0.00004299 + -0.00004316 0.00012258 -0.00004322 + -0.00004299 -0.00004322 0.00012238 + #*EXTRAS*# Step: 8 Bead: 12 + 0.00012244 -0.00004320 -0.00004305 + -0.00004320 0.00012250 -0.00004326 + -0.00004305 -0.00004326 0.00012230 + #*EXTRAS*# Step: 9 Bead: 12 + 0.00012239 -0.00004323 -0.00004308 + -0.00004323 0.00012245 -0.00004328 + -0.00004308 -0.00004328 0.00012225 + #*EXTRAS*# Step: 10 Bead: 12 + 0.00012236 -0.00004324 -0.00004311 + -0.00004324 0.00012242 -0.00004330 + -0.00004311 -0.00004330 0.00012222 + #*EXTRAS*# Step: 11 Bead: 12 + 0.00012233 -0.00004325 -0.00004312 + -0.00004325 0.00012239 -0.00004331 + -0.00004312 -0.00004331 0.00012220 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 new file mode 100644 index 000000000..4cc68ff38 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 13 + 0.00012846 -0.00003745 -0.00003707 + -0.00003745 0.00012860 -0.00003750 + -0.00003707 -0.00003750 0.00012811 + #*EXTRAS*# Step: 1 Bead: 13 + 0.00012623 -0.00004013 -0.00003958 + -0.00004013 0.00012630 -0.00004022 + -0.00003958 -0.00004022 0.00012590 + #*EXTRAS*# Step: 2 Bead: 13 + 0.00012450 -0.00004179 -0.00004130 + -0.00004179 0.00012456 -0.00004189 + -0.00004130 -0.00004189 0.00012423 + #*EXTRAS*# Step: 3 Bead: 13 + 0.00012346 -0.00004259 -0.00004225 + -0.00004259 0.00012352 -0.00004268 + -0.00004225 -0.00004268 0.00012325 + #*EXTRAS*# Step: 4 Bead: 13 + 0.00012295 -0.00004291 -0.00004267 + -0.00004291 0.00012302 -0.00004299 + -0.00004267 -0.00004299 0.00012278 + #*EXTRAS*# Step: 5 Bead: 13 + 0.00012264 -0.00004309 -0.00004291 + -0.00004309 0.00012270 -0.00004316 + -0.00004291 -0.00004316 0.00012249 + #*EXTRAS*# Step: 6 Bead: 13 + 0.00012245 -0.00004319 -0.00004304 + -0.00004319 0.00012251 -0.00004325 + -0.00004304 -0.00004325 0.00012231 + #*EXTRAS*# Step: 7 Bead: 13 + 0.00012233 -0.00004326 -0.00004312 + -0.00004326 0.00012239 -0.00004331 + -0.00004312 -0.00004331 0.00012220 + #*EXTRAS*# Step: 8 Bead: 13 + 0.00012225 -0.00004329 -0.00004317 + -0.00004329 0.00012231 -0.00004334 + -0.00004317 -0.00004334 0.00012213 + #*EXTRAS*# Step: 9 Bead: 13 + 0.00012220 -0.00004332 -0.00004321 + -0.00004332 0.00012226 -0.00004337 + -0.00004321 -0.00004337 0.00012208 + #*EXTRAS*# Step: 10 Bead: 13 + 0.00012217 -0.00004334 -0.00004323 + -0.00004334 0.00012223 -0.00004338 + -0.00004323 -0.00004338 0.00012205 + #*EXTRAS*# Step: 11 Bead: 13 + 0.00012215 -0.00004335 -0.00004324 + -0.00004335 0.00012221 -0.00004339 + -0.00004324 -0.00004339 0.00012203 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 new file mode 100644 index 000000000..8a78d1b95 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 14 + 0.00012788 -0.00003821 -0.00003777 + -0.00003821 0.00012800 -0.00003827 + -0.00003777 -0.00003827 0.00012753 + #*EXTRAS*# Step: 1 Bead: 14 + 0.00012578 -0.00004059 -0.00004004 + -0.00004059 0.00012585 -0.00004069 + -0.00004004 -0.00004069 0.00012546 + #*EXTRAS*# Step: 2 Bead: 14 + 0.00012419 -0.00004204 -0.00004159 + -0.00004204 0.00012425 -0.00004214 + -0.00004159 -0.00004214 0.00012394 + #*EXTRAS*# Step: 3 Bead: 14 + 0.00012321 -0.00004275 -0.00004246 + -0.00004275 0.00012327 -0.00004284 + -0.00004246 -0.00004284 0.00012302 + #*EXTRAS*# Step: 4 Bead: 14 + 0.00012272 -0.00004305 -0.00004285 + -0.00004305 0.00012279 -0.00004312 + -0.00004285 -0.00004312 0.00012256 + #*EXTRAS*# Step: 5 Bead: 14 + 0.00012242 -0.00004321 -0.00004306 + -0.00004321 0.00012249 -0.00004327 + -0.00004306 -0.00004327 0.00012228 + #*EXTRAS*# Step: 6 Bead: 14 + 0.00012224 -0.00004330 -0.00004318 + -0.00004330 0.00012230 -0.00004335 + -0.00004318 -0.00004335 0.00012212 + #*EXTRAS*# Step: 7 Bead: 14 + 0.00012213 -0.00004336 -0.00004326 + -0.00004336 0.00012218 -0.00004340 + -0.00004326 -0.00004340 0.00012201 + #*EXTRAS*# Step: 8 Bead: 14 + 0.00012205 -0.00004339 -0.00004330 + -0.00004339 0.00012211 -0.00004343 + -0.00004330 -0.00004343 0.00012194 + #*EXTRAS*# Step: 9 Bead: 14 + 0.00012201 -0.00004342 -0.00004333 + -0.00004342 0.00012206 -0.00004345 + -0.00004333 -0.00004345 0.00012189 + #*EXTRAS*# Step: 10 Bead: 14 + 0.00012197 -0.00004343 -0.00004335 + -0.00004343 0.00012202 -0.00004346 + -0.00004335 -0.00004346 0.00012186 + #*EXTRAS*# Step: 11 Bead: 14 + 0.00012195 -0.00004344 -0.00004336 + -0.00004344 0.00012200 -0.00004347 + -0.00004336 -0.00004347 0.00012184 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 new file mode 100644 index 000000000..38b6bf286 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 15 + 0.00012726 -0.00003897 -0.00003848 + -0.00003897 0.00012736 -0.00003904 + -0.00003848 -0.00003904 0.00012691 + #*EXTRAS*# Step: 1 Bead: 15 + 0.00012532 -0.00004104 -0.00004049 + -0.00004104 0.00012539 -0.00004114 + -0.00004049 -0.00004114 0.00012502 + #*EXTRAS*# Step: 2 Bead: 15 + 0.00012387 -0.00004229 -0.00004188 + -0.00004229 0.00012394 -0.00004239 + -0.00004188 -0.00004239 0.00012364 + #*EXTRAS*# Step: 3 Bead: 15 + 0.00012294 -0.00004292 -0.00004268 + -0.00004292 0.00012301 -0.00004300 + -0.00004268 -0.00004300 0.00012277 + #*EXTRAS*# Step: 4 Bead: 15 + 0.00012248 -0.00004318 -0.00004302 + -0.00004318 0.00012255 -0.00004324 + -0.00004302 -0.00004324 0.00012234 + #*EXTRAS*# Step: 5 Bead: 15 + 0.00012219 -0.00004332 -0.00004321 + -0.00004332 0.00012225 -0.00004337 + -0.00004321 -0.00004337 0.00012207 + #*EXTRAS*# Step: 6 Bead: 15 + 0.00012202 -0.00004341 -0.00004332 + -0.00004341 0.00012207 -0.00004344 + -0.00004332 -0.00004344 0.00012191 + #*EXTRAS*# Step: 7 Bead: 15 + 0.00012191 -0.00004346 -0.00004339 + -0.00004346 0.00012196 -0.00004349 + -0.00004339 -0.00004349 0.00012180 + #*EXTRAS*# Step: 8 Bead: 15 + 0.00012184 -0.00004349 -0.00004343 + -0.00004349 0.00012188 -0.00004352 + -0.00004343 -0.00004352 0.00012174 + #*EXTRAS*# Step: 9 Bead: 15 + 0.00012179 -0.00004351 -0.00004345 + -0.00004351 0.00012183 -0.00004353 + -0.00004345 -0.00004353 0.00012169 + #*EXTRAS*# Step: 10 Bead: 15 + 0.00012176 -0.00004353 -0.00004347 + -0.00004353 0.00012180 -0.00004354 + -0.00004347 -0.00004354 0.00012166 + #*EXTRAS*# Step: 11 Bead: 15 + 0.00012174 -0.00004354 -0.00004348 + -0.00004354 0.00012178 -0.00004355 + -0.00004348 -0.00004355 0.00012165 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 new file mode 100644 index 000000000..90bd9b912 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 16 + 0.00012661 -0.00003971 -0.00003918 + -0.00003971 0.00012670 -0.00003980 + -0.00003918 -0.00003980 0.00012627 + #*EXTRAS*# Step: 1 Bead: 16 + 0.00012486 -0.00004148 -0.00004095 + -0.00004148 0.00012492 -0.00004158 + -0.00004095 -0.00004158 0.00012457 + #*EXTRAS*# Step: 2 Bead: 16 + 0.00012355 -0.00004252 -0.00004217 + -0.00004252 0.00012361 -0.00004262 + -0.00004217 -0.00004262 0.00012334 + #*EXTRAS*# Step: 3 Bead: 16 + 0.00012266 -0.00004308 -0.00004289 + -0.00004308 0.00012273 -0.00004315 + -0.00004289 -0.00004315 0.00012251 + #*EXTRAS*# Step: 4 Bead: 16 + 0.00012223 -0.00004331 -0.00004319 + -0.00004331 0.00012229 -0.00004336 + -0.00004319 -0.00004336 0.00012210 + #*EXTRAS*# Step: 5 Bead: 16 + 0.00012195 -0.00004344 -0.00004336 + -0.00004344 0.00012200 -0.00004347 + -0.00004336 -0.00004347 0.00012184 + #*EXTRAS*# Step: 6 Bead: 16 + 0.00012179 -0.00004352 -0.00004346 + -0.00004352 0.00012183 -0.00004354 + -0.00004346 -0.00004354 0.00012169 + #*EXTRAS*# Step: 7 Bead: 16 + 0.00012168 -0.00004356 -0.00004352 + -0.00004356 0.00012171 -0.00004357 + -0.00004352 -0.00004357 0.00012159 + #*EXTRAS*# Step: 8 Bead: 16 + 0.00012161 -0.00004359 -0.00004355 + -0.00004359 0.00012164 -0.00004360 + -0.00004355 -0.00004360 0.00012152 + #*EXTRAS*# Step: 9 Bead: 16 + 0.00012157 -0.00004361 -0.00004358 + -0.00004361 0.00012159 -0.00004361 + -0.00004358 -0.00004361 0.00012148 + #*EXTRAS*# Step: 10 Bead: 16 + 0.00012154 -0.00004362 -0.00004359 + -0.00004362 0.00012156 -0.00004362 + -0.00004359 -0.00004362 0.00012145 + #*EXTRAS*# Step: 11 Bead: 16 + 0.00012152 -0.00004363 -0.00004360 + -0.00004363 0.00012154 -0.00004363 + -0.00004360 -0.00004363 0.00012143 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 new file mode 100644 index 000000000..e0a6a0ae0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 17 + 0.00012594 -0.00004043 -0.00003988 + -0.00004043 0.00012601 -0.00004052 + -0.00003988 -0.00004052 0.00012562 + #*EXTRAS*# Step: 1 Bead: 17 + 0.00012439 -0.00004188 -0.00004140 + -0.00004188 0.00012445 -0.00004198 + -0.00004140 -0.00004198 0.00012413 + #*EXTRAS*# Step: 2 Bead: 17 + 0.00012321 -0.00004275 -0.00004246 + -0.00004275 0.00012328 -0.00004284 + -0.00004246 -0.00004284 0.00012302 + #*EXTRAS*# Step: 3 Bead: 17 + 0.00012237 -0.00004323 -0.00004309 + -0.00004323 0.00012244 -0.00004329 + -0.00004309 -0.00004329 0.00012224 + #*EXTRAS*# Step: 4 Bead: 17 + 0.00012196 -0.00004344 -0.00004336 + -0.00004344 0.00012201 -0.00004347 + -0.00004336 -0.00004347 0.00012185 + #*EXTRAS*# Step: 5 Bead: 17 + 0.00012170 -0.00004356 -0.00004351 + -0.00004356 0.00012173 -0.00004357 + -0.00004351 -0.00004357 0.00012160 + #*EXTRAS*# Step: 6 Bead: 17 + 0.00012154 -0.00004363 -0.00004359 + -0.00004363 0.00012156 -0.00004362 + -0.00004359 -0.00004362 0.00012145 + #*EXTRAS*# Step: 7 Bead: 17 + 0.00012143 -0.00004367 -0.00004364 + -0.00004367 0.00012145 -0.00004366 + -0.00004364 -0.00004366 0.00012135 + #*EXTRAS*# Step: 8 Bead: 17 + 0.00012137 -0.00004369 -0.00004367 + -0.00004369 0.00012138 -0.00004368 + -0.00004367 -0.00004368 0.00012129 + #*EXTRAS*# Step: 9 Bead: 17 + 0.00012133 -0.00004371 -0.00004369 + -0.00004371 0.00012134 -0.00004369 + -0.00004369 -0.00004369 0.00012125 + #*EXTRAS*# Step: 10 Bead: 17 + 0.00012130 -0.00004372 -0.00004371 + -0.00004372 0.00012131 -0.00004370 + -0.00004371 -0.00004370 0.00012122 + #*EXTRAS*# Step: 11 Bead: 17 + 0.00012128 -0.00004373 -0.00004372 + -0.00004373 0.00012129 -0.00004371 + -0.00004372 -0.00004371 0.00012120 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 new file mode 100644 index 000000000..37527c2cf --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 18 + 0.00012526 -0.00004110 -0.00004055 + -0.00004110 0.00012533 -0.00004120 + -0.00004055 -0.00004120 0.00012496 + #*EXTRAS*# Step: 1 Bead: 18 + 0.00012392 -0.00004225 -0.00004184 + -0.00004225 0.00012398 -0.00004235 + -0.00004184 -0.00004235 0.00012369 + #*EXTRAS*# Step: 2 Bead: 18 + 0.00012286 -0.00004296 -0.00004274 + -0.00004296 0.00012293 -0.00004304 + -0.00004274 -0.00004304 0.00012269 + #*EXTRAS*# Step: 3 Bead: 18 + 0.00012207 -0.00004339 -0.00004329 + -0.00004339 0.00012212 -0.00004342 + -0.00004329 -0.00004342 0.00012195 + #*EXTRAS*# Step: 4 Bead: 18 + 0.00012167 -0.00004357 -0.00004352 + -0.00004357 0.00012171 -0.00004358 + -0.00004352 -0.00004358 0.00012158 + #*EXTRAS*# Step: 5 Bead: 18 + 0.00012142 -0.00004367 -0.00004365 + -0.00004367 0.00012144 -0.00004366 + -0.00004365 -0.00004366 0.00012134 + #*EXTRAS*# Step: 6 Bead: 18 + 0.00012127 -0.00004373 -0.00004372 + -0.00004373 0.00012128 -0.00004371 + -0.00004372 -0.00004371 0.00012120 + #*EXTRAS*# Step: 7 Bead: 18 + 0.00012117 -0.00004377 -0.00004376 + -0.00004377 0.00012117 -0.00004374 + -0.00004376 -0.00004374 0.00012110 + #*EXTRAS*# Step: 8 Bead: 18 + 0.00012111 -0.00004380 -0.00004379 + -0.00004380 0.00012110 -0.00004376 + -0.00004379 -0.00004376 0.00012104 + #*EXTRAS*# Step: 9 Bead: 18 + 0.00012107 -0.00004381 -0.00004381 + -0.00004381 0.00012106 -0.00004377 + -0.00004381 -0.00004377 0.00012100 + #*EXTRAS*# Step: 10 Bead: 18 + 0.00012104 -0.00004382 -0.00004382 + -0.00004382 0.00012103 -0.00004378 + -0.00004382 -0.00004378 0.00012098 + #*EXTRAS*# Step: 11 Bead: 18 + 0.00012102 -0.00004383 -0.00004382 + -0.00004383 0.00012101 -0.00004378 + -0.00004382 -0.00004378 0.00012096 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 new file mode 100644 index 000000000..b080fb25f --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 19 + 0.00012460 -0.00004170 -0.00004120 + -0.00004170 0.00012466 -0.00004181 + -0.00004120 -0.00004181 0.00012432 + #*EXTRAS*# Step: 1 Bead: 19 + 0.00012344 -0.00004259 -0.00004226 + -0.00004259 0.00012351 -0.00004269 + -0.00004226 -0.00004269 0.00012324 + #*EXTRAS*# Step: 2 Bead: 19 + 0.00012250 -0.00004317 -0.00004301 + -0.00004317 0.00012256 -0.00004323 + -0.00004301 -0.00004323 0.00012236 + #*EXTRAS*# Step: 3 Bead: 19 + 0.00012175 -0.00004353 -0.00004348 + -0.00004353 0.00012178 -0.00004355 + -0.00004348 -0.00004355 0.00012165 + #*EXTRAS*# Step: 4 Bead: 19 + 0.00012137 -0.00004369 -0.00004367 + -0.00004369 0.00012139 -0.00004368 + -0.00004367 -0.00004368 0.00012130 + #*EXTRAS*# Step: 5 Bead: 19 + 0.00012113 -0.00004379 -0.00004378 + -0.00004379 0.00012113 -0.00004375 + -0.00004378 -0.00004375 0.00012107 + #*EXTRAS*# Step: 6 Bead: 19 + 0.00012099 -0.00004384 -0.00004384 + -0.00004384 0.00012097 -0.00004379 + -0.00004384 -0.00004379 0.00012093 + #*EXTRAS*# Step: 7 Bead: 19 + 0.00012090 -0.00004388 -0.00004387 + -0.00004388 0.00012087 -0.00004382 + -0.00004387 -0.00004382 0.00012084 + #*EXTRAS*# Step: 8 Bead: 19 + 0.00012084 -0.00004390 -0.00004390 + -0.00004390 0.00012080 -0.00004383 + -0.00004390 -0.00004383 0.00012078 + #*EXTRAS*# Step: 9 Bead: 19 + 0.00012080 -0.00004392 -0.00004391 + -0.00004392 0.00012076 -0.00004384 + -0.00004391 -0.00004384 0.00012074 + #*EXTRAS*# Step: 10 Bead: 19 + 0.00012077 -0.00004392 -0.00004392 + -0.00004392 0.00012073 -0.00004385 + -0.00004392 -0.00004385 0.00012072 + #*EXTRAS*# Step: 11 Bead: 19 + 0.00012075 -0.00004393 -0.00004393 + -0.00004393 0.00012071 -0.00004385 + -0.00004393 -0.00004385 0.00012070 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 new file mode 100644 index 000000000..e7d77a4e8 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 20 + 0.00012394 -0.00004224 -0.00004182 + -0.00004224 0.00012400 -0.00004234 + -0.00004182 -0.00004234 0.00012371 + #*EXTRAS*# Step: 1 Bead: 20 + 0.00012296 -0.00004291 -0.00004266 + -0.00004291 0.00012303 -0.00004299 + -0.00004266 -0.00004299 0.00012279 + #*EXTRAS*# Step: 2 Bead: 20 + 0.00012212 -0.00004336 -0.00004326 + -0.00004336 0.00012218 -0.00004340 + -0.00004326 -0.00004340 0.00012200 + #*EXTRAS*# Step: 3 Bead: 20 + 0.00012141 -0.00004368 -0.00004366 + -0.00004368 0.00012142 -0.00004367 + -0.00004366 -0.00004367 0.00012133 + #*EXTRAS*# Step: 4 Bead: 20 + 0.00012106 -0.00004382 -0.00004381 + -0.00004382 0.00012104 -0.00004377 + -0.00004381 -0.00004377 0.00012099 + #*EXTRAS*# Step: 5 Bead: 20 + 0.00012083 -0.00004390 -0.00004390 + -0.00004390 0.00012080 -0.00004383 + -0.00004390 -0.00004383 0.00012077 + #*EXTRAS*# Step: 6 Bead: 20 + 0.00012069 -0.00004395 -0.00004395 + -0.00004395 0.00012064 -0.00004387 + -0.00004395 -0.00004387 0.00012064 + #*EXTRAS*# Step: 7 Bead: 20 + 0.00012060 -0.00004398 -0.00004398 + -0.00004398 0.00012055 -0.00004389 + -0.00004398 -0.00004389 0.00012055 + #*EXTRAS*# Step: 8 Bead: 20 + 0.00012055 -0.00004400 -0.00004400 + -0.00004400 0.00012048 -0.00004390 + -0.00004400 -0.00004390 0.00012050 + #*EXTRAS*# Step: 9 Bead: 20 + 0.00012051 -0.00004402 -0.00004401 + -0.00004402 0.00012044 -0.00004391 + -0.00004401 -0.00004391 0.00012046 + #*EXTRAS*# Step: 10 Bead: 20 + 0.00012048 -0.00004402 -0.00004401 + -0.00004402 0.00012042 -0.00004392 + -0.00004401 -0.00004392 0.00012044 + #*EXTRAS*# Step: 11 Bead: 20 + 0.00012047 -0.00004403 -0.00004402 + -0.00004403 0.00012040 -0.00004392 + -0.00004402 -0.00004392 0.00012042 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 new file mode 100644 index 000000000..4bbdac89e --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 21 + 0.00012329 -0.00004270 -0.00004239 + -0.00004270 0.00012336 -0.00004279 + -0.00004239 -0.00004279 0.00012310 + #*EXTRAS*# Step: 1 Bead: 21 + 0.00012246 -0.00004319 -0.00004303 + -0.00004319 0.00012253 -0.00004325 + -0.00004303 -0.00004325 0.00012232 + #*EXTRAS*# Step: 2 Bead: 21 + 0.00012173 -0.00004354 -0.00004349 + -0.00004354 0.00012177 -0.00004356 + -0.00004349 -0.00004356 0.00012163 + #*EXTRAS*# Step: 3 Bead: 21 + 0.00012105 -0.00004382 -0.00004381 + -0.00004382 0.00012103 -0.00004378 + -0.00004381 -0.00004378 0.00012098 + #*EXTRAS*# Step: 4 Bead: 21 + 0.00012072 -0.00004394 -0.00004394 + -0.00004394 0.00012067 -0.00004386 + -0.00004394 -0.00004386 0.00012067 + #*EXTRAS*# Step: 5 Bead: 21 + 0.00012051 -0.00004402 -0.00004401 + -0.00004402 0.00012044 -0.00004391 + -0.00004401 -0.00004391 0.00012046 + #*EXTRAS*# Step: 6 Bead: 21 + 0.00012038 -0.00004406 -0.00004405 + -0.00004406 0.00012029 -0.00004394 + -0.00004405 -0.00004394 0.00012034 + #*EXTRAS*# Step: 7 Bead: 21 + 0.00012029 -0.00004409 -0.00004407 + -0.00004409 0.00012020 -0.00004396 + -0.00004407 -0.00004396 0.00012026 + #*EXTRAS*# Step: 8 Bead: 21 + 0.00012024 -0.00004410 -0.00004408 + -0.00004410 0.00012014 -0.00004397 + -0.00004408 -0.00004397 0.00012020 + #*EXTRAS*# Step: 9 Bead: 21 + 0.00012021 -0.00004412 -0.00004409 + -0.00004412 0.00012011 -0.00004398 + -0.00004409 -0.00004398 0.00012017 + #*EXTRAS*# Step: 10 Bead: 21 + 0.00012018 -0.00004412 -0.00004410 + -0.00004412 0.00012008 -0.00004398 + -0.00004410 -0.00004398 0.00012015 + #*EXTRAS*# Step: 11 Bead: 21 + 0.00012017 -0.00004413 -0.00004410 + -0.00004413 0.00012006 -0.00004399 + -0.00004410 -0.00004399 0.00012013 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 new file mode 100644 index 000000000..ce91ab982 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 22 + 0.00012263 -0.00004310 -0.00004291 + -0.00004310 0.00012270 -0.00004316 + -0.00004291 -0.00004316 0.00012248 + #*EXTRAS*# Step: 1 Bead: 22 + 0.00012195 -0.00004344 -0.00004337 + -0.00004344 0.00012199 -0.00004347 + -0.00004337 -0.00004347 0.00012184 + #*EXTRAS*# Step: 2 Bead: 22 + 0.00012131 -0.00004372 -0.00004370 + -0.00004372 0.00012133 -0.00004370 + -0.00004370 -0.00004370 0.00012124 + #*EXTRAS*# Step: 3 Bead: 22 + 0.00012067 -0.00004396 -0.00004396 + -0.00004396 0.00012062 -0.00004388 + -0.00004396 -0.00004388 0.00012062 + #*EXTRAS*# Step: 4 Bead: 22 + 0.00012036 -0.00004407 -0.00004405 + -0.00004407 0.00012028 -0.00004395 + -0.00004405 -0.00004395 0.00012032 + #*EXTRAS*# Step: 5 Bead: 22 + 0.00012017 -0.00004413 -0.00004410 + -0.00004413 0.00012006 -0.00004399 + -0.00004410 -0.00004399 0.00012013 + #*EXTRAS*# Step: 6 Bead: 22 + 0.00012005 -0.00004417 -0.00004413 + -0.00004417 0.00011993 -0.00004401 + -0.00004413 -0.00004401 0.00012002 + #*EXTRAS*# Step: 7 Bead: 22 + 0.00011997 -0.00004419 -0.00004415 + -0.00004419 0.00011984 -0.00004402 + -0.00004415 -0.00004402 0.00011994 + #*EXTRAS*# Step: 8 Bead: 22 + 0.00011992 -0.00004420 -0.00004416 + -0.00004420 0.00011979 -0.00004403 + -0.00004416 -0.00004403 0.00011989 + #*EXTRAS*# Step: 9 Bead: 22 + 0.00011989 -0.00004421 -0.00004417 + -0.00004421 0.00011975 -0.00004404 + -0.00004417 -0.00004404 0.00011986 + #*EXTRAS*# Step: 10 Bead: 22 + 0.00011987 -0.00004422 -0.00004417 + -0.00004422 0.00011973 -0.00004404 + -0.00004417 -0.00004404 0.00011984 + #*EXTRAS*# Step: 11 Bead: 22 + 0.00011986 -0.00004422 -0.00004418 + -0.00004422 0.00011971 -0.00004404 + -0.00004418 -0.00004404 0.00011983 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 new file mode 100644 index 000000000..9d19ad624 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 23 + 0.00012195 -0.00004344 -0.00004336 + -0.00004344 0.00012200 -0.00004347 + -0.00004336 -0.00004347 0.00012184 + #*EXTRAS*# Step: 1 Bead: 23 + 0.00012140 -0.00004368 -0.00004366 + -0.00004368 0.00012142 -0.00004367 + -0.00004366 -0.00004367 0.00012132 + #*EXTRAS*# Step: 2 Bead: 23 + 0.00012088 -0.00004389 -0.00004388 + -0.00004389 0.00012085 -0.00004382 + -0.00004388 -0.00004382 0.00012082 + #*EXTRAS*# Step: 3 Bead: 23 + 0.00012027 -0.00004410 -0.00004408 + -0.00004410 0.00012017 -0.00004397 + -0.00004408 -0.00004397 0.00012023 + #*EXTRAS*# Step: 4 Bead: 23 + 0.00011999 -0.00004418 -0.00004415 + -0.00004418 0.00011987 -0.00004402 + -0.00004415 -0.00004402 0.00011996 + #*EXTRAS*# Step: 5 Bead: 23 + 0.00011981 -0.00004423 -0.00004419 + -0.00004423 0.00011966 -0.00004405 + -0.00004419 -0.00004405 0.00011979 + #*EXTRAS*# Step: 6 Bead: 23 + 0.00011971 -0.00004426 -0.00004421 + -0.00004426 0.00011954 -0.00004407 + -0.00004421 -0.00004407 0.00011968 + #*EXTRAS*# Step: 7 Bead: 23 + 0.00011964 -0.00004428 -0.00004422 + -0.00004428 0.00011947 -0.00004408 + -0.00004422 -0.00004408 0.00011962 + #*EXTRAS*# Step: 8 Bead: 23 + 0.00011959 -0.00004429 -0.00004423 + -0.00004429 0.00011942 -0.00004409 + -0.00004423 -0.00004409 0.00011957 + #*EXTRAS*# Step: 9 Bead: 23 + 0.00011957 -0.00004430 -0.00004423 + -0.00004430 0.00011939 -0.00004409 + -0.00004423 -0.00004409 0.00011954 + #*EXTRAS*# Step: 10 Bead: 23 + 0.00011955 -0.00004431 -0.00004424 + -0.00004431 0.00011936 -0.00004409 + -0.00004424 -0.00004409 0.00011953 + #*EXTRAS*# Step: 11 Bead: 23 + 0.00011953 -0.00004431 -0.00004424 + -0.00004431 0.00011935 -0.00004410 + -0.00004424 -0.00004410 0.00011951 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 new file mode 100644 index 000000000..b70c1e946 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 24 + 0.00012123 -0.00004375 -0.00004374 + -0.00004375 0.00012123 -0.00004372 + -0.00004374 -0.00004372 0.00012116 + #*EXTRAS*# Step: 1 Bead: 24 + 0.00012082 -0.00004391 -0.00004390 + -0.00004391 0.00012079 -0.00004384 + -0.00004390 -0.00004384 0.00012077 + #*EXTRAS*# Step: 2 Bead: 24 + 0.00012041 -0.00004405 -0.00004404 + -0.00004405 0.00012034 -0.00004393 + -0.00004404 -0.00004393 0.00012037 + #*EXTRAS*# Step: 3 Bead: 24 + 0.00011985 -0.00004422 -0.00004418 + -0.00004422 0.00011970 -0.00004404 + -0.00004418 -0.00004404 0.00011982 + #*EXTRAS*# Step: 4 Bead: 24 + 0.00011961 -0.00004429 -0.00004423 + -0.00004429 0.00011943 -0.00004408 + -0.00004423 -0.00004408 0.00011959 + #*EXTRAS*# Step: 5 Bead: 24 + 0.00011945 -0.00004433 -0.00004425 + -0.00004433 0.00011925 -0.00004411 + -0.00004425 -0.00004411 0.00011943 + #*EXTRAS*# Step: 6 Bead: 24 + 0.00011935 -0.00004436 -0.00004427 + -0.00004436 0.00011915 -0.00004412 + -0.00004427 -0.00004412 0.00011934 + #*EXTRAS*# Step: 7 Bead: 24 + 0.00011929 -0.00004437 -0.00004428 + -0.00004437 0.00011908 -0.00004413 + -0.00004428 -0.00004413 0.00011928 + #*EXTRAS*# Step: 8 Bead: 24 + 0.00011925 -0.00004438 -0.00004428 + -0.00004438 0.00011904 -0.00004413 + -0.00004428 -0.00004413 0.00011924 + #*EXTRAS*# Step: 9 Bead: 24 + 0.00011923 -0.00004439 -0.00004429 + -0.00004439 0.00011901 -0.00004414 + -0.00004429 -0.00004414 0.00011921 + #*EXTRAS*# Step: 10 Bead: 24 + 0.00011921 -0.00004439 -0.00004429 + -0.00004439 0.00011899 -0.00004414 + -0.00004429 -0.00004414 0.00011920 + #*EXTRAS*# Step: 11 Bead: 24 + 0.00011920 -0.00004439 -0.00004429 + -0.00004439 0.00011898 -0.00004414 + -0.00004429 -0.00004414 0.00011919 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 new file mode 100644 index 000000000..e11cb25ad --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 25 + 0.00012045 -0.00004404 -0.00004402 + -0.00004404 0.00012038 -0.00004393 + -0.00004402 -0.00004393 0.00012041 + #*EXTRAS*# Step: 1 Bead: 25 + 0.00012021 -0.00004412 -0.00004409 + -0.00004412 0.00012011 -0.00004398 + -0.00004409 -0.00004398 0.00012017 + #*EXTRAS*# Step: 2 Bead: 25 + 0.00011993 -0.00004420 -0.00004416 + -0.00004420 0.00011979 -0.00004403 + -0.00004416 -0.00004403 0.00011990 + #*EXTRAS*# Step: 3 Bead: 25 + 0.00011942 -0.00004434 -0.00004426 + -0.00004434 0.00011922 -0.00004411 + -0.00004426 -0.00004411 0.00011940 + #*EXTRAS*# Step: 4 Bead: 25 + 0.00011921 -0.00004439 -0.00004429 + -0.00004439 0.00011899 -0.00004414 + -0.00004429 -0.00004414 0.00011920 + #*EXTRAS*# Step: 5 Bead: 25 + 0.00011907 -0.00004442 -0.00004431 + -0.00004442 0.00011883 -0.00004416 + -0.00004431 -0.00004416 0.00011906 + #*EXTRAS*# Step: 6 Bead: 25 + 0.00011899 -0.00004444 -0.00004432 + -0.00004444 0.00011874 -0.00004416 + -0.00004432 -0.00004416 0.00011898 + #*EXTRAS*# Step: 7 Bead: 25 + 0.00011894 -0.00004445 -0.00004432 + -0.00004445 0.00011868 -0.00004417 + -0.00004432 -0.00004417 0.00011893 + #*EXTRAS*# Step: 8 Bead: 25 + 0.00011890 -0.00004446 -0.00004433 + -0.00004446 0.00011864 -0.00004417 + -0.00004433 -0.00004417 0.00011889 + #*EXTRAS*# Step: 9 Bead: 25 + 0.00011888 -0.00004446 -0.00004433 + -0.00004446 0.00011862 -0.00004417 + -0.00004433 -0.00004417 0.00011887 + #*EXTRAS*# Step: 10 Bead: 25 + 0.00011887 -0.00004446 -0.00004433 + -0.00004446 0.00011860 -0.00004418 + -0.00004433 -0.00004418 0.00011886 + #*EXTRAS*# Step: 11 Bead: 25 + 0.00011886 -0.00004446 -0.00004433 + -0.00004446 0.00011859 -0.00004418 + -0.00004433 -0.00004418 0.00011885 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 new file mode 100644 index 000000000..d039005ef --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 26 + 0.00011962 -0.00004429 -0.00004422 + -0.00004429 0.00011945 -0.00004408 + -0.00004422 -0.00004408 0.00011960 + #*EXTRAS*# Step: 1 Bead: 26 + 0.00011956 -0.00004430 -0.00004423 + -0.00004430 0.00011938 -0.00004409 + -0.00004423 -0.00004409 0.00011954 + #*EXTRAS*# Step: 2 Bead: 26 + 0.00011943 -0.00004434 -0.00004426 + -0.00004434 0.00011923 -0.00004411 + -0.00004426 -0.00004411 0.00011941 + #*EXTRAS*# Step: 3 Bead: 26 + 0.00011897 -0.00004444 -0.00004432 + -0.00004444 0.00011872 -0.00004417 + -0.00004432 -0.00004417 0.00011896 + #*EXTRAS*# Step: 4 Bead: 26 + 0.00011880 -0.00004447 -0.00004434 + -0.00004447 0.00011853 -0.00004418 + -0.00004434 -0.00004418 0.00011880 + #*EXTRAS*# Step: 5 Bead: 26 + 0.00011869 -0.00004450 -0.00004435 + -0.00004450 0.00011840 -0.00004419 + -0.00004435 -0.00004419 0.00011868 + #*EXTRAS*# Step: 6 Bead: 26 + 0.00011862 -0.00004451 -0.00004435 + -0.00004451 0.00011833 -0.00004420 + -0.00004435 -0.00004420 0.00011861 + #*EXTRAS*# Step: 7 Bead: 26 + 0.00011857 -0.00004452 -0.00004435 + -0.00004452 0.00011828 -0.00004420 + -0.00004435 -0.00004420 0.00011857 + #*EXTRAS*# Step: 8 Bead: 26 + 0.00011855 -0.00004452 -0.00004436 + -0.00004452 0.00011825 -0.00004420 + -0.00004436 -0.00004420 0.00011854 + #*EXTRAS*# Step: 9 Bead: 26 + 0.00011853 -0.00004452 -0.00004436 + -0.00004452 0.00011823 -0.00004420 + -0.00004436 -0.00004420 0.00011852 + #*EXTRAS*# Step: 10 Bead: 26 + 0.00011852 -0.00004452 -0.00004436 + -0.00004452 0.00011821 -0.00004421 + -0.00004436 -0.00004421 0.00011851 + #*EXTRAS*# Step: 11 Bead: 26 + 0.00011851 -0.00004453 -0.00004436 + -0.00004453 0.00011820 -0.00004421 + -0.00004436 -0.00004421 0.00011850 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 new file mode 100644 index 000000000..1e1323b11 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 27 + 0.00011876 -0.00004448 -0.00004434 + -0.00004448 0.00011848 -0.00004419 + -0.00004434 -0.00004419 0.00011875 + #*EXTRAS*# Step: 1 Bead: 27 + 0.00011890 -0.00004446 -0.00004433 + -0.00004446 0.00011864 -0.00004417 + -0.00004433 -0.00004417 0.00011889 + #*EXTRAS*# Step: 2 Bead: 27 + 0.00011891 -0.00004445 -0.00004433 + -0.00004445 0.00011865 -0.00004417 + -0.00004433 -0.00004417 0.00011890 + #*EXTRAS*# Step: 3 Bead: 27 + 0.00011852 -0.00004452 -0.00004436 + -0.00004452 0.00011822 -0.00004421 + -0.00004436 -0.00004421 0.00011852 + #*EXTRAS*# Step: 4 Bead: 27 + 0.00011839 -0.00004454 -0.00004437 + -0.00004454 0.00011807 -0.00004421 + -0.00004437 -0.00004421 0.00011839 + #*EXTRAS*# Step: 5 Bead: 27 + 0.00011830 -0.00004456 -0.00004437 + -0.00004456 0.00011797 -0.00004422 + -0.00004437 -0.00004422 0.00011829 + #*EXTRAS*# Step: 6 Bead: 27 + 0.00011824 -0.00004456 -0.00004437 + -0.00004456 0.00011791 -0.00004422 + -0.00004437 -0.00004422 0.00011824 + #*EXTRAS*# Step: 7 Bead: 27 + 0.00011821 -0.00004457 -0.00004437 + -0.00004457 0.00011787 -0.00004422 + -0.00004437 -0.00004422 0.00011820 + #*EXTRAS*# Step: 8 Bead: 27 + 0.00011818 -0.00004457 -0.00004437 + -0.00004457 0.00011785 -0.00004423 + -0.00004437 -0.00004423 0.00011818 + #*EXTRAS*# Step: 9 Bead: 27 + 0.00011817 -0.00004457 -0.00004437 + -0.00004457 0.00011783 -0.00004423 + -0.00004437 -0.00004423 0.00011817 + #*EXTRAS*# Step: 10 Bead: 27 + 0.00011816 -0.00004457 -0.00004437 + -0.00004457 0.00011782 -0.00004423 + -0.00004437 -0.00004423 0.00011816 + #*EXTRAS*# Step: 11 Bead: 27 + 0.00011815 -0.00004458 -0.00004437 + -0.00004458 0.00011781 -0.00004423 + -0.00004437 -0.00004423 0.00011815 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 new file mode 100644 index 000000000..79e156a1b --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 28 + 0.00011788 -0.00004460 -0.00004438 + -0.00004460 0.00011751 -0.00004424 + -0.00004438 -0.00004424 0.00011788 + #*EXTRAS*# Step: 1 Bead: 28 + 0.00011822 -0.00004457 -0.00004437 + -0.00004457 0.00011788 -0.00004422 + -0.00004437 -0.00004422 0.00011822 + #*EXTRAS*# Step: 2 Bead: 28 + 0.00011839 -0.00004454 -0.00004437 + -0.00004454 0.00011807 -0.00004421 + -0.00004437 -0.00004421 0.00011838 + #*EXTRAS*# Step: 3 Bead: 28 + 0.00011806 -0.00004459 -0.00004438 + -0.00004459 0.00011771 -0.00004423 + -0.00004438 -0.00004423 0.00011806 + #*EXTRAS*# Step: 4 Bead: 28 + 0.00011797 -0.00004460 -0.00004438 + -0.00004460 0.00011761 -0.00004423 + -0.00004438 -0.00004423 0.00011797 + #*EXTRAS*# Step: 5 Bead: 28 + 0.00011790 -0.00004460 -0.00004438 + -0.00004460 0.00011754 -0.00004424 + -0.00004438 -0.00004424 0.00011790 + #*EXTRAS*# Step: 6 Bead: 28 + 0.00011786 -0.00004461 -0.00004438 + -0.00004461 0.00011749 -0.00004424 + -0.00004438 -0.00004424 0.00011786 + #*EXTRAS*# Step: 7 Bead: 28 + 0.00011783 -0.00004461 -0.00004438 + -0.00004461 0.00011746 -0.00004424 + -0.00004438 -0.00004424 0.00011784 + #*EXTRAS*# Step: 8 Bead: 28 + 0.00011782 -0.00004461 -0.00004438 + -0.00004461 0.00011745 -0.00004424 + -0.00004438 -0.00004424 0.00011782 + #*EXTRAS*# Step: 9 Bead: 28 + 0.00011781 -0.00004461 -0.00004438 + -0.00004461 0.00011743 -0.00004424 + -0.00004438 -0.00004424 0.00011781 + #*EXTRAS*# Step: 10 Bead: 28 + 0.00011780 -0.00004461 -0.00004438 + -0.00004461 0.00011743 -0.00004424 + -0.00004438 -0.00004424 0.00011780 + #*EXTRAS*# Step: 11 Bead: 28 + 0.00011780 -0.00004461 -0.00004438 + -0.00004461 0.00011742 -0.00004424 + -0.00004438 -0.00004424 0.00011780 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 new file mode 100644 index 000000000..d15ab3788 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 29 + 0.00011700 -0.00004463 -0.00004435 + -0.00004463 0.00011658 -0.00004423 + -0.00004435 -0.00004423 0.00011701 + #*EXTRAS*# Step: 1 Bead: 29 + 0.00011753 -0.00004463 -0.00004437 + -0.00004463 0.00011714 -0.00004424 + -0.00004437 -0.00004424 0.00011754 + #*EXTRAS*# Step: 2 Bead: 29 + 0.00011785 -0.00004461 -0.00004438 + -0.00004461 0.00011749 -0.00004424 + -0.00004438 -0.00004424 0.00011786 + #*EXTRAS*# Step: 3 Bead: 29 + 0.00011760 -0.00004462 -0.00004438 + -0.00004462 0.00011721 -0.00004424 + -0.00004438 -0.00004424 0.00011760 + #*EXTRAS*# Step: 4 Bead: 29 + 0.00011755 -0.00004463 -0.00004438 + -0.00004463 0.00011716 -0.00004424 + -0.00004438 -0.00004424 0.00011755 + #*EXTRAS*# Step: 5 Bead: 29 + 0.00011750 -0.00004463 -0.00004437 + -0.00004463 0.00011711 -0.00004424 + -0.00004437 -0.00004424 0.00011751 + #*EXTRAS*# Step: 6 Bead: 29 + 0.00011748 -0.00004463 -0.00004437 + -0.00004463 0.00011708 -0.00004424 + -0.00004437 -0.00004424 0.00011748 + #*EXTRAS*# Step: 7 Bead: 29 + 0.00011746 -0.00004463 -0.00004437 + -0.00004463 0.00011706 -0.00004424 + -0.00004437 -0.00004424 0.00011747 + #*EXTRAS*# Step: 8 Bead: 29 + 0.00011745 -0.00004463 -0.00004437 + -0.00004463 0.00011705 -0.00004424 + -0.00004437 -0.00004424 0.00011745 + #*EXTRAS*# Step: 9 Bead: 29 + 0.00011744 -0.00004463 -0.00004437 + -0.00004463 0.00011704 -0.00004424 + -0.00004437 -0.00004424 0.00011745 + #*EXTRAS*# Step: 10 Bead: 29 + 0.00011744 -0.00004463 -0.00004437 + -0.00004463 0.00011704 -0.00004424 + -0.00004437 -0.00004424 0.00011744 + #*EXTRAS*# Step: 11 Bead: 29 + 0.00011744 -0.00004463 -0.00004437 + -0.00004463 0.00011704 -0.00004424 + -0.00004437 -0.00004424 0.00011744 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 new file mode 100644 index 000000000..eee513202 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 30 + 0.00011614 -0.00004454 -0.00004426 + -0.00004454 0.00011572 -0.00004416 + -0.00004426 -0.00004416 0.00011615 + #*EXTRAS*# Step: 1 Bead: 30 + 0.00011685 -0.00004462 -0.00004434 + -0.00004462 0.00011643 -0.00004422 + -0.00004434 -0.00004422 0.00011686 + #*EXTRAS*# Step: 2 Bead: 30 + 0.00011732 -0.00004463 -0.00004437 + -0.00004463 0.00011692 -0.00004424 + -0.00004437 -0.00004424 0.00011733 + #*EXTRAS*# Step: 3 Bead: 30 + 0.00011714 -0.00004463 -0.00004436 + -0.00004463 0.00011673 -0.00004423 + -0.00004436 -0.00004423 0.00011715 + #*EXTRAS*# Step: 4 Bead: 30 + 0.00011713 -0.00004463 -0.00004436 + -0.00004463 0.00011671 -0.00004423 + -0.00004436 -0.00004423 0.00011714 + #*EXTRAS*# Step: 5 Bead: 30 + 0.00011710 -0.00004463 -0.00004436 + -0.00004463 0.00011669 -0.00004423 + -0.00004436 -0.00004423 0.00011711 + #*EXTRAS*# Step: 6 Bead: 30 + 0.00011709 -0.00004463 -0.00004435 + -0.00004463 0.00011668 -0.00004423 + -0.00004435 -0.00004423 0.00011710 + #*EXTRAS*# Step: 7 Bead: 30 + 0.00011709 -0.00004463 -0.00004435 + -0.00004463 0.00011667 -0.00004423 + -0.00004435 -0.00004423 0.00011709 + #*EXTRAS*# Step: 8 Bead: 30 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011667 -0.00004423 + -0.00004435 -0.00004423 0.00011709 + #*EXTRAS*# Step: 9 Bead: 30 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011709 + #*EXTRAS*# Step: 10 Bead: 30 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011709 + #*EXTRAS*# Step: 11 Bead: 30 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011708 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 new file mode 100644 index 000000000..2d3655a41 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 31 + 0.00011529 -0.00004435 -0.00004411 + -0.00004435 0.00011492 -0.00004403 + -0.00004411 -0.00004403 0.00011532 + #*EXTRAS*# Step: 1 Bead: 31 + 0.00011618 -0.00004455 -0.00004426 + -0.00004455 0.00011576 -0.00004416 + -0.00004426 -0.00004416 0.00011620 + #*EXTRAS*# Step: 2 Bead: 31 + 0.00011680 -0.00004462 -0.00004433 + -0.00004462 0.00011637 -0.00004422 + -0.00004433 -0.00004422 0.00011681 + #*EXTRAS*# Step: 3 Bead: 31 + 0.00011668 -0.00004461 -0.00004432 + -0.00004461 0.00011626 -0.00004421 + -0.00004432 -0.00004421 0.00011669 + #*EXTRAS*# Step: 4 Bead: 31 + 0.00011671 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011672 + #*EXTRAS*# Step: 5 Bead: 31 + 0.00011671 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011672 + #*EXTRAS*# Step: 6 Bead: 31 + 0.00011671 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011673 + #*EXTRAS*# Step: 7 Bead: 31 + 0.00011672 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011673 + #*EXTRAS*# Step: 8 Bead: 31 + 0.00011672 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011673 + #*EXTRAS*# Step: 9 Bead: 31 + 0.00011672 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011673 + #*EXTRAS*# Step: 10 Bead: 31 + 0.00011672 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011673 + #*EXTRAS*# Step: 11 Bead: 31 + 0.00011672 -0.00004461 -0.00004432 + -0.00004461 0.00011629 -0.00004421 + -0.00004432 -0.00004421 0.00011673 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 new file mode 100644 index 000000000..6d9aee4b9 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 32 + 0.00011447 -0.00004408 -0.00004390 + -0.00004408 0.00011418 -0.00004385 + -0.00004390 -0.00004385 0.00011451 + #*EXTRAS*# Step: 1 Bead: 32 + 0.00011553 -0.00004442 -0.00004415 + -0.00004442 0.00011514 -0.00004407 + -0.00004415 -0.00004407 0.00011555 + #*EXTRAS*# Step: 2 Bead: 32 + 0.00011628 -0.00004456 -0.00004427 + -0.00004456 0.00011585 -0.00004417 + -0.00004427 -0.00004417 0.00011629 + #*EXTRAS*# Step: 3 Bead: 32 + 0.00011623 -0.00004456 -0.00004427 + -0.00004456 0.00011581 -0.00004417 + -0.00004427 -0.00004417 0.00011625 + #*EXTRAS*# Step: 4 Bead: 32 + 0.00011630 -0.00004457 -0.00004428 + -0.00004457 0.00011587 -0.00004418 + -0.00004428 -0.00004418 0.00011631 + #*EXTRAS*# Step: 5 Bead: 32 + 0.00011632 -0.00004457 -0.00004428 + -0.00004457 0.00011590 -0.00004418 + -0.00004428 -0.00004418 0.00011634 + #*EXTRAS*# Step: 6 Bead: 32 + 0.00011634 -0.00004457 -0.00004428 + -0.00004457 0.00011592 -0.00004418 + -0.00004428 -0.00004418 0.00011635 + #*EXTRAS*# Step: 7 Bead: 32 + 0.00011635 -0.00004457 -0.00004428 + -0.00004457 0.00011593 -0.00004418 + -0.00004428 -0.00004418 0.00011636 + #*EXTRAS*# Step: 8 Bead: 32 + 0.00011635 -0.00004458 -0.00004429 + -0.00004458 0.00011593 -0.00004418 + -0.00004429 -0.00004418 0.00011637 + #*EXTRAS*# Step: 9 Bead: 32 + 0.00011636 -0.00004458 -0.00004429 + -0.00004458 0.00011594 -0.00004418 + -0.00004429 -0.00004418 0.00011637 + #*EXTRAS*# Step: 10 Bead: 32 + 0.00011636 -0.00004458 -0.00004429 + -0.00004458 0.00011594 -0.00004418 + -0.00004429 -0.00004418 0.00011638 + #*EXTRAS*# Step: 11 Bead: 32 + 0.00011636 -0.00004458 -0.00004429 + -0.00004458 0.00011594 -0.00004418 + -0.00004429 -0.00004418 0.00011638 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 new file mode 100644 index 000000000..81dde4738 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 33 + 0.00011368 -0.00004374 -0.00004364 + -0.00004374 0.00011347 -0.00004360 + -0.00004364 -0.00004360 0.00011372 + #*EXTRAS*# Step: 1 Bead: 33 + 0.00011489 -0.00004423 -0.00004401 + -0.00004423 0.00011455 -0.00004395 + -0.00004401 -0.00004395 0.00011491 + #*EXTRAS*# Step: 2 Bead: 33 + 0.00011576 -0.00004447 -0.00004420 + -0.00004447 0.00011536 -0.00004411 + -0.00004420 -0.00004411 0.00011578 + #*EXTRAS*# Step: 3 Bead: 33 + 0.00011578 -0.00004448 -0.00004420 + -0.00004448 0.00011538 -0.00004411 + -0.00004420 -0.00004411 0.00011581 + #*EXTRAS*# Step: 4 Bead: 33 + 0.00011589 -0.00004450 -0.00004422 + -0.00004450 0.00011548 -0.00004413 + -0.00004422 -0.00004413 0.00011591 + #*EXTRAS*# Step: 5 Bead: 33 + 0.00011594 -0.00004451 -0.00004423 + -0.00004451 0.00011553 -0.00004413 + -0.00004423 -0.00004413 0.00011595 + #*EXTRAS*# Step: 6 Bead: 33 + 0.00011597 -0.00004451 -0.00004423 + -0.00004451 0.00011556 -0.00004414 + -0.00004423 -0.00004414 0.00011599 + #*EXTRAS*# Step: 7 Bead: 33 + 0.00011599 -0.00004452 -0.00004423 + -0.00004452 0.00011557 -0.00004414 + -0.00004423 -0.00004414 0.00011600 + #*EXTRAS*# Step: 8 Bead: 33 + 0.00011600 -0.00004452 -0.00004424 + -0.00004452 0.00011559 -0.00004414 + -0.00004424 -0.00004414 0.00011602 + #*EXTRAS*# Step: 9 Bead: 33 + 0.00011601 -0.00004452 -0.00004424 + -0.00004452 0.00011559 -0.00004414 + -0.00004424 -0.00004414 0.00011602 + #*EXTRAS*# Step: 10 Bead: 33 + 0.00011601 -0.00004452 -0.00004424 + -0.00004452 0.00011560 -0.00004414 + -0.00004424 -0.00004414 0.00011603 + #*EXTRAS*# Step: 11 Bead: 33 + 0.00011602 -0.00004452 -0.00004424 + -0.00004452 0.00011560 -0.00004414 + -0.00004424 -0.00004414 0.00011603 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 new file mode 100644 index 000000000..be9d27b93 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 34 + 0.00011291 -0.00004336 -0.00004333 + -0.00004336 0.00011279 -0.00004331 + -0.00004333 -0.00004331 0.00011296 + #*EXTRAS*# Step: 1 Bead: 34 + 0.00011426 -0.00004400 -0.00004383 + -0.00004400 0.00011399 -0.00004379 + -0.00004383 -0.00004379 0.00011430 + #*EXTRAS*# Step: 2 Bead: 34 + 0.00011526 -0.00004435 -0.00004410 + -0.00004435 0.00011489 -0.00004403 + -0.00004410 -0.00004403 0.00011529 + #*EXTRAS*# Step: 3 Bead: 34 + 0.00011535 -0.00004437 -0.00004412 + -0.00004437 0.00011497 -0.00004404 + -0.00004412 -0.00004404 0.00011537 + #*EXTRAS*# Step: 4 Bead: 34 + 0.00011549 -0.00004441 -0.00004415 + -0.00004441 0.00011510 -0.00004407 + -0.00004415 -0.00004407 0.00011551 + #*EXTRAS*# Step: 5 Bead: 34 + 0.00011556 -0.00004442 -0.00004416 + -0.00004442 0.00011517 -0.00004408 + -0.00004416 -0.00004408 0.00011558 + #*EXTRAS*# Step: 6 Bead: 34 + 0.00011560 -0.00004443 -0.00004417 + -0.00004443 0.00011521 -0.00004409 + -0.00004417 -0.00004409 0.00011562 + #*EXTRAS*# Step: 7 Bead: 34 + 0.00011563 -0.00004444 -0.00004417 + -0.00004444 0.00011523 -0.00004409 + -0.00004417 -0.00004409 0.00011565 + #*EXTRAS*# Step: 8 Bead: 34 + 0.00011565 -0.00004445 -0.00004418 + -0.00004445 0.00011525 -0.00004409 + -0.00004418 -0.00004409 0.00011567 + #*EXTRAS*# Step: 9 Bead: 34 + 0.00011566 -0.00004445 -0.00004418 + -0.00004445 0.00011526 -0.00004409 + -0.00004418 -0.00004409 0.00011568 + #*EXTRAS*# Step: 10 Bead: 34 + 0.00011567 -0.00004445 -0.00004418 + -0.00004445 0.00011527 -0.00004410 + -0.00004418 -0.00004410 0.00011569 + #*EXTRAS*# Step: 11 Bead: 34 + 0.00011567 -0.00004445 -0.00004418 + -0.00004445 0.00011527 -0.00004410 + -0.00004418 -0.00004410 0.00011569 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 new file mode 100644 index 000000000..348e9ab64 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 35 + 0.00011217 -0.00004295 -0.00004298 + -0.00004295 0.00011212 -0.00004296 + -0.00004298 -0.00004296 0.00011223 + #*EXTRAS*# Step: 1 Bead: 35 + 0.00011365 -0.00004373 -0.00004363 + -0.00004373 0.00011345 -0.00004359 + -0.00004363 -0.00004359 0.00011370 + #*EXTRAS*# Step: 2 Bead: 35 + 0.00011477 -0.00004419 -0.00004398 + -0.00004419 0.00011445 -0.00004392 + -0.00004398 -0.00004392 0.00011480 + #*EXTRAS*# Step: 3 Bead: 35 + 0.00011492 -0.00004424 -0.00004402 + -0.00004424 0.00011458 -0.00004395 + -0.00004402 -0.00004395 0.00011495 + #*EXTRAS*# Step: 4 Bead: 35 + 0.00011510 -0.00004430 -0.00004406 + -0.00004430 0.00011474 -0.00004399 + -0.00004406 -0.00004399 0.00011512 + #*EXTRAS*# Step: 5 Bead: 35 + 0.00011519 -0.00004432 -0.00004408 + -0.00004432 0.00011482 -0.00004401 + -0.00004408 -0.00004401 0.00011521 + #*EXTRAS*# Step: 6 Bead: 35 + 0.00011524 -0.00004434 -0.00004409 + -0.00004434 0.00011488 -0.00004402 + -0.00004409 -0.00004402 0.00011527 + #*EXTRAS*# Step: 7 Bead: 35 + 0.00011528 -0.00004435 -0.00004410 + -0.00004435 0.00011491 -0.00004403 + -0.00004410 -0.00004403 0.00011530 + #*EXTRAS*# Step: 8 Bead: 35 + 0.00011530 -0.00004436 -0.00004411 + -0.00004436 0.00011493 -0.00004403 + -0.00004411 -0.00004403 0.00011533 + #*EXTRAS*# Step: 9 Bead: 35 + 0.00011532 -0.00004436 -0.00004411 + -0.00004436 0.00011494 -0.00004404 + -0.00004411 -0.00004404 0.00011534 + #*EXTRAS*# Step: 10 Bead: 35 + 0.00011533 -0.00004436 -0.00004411 + -0.00004436 0.00011495 -0.00004404 + -0.00004411 -0.00004404 0.00011535 + #*EXTRAS*# Step: 11 Bead: 35 + 0.00011533 -0.00004437 -0.00004411 + -0.00004437 0.00011496 -0.00004404 + -0.00004411 -0.00004404 0.00011536 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 new file mode 100644 index 000000000..e9864a1c6 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 36 + 0.00011145 -0.00004252 -0.00004258 + -0.00004252 0.00011145 -0.00004256 + -0.00004258 -0.00004256 0.00011152 + #*EXTRAS*# Step: 1 Bead: 36 + 0.00011307 -0.00004344 -0.00004340 + -0.00004344 0.00011293 -0.00004337 + -0.00004340 -0.00004337 0.00011311 + #*EXTRAS*# Step: 2 Bead: 36 + 0.00011429 -0.00004401 -0.00004384 + -0.00004401 0.00011402 -0.00004380 + -0.00004384 -0.00004380 0.00011433 + #*EXTRAS*# Step: 3 Bead: 36 + 0.00011450 -0.00004409 -0.00004391 + -0.00004409 0.00011420 -0.00004385 + -0.00004391 -0.00004385 0.00011454 + #*EXTRAS*# Step: 4 Bead: 36 + 0.00011471 -0.00004417 -0.00004396 + -0.00004417 0.00011439 -0.00004391 + -0.00004396 -0.00004391 0.00011474 + #*EXTRAS*# Step: 5 Bead: 36 + 0.00011482 -0.00004421 -0.00004399 + -0.00004421 0.00011449 -0.00004393 + -0.00004399 -0.00004393 0.00011485 + #*EXTRAS*# Step: 6 Bead: 36 + 0.00011489 -0.00004423 -0.00004401 + -0.00004423 0.00011455 -0.00004395 + -0.00004401 -0.00004395 0.00011492 + #*EXTRAS*# Step: 7 Bead: 36 + 0.00011494 -0.00004425 -0.00004402 + -0.00004425 0.00011459 -0.00004396 + -0.00004402 -0.00004396 0.00011496 + #*EXTRAS*# Step: 8 Bead: 36 + 0.00011496 -0.00004425 -0.00004403 + -0.00004425 0.00011462 -0.00004396 + -0.00004403 -0.00004396 0.00011499 + #*EXTRAS*# Step: 9 Bead: 36 + 0.00011498 -0.00004426 -0.00004403 + -0.00004426 0.00011464 -0.00004397 + -0.00004403 -0.00004397 0.00011501 + #*EXTRAS*# Step: 10 Bead: 36 + 0.00011499 -0.00004426 -0.00004404 + -0.00004426 0.00011465 -0.00004397 + -0.00004404 -0.00004397 0.00011502 + #*EXTRAS*# Step: 11 Bead: 36 + 0.00011500 -0.00004427 -0.00004404 + -0.00004427 0.00011465 -0.00004397 + -0.00004404 -0.00004397 0.00011503 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 new file mode 100644 index 000000000..4c105a6d7 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 37 + 0.00011076 -0.00004208 -0.00004216 + -0.00004208 0.00011078 -0.00004213 + -0.00004216 -0.00004213 0.00011084 + #*EXTRAS*# Step: 1 Bead: 37 + 0.00011250 -0.00004313 -0.00004314 + -0.00004313 0.00011242 -0.00004312 + -0.00004314 -0.00004312 0.00011255 + #*EXTRAS*# Step: 2 Bead: 37 + 0.00011383 -0.00004381 -0.00004369 + -0.00004381 0.00011360 -0.00004365 + -0.00004369 -0.00004365 0.00011387 + #*EXTRAS*# Step: 3 Bead: 37 + 0.00011409 -0.00004393 -0.00004378 + -0.00004393 0.00011384 -0.00004374 + -0.00004378 -0.00004374 0.00011413 + #*EXTRAS*# Step: 4 Bead: 37 + 0.00011434 -0.00004403 -0.00004386 + -0.00004403 0.00011405 -0.00004381 + -0.00004386 -0.00004381 0.00011437 + #*EXTRAS*# Step: 5 Bead: 37 + 0.00011447 -0.00004408 -0.00004390 + -0.00004408 0.00011417 -0.00004384 + -0.00004390 -0.00004384 0.00011450 + #*EXTRAS*# Step: 6 Bead: 37 + 0.00011455 -0.00004411 -0.00004392 + -0.00004411 0.00011424 -0.00004386 + -0.00004392 -0.00004386 0.00011458 + #*EXTRAS*# Step: 7 Bead: 37 + 0.00011460 -0.00004413 -0.00004393 + -0.00004413 0.00011429 -0.00004388 + -0.00004393 -0.00004388 0.00011463 + #*EXTRAS*# Step: 8 Bead: 37 + 0.00011463 -0.00004414 -0.00004394 + -0.00004414 0.00011432 -0.00004389 + -0.00004394 -0.00004389 0.00011466 + #*EXTRAS*# Step: 9 Bead: 37 + 0.00011465 -0.00004415 -0.00004395 + -0.00004415 0.00011434 -0.00004389 + -0.00004395 -0.00004389 0.00011469 + #*EXTRAS*# Step: 10 Bead: 37 + 0.00011467 -0.00004415 -0.00004395 + -0.00004415 0.00011435 -0.00004390 + -0.00004395 -0.00004390 0.00011470 + #*EXTRAS*# Step: 11 Bead: 37 + 0.00011468 -0.00004416 -0.00004396 + -0.00004416 0.00011436 -0.00004390 + -0.00004396 -0.00004390 0.00011471 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 new file mode 100644 index 000000000..439333822 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 38 + 0.00011010 -0.00004163 -0.00004170 + -0.00004163 0.00011012 -0.00004168 + -0.00004170 -0.00004168 0.00011018 + #*EXTRAS*# Step: 1 Bead: 38 + 0.00011194 -0.00004281 -0.00004286 + -0.00004281 0.00011191 -0.00004284 + -0.00004286 -0.00004284 0.00011201 + #*EXTRAS*# Step: 2 Bead: 38 + 0.00011337 -0.00004360 -0.00004352 + -0.00004360 0.00011320 -0.00004349 + -0.00004352 -0.00004349 0.00011342 + #*EXTRAS*# Step: 3 Bead: 38 + 0.00011370 -0.00004375 -0.00004365 + -0.00004375 0.00011349 -0.00004361 + -0.00004365 -0.00004361 0.00011374 + #*EXTRAS*# Step: 4 Bead: 38 + 0.00011397 -0.00004388 -0.00004374 + -0.00004388 0.00011373 -0.00004370 + -0.00004374 -0.00004370 0.00011401 + #*EXTRAS*# Step: 5 Bead: 38 + 0.00011412 -0.00004394 -0.00004379 + -0.00004394 0.00011386 -0.00004374 + -0.00004379 -0.00004374 0.00011416 + #*EXTRAS*# Step: 6 Bead: 38 + 0.00011421 -0.00004398 -0.00004382 + -0.00004398 0.00011394 -0.00004377 + -0.00004382 -0.00004377 0.00011425 + #*EXTRAS*# Step: 7 Bead: 38 + 0.00011427 -0.00004400 -0.00004384 + -0.00004400 0.00011400 -0.00004379 + -0.00004384 -0.00004379 0.00011431 + #*EXTRAS*# Step: 8 Bead: 38 + 0.00011431 -0.00004402 -0.00004385 + -0.00004402 0.00011403 -0.00004380 + -0.00004385 -0.00004380 0.00011434 + #*EXTRAS*# Step: 9 Bead: 38 + 0.00011433 -0.00004403 -0.00004386 + -0.00004403 0.00011405 -0.00004381 + -0.00004386 -0.00004381 0.00011437 + #*EXTRAS*# Step: 10 Bead: 38 + 0.00011435 -0.00004403 -0.00004386 + -0.00004403 0.00011407 -0.00004381 + -0.00004386 -0.00004381 0.00011439 + #*EXTRAS*# Step: 11 Bead: 38 + 0.00011436 -0.00004404 -0.00004387 + -0.00004404 0.00011408 -0.00004381 + -0.00004387 -0.00004381 0.00011440 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 new file mode 100644 index 000000000..1d99bdeb6 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 39 + 0.00010946 -0.00004117 -0.00004123 + -0.00004117 0.00010948 -0.00004120 + -0.00004123 -0.00004120 0.00010953 + #*EXTRAS*# Step: 1 Bead: 39 + 0.00011141 -0.00004249 -0.00004256 + -0.00004249 0.00011141 -0.00004254 + -0.00004256 -0.00004254 0.00011148 + #*EXTRAS*# Step: 2 Bead: 39 + 0.00011293 -0.00004337 -0.00004334 + -0.00004337 0.00011281 -0.00004331 + -0.00004334 -0.00004331 0.00011298 + #*EXTRAS*# Step: 3 Bead: 39 + 0.00011331 -0.00004357 -0.00004350 + -0.00004357 0.00011315 -0.00004347 + -0.00004350 -0.00004347 0.00011336 + #*EXTRAS*# Step: 4 Bead: 39 + 0.00011361 -0.00004371 -0.00004361 + -0.00004371 0.00011341 -0.00004358 + -0.00004361 -0.00004358 0.00011366 + #*EXTRAS*# Step: 5 Bead: 39 + 0.00011378 -0.00004379 -0.00004368 + -0.00004379 0.00011356 -0.00004364 + -0.00004368 -0.00004364 0.00011382 + #*EXTRAS*# Step: 6 Bead: 39 + 0.00011389 -0.00004384 -0.00004371 + -0.00004384 0.00011366 -0.00004367 + -0.00004371 -0.00004367 0.00011393 + #*EXTRAS*# Step: 7 Bead: 39 + 0.00011395 -0.00004387 -0.00004373 + -0.00004387 0.00011371 -0.00004369 + -0.00004373 -0.00004369 0.00011399 + #*EXTRAS*# Step: 8 Bead: 39 + 0.00011400 -0.00004389 -0.00004375 + -0.00004389 0.00011375 -0.00004371 + -0.00004375 -0.00004371 0.00011403 + #*EXTRAS*# Step: 9 Bead: 39 + 0.00011402 -0.00004390 -0.00004376 + -0.00004390 0.00011378 -0.00004372 + -0.00004376 -0.00004372 0.00011406 + #*EXTRAS*# Step: 10 Bead: 39 + 0.00011404 -0.00004391 -0.00004376 + -0.00004391 0.00011379 -0.00004372 + -0.00004376 -0.00004372 0.00011408 + #*EXTRAS*# Step: 11 Bead: 39 + 0.00011405 -0.00004391 -0.00004377 + -0.00004391 0.00011380 -0.00004372 + -0.00004377 -0.00004372 0.00011409 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 new file mode 100644 index 000000000..8dd3b4823 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 40 + 0.00010885 -0.00004069 -0.00004073 + -0.00004069 0.00010886 -0.00004071 + -0.00004073 -0.00004071 0.00010891 + #*EXTRAS*# Step: 1 Bead: 40 + 0.00011090 -0.00004217 -0.00004225 + -0.00004217 0.00011091 -0.00004222 + -0.00004225 -0.00004222 0.00011097 + #*EXTRAS*# Step: 2 Bead: 40 + 0.00011250 -0.00004314 -0.00004314 + -0.00004314 0.00011242 -0.00004312 + -0.00004314 -0.00004312 0.00011256 + #*EXTRAS*# Step: 3 Bead: 40 + 0.00011294 -0.00004337 -0.00004334 + -0.00004337 0.00011281 -0.00004332 + -0.00004334 -0.00004332 0.00011299 + #*EXTRAS*# Step: 4 Bead: 40 + 0.00011327 -0.00004355 -0.00004348 + -0.00004355 0.00011311 -0.00004345 + -0.00004348 -0.00004345 0.00011332 + #*EXTRAS*# Step: 5 Bead: 40 + 0.00011345 -0.00004364 -0.00004355 + -0.00004364 0.00011327 -0.00004352 + -0.00004355 -0.00004352 0.00011350 + #*EXTRAS*# Step: 6 Bead: 40 + 0.00011357 -0.00004369 -0.00004360 + -0.00004369 0.00011338 -0.00004356 + -0.00004360 -0.00004356 0.00011361 + #*EXTRAS*# Step: 7 Bead: 40 + 0.00011364 -0.00004373 -0.00004363 + -0.00004373 0.00011344 -0.00004359 + -0.00004363 -0.00004359 0.00011369 + #*EXTRAS*# Step: 8 Bead: 40 + 0.00011369 -0.00004375 -0.00004364 + -0.00004375 0.00011348 -0.00004361 + -0.00004364 -0.00004361 0.00011373 + #*EXTRAS*# Step: 9 Bead: 40 + 0.00011372 -0.00004376 -0.00004365 + -0.00004376 0.00011351 -0.00004362 + -0.00004365 -0.00004362 0.00011376 + #*EXTRAS*# Step: 10 Bead: 40 + 0.00011374 -0.00004377 -0.00004366 + -0.00004377 0.00011353 -0.00004362 + -0.00004366 -0.00004362 0.00011378 + #*EXTRAS*# Step: 11 Bead: 40 + 0.00011375 -0.00004378 -0.00004367 + -0.00004378 0.00011354 -0.00004363 + -0.00004367 -0.00004363 0.00011380 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 new file mode 100644 index 000000000..87466bf84 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 41 + 0.00010826 -0.00004021 -0.00004023 + -0.00004021 0.00010826 -0.00004022 + -0.00004023 -0.00004022 0.00010830 + #*EXTRAS*# Step: 1 Bead: 41 + 0.00011041 -0.00004184 -0.00004192 + -0.00004184 0.00011043 -0.00004189 + -0.00004192 -0.00004189 0.00011048 + #*EXTRAS*# Step: 2 Bead: 41 + 0.00011209 -0.00004290 -0.00004294 + -0.00004290 0.00011205 -0.00004292 + -0.00004294 -0.00004292 0.00011215 + #*EXTRAS*# Step: 3 Bead: 41 + 0.00011258 -0.00004318 -0.00004318 + -0.00004318 0.00011249 -0.00004316 + -0.00004318 -0.00004316 0.00011263 + #*EXTRAS*# Step: 4 Bead: 41 + 0.00011294 -0.00004337 -0.00004334 + -0.00004337 0.00011281 -0.00004332 + -0.00004334 -0.00004332 0.00011299 + #*EXTRAS*# Step: 5 Bead: 41 + 0.00011314 -0.00004348 -0.00004343 + -0.00004348 0.00011299 -0.00004340 + -0.00004343 -0.00004340 0.00011319 + #*EXTRAS*# Step: 6 Bead: 41 + 0.00011326 -0.00004354 -0.00004348 + -0.00004354 0.00011311 -0.00004345 + -0.00004348 -0.00004345 0.00011331 + #*EXTRAS*# Step: 7 Bead: 41 + 0.00011334 -0.00004358 -0.00004351 + -0.00004358 0.00011318 -0.00004348 + -0.00004351 -0.00004348 0.00011339 + #*EXTRAS*# Step: 8 Bead: 41 + 0.00011340 -0.00004361 -0.00004353 + -0.00004361 0.00011322 -0.00004350 + -0.00004353 -0.00004350 0.00011344 + #*EXTRAS*# Step: 9 Bead: 41 + 0.00011343 -0.00004362 -0.00004354 + -0.00004362 0.00011325 -0.00004351 + -0.00004354 -0.00004351 0.00011347 + #*EXTRAS*# Step: 10 Bead: 41 + 0.00011345 -0.00004363 -0.00004355 + -0.00004363 0.00011327 -0.00004352 + -0.00004355 -0.00004352 0.00011350 + #*EXTRAS*# Step: 11 Bead: 41 + 0.00011347 -0.00004364 -0.00004356 + -0.00004364 0.00011328 -0.00004353 + -0.00004356 -0.00004353 0.00011351 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 new file mode 100644 index 000000000..c3e7db5b4 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 42 + 0.00010769 -0.00003973 -0.00003972 + -0.00003973 0.00010769 -0.00003973 + -0.00003972 -0.00003973 0.00010770 + #*EXTRAS*# Step: 1 Bead: 42 + 0.00010993 -0.00004151 -0.00004158 + -0.00004151 0.00010996 -0.00004155 + -0.00004158 -0.00004155 0.00011001 + #*EXTRAS*# Step: 2 Bead: 42 + 0.00011169 -0.00004267 -0.00004272 + -0.00004267 0.00011168 -0.00004270 + -0.00004272 -0.00004270 0.00011176 + #*EXTRAS*# Step: 3 Bead: 42 + 0.00011223 -0.00004298 -0.00004301 + -0.00004298 0.00011217 -0.00004299 + -0.00004301 -0.00004299 0.00011229 + #*EXTRAS*# Step: 4 Bead: 42 + 0.00011261 -0.00004320 -0.00004320 + -0.00004320 0.00011252 -0.00004317 + -0.00004320 -0.00004317 0.00011267 + #*EXTRAS*# Step: 5 Bead: 42 + 0.00011283 -0.00004332 -0.00004330 + -0.00004332 0.00011272 -0.00004327 + -0.00004330 -0.00004327 0.00011288 + #*EXTRAS*# Step: 6 Bead: 42 + 0.00011297 -0.00004339 -0.00004336 + -0.00004339 0.00011284 -0.00004333 + -0.00004336 -0.00004333 0.00011302 + #*EXTRAS*# Step: 7 Bead: 42 + 0.00011306 -0.00004344 -0.00004339 + -0.00004344 0.00011292 -0.00004337 + -0.00004339 -0.00004337 0.00011310 + #*EXTRAS*# Step: 8 Bead: 42 + 0.00011311 -0.00004346 -0.00004342 + -0.00004346 0.00011297 -0.00004339 + -0.00004342 -0.00004339 0.00011316 + #*EXTRAS*# Step: 9 Bead: 42 + 0.00011315 -0.00004348 -0.00004343 + -0.00004348 0.00011300 -0.00004340 + -0.00004343 -0.00004340 0.00011319 + #*EXTRAS*# Step: 10 Bead: 42 + 0.00011317 -0.00004349 -0.00004344 + -0.00004349 0.00011302 -0.00004341 + -0.00004344 -0.00004341 0.00011322 + #*EXTRAS*# Step: 11 Bead: 42 + 0.00011319 -0.00004350 -0.00004345 + -0.00004350 0.00011303 -0.00004342 + -0.00004345 -0.00004342 0.00011323 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 new file mode 100644 index 000000000..dc58becf7 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 43 + 0.00010715 -0.00003923 -0.00003921 + -0.00003923 0.00010715 -0.00003925 + -0.00003921 -0.00003925 0.00010712 + #*EXTRAS*# Step: 1 Bead: 43 + 0.00010948 -0.00004118 -0.00004124 + -0.00004118 0.00010950 -0.00004121 + -0.00004124 -0.00004121 0.00010955 + #*EXTRAS*# Step: 2 Bead: 43 + 0.00011131 -0.00004243 -0.00004250 + -0.00004243 0.00011131 -0.00004248 + -0.00004250 -0.00004248 0.00011138 + #*EXTRAS*# Step: 3 Bead: 43 + 0.00011189 -0.00004278 -0.00004283 + -0.00004278 0.00011186 -0.00004281 + -0.00004283 -0.00004281 0.00011196 + #*EXTRAS*# Step: 4 Bead: 43 + 0.00011231 -0.00004302 -0.00004305 + -0.00004302 0.00011224 -0.00004303 + -0.00004305 -0.00004303 0.00011236 + #*EXTRAS*# Step: 5 Bead: 43 + 0.00011254 -0.00004316 -0.00004316 + -0.00004316 0.00011246 -0.00004314 + -0.00004316 -0.00004314 0.00011259 + #*EXTRAS*# Step: 6 Bead: 43 + 0.00011268 -0.00004324 -0.00004323 + -0.00004324 0.00011259 -0.00004321 + -0.00004323 -0.00004321 0.00011274 + #*EXTRAS*# Step: 7 Bead: 43 + 0.00011278 -0.00004329 -0.00004327 + -0.00004329 0.00011267 -0.00004325 + -0.00004327 -0.00004325 0.00011283 + #*EXTRAS*# Step: 8 Bead: 43 + 0.00011284 -0.00004332 -0.00004330 + -0.00004332 0.00011272 -0.00004327 + -0.00004330 -0.00004327 0.00011289 + #*EXTRAS*# Step: 9 Bead: 43 + 0.00011287 -0.00004334 -0.00004331 + -0.00004334 0.00011276 -0.00004329 + -0.00004331 -0.00004329 0.00011293 + #*EXTRAS*# Step: 10 Bead: 43 + 0.00011290 -0.00004335 -0.00004333 + -0.00004335 0.00011278 -0.00004330 + -0.00004333 -0.00004330 0.00011295 + #*EXTRAS*# Step: 11 Bead: 43 + 0.00011292 -0.00004336 -0.00004333 + -0.00004336 0.00011279 -0.00004331 + -0.00004333 -0.00004331 0.00011297 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 new file mode 100644 index 000000000..7c3778b4d --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 44 + 0.00010664 -0.00003874 -0.00003871 + -0.00003874 0.00010664 -0.00003877 + -0.00003871 -0.00003877 0.00010656 + #*EXTRAS*# Step: 1 Bead: 44 + 0.00010905 -0.00004085 -0.00004090 + -0.00004085 0.00010906 -0.00004087 + -0.00004090 -0.00004087 0.00010911 + #*EXTRAS*# Step: 2 Bead: 44 + 0.00011095 -0.00004220 -0.00004228 + -0.00004220 0.00011096 -0.00004225 + -0.00004228 -0.00004225 0.00011102 + #*EXTRAS*# Step: 3 Bead: 44 + 0.00011157 -0.00004259 -0.00004265 + -0.00004259 0.00011156 -0.00004263 + -0.00004265 -0.00004263 0.00011164 + #*EXTRAS*# Step: 4 Bead: 44 + 0.00011201 -0.00004285 -0.00004289 + -0.00004285 0.00011197 -0.00004288 + -0.00004289 -0.00004288 0.00011207 + #*EXTRAS*# Step: 5 Bead: 44 + 0.00011226 -0.00004300 -0.00004302 + -0.00004300 0.00011220 -0.00004300 + -0.00004302 -0.00004300 0.00011232 + #*EXTRAS*# Step: 6 Bead: 44 + 0.00011241 -0.00004309 -0.00004310 + -0.00004309 0.00011234 -0.00004308 + -0.00004310 -0.00004308 0.00011247 + #*EXTRAS*# Step: 7 Bead: 44 + 0.00011251 -0.00004314 -0.00004315 + -0.00004314 0.00011243 -0.00004313 + -0.00004315 -0.00004313 0.00011256 + #*EXTRAS*# Step: 8 Bead: 44 + 0.00011257 -0.00004317 -0.00004318 + -0.00004317 0.00011249 -0.00004315 + -0.00004318 -0.00004315 0.00011263 + #*EXTRAS*# Step: 9 Bead: 44 + 0.00011261 -0.00004320 -0.00004320 + -0.00004320 0.00011252 -0.00004317 + -0.00004320 -0.00004317 0.00011267 + #*EXTRAS*# Step: 10 Bead: 44 + 0.00011264 -0.00004321 -0.00004321 + -0.00004321 0.00011255 -0.00004319 + -0.00004321 -0.00004319 0.00011269 + #*EXTRAS*# Step: 11 Bead: 44 + 0.00011266 -0.00004322 -0.00004322 + -0.00004322 0.00011256 -0.00004319 + -0.00004322 -0.00004319 0.00011271 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 new file mode 100644 index 000000000..d03a35aa1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 45 + 0.00010616 -0.00003826 -0.00003821 + -0.00003826 0.00010615 -0.00003831 + -0.00003821 -0.00003831 0.00010603 + #*EXTRAS*# Step: 1 Bead: 45 + 0.00010863 -0.00004052 -0.00004055 + -0.00004052 0.00010865 -0.00004053 + -0.00004055 -0.00004053 0.00010869 + #*EXTRAS*# Step: 2 Bead: 45 + 0.00011060 -0.00004197 -0.00004205 + -0.00004197 0.00011062 -0.00004202 + -0.00004205 -0.00004202 0.00011067 + #*EXTRAS*# Step: 3 Bead: 45 + 0.00011126 -0.00004240 -0.00004247 + -0.00004240 0.00011127 -0.00004245 + -0.00004247 -0.00004245 0.00011134 + #*EXTRAS*# Step: 4 Bead: 45 + 0.00011172 -0.00004268 -0.00004274 + -0.00004268 0.00011171 -0.00004272 + -0.00004274 -0.00004272 0.00011179 + #*EXTRAS*# Step: 5 Bead: 45 + 0.00011199 -0.00004284 -0.00004288 + -0.00004284 0.00011195 -0.00004286 + -0.00004288 -0.00004286 0.00011205 + #*EXTRAS*# Step: 6 Bead: 45 + 0.00011215 -0.00004294 -0.00004297 + -0.00004294 0.00011210 -0.00004295 + -0.00004297 -0.00004295 0.00011221 + #*EXTRAS*# Step: 7 Bead: 45 + 0.00011225 -0.00004299 -0.00004302 + -0.00004299 0.00011220 -0.00004300 + -0.00004302 -0.00004300 0.00011231 + #*EXTRAS*# Step: 8 Bead: 45 + 0.00011232 -0.00004303 -0.00004305 + -0.00004303 0.00011226 -0.00004303 + -0.00004305 -0.00004303 0.00011238 + #*EXTRAS*# Step: 9 Bead: 45 + 0.00011236 -0.00004306 -0.00004307 + -0.00004306 0.00011230 -0.00004305 + -0.00004307 -0.00004305 0.00011242 + #*EXTRAS*# Step: 10 Bead: 45 + 0.00011239 -0.00004307 -0.00004309 + -0.00004307 0.00011232 -0.00004307 + -0.00004309 -0.00004307 0.00011245 + #*EXTRAS*# Step: 11 Bead: 45 + 0.00011241 -0.00004308 -0.00004310 + -0.00004308 0.00011234 -0.00004308 + -0.00004310 -0.00004308 0.00011247 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 new file mode 100644 index 000000000..fb7af2cb0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 46 + 0.00010571 -0.00003778 -0.00003773 + -0.00003778 0.00010570 -0.00003786 + -0.00003773 -0.00003786 0.00010554 + #*EXTRAS*# Step: 1 Bead: 46 + 0.00010824 -0.00004020 -0.00004022 + -0.00004020 0.00010825 -0.00004020 + -0.00004022 -0.00004020 0.00010828 + #*EXTRAS*# Step: 2 Bead: 46 + 0.00011026 -0.00004174 -0.00004182 + -0.00004174 0.00011029 -0.00004179 + -0.00004182 -0.00004179 0.00011034 + #*EXTRAS*# Step: 3 Bead: 46 + 0.00011097 -0.00004221 -0.00004229 + -0.00004221 0.00011098 -0.00004227 + -0.00004229 -0.00004227 0.00011105 + #*EXTRAS*# Step: 4 Bead: 46 + 0.00011145 -0.00004252 -0.00004258 + -0.00004252 0.00011145 -0.00004257 + -0.00004258 -0.00004257 0.00011152 + #*EXTRAS*# Step: 5 Bead: 46 + 0.00011173 -0.00004269 -0.00004274 + -0.00004269 0.00011171 -0.00004272 + -0.00004274 -0.00004272 0.00011179 + #*EXTRAS*# Step: 6 Bead: 46 + 0.00011190 -0.00004279 -0.00004284 + -0.00004279 0.00011187 -0.00004282 + -0.00004284 -0.00004282 0.00011196 + #*EXTRAS*# Step: 7 Bead: 46 + 0.00011201 -0.00004285 -0.00004289 + -0.00004285 0.00011197 -0.00004288 + -0.00004289 -0.00004288 0.00011207 + #*EXTRAS*# Step: 8 Bead: 46 + 0.00011208 -0.00004289 -0.00004293 + -0.00004289 0.00011204 -0.00004291 + -0.00004293 -0.00004291 0.00011214 + #*EXTRAS*# Step: 9 Bead: 46 + 0.00011212 -0.00004292 -0.00004295 + -0.00004292 0.00011208 -0.00004294 + -0.00004295 -0.00004294 0.00011218 + #*EXTRAS*# Step: 10 Bead: 46 + 0.00011215 -0.00004294 -0.00004297 + -0.00004294 0.00011210 -0.00004295 + -0.00004297 -0.00004295 0.00011221 + #*EXTRAS*# Step: 11 Bead: 46 + 0.00011217 -0.00004295 -0.00004298 + -0.00004295 0.00011212 -0.00004296 + -0.00004298 -0.00004296 0.00011223 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 new file mode 100644 index 000000000..b9d92fdd2 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 47 + 0.00010529 -0.00003732 -0.00003726 + -0.00003732 0.00010529 -0.00003742 + -0.00003726 -0.00003742 0.00010507 + #*EXTRAS*# Step: 1 Bead: 47 + 0.00010787 -0.00003988 -0.00003988 + -0.00003988 0.00010787 -0.00003988 + -0.00003988 -0.00003988 0.00010789 + #*EXTRAS*# Step: 2 Bead: 47 + 0.00010995 -0.00004152 -0.00004159 + -0.00004152 0.00010997 -0.00004157 + -0.00004159 -0.00004157 0.00011003 + #*EXTRAS*# Step: 3 Bead: 47 + 0.00011069 -0.00004203 -0.00004211 + -0.00004203 0.00011071 -0.00004209 + -0.00004211 -0.00004209 0.00011077 + #*EXTRAS*# Step: 4 Bead: 47 + 0.00011120 -0.00004236 -0.00004243 + -0.00004236 0.00011120 -0.00004241 + -0.00004243 -0.00004241 0.00011127 + #*EXTRAS*# Step: 5 Bead: 47 + 0.00011148 -0.00004254 -0.00004260 + -0.00004254 0.00011148 -0.00004258 + -0.00004260 -0.00004258 0.00011155 + #*EXTRAS*# Step: 6 Bead: 47 + 0.00011166 -0.00004265 -0.00004271 + -0.00004265 0.00011165 -0.00004269 + -0.00004271 -0.00004269 0.00011173 + #*EXTRAS*# Step: 7 Bead: 47 + 0.00011178 -0.00004272 -0.00004277 + -0.00004272 0.00011175 -0.00004275 + -0.00004277 -0.00004275 0.00011184 + #*EXTRAS*# Step: 8 Bead: 47 + 0.00011185 -0.00004276 -0.00004281 + -0.00004276 0.00011182 -0.00004279 + -0.00004281 -0.00004279 0.00011191 + #*EXTRAS*# Step: 9 Bead: 47 + 0.00011190 -0.00004279 -0.00004283 + -0.00004279 0.00011187 -0.00004282 + -0.00004283 -0.00004282 0.00011196 + #*EXTRAS*# Step: 10 Bead: 47 + 0.00011193 -0.00004281 -0.00004285 + -0.00004281 0.00011190 -0.00004283 + -0.00004285 -0.00004283 0.00011199 + #*EXTRAS*# Step: 11 Bead: 47 + 0.00011195 -0.00004282 -0.00004286 + -0.00004282 0.00011191 -0.00004284 + -0.00004286 -0.00004284 0.00011201 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 new file mode 100644 index 000000000..57ebaf0c8 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 48 + 0.00010490 -0.00003687 -0.00003681 + -0.00003687 0.00010490 -0.00003699 + -0.00003681 -0.00003699 0.00010465 + #*EXTRAS*# Step: 1 Bead: 48 + 0.00010752 -0.00003957 -0.00003956 + -0.00003957 0.00010752 -0.00003958 + -0.00003956 -0.00003958 0.00010751 + #*EXTRAS*# Step: 2 Bead: 48 + 0.00010965 -0.00004131 -0.00004137 + -0.00004131 0.00010967 -0.00004134 + -0.00004137 -0.00004134 0.00010972 + #*EXTRAS*# Step: 3 Bead: 48 + 0.00011043 -0.00004186 -0.00004193 + -0.00004186 0.00011045 -0.00004191 + -0.00004193 -0.00004191 0.00011051 + #*EXTRAS*# Step: 4 Bead: 48 + 0.00011095 -0.00004220 -0.00004228 + -0.00004220 0.00011097 -0.00004226 + -0.00004228 -0.00004226 0.00011103 + #*EXTRAS*# Step: 5 Bead: 48 + 0.00011125 -0.00004239 -0.00004247 + -0.00004239 0.00011126 -0.00004244 + -0.00004247 -0.00004244 0.00011132 + #*EXTRAS*# Step: 6 Bead: 48 + 0.00011144 -0.00004251 -0.00004258 + -0.00004251 0.00011143 -0.00004256 + -0.00004258 -0.00004256 0.00011151 + #*EXTRAS*# Step: 7 Bead: 48 + 0.00011156 -0.00004258 -0.00004264 + -0.00004258 0.00011155 -0.00004263 + -0.00004264 -0.00004263 0.00011162 + #*EXTRAS*# Step: 8 Bead: 48 + 0.00011163 -0.00004263 -0.00004269 + -0.00004263 0.00011162 -0.00004267 + -0.00004269 -0.00004267 0.00011170 + #*EXTRAS*# Step: 9 Bead: 48 + 0.00011168 -0.00004266 -0.00004272 + -0.00004266 0.00011166 -0.00004270 + -0.00004272 -0.00004270 0.00011175 + #*EXTRAS*# Step: 10 Bead: 48 + 0.00011171 -0.00004268 -0.00004273 + -0.00004268 0.00011169 -0.00004271 + -0.00004273 -0.00004271 0.00011178 + #*EXTRAS*# Step: 11 Bead: 48 + 0.00011173 -0.00004269 -0.00004275 + -0.00004269 0.00011172 -0.00004273 + -0.00004275 -0.00004273 0.00011180 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 new file mode 100644 index 000000000..82e38da1f --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 49 + 0.00010455 -0.00003644 -0.00003638 + -0.00003644 0.00010454 -0.00003659 + -0.00003638 -0.00003659 0.00010425 + #*EXTRAS*# Step: 1 Bead: 49 + 0.00010719 -0.00003927 -0.00003925 + -0.00003927 0.00010719 -0.00003928 + -0.00003925 -0.00003928 0.00010716 + #*EXTRAS*# Step: 2 Bead: 49 + 0.00010937 -0.00004110 -0.00004115 + -0.00004110 0.00010939 -0.00004113 + -0.00004115 -0.00004113 0.00010944 + #*EXTRAS*# Step: 3 Bead: 49 + 0.00011018 -0.00004168 -0.00004176 + -0.00004168 0.00011021 -0.00004173 + -0.00004176 -0.00004173 0.00011026 + #*EXTRAS*# Step: 4 Bead: 49 + 0.00011072 -0.00004205 -0.00004213 + -0.00004205 0.00011074 -0.00004211 + -0.00004213 -0.00004211 0.00011080 + #*EXTRAS*# Step: 5 Bead: 49 + 0.00011103 -0.00004225 -0.00004233 + -0.00004225 0.00011105 -0.00004231 + -0.00004233 -0.00004231 0.00011111 + #*EXTRAS*# Step: 6 Bead: 49 + 0.00011123 -0.00004238 -0.00004245 + -0.00004238 0.00011123 -0.00004243 + -0.00004245 -0.00004243 0.00011130 + #*EXTRAS*# Step: 7 Bead: 49 + 0.00011135 -0.00004245 -0.00004252 + -0.00004245 0.00011135 -0.00004250 + -0.00004252 -0.00004250 0.00011142 + #*EXTRAS*# Step: 8 Bead: 49 + 0.00011143 -0.00004250 -0.00004257 + -0.00004250 0.00011142 -0.00004255 + -0.00004257 -0.00004255 0.00011150 + #*EXTRAS*# Step: 9 Bead: 49 + 0.00011148 -0.00004253 -0.00004260 + -0.00004253 0.00011147 -0.00004258 + -0.00004260 -0.00004258 0.00011155 + #*EXTRAS*# Step: 10 Bead: 49 + 0.00011151 -0.00004255 -0.00004262 + -0.00004255 0.00011150 -0.00004260 + -0.00004262 -0.00004260 0.00011158 + #*EXTRAS*# Step: 11 Bead: 49 + 0.00011153 -0.00004257 -0.00004263 + -0.00004257 0.00011153 -0.00004261 + -0.00004263 -0.00004261 0.00011160 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 new file mode 100644 index 000000000..480adba2c --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 50 + 0.00010422 -0.00003604 -0.00003597 + -0.00003604 0.00010422 -0.00003619 + -0.00003597 -0.00003619 0.00010390 + #*EXTRAS*# Step: 1 Bead: 50 + 0.00010688 -0.00003898 -0.00003895 + -0.00003898 0.00010688 -0.00003900 + -0.00003895 -0.00003900 0.00010683 + #*EXTRAS*# Step: 2 Bead: 50 + 0.00010910 -0.00004090 -0.00004094 + -0.00004090 0.00010912 -0.00004092 + -0.00004094 -0.00004092 0.00010917 + #*EXTRAS*# Step: 3 Bead: 50 + 0.00010995 -0.00004152 -0.00004159 + -0.00004152 0.00010997 -0.00004156 + -0.00004159 -0.00004156 0.00011002 + #*EXTRAS*# Step: 4 Bead: 50 + 0.00011051 -0.00004191 -0.00004199 + -0.00004191 0.00011053 -0.00004196 + -0.00004199 -0.00004196 0.00011058 + #*EXTRAS*# Step: 5 Bead: 50 + 0.00011083 -0.00004212 -0.00004220 + -0.00004212 0.00011085 -0.00004218 + -0.00004220 -0.00004218 0.00011090 + #*EXTRAS*# Step: 6 Bead: 50 + 0.00011103 -0.00004225 -0.00004233 + -0.00004225 0.00011104 -0.00004231 + -0.00004233 -0.00004231 0.00011110 + #*EXTRAS*# Step: 7 Bead: 50 + 0.00011115 -0.00004233 -0.00004241 + -0.00004233 0.00011116 -0.00004238 + -0.00004241 -0.00004238 0.00011123 + #*EXTRAS*# Step: 8 Bead: 50 + 0.00011124 -0.00004238 -0.00004245 + -0.00004238 0.00011124 -0.00004243 + -0.00004245 -0.00004243 0.00011131 + #*EXTRAS*# Step: 9 Bead: 50 + 0.00011129 -0.00004242 -0.00004249 + -0.00004242 0.00011129 -0.00004247 + -0.00004249 -0.00004247 0.00011136 + #*EXTRAS*# Step: 10 Bead: 50 + 0.00011132 -0.00004244 -0.00004251 + -0.00004244 0.00011132 -0.00004249 + -0.00004251 -0.00004249 0.00011139 + #*EXTRAS*# Step: 11 Bead: 50 + 0.00011135 -0.00004245 -0.00004252 + -0.00004245 0.00011135 -0.00004250 + -0.00004252 -0.00004250 0.00011142 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 new file mode 100644 index 000000000..8aa146f06 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 51 + 0.00010393 -0.00003565 -0.00003558 + -0.00003565 0.00010392 -0.00003582 + -0.00003558 -0.00003582 0.00010358 + #*EXTRAS*# Step: 1 Bead: 51 + 0.00010660 -0.00003870 -0.00003866 + -0.00003870 0.00010659 -0.00003873 + -0.00003866 -0.00003873 0.00010652 + #*EXTRAS*# Step: 2 Bead: 51 + 0.00010886 -0.00004070 -0.00004074 + -0.00004070 0.00010887 -0.00004072 + -0.00004074 -0.00004072 0.00010892 + #*EXTRAS*# Step: 3 Bead: 51 + 0.00010973 -0.00004136 -0.00004143 + -0.00004136 0.00010975 -0.00004140 + -0.00004143 -0.00004140 0.00010981 + #*EXTRAS*# Step: 4 Bead: 51 + 0.00011031 -0.00004177 -0.00004185 + -0.00004177 0.00011033 -0.00004182 + -0.00004185 -0.00004182 0.00011038 + #*EXTRAS*# Step: 5 Bead: 51 + 0.00011064 -0.00004200 -0.00004207 + -0.00004200 0.00011066 -0.00004205 + -0.00004207 -0.00004205 0.00011071 + #*EXTRAS*# Step: 6 Bead: 51 + 0.00011084 -0.00004213 -0.00004221 + -0.00004213 0.00011086 -0.00004219 + -0.00004221 -0.00004219 0.00011092 + #*EXTRAS*# Step: 7 Bead: 51 + 0.00011097 -0.00004222 -0.00004229 + -0.00004222 0.00011099 -0.00004227 + -0.00004229 -0.00004227 0.00011105 + #*EXTRAS*# Step: 8 Bead: 51 + 0.00011106 -0.00004227 -0.00004234 + -0.00004227 0.00011107 -0.00004232 + -0.00004234 -0.00004232 0.00011113 + #*EXTRAS*# Step: 9 Bead: 51 + 0.00011111 -0.00004230 -0.00004238 + -0.00004230 0.00011112 -0.00004236 + -0.00004238 -0.00004236 0.00011118 + #*EXTRAS*# Step: 10 Bead: 51 + 0.00011115 -0.00004233 -0.00004240 + -0.00004233 0.00011115 -0.00004238 + -0.00004240 -0.00004238 0.00011122 + #*EXTRAS*# Step: 11 Bead: 51 + 0.00011117 -0.00004234 -0.00004241 + -0.00004234 0.00011118 -0.00004239 + -0.00004241 -0.00004239 0.00011124 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 new file mode 100644 index 000000000..2f2ef6334 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 52 + 0.00010366 -0.00003529 -0.00003522 + -0.00003529 0.00010365 -0.00003547 + -0.00003522 -0.00003547 0.00010329 + #*EXTRAS*# Step: 1 Bead: 52 + 0.00010634 -0.00003844 -0.00003839 + -0.00003844 0.00010633 -0.00003848 + -0.00003839 -0.00003848 0.00010623 + #*EXTRAS*# Step: 2 Bead: 52 + 0.00010863 -0.00004052 -0.00004055 + -0.00004052 0.00010864 -0.00004053 + -0.00004055 -0.00004053 0.00010868 + #*EXTRAS*# Step: 3 Bead: 52 + 0.00010953 -0.00004122 -0.00004128 + -0.00004122 0.00010955 -0.00004125 + -0.00004128 -0.00004125 0.00010960 + #*EXTRAS*# Step: 4 Bead: 52 + 0.00011012 -0.00004164 -0.00004172 + -0.00004164 0.00011014 -0.00004169 + -0.00004172 -0.00004169 0.00011020 + #*EXTRAS*# Step: 5 Bead: 52 + 0.00011046 -0.00004188 -0.00004195 + -0.00004188 0.00011048 -0.00004193 + -0.00004195 -0.00004193 0.00011054 + #*EXTRAS*# Step: 6 Bead: 52 + 0.00011067 -0.00004202 -0.00004210 + -0.00004202 0.00011069 -0.00004207 + -0.00004210 -0.00004207 0.00011075 + #*EXTRAS*# Step: 7 Bead: 52 + 0.00011080 -0.00004211 -0.00004218 + -0.00004211 0.00011082 -0.00004216 + -0.00004218 -0.00004216 0.00011088 + #*EXTRAS*# Step: 8 Bead: 52 + 0.00011089 -0.00004216 -0.00004224 + -0.00004216 0.00011091 -0.00004222 + -0.00004224 -0.00004222 0.00011096 + #*EXTRAS*# Step: 9 Bead: 52 + 0.00011095 -0.00004220 -0.00004227 + -0.00004220 0.00011096 -0.00004225 + -0.00004227 -0.00004225 0.00011102 + #*EXTRAS*# Step: 10 Bead: 52 + 0.00011098 -0.00004222 -0.00004230 + -0.00004222 0.00011099 -0.00004228 + -0.00004230 -0.00004228 0.00011106 + #*EXTRAS*# Step: 11 Bead: 52 + 0.00011101 -0.00004224 -0.00004231 + -0.00004224 0.00011102 -0.00004229 + -0.00004231 -0.00004229 0.00011108 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 new file mode 100644 index 000000000..215993bc2 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 53 + 0.00010343 -0.00003495 -0.00003489 + -0.00003495 0.00010341 -0.00003514 + -0.00003489 -0.00003514 0.00010304 + #*EXTRAS*# Step: 1 Bead: 53 + 0.00010610 -0.00003820 -0.00003814 + -0.00003820 0.00010609 -0.00003825 + -0.00003814 -0.00003825 0.00010597 + #*EXTRAS*# Step: 2 Bead: 53 + 0.00010842 -0.00004035 -0.00004037 + -0.00004035 0.00010843 -0.00004036 + -0.00004037 -0.00004036 0.00010847 + #*EXTRAS*# Step: 3 Bead: 53 + 0.00010934 -0.00004108 -0.00004113 + -0.00004108 0.00010936 -0.00004111 + -0.00004113 -0.00004111 0.00010941 + #*EXTRAS*# Step: 4 Bead: 53 + 0.00010995 -0.00004152 -0.00004159 + -0.00004152 0.00010997 -0.00004156 + -0.00004159 -0.00004156 0.00011002 + #*EXTRAS*# Step: 5 Bead: 53 + 0.00011030 -0.00004177 -0.00004184 + -0.00004177 0.00011032 -0.00004182 + -0.00004184 -0.00004182 0.00011037 + #*EXTRAS*# Step: 6 Bead: 53 + 0.00011051 -0.00004191 -0.00004199 + -0.00004191 0.00011054 -0.00004197 + -0.00004199 -0.00004197 0.00011059 + #*EXTRAS*# Step: 7 Bead: 53 + 0.00011065 -0.00004200 -0.00004208 + -0.00004200 0.00011067 -0.00004206 + -0.00004208 -0.00004206 0.00011073 + #*EXTRAS*# Step: 8 Bead: 53 + 0.00011074 -0.00004206 -0.00004214 + -0.00004206 0.00011076 -0.00004212 + -0.00004214 -0.00004212 0.00011081 + #*EXTRAS*# Step: 9 Bead: 53 + 0.00011079 -0.00004210 -0.00004218 + -0.00004210 0.00011081 -0.00004215 + -0.00004218 -0.00004215 0.00011087 + #*EXTRAS*# Step: 10 Bead: 53 + 0.00011083 -0.00004212 -0.00004220 + -0.00004212 0.00011085 -0.00004218 + -0.00004220 -0.00004218 0.00011091 + #*EXTRAS*# Step: 11 Bead: 53 + 0.00011086 -0.00004214 -0.00004222 + -0.00004214 0.00011087 -0.00004219 + -0.00004222 -0.00004219 0.00011093 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 new file mode 100644 index 000000000..c921bcee0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 54 + 0.00010322 -0.00003464 -0.00003459 + -0.00003464 0.00010320 -0.00003483 + -0.00003459 -0.00003483 0.00010282 + #*EXTRAS*# Step: 1 Bead: 54 + 0.00010588 -0.00003797 -0.00003791 + -0.00003797 0.00010588 -0.00003803 + -0.00003791 -0.00003803 0.00010573 + #*EXTRAS*# Step: 2 Bead: 54 + 0.00010823 -0.00004019 -0.00004020 + -0.00004019 0.00010823 -0.00004019 + -0.00004020 -0.00004019 0.00010827 + #*EXTRAS*# Step: 3 Bead: 54 + 0.00010917 -0.00004095 -0.00004100 + -0.00004095 0.00010919 -0.00004097 + -0.00004100 -0.00004097 0.00010924 + #*EXTRAS*# Step: 4 Bead: 54 + 0.00010979 -0.00004141 -0.00004148 + -0.00004141 0.00010982 -0.00004145 + -0.00004148 -0.00004145 0.00010987 + #*EXTRAS*# Step: 5 Bead: 54 + 0.00011015 -0.00004166 -0.00004174 + -0.00004166 0.00011017 -0.00004171 + -0.00004174 -0.00004171 0.00011023 + #*EXTRAS*# Step: 6 Bead: 54 + 0.00011037 -0.00004181 -0.00004189 + -0.00004181 0.00011039 -0.00004187 + -0.00004189 -0.00004187 0.00011045 + #*EXTRAS*# Step: 7 Bead: 54 + 0.00011051 -0.00004191 -0.00004199 + -0.00004191 0.00011053 -0.00004196 + -0.00004199 -0.00004196 0.00011058 + #*EXTRAS*# Step: 8 Bead: 54 + 0.00011060 -0.00004197 -0.00004205 + -0.00004197 0.00011062 -0.00004202 + -0.00004205 -0.00004202 0.00011067 + #*EXTRAS*# Step: 9 Bead: 54 + 0.00011066 -0.00004201 -0.00004209 + -0.00004201 0.00011068 -0.00004206 + -0.00004209 -0.00004206 0.00011073 + #*EXTRAS*# Step: 10 Bead: 54 + 0.00011069 -0.00004203 -0.00004211 + -0.00004203 0.00011071 -0.00004209 + -0.00004211 -0.00004209 0.00011077 + #*EXTRAS*# Step: 11 Bead: 54 + 0.00011072 -0.00004205 -0.00004213 + -0.00004205 0.00011074 -0.00004210 + -0.00004213 -0.00004210 0.00011079 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 new file mode 100644 index 000000000..bd8a7fc4c --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 55 + 0.00010303 -0.00003435 -0.00003431 + -0.00003435 0.00010301 -0.00003455 + -0.00003431 -0.00003455 0.00010262 + #*EXTRAS*# Step: 1 Bead: 55 + 0.00010569 -0.00003776 -0.00003770 + -0.00003776 0.00010568 -0.00003784 + -0.00003770 -0.00003784 0.00010551 + #*EXTRAS*# Step: 2 Bead: 55 + 0.00010806 -0.00004004 -0.00004005 + -0.00004004 0.00010806 -0.00004005 + -0.00004005 -0.00004005 0.00010808 + #*EXTRAS*# Step: 3 Bead: 55 + 0.00010902 -0.00004083 -0.00004088 + -0.00004083 0.00010904 -0.00004085 + -0.00004088 -0.00004085 0.00010909 + #*EXTRAS*# Step: 4 Bead: 55 + 0.00010965 -0.00004131 -0.00004137 + -0.00004131 0.00010967 -0.00004134 + -0.00004137 -0.00004134 0.00010972 + #*EXTRAS*# Step: 5 Bead: 55 + 0.00011001 -0.00004157 -0.00004164 + -0.00004157 0.00011004 -0.00004161 + -0.00004164 -0.00004161 0.00011009 + #*EXTRAS*# Step: 6 Bead: 55 + 0.00011024 -0.00004172 -0.00004180 + -0.00004172 0.00011026 -0.00004177 + -0.00004180 -0.00004177 0.00011032 + #*EXTRAS*# Step: 7 Bead: 55 + 0.00011038 -0.00004182 -0.00004190 + -0.00004182 0.00011040 -0.00004187 + -0.00004190 -0.00004187 0.00011046 + #*EXTRAS*# Step: 8 Bead: 55 + 0.00011047 -0.00004188 -0.00004196 + -0.00004188 0.00011049 -0.00004194 + -0.00004196 -0.00004194 0.00011055 + #*EXTRAS*# Step: 9 Bead: 55 + 0.00011053 -0.00004192 -0.00004200 + -0.00004192 0.00011055 -0.00004198 + -0.00004200 -0.00004198 0.00011061 + #*EXTRAS*# Step: 10 Bead: 55 + 0.00011057 -0.00004195 -0.00004203 + -0.00004195 0.00011059 -0.00004200 + -0.00004203 -0.00004200 0.00011065 + #*EXTRAS*# Step: 11 Bead: 55 + 0.00011059 -0.00004197 -0.00004205 + -0.00004197 0.00011062 -0.00004202 + -0.00004205 -0.00004202 0.00011067 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 new file mode 100644 index 000000000..902b8e476 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 56 + 0.00010287 -0.00003410 -0.00003406 + -0.00003410 0.00010284 -0.00003429 + -0.00003406 -0.00003429 0.00010245 + #*EXTRAS*# Step: 1 Bead: 56 + 0.00010551 -0.00003757 -0.00003751 + -0.00003757 0.00010551 -0.00003766 + -0.00003751 -0.00003766 0.00010532 + #*EXTRAS*# Step: 2 Bead: 56 + 0.00010790 -0.00003991 -0.00003991 + -0.00003991 0.00010790 -0.00003991 + -0.00003991 -0.00003991 0.00010792 + #*EXTRAS*# Step: 3 Bead: 56 + 0.00010888 -0.00004072 -0.00004076 + -0.00004072 0.00010890 -0.00004074 + -0.00004076 -0.00004074 0.00010895 + #*EXTRAS*# Step: 4 Bead: 56 + 0.00010952 -0.00004121 -0.00004127 + -0.00004121 0.00010955 -0.00004125 + -0.00004127 -0.00004125 0.00010960 + #*EXTRAS*# Step: 5 Bead: 56 + 0.00010989 -0.00004148 -0.00004155 + -0.00004148 0.00010992 -0.00004152 + -0.00004155 -0.00004152 0.00010997 + #*EXTRAS*# Step: 6 Bead: 56 + 0.00011012 -0.00004164 -0.00004172 + -0.00004164 0.00011015 -0.00004169 + -0.00004172 -0.00004169 0.00011020 + #*EXTRAS*# Step: 7 Bead: 56 + 0.00011027 -0.00004174 -0.00004182 + -0.00004174 0.00011029 -0.00004179 + -0.00004182 -0.00004179 0.00011034 + #*EXTRAS*# Step: 8 Bead: 56 + 0.00011036 -0.00004181 -0.00004188 + -0.00004181 0.00011038 -0.00004186 + -0.00004188 -0.00004186 0.00011044 + #*EXTRAS*# Step: 9 Bead: 56 + 0.00011042 -0.00004185 -0.00004193 + -0.00004185 0.00011044 -0.00004190 + -0.00004193 -0.00004190 0.00011050 + #*EXTRAS*# Step: 10 Bead: 56 + 0.00011046 -0.00004188 -0.00004195 + -0.00004188 0.00011048 -0.00004193 + -0.00004195 -0.00004193 0.00011054 + #*EXTRAS*# Step: 11 Bead: 56 + 0.00011048 -0.00004189 -0.00004197 + -0.00004189 0.00011051 -0.00004195 + -0.00004197 -0.00004195 0.00011056 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 new file mode 100644 index 000000000..acc470c7c --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 57 + 0.00010273 -0.00003387 -0.00003384 + -0.00003387 0.00010269 -0.00003406 + -0.00003384 -0.00003406 0.00010231 + #*EXTRAS*# Step: 1 Bead: 57 + 0.00010536 -0.00003741 -0.00003734 + -0.00003741 0.00010536 -0.00003750 + -0.00003734 -0.00003750 0.00010516 + #*EXTRAS*# Step: 2 Bead: 57 + 0.00010777 -0.00003979 -0.00003979 + -0.00003979 0.00010777 -0.00003979 + -0.00003979 -0.00003979 0.00010778 + #*EXTRAS*# Step: 3 Bead: 57 + 0.00010876 -0.00004063 -0.00004066 + -0.00004063 0.00010878 -0.00004064 + -0.00004066 -0.00004064 0.00010882 + #*EXTRAS*# Step: 4 Bead: 57 + 0.00010941 -0.00004113 -0.00004119 + -0.00004113 0.00010943 -0.00004116 + -0.00004119 -0.00004116 0.00010949 + #*EXTRAS*# Step: 5 Bead: 57 + 0.00010979 -0.00004141 -0.00004147 + -0.00004141 0.00010981 -0.00004145 + -0.00004147 -0.00004145 0.00010986 + #*EXTRAS*# Step: 6 Bead: 57 + 0.00011002 -0.00004157 -0.00004165 + -0.00004157 0.00011005 -0.00004162 + -0.00004165 -0.00004162 0.00011010 + #*EXTRAS*# Step: 7 Bead: 57 + 0.00011017 -0.00004167 -0.00004175 + -0.00004167 0.00011019 -0.00004172 + -0.00004175 -0.00004172 0.00011024 + #*EXTRAS*# Step: 8 Bead: 57 + 0.00011026 -0.00004174 -0.00004182 + -0.00004174 0.00011028 -0.00004179 + -0.00004182 -0.00004179 0.00011034 + #*EXTRAS*# Step: 9 Bead: 57 + 0.00011032 -0.00004178 -0.00004186 + -0.00004178 0.00011035 -0.00004183 + -0.00004186 -0.00004183 0.00011040 + #*EXTRAS*# Step: 10 Bead: 57 + 0.00011036 -0.00004181 -0.00004189 + -0.00004181 0.00011038 -0.00004186 + -0.00004189 -0.00004186 0.00011044 + #*EXTRAS*# Step: 11 Bead: 57 + 0.00011039 -0.00004183 -0.00004191 + -0.00004183 0.00011041 -0.00004188 + -0.00004191 -0.00004188 0.00011046 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 new file mode 100644 index 000000000..75a01bb8c --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 58 + 0.00010261 -0.00003368 -0.00003365 + -0.00003368 0.00010257 -0.00003386 + -0.00003365 -0.00003386 0.00010219 + #*EXTRAS*# Step: 1 Bead: 58 + 0.00010524 -0.00003726 -0.00003720 + -0.00003726 0.00010523 -0.00003736 + -0.00003720 -0.00003736 0.00010501 + #*EXTRAS*# Step: 2 Bead: 58 + 0.00010765 -0.00003969 -0.00003968 + -0.00003969 0.00010765 -0.00003969 + -0.00003968 -0.00003969 0.00010766 + #*EXTRAS*# Step: 3 Bead: 58 + 0.00010866 -0.00004055 -0.00004058 + -0.00004055 0.00010867 -0.00004056 + -0.00004058 -0.00004056 0.00010872 + #*EXTRAS*# Step: 4 Bead: 58 + 0.00010932 -0.00004106 -0.00004111 + -0.00004106 0.00010934 -0.00004109 + -0.00004111 -0.00004109 0.00010939 + #*EXTRAS*# Step: 5 Bead: 58 + 0.00010970 -0.00004134 -0.00004141 + -0.00004134 0.00010972 -0.00004138 + -0.00004141 -0.00004138 0.00010977 + #*EXTRAS*# Step: 6 Bead: 58 + 0.00010993 -0.00004151 -0.00004158 + -0.00004151 0.00010996 -0.00004155 + -0.00004158 -0.00004155 0.00011001 + #*EXTRAS*# Step: 7 Bead: 58 + 0.00011008 -0.00004161 -0.00004169 + -0.00004161 0.00011011 -0.00004166 + -0.00004169 -0.00004166 0.00011016 + #*EXTRAS*# Step: 8 Bead: 58 + 0.00011018 -0.00004168 -0.00004176 + -0.00004168 0.00011020 -0.00004173 + -0.00004176 -0.00004173 0.00011025 + #*EXTRAS*# Step: 9 Bead: 58 + 0.00011024 -0.00004172 -0.00004180 + -0.00004172 0.00011026 -0.00004177 + -0.00004180 -0.00004177 0.00011031 + #*EXTRAS*# Step: 10 Bead: 58 + 0.00011028 -0.00004175 -0.00004183 + -0.00004175 0.00011030 -0.00004180 + -0.00004183 -0.00004180 0.00011035 + #*EXTRAS*# Step: 11 Bead: 58 + 0.00011030 -0.00004177 -0.00004185 + -0.00004177 0.00011033 -0.00004182 + -0.00004185 -0.00004182 0.00011038 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 new file mode 100644 index 000000000..f9f4bec45 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 59 + 0.00010252 -0.00003351 -0.00003348 + -0.00003351 0.00010246 -0.00003369 + -0.00003348 -0.00003369 0.00010209 + #*EXTRAS*# Step: 1 Bead: 59 + 0.00010513 -0.00003714 -0.00003707 + -0.00003714 0.00010513 -0.00003725 + -0.00003707 -0.00003725 0.00010490 + #*EXTRAS*# Step: 2 Bead: 59 + 0.00010755 -0.00003960 -0.00003959 + -0.00003960 0.00010755 -0.00003961 + -0.00003959 -0.00003961 0.00010755 + #*EXTRAS*# Step: 3 Bead: 59 + 0.00010858 -0.00004048 -0.00004050 + -0.00004048 0.00010859 -0.00004049 + -0.00004050 -0.00004049 0.00010863 + #*EXTRAS*# Step: 4 Bead: 59 + 0.00010924 -0.00004100 -0.00004105 + -0.00004100 0.00010926 -0.00004102 + -0.00004105 -0.00004102 0.00010931 + #*EXTRAS*# Step: 5 Bead: 59 + 0.00010962 -0.00004129 -0.00004135 + -0.00004129 0.00010965 -0.00004132 + -0.00004135 -0.00004132 0.00010970 + #*EXTRAS*# Step: 6 Bead: 59 + 0.00010986 -0.00004146 -0.00004153 + -0.00004146 0.00010988 -0.00004150 + -0.00004153 -0.00004150 0.00010994 + #*EXTRAS*# Step: 7 Bead: 59 + 0.00011001 -0.00004156 -0.00004164 + -0.00004156 0.00011003 -0.00004161 + -0.00004164 -0.00004161 0.00011009 + #*EXTRAS*# Step: 8 Bead: 59 + 0.00011010 -0.00004163 -0.00004171 + -0.00004163 0.00011013 -0.00004168 + -0.00004171 -0.00004168 0.00011018 + #*EXTRAS*# Step: 9 Bead: 59 + 0.00011017 -0.00004168 -0.00004175 + -0.00004168 0.00011019 -0.00004172 + -0.00004175 -0.00004172 0.00011024 + #*EXTRAS*# Step: 10 Bead: 59 + 0.00011021 -0.00004170 -0.00004178 + -0.00004170 0.00011023 -0.00004175 + -0.00004178 -0.00004175 0.00011029 + #*EXTRAS*# Step: 11 Bead: 59 + 0.00011023 -0.00004172 -0.00004180 + -0.00004172 0.00011026 -0.00004177 + -0.00004180 -0.00004177 0.00011031 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 new file mode 100644 index 000000000..0491723b4 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 60 + 0.00010243 -0.00003337 -0.00003335 + -0.00003337 0.00010238 -0.00003355 + -0.00003335 -0.00003355 0.00010201 + #*EXTRAS*# Step: 1 Bead: 60 + 0.00010504 -0.00003704 -0.00003697 + -0.00003704 0.00010504 -0.00003715 + -0.00003697 -0.00003715 0.00010480 + #*EXTRAS*# Step: 2 Bead: 60 + 0.00010748 -0.00003953 -0.00003952 + -0.00003953 0.00010747 -0.00003954 + -0.00003952 -0.00003954 0.00010747 + #*EXTRAS*# Step: 3 Bead: 60 + 0.00010851 -0.00004042 -0.00004045 + -0.00004042 0.00010852 -0.00004043 + -0.00004045 -0.00004043 0.00010856 + #*EXTRAS*# Step: 4 Bead: 60 + 0.00010917 -0.00004095 -0.00004100 + -0.00004095 0.00010919 -0.00004097 + -0.00004100 -0.00004097 0.00010924 + #*EXTRAS*# Step: 5 Bead: 60 + 0.00010956 -0.00004124 -0.00004130 + -0.00004124 0.00010958 -0.00004127 + -0.00004130 -0.00004127 0.00010964 + #*EXTRAS*# Step: 6 Bead: 60 + 0.00010980 -0.00004142 -0.00004148 + -0.00004142 0.00010983 -0.00004146 + -0.00004148 -0.00004146 0.00010988 + #*EXTRAS*# Step: 7 Bead: 60 + 0.00010995 -0.00004152 -0.00004159 + -0.00004152 0.00010998 -0.00004157 + -0.00004159 -0.00004157 0.00011003 + #*EXTRAS*# Step: 8 Bead: 60 + 0.00011005 -0.00004159 -0.00004166 + -0.00004159 0.00011007 -0.00004164 + -0.00004166 -0.00004164 0.00011012 + #*EXTRAS*# Step: 9 Bead: 60 + 0.00011011 -0.00004164 -0.00004171 + -0.00004164 0.00011014 -0.00004168 + -0.00004171 -0.00004168 0.00011019 + #*EXTRAS*# Step: 10 Bead: 60 + 0.00011015 -0.00004166 -0.00004174 + -0.00004166 0.00011018 -0.00004171 + -0.00004174 -0.00004171 0.00011023 + #*EXTRAS*# Step: 11 Bead: 60 + 0.00011018 -0.00004168 -0.00004176 + -0.00004168 0.00011020 -0.00004173 + -0.00004176 -0.00004173 0.00011026 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 new file mode 100644 index 000000000..1f23cd1a4 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 61 + 0.00010237 -0.00003327 -0.00003325 + -0.00003327 0.00010231 -0.00003345 + -0.00003325 -0.00003345 0.00010195 + #*EXTRAS*# Step: 1 Bead: 61 + 0.00010498 -0.00003696 -0.00003690 + -0.00003696 0.00010498 -0.00003708 + -0.00003690 -0.00003708 0.00010473 + #*EXTRAS*# Step: 2 Bead: 61 + 0.00010742 -0.00003948 -0.00003947 + -0.00003948 0.00010742 -0.00003949 + -0.00003947 -0.00003949 0.00010741 + #*EXTRAS*# Step: 3 Bead: 61 + 0.00010846 -0.00004038 -0.00004040 + -0.00004038 0.00010846 -0.00004039 + -0.00004040 -0.00004039 0.00010850 + #*EXTRAS*# Step: 4 Bead: 61 + 0.00010913 -0.00004091 -0.00004096 + -0.00004091 0.00010915 -0.00004094 + -0.00004096 -0.00004094 0.00010919 + #*EXTRAS*# Step: 5 Bead: 61 + 0.00010952 -0.00004121 -0.00004127 + -0.00004121 0.00010954 -0.00004124 + -0.00004127 -0.00004124 0.00010959 + #*EXTRAS*# Step: 6 Bead: 61 + 0.00010976 -0.00004138 -0.00004145 + -0.00004138 0.00010978 -0.00004142 + -0.00004145 -0.00004142 0.00010983 + #*EXTRAS*# Step: 7 Bead: 61 + 0.00010991 -0.00004149 -0.00004156 + -0.00004149 0.00010993 -0.00004154 + -0.00004156 -0.00004154 0.00010998 + #*EXTRAS*# Step: 8 Bead: 61 + 0.00011000 -0.00004156 -0.00004163 + -0.00004156 0.00011003 -0.00004161 + -0.00004163 -0.00004161 0.00011008 + #*EXTRAS*# Step: 9 Bead: 61 + 0.00011007 -0.00004161 -0.00004168 + -0.00004161 0.00011009 -0.00004165 + -0.00004168 -0.00004165 0.00011015 + #*EXTRAS*# Step: 10 Bead: 61 + 0.00011011 -0.00004164 -0.00004171 + -0.00004164 0.00011013 -0.00004168 + -0.00004171 -0.00004168 0.00011019 + #*EXTRAS*# Step: 11 Bead: 61 + 0.00011014 -0.00004165 -0.00004173 + -0.00004165 0.00011016 -0.00004170 + -0.00004173 -0.00004170 0.00011021 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 new file mode 100644 index 000000000..2bbd529cc --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 62 + 0.00010233 -0.00003319 -0.00003317 + -0.00003319 0.00010227 -0.00003337 + -0.00003317 -0.00003337 0.00010191 + #*EXTRAS*# Step: 1 Bead: 62 + 0.00010493 -0.00003691 -0.00003684 + -0.00003691 0.00010493 -0.00003703 + -0.00003684 -0.00003703 0.00010468 + #*EXTRAS*# Step: 2 Bead: 62 + 0.00010738 -0.00003944 -0.00003943 + -0.00003944 0.00010738 -0.00003945 + -0.00003943 -0.00003945 0.00010737 + #*EXTRAS*# Step: 3 Bead: 62 + 0.00010842 -0.00004035 -0.00004037 + -0.00004035 0.00010843 -0.00004036 + -0.00004037 -0.00004036 0.00010847 + #*EXTRAS*# Step: 4 Bead: 62 + 0.00010910 -0.00004089 -0.00004094 + -0.00004089 0.00010911 -0.00004091 + -0.00004094 -0.00004091 0.00010916 + #*EXTRAS*# Step: 5 Bead: 62 + 0.00010949 -0.00004118 -0.00004124 + -0.00004118 0.00010951 -0.00004122 + -0.00004124 -0.00004122 0.00010956 + #*EXTRAS*# Step: 6 Bead: 62 + 0.00010973 -0.00004136 -0.00004143 + -0.00004136 0.00010975 -0.00004140 + -0.00004143 -0.00004140 0.00010980 + #*EXTRAS*# Step: 7 Bead: 62 + 0.00010988 -0.00004147 -0.00004154 + -0.00004147 0.00010990 -0.00004151 + -0.00004154 -0.00004151 0.00010996 + #*EXTRAS*# Step: 8 Bead: 62 + 0.00010998 -0.00004154 -0.00004161 + -0.00004154 0.00011000 -0.00004159 + -0.00004161 -0.00004159 0.00011005 + #*EXTRAS*# Step: 9 Bead: 62 + 0.00011004 -0.00004159 -0.00004166 + -0.00004159 0.00011007 -0.00004163 + -0.00004166 -0.00004163 0.00011012 + #*EXTRAS*# Step: 10 Bead: 62 + 0.00011008 -0.00004162 -0.00004169 + -0.00004162 0.00011011 -0.00004166 + -0.00004169 -0.00004166 0.00011016 + #*EXTRAS*# Step: 11 Bead: 62 + 0.00011011 -0.00004164 -0.00004171 + -0.00004164 0.00011013 -0.00004168 + -0.00004171 -0.00004168 0.00011019 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 new file mode 100644 index 000000000..77fd0ce26 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 @@ -0,0 +1,48 @@ + #*EXTRAS*# Step: 0 Bead: 63 + 0.00010230 -0.00003314 -0.00003313 + -0.00003314 0.00010224 -0.00003332 + -0.00003313 -0.00003332 0.00010188 + #*EXTRAS*# Step: 1 Bead: 63 + 0.00010491 -0.00003688 -0.00003681 + -0.00003688 0.00010491 -0.00003700 + -0.00003681 -0.00003700 0.00010465 + #*EXTRAS*# Step: 2 Bead: 63 + 0.00010736 -0.00003943 -0.00003941 + -0.00003943 0.00010736 -0.00003944 + -0.00003941 -0.00003944 0.00010734 + #*EXTRAS*# Step: 3 Bead: 63 + 0.00010840 -0.00004034 -0.00004036 + -0.00004034 0.00010841 -0.00004034 + -0.00004036 -0.00004034 0.00010845 + #*EXTRAS*# Step: 4 Bead: 63 + 0.00010908 -0.00004088 -0.00004092 + -0.00004088 0.00010910 -0.00004090 + -0.00004092 -0.00004090 0.00010915 + #*EXTRAS*# Step: 5 Bead: 63 + 0.00010947 -0.00004117 -0.00004123 + -0.00004117 0.00010949 -0.00004120 + -0.00004123 -0.00004120 0.00010954 + #*EXTRAS*# Step: 6 Bead: 63 + 0.00010971 -0.00004135 -0.00004142 + -0.00004135 0.00010974 -0.00004139 + -0.00004142 -0.00004139 0.00010979 + #*EXTRAS*# Step: 7 Bead: 63 + 0.00010986 -0.00004146 -0.00004153 + -0.00004146 0.00010989 -0.00004150 + -0.00004153 -0.00004150 0.00010994 + #*EXTRAS*# Step: 8 Bead: 63 + 0.00010996 -0.00004153 -0.00004160 + -0.00004153 0.00010999 -0.00004158 + -0.00004160 -0.00004158 0.00011004 + #*EXTRAS*# Step: 9 Bead: 63 + 0.00011003 -0.00004158 -0.00004165 + -0.00004158 0.00011005 -0.00004162 + -0.00004165 -0.00004162 0.00011010 + #*EXTRAS*# Step: 10 Bead: 63 + 0.00011007 -0.00004161 -0.00004168 + -0.00004161 0.00011009 -0.00004165 + -0.00004168 -0.00004165 0.00011014 + #*EXTRAS*# Step: 11 Bead: 63 + 0.00011010 -0.00004163 -0.00004170 + -0.00004163 0.00011012 -0.00004167 + -0.00004170 -0.00004167 0.00011017 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 new file mode 100644 index 000000000..ca2a04ca5 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 @@ -0,0 +1 @@ +-1.790762173407876596e-03 1.605996708104646693e-04 1.595916396470224664e-04 -1.865952984358739200e-03 1.599634670600206773e-04 1.587470278452119386e-04 -1.994572598333122209e-03 1.587706057530746261e-04 1.572060344017630262e-04 -2.175467384291874737e-03 1.570356441542739240e-04 1.549787358663584137e-04 -2.406717299867169781e-03 1.547767297439942057e-04 1.520812623441293945e-04 -2.685661674185229990e-03 1.519652560665271668e-04 1.485439278503754745e-04 -3.009095499643968819e-03 1.485747572264602503e-04 1.444006059991063777e-04 -3.373238898267761146e-03 1.445920890004210202e-04 1.396855421153240010e-04 -3.773719163610178822e-03 1.400027559321057491e-04 1.344349109612397717e-04 -4.205531464273506992e-03 1.347914585320797009e-04 1.286857972704309001e-04 -4.662929502800216078e-03 1.289434222723618141e-04 1.224757707829939447e-04 -5.139540688331577234e-03 1.224450957239504108e-04 1.158410834817677948e-04 -5.628463992118844759e-03 1.152851100242362545e-04 1.088152659529708624e-04 -6.122312297430441801e-03 1.074559531693518717e-04 1.014285701502294293e-04 -6.613072053176566670e-03 9.895838841287254062e-05 9.370980670402189491e-05 -7.092146248172816192e-03 8.980668421959980168e-05 8.568830320195296212e-05 -7.550723985622619615e-03 8.003180714547837712e-05 7.739452396395819723e-05 -7.982599710937045290e-03 6.968833021344260955e-05 6.886461790645049023e-05 -8.389082199238027948e-03 5.886629397722456416e-05 6.014902991958995444e-05 -8.778758742441241519e-03 4.801696343188001256e-05 5.140830347323791948e-05 -9.155907795781735234e-03 3.860795411460528690e-05 4.313150821412856757e-05 -9.516685965926779955e-03 3.087543721385691383e-05 3.552617297838205047e-05 -9.857053399566929192e-03 2.482555356826129196e-05 2.873422449340736008e-05 -1.017295518607843480e-02 2.037493864570317440e-05 2.286090969003024516e-05 -1.045919393358357360e-02 1.734130615999967452e-05 1.796271961534478612e-05 -1.068976105282406185e-02 1.480214502866266986e-05 1.390997041516032444e-05 -1.084845349531760386e-02 1.198392136869672118e-05 1.053915700988434733e-05 -1.093160112608608688e-02 9.186868665706770455e-06 7.880499124445369900e-06 -1.093546640215261288e-02 6.762628071574709450e-06 5.975803840689837166e-06 -1.085830535054584794e-02 5.099997747754664706e-06 4.875650107791152627e-06 -1.071058020571687662e-02 4.639594924859498120e-06 4.637485225435656302e-06 -1.053231173536757492e-02 5.437001916182493629e-06 5.259025246760167451e-06 -1.033063190062910933e-02 7.231322209186677700e-06 6.674833131379043045e-06 -1.010656385562406362e-02 9.737608861080378781e-06 8.795576305930843502e-06 -9.861443622532859582e-03 1.266342784300513477e-05 1.151588164992699536e-05 -9.596821746567394881e-03 1.572424795354245084e-05 1.472305346666804650e-05 -9.311051924263985535e-03 1.890045096812509209e-05 1.832003065196420328e-05 -8.992328451482839782e-03 2.233710636174199120e-05 2.222121207259048246e-05 -8.632373655985249236e-03 2.600890513402304979e-05 2.633397970751588877e-05 -8.230608385642336142e-03 2.988780488961053521e-05 3.057253088478920490e-05 -7.791701296678669314e-03 3.394480600009372630e-05 3.486047680355928996e-05 -7.320877460381595633e-03 3.814993308439641371e-05 3.913091776052559587e-05 -6.823768575359857001e-03 4.246658856763628844e-05 4.333434776334996609e-05 -6.312173212824001393e-03 4.679857762976839987e-05 4.750383697911697052e-05 -5.802943216707425085e-03 5.108832858723529106e-05 5.162245578004016216e-05 -5.308674577987209514e-03 5.529747604706746405e-05 5.565524907735003508e-05 -4.838216588861554354e-03 5.939162468818634603e-05 5.957060411701156345e-05 -4.397573686602709690e-03 6.334046150710285149e-05 6.334048385287951554e-05 -3.989615775878550819e-03 6.711884816969423148e-05 6.694151489467973061e-05 -3.613696003885667404e-03 7.070614318361829272e-05 7.035448691266677282e-05 -3.268663445671344224e-03 7.408543489853747699e-05 7.356374611135706437e-05 -2.953405177046155173e-03 7.724337545513171213e-05 7.655709394487028076e-05 -2.666785569923133502e-03 8.017018540896247492e-05 7.932580653638889436e-05 -2.407675360174985069e-03 8.285915596542620294e-05 8.186418405742385755e-05 -2.175015995982612117e-03 8.530522510526870525e-05 8.416897844124702111e-05 -1.967813790605789717e-03 8.748897019788161452e-05 8.624133307690208137e-05 -1.785105955680670823e-03 8.940776741226141606e-05 8.808311909062810959e-05 -1.626048918521727808e-03 9.106929472288936844e-05 8.969550369193561427e-05 -1.489925578307425185e-03 9.248106921719925777e-05 9.107967001656994924e-05 -1.376132238663086219e-03 9.365013635479569947e-05 9.223673149919608461e-05 -1.284164425000997468e-03 9.458284401899358102e-05 9.316770162922415944e-05 -1.213612301108031935e-03 9.528464250431165387e-05 9.387345821614870008e-05 -1.164165089509900568e-03 9.575990791656120314e-05 9.435469397061122627e-05 -1.135580283876044599e-03 9.601195545944826704e-05 9.461203550353332195e-05 2.917903169062088044e-13 5.511521614660179758e-01 3.762236597462519431e-10 2.957856523887286367e-13 5.511521614684432580e-01 3.785114476734373942e-10 3.012790611229457929e-13 5.511521614716138329e-01 3.814146774464362102e-10 3.079887321215927070e-13 5.511521614751169196e-01 3.845291608903082408e-10 3.154646124472693945e-13 5.511521614783438938e-01 3.872607528579846991e-10 3.237340729534500045e-13 5.511521614812954217e-01 3.896325427734285649e-10 3.327642027980257029e-13 5.511521614839027805e-01 3.916034197826572668e-10 3.422785857222165250e-13 5.511521614858165830e-01 3.928570373010328319e-10 3.519395728199752597e-13 5.511521614866456975e-01 3.930394183234752154e-10 3.613406266158588660e-13 5.511521614859632434e-01 3.917639836607266749e-10 3.699849808081311154e-13 5.511521614833087002e-01 3.886123443983367585e-10 3.773033644962079921e-13 5.511521614782124434e-01 3.831558232240210059e-10 3.826811513409983586e-13 5.511521614702247218e-01 3.749812955030002183e-10 3.854875568059762506e-13 5.511521614589453000e-01 3.637166114893790760e-10 3.850580275988814748e-13 5.511521614440334504e-01 3.490362131117335107e-10 3.807024236075795410e-13 5.511521614252311574e-01 3.306798275607005259e-10 3.718268158288078532e-13 5.511521614024329496e-01 3.085178360856541414e-10 3.593709730154878086e-13 5.511521613768211036e-01 2.836693740542055867e-10 3.499966691197678774e-13 5.511521613537336828e-01 2.613482412458561146e-10 3.552895784918116902e-13 5.511521613407461828e-01 2.490087128754098251e-10 3.662886436740215341e-13 5.511521613293756117e-01 2.382204380396184745e-10 3.851374197344128210e-13 5.511521613191717739e-01 2.284988702250335225e-10 4.209148213379204003e-13 5.511521613121628249e-01 2.218428492478117728e-10 4.960568229338628674e-13 5.511521613124187313e-01 2.223077886449103002e-10 6.787299110193688439e-13 5.511521613284796617e-01 2.384193930938614710e-10 1.299662818891701278e-12 5.511521613860900226e-01 2.958536120146215118e-10 2.497686512579768927e-11 5.511521626327681167e-01 1.538306107400407574e-09 -2.571026561102797369e-13 5.511521611352059313e-01 4.563208164190086108e-11 -1.289061491509387892e-14 5.511521610966300111e-01 7.204039665178186534e-12 -4.068022567755670722e-15 5.511521610946271688e-01 5.204191130155853619e-12 -4.701871804353251686e-16 5.511521610909093649e-01 1.505792504171232336e-12 -1.218461742793128835e-18 5.511521610894231094e-01 3.187802854807988938e-14 9.318285259121748696e-17 5.511521610900386170e-01 6.518978386080218023e-13 8.522084109704415865e-16 5.511521610925173009e-01 3.131832285555420460e-12 2.728653096768182918e-15 5.511521610967710094e-01 7.389834803728156104e-12 5.943731731812185206e-15 5.511521611027214718e-01 1.335369331516320988e-11 1.120859017714450194e-14 5.511521611114884589e-01 2.214923663479915020e-11 1.943108419359773055e-14 5.511521611242313767e-01 3.493976196307410421e-11 3.064367916407166726e-14 5.511521611404694987e-01 5.124041713116720969e-11 4.467173015948575559e-14 5.511521611596652548e-01 7.050365023416428727e-11 6.136648730967301820e-14 5.511521611815077826e-01 9.240648013159238102e-11 8.049214250213229299e-14 5.511521612056466957e-01 1.165875134921801809e-10 1.013231125575992112e-13 5.511521612311072182e-01 1.420632540469662323e-10 1.193756286162059827e-13 5.511521612519036939e-01 1.628384302517587930e-10 1.338852177565731384e-13 5.511521612675374104e-01 1.784256163430550392e-10 1.454708021526184375e-13 5.511521612792381619e-01 1.900674107267893595e-10 1.548123255291868056e-13 5.511521612881321586e-01 1.988986129559824627e-10 1.625688037630611931e-13 5.511521612951898463e-01 2.058950093770817486e-10 1.692076761866166035e-13 5.511521613010689213e-01 2.117167153453242961e-10 1.748388341017253284e-13 5.511521613059403579e-01 2.165356048070802835e-10 1.795291671286952711e-13 5.511521613099008565e-01 2.204490575784933533e-10 1.833601478043232285e-13 5.511521613130522246e-01 2.235590832465329311e-10 1.864136284131981866e-13 5.511521613154918287e-01 2.259630422445095734e-10 1.887691568753339069e-13 5.511521613173105960e-01 2.277521299509455696e-10 1.905119289545006617e-13 5.511521613186008972e-01 2.290192997072288420e-10 1.918278436039366542e-13 5.511521613195713432e-01 2.299737036142419700e-10 1.927974500070088851e-13 5.511521613203026471e-01 2.306960099813668255e-10 1.934416107933002934e-13 5.511521613208049120e-01 2.311954234080971175e-10 1.937845150475534032e-13 5.511521613210934589e-01 2.314857582850626343e-10 1.938509534173833018e-13 5.511521613211857185e-01 2.315828712320134599e-10 1.936636987108705143e-13 5.511521613210987880e-01 2.315023177842070176e-10 1.932424632218286303e-13 5.511521613208482107e-01 2.312581544388908067e-10 1.926043305817225132e-13 5.511521613204476422e-01 2.308628156874353704e-10 1.917597370821630045e-13 5.511521613199058534e-01 2.303242326023405397e-10 2.914770098097496775e-13 3.762236597462519431e-10 5.511521614652096224e-01 2.953627542668251830e-13 3.785114476734373942e-10 5.511521614673602354e-01 3.006412285111191367e-13 3.814146774464362102e-10 5.511521614699971261e-01 3.070322424798602194e-13 3.845291608903082408e-10 5.511521614727249441e-01 3.140912787876028295e-13 3.872607528579846991e-10 5.511521614749648190e-01 3.218564330041569143e-13 3.896325427734285649e-10 5.511521614767626032e-01 3.303100961669066259e-13 3.916034197826572668e-10 5.511521614781053069e-01 3.391965172488887947e-13 3.928570373010328319e-10 5.511521614787094903e-01 3.482041837493549591e-13 3.930394183234752154e-10 5.511521614782577405e-01 3.569585325262896888e-13 3.917639836607266749e-10 5.511521614764028909e-01 3.650008807196300206e-13 3.886123443983367585e-10 5.511521614727672436e-01 3.718044249731046856e-13 3.831558232240210059e-10 5.511521614669615543e-01 3.767992327422659656e-13 3.749812955030002183e-10 5.511521614586076812e-01 3.793970779048742926e-13 3.637166114893790760e-10 5.511521614473600117e-01 3.789697725684088057e-13 3.490362131117335107e-10 5.511521614329074614e-01 3.748515438003003418e-13 3.306798275607005259e-10 5.511521614149876847e-01 3.664518059791819068e-13 3.085178360856541414e-10 5.511521613934479147e-01 3.546676469407251613e-13 2.836693740542055867e-10 5.511521613693466382e-01 3.460305506348096790e-13 2.613482412458561146e-10 5.511521613477765591e-01 3.519713947314324399e-13 2.490087128754098251e-10 5.511521613360730321e-01 3.635943018199743826e-13 2.382204380396184745e-10 5.511521613258580921e-01 3.829869362194525848e-13 2.284988702250335225e-10 5.511521613166129319e-01 4.191574141576137796e-13 2.218428492478117728e-10 5.511521613103065320e-01 4.944530953595475109e-13 2.223077886449103002e-10 5.511521613109789941e-01 6.768270429300947446e-13 2.384193930938614710e-10 5.511521613271408437e-01 1.295954793830916163e-12 2.958536120146215118e-10 5.511521613843994860e-01 2.489478166074976138e-11 1.538306107400407574e-09 5.511521626226405512e-01 -2.560706813505254947e-13 4.563208164190086108e-11 5.511521611348387806e-01 -1.282632654918462956e-14 7.204039665178186534e-12 5.511521610965580686e-01 -4.042313720325914064e-15 5.204191130155853619e-12 5.511521610945612215e-01 -4.659692242885138246e-16 1.505792504171232336e-12 5.511521610908821645e-01 -1.168849800890052429e-18 3.187802854807988938e-14 5.511521610894205558e-01 9.364667811185155955e-17 6.518978386080218023e-13 5.511521610900450563e-01 8.534326518830655716e-16 3.131832285555420460e-12 5.511521610925262937e-01 2.731858101855840766e-15 7.389834803728156104e-12 5.511521610967884399e-01 5.953566132290205333e-15 1.335369331516320988e-11 5.511521611027657697e-01 1.123426011102706971e-14 2.214923663479915020e-11 5.511521611115899333e-01 1.948591090213573537e-14 3.493976196307410421e-11 5.511521611244282193e-01 3.074018416988690272e-14 5.124041713116720969e-11 5.511521611407916854e-01 4.481685206580395314e-14 7.050365023416428727e-11 5.511521611601225556e-01 6.155878571499652915e-14 9.240648013159238102e-11 5.511521611820859867e-01 8.072109447938792039e-14 1.165875134921801809e-10 5.511521612063090547e-01 1.015704886568069310e-13 1.420632540469662323e-10 5.511521612317999974e-01 1.196140930770360122e-13 1.628384302517587930e-10 5.511521612525536185e-01 1.340942223753508955e-13 1.784256163430550392e-10 5.511521612680940763e-01 1.456387485432831504e-13 1.900674107267893595e-10 5.511521612796767000e-01 1.549341673964346293e-13 1.988986129559824627e-10 5.511521612884450194e-01 1.626439234548387534e-13 2.058950093770817486e-10 5.511521612953800275e-01 1.692377553196744847e-13 2.117167153453242961e-10 5.511521613011443055e-01 1.748268916381843161e-13 2.165356048070802835e-10 5.511521613059107150e-01 1.794788210213369962e-13 2.204490575784933533e-10 5.511521613097771777e-01 1.832755029612072646e-13 2.235590832465329311e-10 5.511521613128458341e-01 1.862991198612206671e-13 2.259630422445095734e-10 5.511521613152141619e-01 1.886295781008394587e-13 2.277521299509455696e-10 5.511521613169736433e-01 1.903525832588072012e-13 2.290192997072288420e-10 5.511521613182176482e-01 1.916546949250127911e-13 2.299737036142419700e-10 5.511521613191560087e-01 1.926164735276632674e-13 2.306960099813668255e-10 5.511521613198693270e-01 1.932580301655525106e-13 2.311954234080971175e-10 5.511521613203659298e-01 1.936023658377226721e-13 2.314857582850626343e-10 5.511521613206581405e-01 1.936729103326485733e-13 2.315828712320134599e-10 5.511521613207600589e-01 1.934910851295204005e-13 2.315023177842070176e-10 5.511521613206858961e-01 1.930753831788128060e-13 2.312581544388908067e-10 5.511521613204480863e-01 1.924418794948273105e-13 2.308628156874353704e-10 5.511521613200579539e-01 1.916002651525291040e-13 2.303242326023405397e-10 5.511521613195226044e-01 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 new file mode 100644 index 000000000..f3ba6c3dd --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 @@ -0,0 +1 @@ +-9.134585674756787524e-03 1.605996697703740211e-04 1.595916386145714320e-04 -9.144532982844077312e-03 1.599634660174528169e-04 1.587470268104653230e-04 -9.164342846567859885e-03 1.587706047093321682e-04 1.572060333661626284e-04 -9.193846310522167317e-03 1.570356431110901283e-04 1.549787348317591140e-04 -9.232791522661456390e-03 1.547767287037380270e-04 1.520812613130185966e-04 -9.280845626512433319e-03 1.519652550314838321e-04 1.485439268251339780e-04 -9.337597305892307575e-03 1.485747561989581109e-04 1.444006049821049804e-04 -9.402559959871078024e-03 1.445920879831169949e-04 1.396855411092674077e-04 -9.475175508921617265e-03 1.400027549280998429e-04 1.344349099691424169e-04 -9.554818835432788565e-03 1.347914575449034042e-04 1.286857962957567013e-04 -9.640802849380540260e-03 1.289434213060983137e-04 1.224757698296349438e-04 -9.732384165960216230e-03 1.224450947832014401e-04 1.158410825541208788e-04 -9.828769377779456376e-03 1.152851091141699613e-04 1.088152650559172586e-04 -9.929121895779305720e-03 1.074559522953622161e-04 1.014285692888477439e-04 -1.003256932601343139e-02 9.895838758027230295e-05 9.370980588325678105e-05 -1.013821133741583946e-02 8.980668343309010967e-05 8.568830242619467964e-05 -1.024512796672480061e-02 8.003180640836042310e-05 7.739452323621849714e-05 -1.035238829816895190e-02 6.968832952575748478e-05 6.886461722659471460e-05 -1.045821809045083435e-02 5.886629333037813683e-05 6.014902927905128660e-05 -1.055758734344286638e-02 4.801696280467194925e-05 5.140830285104853992e-05 -1.064853224472725977e-02 3.860795349979551588e-05 4.313150760319287453e-05 -1.072961158330703463e-02 3.087543660206195669e-05 3.552617236955072608e-05 -1.079946386909111725e-02 2.482555293997900790e-05 2.873422386744954111e-05 -1.085682402640415593e-02 2.037493795734258829e-05 2.286090900373599592e-05 -1.090053913910639383e-02 1.734130530100820431e-05 1.796271875868967334e-05 -1.092958286660121285e-02 1.480214354598296480e-05 1.390996893669586021e-05 -1.094306882098045747e-02 1.198389572245599350e-05 1.053913144792366896e-05 -1.094026230323302817e-02 9.186869631838545392e-06 7.880500086016272216e-06 -1.092058966944080105e-02 6.762628077373690130e-06 5.975803846457316691e-06 -1.088364586240226847e-02 5.099997747322703314e-06 4.875650107391955316e-06 -1.082919936765017882e-02 4.639594928384924632e-06 4.637485229135868911e-06 -1.075937296322886441e-02 5.437001804225335302e-06 5.259025121501226591e-06 -1.068338152818447059e-02 7.231322190195440928e-06 6.674833112169900272e-06 -1.060247603834036864e-02 9.737608830191536813e-06 8.795576274982602502e-06 -1.051691657052899499e-02 1.266342782034454026e-05 1.151588162709417364e-05 -1.042701574244117406e-02 1.572424791643158267e-05 1.472305342930445589e-05 -1.033313207784622434e-02 1.890045091165988361e-05 1.832003059515666812e-05 -1.023566697414743723e-02 2.233710627915953822e-05 2.222121198951196295e-05 -1.013506130957510590e-02 2.600890501813623711e-05 2.633397959095025372e-05 -1.003179183592989646e-02 2.988780473355668495e-05 3.057253072787688674e-05 -9.926367196984716909e-03 3.394480579773957453e-05 3.486047660017605414e-05 -9.819323673323023666e-03 3.814993283058235409e-05 3.913091750553747406e-05 -9.711220708661625484e-03 4.246658825885934508e-05 4.333434745331461637e-05 -9.602636274378540185e-03 4.679857727069864487e-05 4.750383661883215015e-05 -9.494162111248634003e-03 5.108832818476109452e-05 5.162245537644658786e-05 -9.386398925789738931e-03 5.529747560776130018e-05 5.565524863711876892e-05 -9.279948067703644443e-03 5.939162421809424791e-05 5.957060364620464407e-05 -9.173100131361088677e-03 6.334046101163236556e-05 6.334048335694134545e-05 -9.064822689088310875e-03 6.711884765364202401e-05 6.694151437841268848e-05 -8.956325924974565048e-03 7.070614265113855208e-05 7.035448638023209433e-05 -8.848803997371163660e-03 7.408543435322276129e-05 7.356374556631735655e-05 -8.743423879258227158e-03 7.724337490001736734e-05 7.655709339023917843e-05 -8.641314747217070102e-03 8.017018484658000469e-05 7.932580597467117558e-05 -8.543557981316908176e-03 8.285915539783338232e-05 8.186418349067851711e-05 -8.451177838363873804e-03 8.530522453417113335e-05 8.416897787112252065e-05 -8.365132843959378894e-03 8.748896962446158670e-05 8.624133250456588980e-05 -8.286307950334909425e-03 8.940776683740736823e-05 8.808311851692895392e-05 -8.215507466022148320e-03 9.106929414731420420e-05 8.969550311757711460e-05 -8.153448778697386726e-03 9.248106864149548004e-05 9.107966944211040193e-05 -8.100756879468703348e-03 9.365013577946037430e-05 9.223673092514861544e-05 -8.057959686418742981e-03 9.458284344440486457e-05 9.316770105594586395e-05 -8.025484163255441547e-03 9.528464193080743775e-05 9.387345764397551830e-05 -8.003653226428590617e-03 9.575990734438512113e-05 9.435469339977519104e-05 -7.992683433764509113e-03 9.601195488887822726e-05 9.461203493429742005e-05 -7.483003202404360143e-13 5.511521630592635113e-01 1.950433492338031679e-09 -7.467822336432144076e-13 5.511521630528296578e-01 1.943887612175451405e-09 -7.424633965591639142e-13 5.511521630366444935e-01 1.927504806754901734e-09 -7.351950197119874141e-13 5.511521630105943315e-01 1.901194709446427386e-09 -7.247915545355249730e-13 5.511521629745177453e-01 1.864828782379255170e-09 -7.113092410027872709e-13 5.511521629290222490e-01 1.819057495629983268e-09 -6.947379486093860546e-13 5.511521628746913759e-01 1.764514895794754439e-09 -6.750254592903715136e-13 5.511521628119100402e-01 1.701641827540130308e-09 -6.520663099606242417e-13 5.511521627411013480e-01 1.630919481476733441e-09 -6.258356526432894739e-13 5.511521626627149395e-01 1.552855364155636037e-09 -5.962784819267787314e-13 5.511521625772056732e-01 1.467955904721621694e-09 -5.634456159170440122e-13 5.511521624850478362e-01 1.376737200805610928e-09 -5.273851652511155482e-13 5.511521623867956521e-01 1.279777767621318787e-09 -4.885020879868745322e-13 5.511521622835908740e-01 1.178210518165897854e-09 -4.475422262987236969e-13 5.511521621774148061e-01 1.073966533697004767e-09 -4.058072887769604884e-13 5.511521620712674929e-01 9.699557672950329612e-10 -3.652911426235096115e-13 5.511521619697711261e-01 8.706753201224190841e-10 -3.283141682074856635e-13 5.511521618782208032e-01 7.812740225656417570e-10 -2.968497573266147482e-13 5.511521618009173062e-01 7.058926315170208715e-10 -2.719184910912001884e-13 5.511521617399753881e-01 6.465125841978830745e-10 -2.485211218605026062e-13 5.511521616831341897e-01 5.909166394908877933e-10 -2.266575438936469122e-13 5.511521616303285409e-01 5.390139672353974600e-10 -2.073674646553466954e-13 5.511521615841503685e-01 4.934041156686709911e-10 -1.923037611453043131e-13 5.511521615487129377e-01 4.582401107553448210e-10 -1.802615593085004876e-13 5.511521615215272396e-01 4.310956822094511443e-10 -1.830168869410507323e-13 5.511521615316815614e-01 4.410601460370881875e-10 -6.693756002553272955e-13 5.511521627331743556e-01 1.638346781416880319e-09 7.090291198329738528e-13 5.511521592931275526e-01 -1.787309851468304170e-09 -7.091634614254713780e-15 5.511521611085256067e-01 1.902474022695203447e-11 -4.499983764801206577e-15 5.511521611036604984e-01 1.412081182063033575e-11 3.055240393526796985e-15 5.511521610624007250e-01 -2.863978515047060873e-11 -1.119583768356680608e-13 5.511521611469352155e-01 6.437404641550518016e-11 -1.889805490473001018e-14 5.511521611152149225e-01 2.612309231072588059e-11 -3.003663296094454200e-14 5.511521611377221408e-01 4.842590719892837176e-11 -1.993194251456543679e-14 5.511521611235767892e-01 3.447517372232903879e-11 -3.116713886200589859e-14 5.511521611449047287e-01 5.593229909991251289e-11 -4.525661852729104143e-14 5.511521611719949476e-01 8.319418854742271374e-11 -6.315137161200492963e-14 5.511521612068179810e-01 1.182412632061175200e-10 -8.524313270574344290e-14 5.511521612502920942e-01 1.619798940047533896e-10 -1.113821218594378333e-13 5.511521613024108479e-01 2.143805845197719288e-10 -1.409876690394606122e-13 5.511521613622980542e-01 2.745350560728434943e-10 -1.733219031283839236e-13 5.511521614288286131e-01 3.412783307253936490e-10 -2.074538359915610872e-13 5.511521615003264207e-01 4.128952456500381835e-10 -2.396941187017842320e-13 5.511521615694587872e-01 4.820208638937688527e-10 -2.685889892611795456e-13 5.511521616332641926e-01 5.456903263116505828e-10 -2.938353639413805308e-13 5.511521616908627852e-01 6.030377825188995409e-10 -3.152797735016569503e-13 5.511521617417585173e-01 6.535914503269308961e-10 -3.329016837379614098e-13 5.511521617856158795e-01 6.970447825635150204e-10 -3.468445580724778784e-13 5.511521618224917152e-01 7.334858996619357849e-10 -3.576409185945777955e-13 5.511521618531881606e-01 7.637441078043701409e-10 -3.657855427855871772e-13 5.511521618785782950e-01 7.887128251004856215e-10 -3.717542145471976632e-13 5.511521618994686955e-01 8.092118556976023894e-10 -3.759688489624243073e-13 5.511521619165721253e-01 8.259609827781065927e-10 -3.788236748860460725e-13 5.511521619305010944e-01 8.395765825141937332e-10 -3.805856620362843027e-13 5.511521619417839579e-01 8.505878450562890946e-10 -3.815921972707132274e-13 5.511521619509902603e-01 8.595644467396184492e-10 -3.820565636356893194e-13 5.511521619584920373e-01 8.668769177654488538e-10 -3.821335482532235436e-13 5.511521619645083359e-01 8.727407589053309958e-10 -3.819192538046216436e-13 5.511521619691801543e-01 8.772930845561105519e-10 -3.814843745454020607e-13 5.511521619726192922e-01 8.806410044932100141e-10 -3.809250302960740857e-13 5.511521619749152334e-01 8.828705429280707850e-10 -3.802617527723831028e-13 5.511521619761369228e-01 8.840461064994709127e-10 -3.795717456186566548e-13 5.511521619763303237e-01 8.842119447270536309e-10 -3.788102969013693589e-13 5.511521619755157531e-01 8.833849688511907989e-10 -7.409740865752962462e-13 1.950433492338031679e-09 5.511521630207968370e-01 -7.393838678820082808e-13 1.943887612175451405e-09 5.511521630141350547e-01 -7.349591372360591444e-13 1.927504806754901734e-09 5.511521629975484338e-01 -7.275670734586942571e-13 1.901194709446427386e-09 5.511521629709713599e-01 -7.170195003592227926e-13 1.864828782379255170e-09 5.511521629343111295e-01 -7.033850664819394991e-13 1.819057495629983268e-09 5.511521628882630752e-01 -6.866912998001137219e-13 1.764514895794754439e-09 5.511521628335125378e-01 -6.668600825293554758e-13 1.701641827540130308e-09 5.511521627705567861e-01 -6.438931861732227125e-13 1.630919481476733441e-09 5.511521626999335011e-01 -6.177156332282134610e-13 1.552855364155636037e-09 5.511521626222037895e-01 -5.883581008443319309e-13 1.467955904721621694e-09 5.511521625379224298e-01 -5.558425003499410317e-13 1.376737200805610928e-09 5.511521624476424241e-01 -5.202543741418641632e-13 1.279777767621318787e-09 5.511521623519624047e-01 -4.819846107532807769e-13 1.178210518165897854e-09 5.511521622520028085e-01 -4.417953504128917034e-13 1.073966533697004767e-09 5.511521621496451306e-01 -4.009067547721292502e-13 9.699557672950329612e-10 5.511521620477126682e-01 -3.612878784548760895e-13 8.706753201224190841e-10 5.511521619505823644e-01 -3.251881499856974526e-13 7.812740225656417570e-10 5.511521618632655439e-01 -2.945081192575381609e-13 7.058926315170208715e-10 5.511521617897496839e-01 -2.702179881650770759e-13 6.465125841978830745e-10 5.511521617318896338e-01 -2.473414023412526163e-13 5.909166394908877933e-10 5.511521616775105770e-01 -2.258443886320920973e-13 5.390139672353974600e-10 5.511521616264947188e-01 -2.068004040486082865e-13 4.934041156686709911e-10 5.511521615814450881e-01 -1.918411561858523601e-13 4.582401107553448210e-10 5.511521615465508894e-01 -1.798280647397963795e-13 4.310956822094511443e-10 5.511521615194467927e-01 -1.825096707088932227e-13 4.410601460370881875e-10 5.511521615292220844e-01 -6.671790192788908519e-13 1.638346781416880319e-09 5.511521627223172626e-01 7.055002205548085339e-13 -1.787309851468304170e-09 5.511521593109881545e-01 -7.058846470327387290e-15 1.902474022695203447e-11 5.511521611083038952e-01 -4.441512338525951313e-15 1.412081182063033575e-11 5.511521611033577406e-01 3.234244534484312401e-15 -2.863978515047060873e-11 5.511521610590157660e-01 -1.252601093389717515e-13 6.437404641550518016e-11 5.511521611614242921e-01 -1.911549544083326266e-14 2.612309231072588059e-11 5.511521611158218814e-01 -3.009480883395256689e-14 4.842590719892837176e-11 5.511521611379172070e-01 -2.010096261576720063e-14 3.447517372232903879e-11 5.511521611241616547e-01 -3.141002556785286156e-14 5.593229909991251289e-11 5.511521611457508296e-01 -4.557328285594743294e-14 8.319418854742271374e-11 5.511521611731887704e-01 -6.359260712829053158e-14 1.182412632061175200e-10 5.511521612084641086e-01 -8.582545541618341495e-14 1.619798940047533896e-10 5.511521612524713509e-01 -1.120954659747499941e-13 2.143805845197719288e-10 5.511521613051558743e-01 -1.418244462527408258e-13 2.745350560728434943e-10 5.511521613655777641e-01 -1.742670296518714827e-13 3.412783307253936490e-10 5.511521614325316509e-01 -2.084648463852934498e-13 4.128952456500381835e-10 5.511521615042647149e-01 -2.406707188651362149e-13 4.820208638937688527e-10 5.511521615733796509e-01 -2.694993527665115072e-13 5.456903263116505828e-10 5.511521616369104981e-01 -2.945925242414211081e-13 6.030377825188995409e-10 5.511521616940044943e-01 -3.158727427438499607e-13 6.535914503269308961e-10 5.511521617442154408e-01 -3.332942350131144151e-13 6.970447825635150204e-10 5.511521617872651158e-01 -3.470292750684539133e-13 7.334858996619357849e-10 5.511521618232720909e-01 -3.576077962969625311e-13 7.637441078043701409e-10 5.511521618530935696e-01 -3.655608997653463428e-13 7.887128251004856215e-10 5.511521618776423770e-01 -3.713556124622089800e-13 8.092118556976023894e-10 5.511521618977516246e-01 -3.754186008966252415e-13 8.259609827781065927e-10 5.511521619141482864e-01 -3.781157787599434088e-13 8.395765825141937332e-10 5.511521619274515338e-01 -3.797719182271167421e-13 8.505878450562890946e-10 5.511521619381926085e-01 -3.806814940607898947e-13 8.595644467396184492e-10 5.511521619469410549e-01 -3.810826607138152456e-13 8.668769177654488538e-10 5.511521619540653560e-01 -3.811004771263811418e-13 8.727407589053309958e-10 5.511521619597780086e-01 -3.808571815327970605e-13 8.772930845561105519e-10 5.511521619642114622e-01 -3.803745309966029981e-13 8.806410044932100141e-10 5.511521619674690786e-01 -3.797872008797974982e-13 8.828705429280707850e-10 5.511521619696325702e-01 -3.790978202893884445e-13 8.840461064994709127e-10 5.511521619707627773e-01 -3.783941382897008405e-13 8.842119447270536309e-10 5.511521619709012221e-01 -3.776356458228757440e-13 8.833849688511907989e-10 5.511521619700623376e-01 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener new file mode 100644 index 000000000..8347f77c9 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.10435200024310802 +1 0.10458012014029815 +2 0.10499336099755491 +3 0.1055903684118013 +4 0.10636890870065621 +5 0.10732582252175506 +6 0.1084567564170259 +7 0.10975608515312206 +8 0.1112166964706233 +9 0.11282965375699106 +10 0.11458365648787314 +11 0.11646496885951468 +12 0.11845732347460955 +13 0.12054171034796743 +14 0.12269568388566807 +15 0.12489306789087287 +16 0.12710456437010614 +17 0.12930135770236537 +18 0.13145910540160105 +19 0.13355346652224132 +20 0.1355604730428064 +21 0.13745689822787427 +22 0.13922015616731154 +23 0.14082815062633774 +24 0.14226026905521147 +25 0.14349668290480055 +26 0.1445186751021504 +27 0.1453095567724877 +28 0.1458551691373635 +29 0.14614421061539154 +30 0.1461684237444241 +31 0.14592731087197264 +32 0.1454364904448951 +33 0.14471663894713344 +34 0.14379070378611125 +35 0.14268312766495347 +36 0.14141910229929616 +37 0.1400242568593778 +38 0.13852405524475148 +39 0.13693594937009554 +40 0.1352682259843752 +41 0.133530088851709 +42 0.13173228208063156 +43 0.12988686223111062 +44 0.1280064142542446 +45 0.126104251696744 +46 0.12419434117840034 +47 0.12229117015464314 +48 0.12041038086778931 +49 0.11857101694303926 +50 0.11679097652800079 +51 0.11508603372495745 +52 0.11346972772486705 +53 0.1119535425369769 +54 0.11054725529955563 +55 0.10925917485864142 +56 0.10809619024229951 +57 0.10706395108882347 +58 0.1061670534108405 +59 0.10540916889161556 +60 0.1047931438779291 +61 0.10432111251010957 +62 0.1039946237220952 +63 0.10381459623806397 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz new file mode 100644 index 000000000..d6711156d --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +D 2.2296719463915484 -2.619441202791937e-05 -2.6166286010633166e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +D 2.230617074640179 -2.6234153915720484e-05 -2.619664575684127e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +D 2.2323317070469857 -2.6309681191672105e-05 -2.6253981418693242e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +D 2.2348148290413676 -2.641586372459864e-05 -2.6333828822051484e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +D 2.2380643108115446 -2.65460915583343e-05 -2.64305288024654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +D 2.242077214427925 -2.6691994585651368e-05 -2.653718465905387e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +D 2.246849313017528 -2.6843564233083084e-05 -2.6645599610578535e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +D 2.2523755365111215 -2.6989297331060924e-05 -2.6746274832008708e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +D 2.2586499638311768 -2.7116268994223346e-05 -2.682846655016019e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +D 2.265665388765594 -2.7210259926653055e-05 -2.6880276609364334e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +D 2.273412032854628 -2.7255948508480735e-05 -2.6888783397516332e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +D 2.281878277202424 -2.7237192205197823e-05 -2.6840233088108822e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +D 2.2910513338601612 -2.7137394308182474e-05 -2.672028703024727e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +D 2.3009174265372856 -2.6939958468471007e-05 -2.6514325109784784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +D 2.311459546216867 -2.6628843862797897e-05 -2.6207812942785776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +D 2.3226565843471394 -2.618926020561152e-05 -2.5786766803768926e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +D 2.3344865661383136 -2.5608516200641137e-05 -2.5238327658769665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +D 2.3469268811324886 -2.487699729592541e-05 -2.4551412592374673e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +D 2.359952011487809 -2.3989288093695455e-05 -2.371744448270224e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +D 2.37353126610515 -2.2945468023562507e-05 -2.2731171618017035e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +D 2.3876325316647677 -2.175116135890678e-05 -2.159116441649958e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +D 2.4022233802242314 -2.0412515652782555e-05 -2.0298538729681438e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +D 2.4172687075307477 -1.8935538694906212e-05 -1.885648268839713e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +D 2.432725969230559 -1.7325939536104076e-05 -1.7269925616441828e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +D 2.4485503064867014 -1.5588932779216884e-05 -1.5545228085405195e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +D 2.46469615527222 -1.3729066458709845e-05 -1.3689896512368749e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +D 2.4811171835788226 -1.1751242237951108e-05 -1.1712623192823262e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +D 2.4977635128299713 -9.662535019590646e-06 -9.623750930721992e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +D 2.514583382308031 -7.472733524923033e-06 -7.435465340049839e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +D 2.531524666420477 -5.194656323082042e-06 -5.161827444091524e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +D 2.548535102403122 -2.8442411108649427e-06 -2.8186563065845445e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +D 2.565562921961005 -4.4040082342622287e-07 -4.232647950645104e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +D 2.582557327970536 1.9960879304868e-06 2.0060236350761574e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +D 2.599467543600721 4.444061232253395e-06 4.450445354543358e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +D 2.616242724409365 6.883244848747797e-06 6.891358407030648e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +D 2.632835458664418 9.295368841649292e-06 9.310780525940801e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +D 2.649202404631441 1.1665141468743203e-05 1.1691876136713952e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +D 2.6653005308853692 1.3979842586168898e-05 1.401928807386366e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +D 2.6810867494753 1.6228240627875306e-05 1.627934764442009e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +D 2.696519889094831 1.8400496922922536e-05 1.8460273307934843e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +D 2.7115636094186732 2.048809367016108e-05 2.0552295298367443e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +D 2.7261822935677107 2.2483750255993763e-05 2.2547703060070993e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +D 2.7403407406711877 2.4381315717553052e-05 2.4440835706522454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +D 2.754005373195774 2.6175670235409408e-05 2.6227963899455168e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +D 2.7671486730219543 2.7863090338675164e-05 2.790658666136301e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +D 2.779745778921899 2.9441286805462265e-05 2.9475267909154095e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +D 2.791773698961617 3.0909295120082775e-05 3.093362164973135e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +D 2.803211017371933 3.226735152150357e-05 3.228226161825952e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +D 2.8140412525317133 3.351675504218708e-05 3.352272117891817e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +D 2.8242508315357053 3.4659715253690844e-05 3.465734781024439e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +D 2.833827205344768 3.569919368757156e-05 3.568918241311985e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +D 2.8427591875132294 3.6638743119884046e-05 3.662182949246522e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +D 2.8510380836591898 3.748234645453314e-05 3.745932212989862e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +D 2.8586573172985394 3.823425857406711e-05 3.820598756932762e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +D 2.8656113418938256 3.889885434704505e-05 3.8866319008232235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +D 2.8718952024910136 3.9480491470659595e-05 3.9444855380407995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +D 2.8775050182670574 3.9983568373437155e-05 3.994603634823055e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +D 2.8824377705832016 4.041242303321893e-05 4.037407071557091e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +D 2.8866910353355717 4.077116512913104e-05 4.073284197537209e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +D 2.890262936170148 4.10635521318485e-05 4.1025837172872314e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +D 2.8931521754468346 4.129290057783304e-05 4.125609596835846e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +D 2.895357927995945 4.1462026899210815e-05 4.142617824902743e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +D 2.8968795979101114 4.1573214020175913e-05 4.153814931884134e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +D 2.89771729893857 4.162820136403926e-05 4.15935823410379e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener new file mode 100644 index 000000000..ec83dc3f1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.13344076815778944 +1 0.13350597554029547 +2 0.13363575948820305 +3 0.1338288632110306 +4 0.134083413638433 +5 0.13439693597364508 +6 0.13476637311767872 +7 0.13518810997043584 +8 0.13565800260347652 +9 0.13617141228015153 +10 0.13672324427064092 +11 0.13730799137215854 +12 0.13791978199771937 +13 0.13855243264065165 +14 0.13919950445753013 +15 0.13985436364001252 +16 0.14051024516837346 +17 0.1411603194579342 +18 0.14179775445635487 +19 0.14241568519506387 +20 0.14300728328348783 +21 0.14356589508503978 +22 0.1440851172115186 +23 0.14455886944443586 +24 0.14498146573989762 +25 0.14534768216272217 +26 0.1456528205872441 +27 0.1458927670262171 +28 0.14606404350729021 +29 0.14616385250803637 +30 0.14619011308405766 +31 0.1461415902639429 +32 0.14601937534911896 +33 0.1458265254311242 +34 0.145566805530133 +35 0.14524457610961072 +36 0.14486470916780467 +37 0.14443250216916687 +38 0.14395359154023069 +39 0.1434338673450423 +40 0.14287939061258836 +41 0.14229631461851475 +42 0.14169081123268026 +43 0.1410690032391952 +44 0.14043690332361008 +45 0.1398003602086623 +46 0.1391650122122337 +47 0.13853604243049505 +48 0.13791761692261295 +49 0.13731369340396973 +50 0.13672823296400757 +51 0.13616515878196916 +52 0.13562831507462428 +53 0.13512142682802297 +54 0.13464806082706757 +55 0.13421158845277156 +56 0.13381515066910485 +57 0.13346162557208227 +58 0.13315359882371663 +59 0.13289333724556276 +60 0.13268276580079472 +61 0.13252344815140743 +62 0.13241657093852707 +63 0.1323629318989296 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz new file mode 100644 index 000000000..fca756684 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +D 2.3727731017022706 -6.573162036991345e-05 -6.535304604594781e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +D 2.373211152535036 -6.558776358100927e-05 -6.521311521270003e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +D 2.374086336849262 -6.529995479117887e-05 -6.493310677907257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +D 2.3753968183111454 -6.486801167613696e-05 -6.451272657833811e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +D 2.377139838420972 -6.429169423402565e-05 -6.395155921203273e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +D 2.37931171193371 -6.357074700803162e-05 -6.324910564364996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +D 2.381907821115009 -6.270495691282956e-05 -6.240483055032214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +D 2.3849226091344726 -6.169421933174741e-05 -6.141821921289561e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +D 2.3883495729623347 -6.053860853196572e-05 -6.0288842625615316e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +D 2.3921812561951343 -5.923845041678968e-05 -5.901642876229827e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +D 2.3964092422848546 -5.7794393811117935e-05 -5.760093792169858e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +D 2.401024148687287 -5.620747626197443e-05 -5.6042639786074694e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +D 2.4060156224757043 -5.447918039126816e-05 -5.434218976683748e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +D 2.411372337984157 -5.2611476953714386e-05 -5.2500702052363254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +D 2.4170819970525947 -5.060685097332284e-05 -5.0519816664465235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +D 2.4231313324387553 -4.846830752071089e-05 -4.840175769929152e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +D 2.4295061149433943 -4.61993541414527e-05 -4.614938008733449e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +D 2.4361911647625227 -4.3803957614910634e-05 -4.3766202545027057e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +D 2.4431703675355485 -4.128647289336364e-05 -4.1256424416465107e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +D 2.4504266958110636 -3.865154957532089e-05 -3.862492573237442e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +D 2.4579422413457497 -3.590413613928061e-05 -3.5877272101938436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +D 2.465698258604672 -3.304954489475672e-05 -3.301971463923961e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +D 2.473675216355156 -3.0093579979163408e-05 -3.0059196327528187e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +D 2.481852857235644 -2.7042654959074005e-05 -2.7003348559266155e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +D 2.490210265066654 -2.3903891078600977e-05 -2.3860475946633696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +D 2.4987259394908965 -2.0685194279615693e-05 -2.0639529680564187e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +D 2.5073778773600814 -1.739532645244757e-05 -1.7350073171218784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +D 2.5161436601187166 -1.4043929653684157e-05 -1.400223276082765e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +D 2.5250005462861926 -1.0641484783303672e-05 -1.0606628969640474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +D 2.5339255680037502 -7.1992391755792265e-06 -7.174295979514513e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +D 2.542895630503215 -3.729096774266929e-06 -3.716589844259222e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +D 2.5518876132687565 -2.434638561861346e-07 -2.450859502842762e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +D 2.5608784706097456 3.2449577144353783e-06 3.2285338108183623e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +D 2.569845316057347 6.723427581273953e-06 6.692602463791477e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +D 2.578765492870325 1.0179404857873026e-05 1.0135587183684696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +D 2.58761664169884 1.3600744151105706e-05 1.3546200977389311e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +D 2.596376765285668 1.6975855133435043e-05 1.6913505143121867e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +D 2.6050242898107223 2.0293823241201297e-05 2.0227000487118942e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +D 2.6135381225336554 2.3544491559150596e-05 2.3476705789993175e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +D 2.6218977054462664 2.671851491144886e-05 2.6653223087983003e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +D 2.6300830647037903 2.98073862802409e-05 2.974778902402017e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +D 2.6380748556678935 3.280343851672054e-05 3.275231211043777e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +D 2.6458544034562985 3.56998244383029e-05 3.565939623610022e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +D 2.6534037389585743 3.849047874248332e-05 3.846235069520494e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +D 2.660705630338084 4.1170068121325584e-05 4.115518359382816e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +D 2.6677436101028182 4.373392769027831e-05 4.3732586316821016e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +D 2.674501997880584 4.617798677051143e-05 4.6189909246984204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +D 2.6809659190822788 4.849868649273772e-05 4.8523129041839296e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +D 2.687121320810235 5.069290824180629e-05 5.072881000319861e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +D 2.6929549884902007 5.2757952109481076e-05 5.280406322766094e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +D 2.6984545585902553 5.4691518299640154e-05 5.474650183757304e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +D 2.7036085265029537 5.649168165979415e-05 5.655419297152121e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +D 2.7084062501095665 5.815686119753453e-05 5.822560785216067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +D 2.7128379495945523 5.968578611152712e-05 5.975957112232412e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +D 2.716894704112094 6.10774596780074e-05 6.115521055529296e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +D 2.720568445925636 6.233112224936453e-05 6.241190813176001e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +D 2.7238519526475953 6.344621594798394e-05 6.352925310555834e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +D 2.726738838193951 6.442234915949323e-05 6.450699806621023e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +D 2.729223543049307 6.525926214838458e-05 6.534501871021933e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +D 2.7313013244007887 6.595679542998242e-05 6.604327773127232e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +D 2.7329682466547207 6.651486149761198e-05 6.660179322256007e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +D 2.734221172794841 6.693342041753533e-05 6.702061189531636e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +D 2.735057756976749 6.721245971941856e-05 6.729978734375631e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +D 2.735476438682034 6.735197892177608e-05 6.743936352210504e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 new file mode 100644 index 000000000..6cd984f2a --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 @@ -0,0 +1 @@ +-9.061855378392017976e-03 2.664540927089443698e-05 3.098757237676578232e-05 -9.072053528254145349e-03 2.648303929952405410e-05 3.082184066544540026e-05 -9.092362216305384728e-03 2.616168673230740891e-05 3.049240975682717498e-05 -9.122606915449724824e-03 2.568804803030458913e-05 3.000332763420027801e-05 -9.162527575992391107e-03 2.507197263931204546e-05 2.936062264378969371e-05 -9.211780715335984165e-03 2.432623011473526091e-05 2.857224838494952729e-05 -9.269942204386894327e-03 2.346620221581877845e-05 2.764800590812681530e-05 -9.336510748974126764e-03 2.250950263470058205e-05 2.659944004226394649e-05 -9.410912062185926991e-03 2.147552821286094959e-05 2.543970652544972916e-05 -9.492503719778503518e-03 2.038494697072270310e-05 2.418340684512274496e-05 -9.580580685669930555e-03 1.925913004264360475e-05 2.284638836163663668e-05 -9.674381488035810675e-03 1.811953662004888669e-05 2.144550838153734301e-05 -9.773095018593174615e-03 1.698706318526408722e-05 1.999836233855441800e-05 -9.875867918488823172e-03 1.588137053854111319e-05 1.852297804801410176e-05 -9.981812504054431504e-03 1.482020420525246315e-05 1.703748000937455346e-05 -1.009001517479298816e-02 1.381872555787605039e-05 1.555972976453388174e-05 -1.019954523481683695e-02 1.288887216337633959e-05 1.410695018409457665e-05 -1.030946404794483122e-02 1.203876625476238177e-05 1.269534303320755183e-05 -1.041789729204695668e-02 1.124228541854011920e-05 1.133380549800700756e-05 -1.051998595374178426e-02 1.038636080321890423e-05 1.001236803883887808e-05 -1.061383054297925475e-02 9.467737823937576202e-06 8.740628533707002165e-06 -1.069798013925073524e-02 8.499518605155226563e-06 7.530327839595928768e-06 -1.077106040793990305e-02 7.498047398141633466e-06 6.392794499864175696e-06 -1.083179021556197712e-02 6.482868882941178750e-06 5.338931460944801744e-06 -1.087899741725244229e-02 5.476596089059168539e-06 4.379200484349797496e-06 -1.091163356150816506e-02 4.504678513910079013e-06 3.523596266807426779e-06 -1.092878726714692841e-02 3.595062404477224389e-06 2.781601951854822854e-06 -1.092969604389205408e-02 2.777737627850703894e-06 2.162118154689148138e-06 -1.091375635065014275e-02 2.084169305987699101e-06 1.673359005177432426e-06 -1.088053171366664372e-02 1.546617553563474460e-06 1.322711166878409706e-06 -1.082975875955774839e-02 1.197355195285058731e-06 1.116555317809405249e-06 -1.076353854942566080e-02 1.068006474978134338e-06 1.060080547164248661e-06 -1.069099529109772927e-02 1.169906854527051106e-06 1.154599868374194460e-06 -1.061337279037817202e-02 1.486295098906186625e-06 1.396231485365216933e-06 -1.053093490500627179e-02 1.996504492928880106e-06 1.778936772905664578e-06 -1.044399541042680818e-02 2.677890481066476738e-06 2.294878744941987686e-06 -1.035291536296295729e-02 3.506429071035120637e-06 2.934647490896683409e-06 -1.025809996984188878e-02 4.457321973146198373e-06 3.687512930973994667e-06 -1.015999502282908737e-02 5.505587920859737251e-06 4.541693384029557850e-06 -1.005908295573720163e-02 6.626621355816490495e-06 5.484628645749040142e-06 -9.955878588082679378e-03 7.796702302285152286e-06 6.503247213743984512e-06 -9.850924617395230912e-03 8.993444509902587020e-06 7.584218793064951376e-06 -9.744786921511846070e-03 1.019617251285177730e-05 8.714185074676665185e-06 -9.638049730067791906e-03 1.138622185281087777e-05 9.879963795279185783e-06 -9.531310721386460419e-03 1.254716010420819819e-05 1.106872307432706743e-05 -9.425176097275295845e-03 1.366492935404761320e-05 1.226812484475597799e-05 -9.320248876645582242e-03 1.472799091894280330e-05 1.346644268193181128e-05 -9.215013348092947892e-03 1.575266061802714068e-05 1.465424686214770664e-05 -9.108262214701524570e-03 1.675847123034744505e-05 1.582285479264752457e-05 -9.001195322586681355e-03 1.773901651225156845e-05 1.696255382079780657e-05 -8.895007293771139273e-03 1.868785839976834593e-05 1.806430099942642848e-05 -8.790865473274591529e-03 1.959871135919774099e-05 1.911975637315744343e-05 -8.689899316998784054e-03 2.046549859414538279e-05 2.012129430498647452e-05 -8.593190395993882333e-03 2.128240440308712552e-05 2.106200289595980789e-05 -8.501763078222847325e-03 2.204392271547839775e-05 2.193567370050881755e-05 -8.416575934625750849e-03 2.274490183362351016e-05 2.273678392755690931e-05 -8.338513903419154244e-03 2.338058539784866824e-05 2.346047324084274909e-05 -8.268381235134358159e-03 2.394664956397403780e-05 2.410251713802320718e-05 -8.206895231242511760e-03 2.443923635818371774e-05 2.465929872491314174e-05 -8.154680781603199785e-03 2.485498314865283742e-05 2.512778050773649082e-05 -8.112265700042919914e-03 2.519104815084123442e-05 2.550547762280921667e-05 -8.080076853535841236e-03 2.544513187984290010e-05 2.579043371399642099e-05 -8.058437078099105200e-03 2.561549444958719488e-05 2.598120045509114584e-05 -8.047562874109801326e-03 2.570096863777318239e-05 2.607682150862987956e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.323488980084844280e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener new file mode 100644 index 000000000..ec83dc3f1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.13344076815778944 +1 0.13350597554029547 +2 0.13363575948820305 +3 0.1338288632110306 +4 0.134083413638433 +5 0.13439693597364508 +6 0.13476637311767872 +7 0.13518810997043584 +8 0.13565800260347652 +9 0.13617141228015153 +10 0.13672324427064092 +11 0.13730799137215854 +12 0.13791978199771937 +13 0.13855243264065165 +14 0.13919950445753013 +15 0.13985436364001252 +16 0.14051024516837346 +17 0.1411603194579342 +18 0.14179775445635487 +19 0.14241568519506387 +20 0.14300728328348783 +21 0.14356589508503978 +22 0.1440851172115186 +23 0.14455886944443586 +24 0.14498146573989762 +25 0.14534768216272217 +26 0.1456528205872441 +27 0.1458927670262171 +28 0.14606404350729021 +29 0.14616385250803637 +30 0.14619011308405766 +31 0.1461415902639429 +32 0.14601937534911896 +33 0.1458265254311242 +34 0.145566805530133 +35 0.14524457610961072 +36 0.14486470916780467 +37 0.14443250216916687 +38 0.14395359154023069 +39 0.1434338673450423 +40 0.14287939061258836 +41 0.14229631461851475 +42 0.14169081123268026 +43 0.1410690032391952 +44 0.14043690332361008 +45 0.1398003602086623 +46 0.1391650122122337 +47 0.13853604243049505 +48 0.13791761692261295 +49 0.13731369340396973 +50 0.13672823296400757 +51 0.13616515878196916 +52 0.13562831507462428 +53 0.13512142682802297 +54 0.13464806082706757 +55 0.13421158845277156 +56 0.13381515066910485 +57 0.13346162557208227 +58 0.13315359882371663 +59 0.13289333724556276 +60 0.13268276580079472 +61 0.13252344815140743 +62 0.13241657093852707 +63 0.1323629318989296 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz new file mode 100644 index 000000000..fca756684 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +D 2.3727731017022706 -6.573162036991345e-05 -6.535304604594781e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +D 2.373211152535036 -6.558776358100927e-05 -6.521311521270003e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +D 2.374086336849262 -6.529995479117887e-05 -6.493310677907257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +D 2.3753968183111454 -6.486801167613696e-05 -6.451272657833811e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +D 2.377139838420972 -6.429169423402565e-05 -6.395155921203273e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +D 2.37931171193371 -6.357074700803162e-05 -6.324910564364996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +D 2.381907821115009 -6.270495691282956e-05 -6.240483055032214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +D 2.3849226091344726 -6.169421933174741e-05 -6.141821921289561e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +D 2.3883495729623347 -6.053860853196572e-05 -6.0288842625615316e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +D 2.3921812561951343 -5.923845041678968e-05 -5.901642876229827e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +D 2.3964092422848546 -5.7794393811117935e-05 -5.760093792169858e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +D 2.401024148687287 -5.620747626197443e-05 -5.6042639786074694e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +D 2.4060156224757043 -5.447918039126816e-05 -5.434218976683748e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +D 2.411372337984157 -5.2611476953714386e-05 -5.2500702052363254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +D 2.4170819970525947 -5.060685097332284e-05 -5.0519816664465235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +D 2.4231313324387553 -4.846830752071089e-05 -4.840175769929152e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +D 2.4295061149433943 -4.61993541414527e-05 -4.614938008733449e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +D 2.4361911647625227 -4.3803957614910634e-05 -4.3766202545027057e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +D 2.4431703675355485 -4.128647289336364e-05 -4.1256424416465107e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +D 2.4504266958110636 -3.865154957532089e-05 -3.862492573237442e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +D 2.4579422413457497 -3.590413613928061e-05 -3.5877272101938436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +D 2.465698258604672 -3.304954489475672e-05 -3.301971463923961e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +D 2.473675216355156 -3.0093579979163408e-05 -3.0059196327528187e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +D 2.481852857235644 -2.7042654959074005e-05 -2.7003348559266155e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +D 2.490210265066654 -2.3903891078600977e-05 -2.3860475946633696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +D 2.4987259394908965 -2.0685194279615693e-05 -2.0639529680564187e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +D 2.5073778773600814 -1.739532645244757e-05 -1.7350073171218784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +D 2.5161436601187166 -1.4043929653684157e-05 -1.400223276082765e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +D 2.5250005462861926 -1.0641484783303672e-05 -1.0606628969640474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +D 2.5339255680037502 -7.1992391755792265e-06 -7.174295979514513e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +D 2.542895630503215 -3.729096774266929e-06 -3.716589844259222e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +D 2.5518876132687565 -2.434638561861346e-07 -2.450859502842762e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +D 2.5608784706097456 3.2449577144353783e-06 3.2285338108183623e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +D 2.569845316057347 6.723427581273953e-06 6.692602463791477e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +D 2.578765492870325 1.0179404857873026e-05 1.0135587183684696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +D 2.58761664169884 1.3600744151105706e-05 1.3546200977389311e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +D 2.596376765285668 1.6975855133435043e-05 1.6913505143121867e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +D 2.6050242898107223 2.0293823241201297e-05 2.0227000487118942e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +D 2.6135381225336554 2.3544491559150596e-05 2.3476705789993175e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +D 2.6218977054462664 2.671851491144886e-05 2.6653223087983003e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +D 2.6300830647037903 2.98073862802409e-05 2.974778902402017e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +D 2.6380748556678935 3.280343851672054e-05 3.275231211043777e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +D 2.6458544034562985 3.56998244383029e-05 3.565939623610022e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +D 2.6534037389585743 3.849047874248332e-05 3.846235069520494e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +D 2.660705630338084 4.1170068121325584e-05 4.115518359382816e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +D 2.6677436101028182 4.373392769027831e-05 4.3732586316821016e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +D 2.674501997880584 4.617798677051143e-05 4.6189909246984204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +D 2.6809659190822788 4.849868649273772e-05 4.8523129041839296e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +D 2.687121320810235 5.069290824180629e-05 5.072881000319861e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +D 2.6929549884902007 5.2757952109481076e-05 5.280406322766094e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +D 2.6984545585902553 5.4691518299640154e-05 5.474650183757304e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +D 2.7036085265029537 5.649168165979415e-05 5.655419297152121e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +D 2.7084062501095665 5.815686119753453e-05 5.822560785216067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +D 2.7128379495945523 5.968578611152712e-05 5.975957112232412e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +D 2.716894704112094 6.10774596780074e-05 6.115521055529296e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +D 2.720568445925636 6.233112224936453e-05 6.241190813176001e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +D 2.7238519526475953 6.344621594798394e-05 6.352925310555834e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +D 2.726738838193951 6.442234915949323e-05 6.450699806621023e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +D 2.729223543049307 6.525926214838458e-05 6.534501871021933e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +D 2.7313013244007887 6.595679542998242e-05 6.604327773127232e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +D 2.7329682466547207 6.651486149761198e-05 6.660179322256007e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +D 2.734221172794841 6.693342041753533e-05 6.702061189531636e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +D 2.735057756976749 6.721245971941856e-05 6.729978734375631e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +D 2.735476438682034 6.735197892177608e-05 6.743936352210504e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz new file mode 100644 index 000000000..8b1d1f419 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +D -0.0018660518736817906 3.622812461878516e-05 3.6019472561998554e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +D -0.0018620443607219002 3.6148837638693244e-05 3.5942349380850994e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +D -0.001854024754273556 3.59902112021977e-05 3.578802212753396e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +D -0.0018419841830200066 3.5752144820874666e-05 3.555632867141997e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +D -0.0018259100593112124 3.543450621718151e-05 3.524704006474792e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +D -0.0018057869282991023 3.5037154595543496e-05 3.48598812624688e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +D -0.0017815975767378565 3.4559972513523094e-05 3.439455722022724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +D -0.0017533243815192926 3.40029023114154e-05 3.3850784249449306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +D -0.001720950873206811 3.336598492173749e-05 3.322832590268601e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +D -0.0016844634851634337 3.2649399966800306e-05 3.252703225211872e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +D -0.0016438534544539064 3.1853505047848914e-05 3.174688141631996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +D -0.001599118836589558 3.097887201116779e-05 3.0888022031249295e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +D -0.0015502665925036078 3.0026318007026155e-05 2.9950815328322207e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +D -0.0014973147030178146 2.8996929221144317e-05 2.8935875394870175e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +D -0.001440294263591693 2.7892075279875578e-05 2.7844106132459788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +D -0.001379251510509959 2.671341243438494e-05 2.667673335648954e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +D -0.0013142497289489847 2.546287387599571e-05 2.5435330568070065e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +D -0.0012453709937240009 2.4142645903726033e-05 2.412183711536762e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +D -0.001172719038224144 2.2755128758935888e-05 2.2738567475955815e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +D -0.001096440284274665 2.1302885077891803e-05 2.128821128931535e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +D -0.0010167252348586406 1.9788642225212173e-05 1.977383605297545e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +D -0.0009337960960280491 1.821532809176598e-05 1.8198887081971875e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +D -0.0008479060490378361 1.658614164043231e-05 1.6567191016527414e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +D -0.000759338193633965 1.4904617722288343e-05 1.4882953915089605e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +D -0.0006684038125637904 1.3174681226416316e-05 1.3150752882608568e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +D -0.0005754399731936938 1.1400689529764076e-05 1.1375521387311559e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +D -0.00048080650176049195 9.587471767121907e-06 9.562530323376277e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +D -0.000384882385097928 7.74034217881539e-06 7.717360846206815e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +D -0.00028806167277086446 5.8650773355176765e-06 5.845866478490677e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +D -0.0001907489687453904 3.9678762298198896e-06 3.9541287334043455e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +D -9.335461524651834e-05 2.055299746048691e-06 2.0484065245463495e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +D 3.7141702529989687e-06 1.3418563048414451e-07 1.350796511518256e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +D 0.00010011345542751705 -1.7884654569547458e-06 -1.7794133869827038e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +D 0.0001955535800291956 -3.705631641347149e-06 -3.6886423112308482e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +D 0.00028975640300377565 -5.610400986020552e-06 -5.586250780197743e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +D 0.0003824557576763887 -7.496079531305789e-06 -7.466017943239325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +D 0.00047339896489504227 -9.356279243133138e-06 -9.321914911228127e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +D 0.0005623481551086827 -1.1184984536154181e-05 -1.1148155030831748e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +D 0.000649081379604965 -1.297659740457675e-05 -1.2939237131414532e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +D 0.0007333934956959757 -1.4725967234544127e-05 -1.4689981504939455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +D 0.0008150968154294055 -1.6428405364781007e-05 -1.639555820821995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +D 0.0008940215123513424 -1.8079686029653455e-05 -1.8051507600341975e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +D 0.00097001578574858 -1.967603538968246e-05 -1.9653753298669492e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +D 0.0010429457865782131 -2.1214110540284903e-05 -2.11986077062402e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +D 0.0011126953137798967 -2.2690972017265998e-05 -2.2682768377768998e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +D 0.001179165293834631 -2.4104048759424007e-05 -2.4103309458544184e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +D 0.0012422730600919493 -2.545109720332463e-05 -2.545766830199814e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +D 0.0013019469358093625 -2.6730155870469197e-05 -2.6743627434229065e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +D 0.001358113556344446 -2.793950592937768e-05 -2.7959293262755972e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +D 0.0014107150112688874 -2.907765931979103e-05 -2.9103073562226113e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +D 0.0014597126287351088 -3.0143348504106588e-05 -3.0173652799862635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +D 0.0015050849715898614 -3.1135512430369404e-05 -3.11699656749203e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +D 0.0015468256434708813 -3.2053279731196844e-05 -3.20911695984617e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +D 0.0015849409626666976 -3.289595000168727e-05 -3.293661676984403e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +D 0.0016194475614604241 -3.366297389538385e-05 -3.3705826459426384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +D 0.0016503699673877056 -3.435393273086422e-05 -3.4398458044531996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +D 0.0016777382204925697 -3.496851903267546e-05 -3.5014285141523315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +D 0.0017015855773900833 -3.550651696170993e-05 -3.555317138958086e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +D 0.0017219463490160747 -3.5967783364181184e-05 -3.6015048278564015e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +D 0.0017388539144249891 -3.6352230339765606e-05 -3.6399895247017525e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +D 0.001752338948120828 -3.66598096589703e-05 -3.670772226704267e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +D 0.0017624278932598908 -3.689049931222929e-05 -3.693855508363688e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +D 0.0017691417077559607 -3.7044292426491116e-05 -3.709242323536766e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +D 0.0017724949049269768 -3.712118873638392e-05 -3.716935094770116e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..0293755ee --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +D -0.0028588579706978886 1.4437106797653668e-05 1.4421605082443541e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +D -0.0028551564247003705 1.4459010625001025e-05 1.4438337922176264e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +D -0.0028483146135055283 1.4500637646362955e-05 1.4469938596113468e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +D -0.002838119629476885 1.4559160378855359e-05 1.451394666503174e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +D -0.002824272329815609 1.4630935730852758e-05 1.4567243068214171e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +D -0.002806393715298487 1.4711350499668045e-05 1.4626026674065744e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +D -0.0027840370905967177 1.4794888438405592e-05 1.4685779808892968e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +D -0.0027566984747163454 1.487520955029833e-05 1.474126717475236e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +D -0.0027238308567461298 1.4945190256847413e-05 1.4786567317835198e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +D -0.0026848627268221776 1.4996993562378853e-05 1.4815122543931731e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +D -0.002639224296545019 1.5022174922990288e-05 1.4819811078605635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +D -0.0025863649926720924 1.5011837345901864e-05 1.479305247065413e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +D -0.0025257710245732705 1.4956833519289678e-05 1.4726943941649579e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +D -0.002456985599109257 1.4848016329556204e-05 1.4613427584084559e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +D -0.002379647097387393 1.4676544842292996e-05 1.4444492740842866e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +D -0.0022935208785061856 1.443426735965515e-05 1.4212432251405383e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +D -0.002198496825014237 1.4114189046276015e-05 1.3910158831413024e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +D -0.00209449730515764 1.3711010821064202e-05 1.3531564108084563e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +D -0.00198138253957698 1.322174797583622e-05 1.3071920782158967e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +D -0.0018591130561937258 1.2646444288393968e-05 1.2528334361363893e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +D -0.0017277450161351329 1.1988199589165502e-05 1.190001692859008e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +D -0.0015874256303747673 1.1250402115302105e-05 1.1187583487820604e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +D -0.0014384197782641485 1.0436363073089324e-05 1.0392791184254749e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +D -0.0012811634591928473 9.549229018227864e-06 9.518356825354928e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +D -0.0011162330290022046 8.591873990342615e-06 8.567786053898553e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +D -0.0009445452725943722 7.566804648457788e-06 7.545216047882138e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +D -0.000767324303871637 6.4767225549316715e-06 6.455437584750251e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +D -0.0005859579966761682 5.325527057649295e-06 5.304151123253453e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +D -0.0004019534967415484 4.118613231506464e-06 4.098072790873724e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +D -0.00021689327846641465 2.8630460585833316e-06 2.8449523509815655e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +D -3.2402216865165805e-05 1.5676096349125004e-06 1.5535085147423096e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +D 0.0001500635154829055 2.427278655769095e-07 2.3328330651286266e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +D 0.00032956586908914666 -1.1001481766122476e-06 -1.1056242616686178e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +D 0.0005052872624287663 -2.449353952170036e-06 -2.4528725749668077e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +D 0.0006764530861017888 -3.7937152736947585e-06 -3.7981870788764773e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +D 0.0008423747761222727 -5.123162625197986e-06 -5.13165680830128e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +D 0.001002459763718507 -6.429267929911277e-06 -6.444002799939363e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +D 0.0011561774965601554 -7.705020453056475e-06 -7.726760918844667e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +D 0.0013030558057977916 -8.944229892732112e-06 -8.972397635347602e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +D 0.00144254321424588 -1.0141473644187425e-05 -1.0174419527969069e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +D 0.0015740251248491234 -1.1292057102911129e-05 -1.1327441969042524e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +D 0.001697004053532831 -1.2391967542985086e-05 -1.2427215269159977e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +D 0.0018111141271062892 -1.3437814847932076e-05 -1.3470619418480576e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +D 0.0019161311730233597 -1.4426777218209114e-05 -1.4455598984159218e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +D 0.0020120003026955933 -1.5356802454789717e-05 -1.5380775547038565e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +D 0.00209879751990021 -1.6226628848083073e-05 -1.6245357606819023e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +D 0.002176713317353931 -1.7035724803183355e-05 -1.704913242257097e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +D 0.0022460393231655148 -1.7784220523707708e-05 -1.77924382557568e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +D 0.00230723567759177 -1.8472831974205114e-05 -1.8476120223357813e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +D 0.0023609954763357897 -1.91027769648146e-05 -1.910147214324283e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +D 0.0024080144349016962 -1.9675687750053773e-05 -1.9670170014504455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +D 0.002448946007925917 -2.019352245012311e-05 -2.0184200467819362e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +D 0.002484404160650643 -2.065847625111717e-05 -2.064578634483723e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +D 0.0025149590659542705 -2.1072894240747624e-05 -2.1057312615389286e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +D 0.0025411316221171944 -2.1439187637275288e-05 -2.142125571497683e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +D 0.0025633922413990473 -2.1759758194925263e-05 -2.1740117286770314e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +D 0.0025821633286377517 -2.203703011708527e-05 -2.2016344260282588e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +D 0.002597819161153955 -2.227339428961725e-05 -2.2252256326862757e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +D 0.002610685935909768 -2.2471115771052947e-05 -2.244999388203894e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +D 0.0026210426822979417 -2.2632265499475123e-05 -2.261147881833e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +D 0.002629122356213608 -2.2758671391121997e-05 -2.273838645107203e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +D 0.0026351124641959905 -2.285188572864646e-05 -2.2832127667625746e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +D 0.0026391552667620957 -2.2913166750651677e-05 -2.2893840764733173e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +D 0.0026413497719772455 -2.294347314405453e-05 -2.2924392794712523e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz new file mode 100644 index 000000000..8b1d1f419 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +D -0.0018660518736817906 3.622812461878516e-05 3.6019472561998554e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +D -0.0018620443607219002 3.6148837638693244e-05 3.5942349380850994e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +D -0.001854024754273556 3.59902112021977e-05 3.578802212753396e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +D -0.0018419841830200066 3.5752144820874666e-05 3.555632867141997e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +D -0.0018259100593112124 3.543450621718151e-05 3.524704006474792e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +D -0.0018057869282991023 3.5037154595543496e-05 3.48598812624688e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +D -0.0017815975767378565 3.4559972513523094e-05 3.439455722022724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +D -0.0017533243815192926 3.40029023114154e-05 3.3850784249449306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +D -0.001720950873206811 3.336598492173749e-05 3.322832590268601e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +D -0.0016844634851634337 3.2649399966800306e-05 3.252703225211872e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +D -0.0016438534544539064 3.1853505047848914e-05 3.174688141631996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +D -0.001599118836589558 3.097887201116779e-05 3.0888022031249295e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +D -0.0015502665925036078 3.0026318007026155e-05 2.9950815328322207e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +D -0.0014973147030178146 2.8996929221144317e-05 2.8935875394870175e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +D -0.001440294263591693 2.7892075279875578e-05 2.7844106132459788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +D -0.001379251510509959 2.671341243438494e-05 2.667673335648954e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +D -0.0013142497289489847 2.546287387599571e-05 2.5435330568070065e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +D -0.0012453709937240009 2.4142645903726033e-05 2.412183711536762e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +D -0.001172719038224144 2.2755128758935888e-05 2.2738567475955815e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +D -0.001096440284274665 2.1302885077891803e-05 2.128821128931535e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +D -0.0010167252348586406 1.9788642225212173e-05 1.977383605297545e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +D -0.0009337960960280491 1.821532809176598e-05 1.8198887081971875e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +D -0.0008479060490378361 1.658614164043231e-05 1.6567191016527414e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +D -0.000759338193633965 1.4904617722288343e-05 1.4882953915089605e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +D -0.0006684038125637904 1.3174681226416316e-05 1.3150752882608568e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +D -0.0005754399731936938 1.1400689529764076e-05 1.1375521387311559e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +D -0.00048080650176049195 9.587471767121907e-06 9.562530323376277e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +D -0.000384882385097928 7.74034217881539e-06 7.717360846206815e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +D -0.00028806167277086446 5.8650773355176765e-06 5.845866478490677e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +D -0.0001907489687453904 3.9678762298198896e-06 3.9541287334043455e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +D -9.335461524651834e-05 2.055299746048691e-06 2.0484065245463495e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +D 3.7141702529989687e-06 1.3418563048414451e-07 1.350796511518256e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +D 0.00010011345542751705 -1.7884654569547458e-06 -1.7794133869827038e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +D 0.0001955535800291956 -3.705631641347149e-06 -3.6886423112308482e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +D 0.00028975640300377565 -5.610400986020552e-06 -5.586250780197743e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +D 0.0003824557576763887 -7.496079531305789e-06 -7.466017943239325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +D 0.00047339896489504227 -9.356279243133138e-06 -9.321914911228127e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +D 0.0005623481551086827 -1.1184984536154181e-05 -1.1148155030831748e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +D 0.000649081379604965 -1.297659740457675e-05 -1.2939237131414532e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +D 0.0007333934956959757 -1.4725967234544127e-05 -1.4689981504939455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +D 0.0008150968154294055 -1.6428405364781007e-05 -1.639555820821995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +D 0.0008940215123513424 -1.8079686029653455e-05 -1.8051507600341975e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +D 0.00097001578574858 -1.967603538968246e-05 -1.9653753298669492e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +D 0.0010429457865782131 -2.1214110540284903e-05 -2.11986077062402e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +D 0.0011126953137798967 -2.2690972017265998e-05 -2.2682768377768998e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +D 0.001179165293834631 -2.4104048759424007e-05 -2.4103309458544184e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +D 0.0012422730600919493 -2.545109720332463e-05 -2.545766830199814e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +D 0.0013019469358093625 -2.6730155870469197e-05 -2.6743627434229065e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +D 0.001358113556344446 -2.793950592937768e-05 -2.7959293262755972e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +D 0.0014107150112688874 -2.907765931979103e-05 -2.9103073562226113e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +D 0.0014597126287351088 -3.0143348504106588e-05 -3.0173652799862635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +D 0.0015050849715898614 -3.1135512430369404e-05 -3.11699656749203e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +D 0.0015468256434708813 -3.2053279731196844e-05 -3.20911695984617e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +D 0.0015849409626666976 -3.289595000168727e-05 -3.293661676984403e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +D 0.0016194475614604241 -3.366297389538385e-05 -3.3705826459426384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +D 0.0016503699673877056 -3.435393273086422e-05 -3.4398458044531996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +D 0.0016777382204925697 -3.496851903267546e-05 -3.5014285141523315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +D 0.0017015855773900833 -3.550651696170993e-05 -3.555317138958086e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +D 0.0017219463490160747 -3.5967783364181184e-05 -3.6015048278564015e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +D 0.0017388539144249891 -3.6352230339765606e-05 -3.6399895247017525e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +D 0.001752338948120828 -3.66598096589703e-05 -3.670772226704267e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +D 0.0017624278932598908 -3.689049931222929e-05 -3.693855508363688e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +D 0.0017691417077559607 -3.7044292426491116e-05 -3.709242323536766e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +D 0.0017724949049269768 -3.712118873638392e-05 -3.716935094770116e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 new file mode 100644 index 000000000..35f8223ca --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 new file mode 100644 index 000000000..425ff74f1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 0 +{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} + #*EXTRAS*# Step: 1 Bead: 0 +{"friction": [[0.00012934543425376094, -3.618271039482692e-05, -3.5904795117197906e-05], [-3.618271039482692e-05, 0.00012951879292860837, -3.6216758470280675e-05], [-3.5904795117197906e-05, -3.6216758470280675e-05, 0.0001290051849108313]]} + #*EXTRAS*# Step: 2 Bead: 0 +{"friction": [[0.00012680530963699927, -3.9497470282282685e-05, -3.8976481610773324e-05], [-3.9497470282282685e-05, 0.00012689629007119941, -3.957872420317071e-05], [-3.8976481610773324e-05, -3.957872420317071e-05, 0.000126462327563967]]} + #*EXTRAS*# Step: 3 Bead: 0 +{"friction": [[0.00012527459299002867, -4.1091076486058416e-05, -4.054114005433311e-05], [-4.1091076486058416e-05, 0.00012533642179523015, -4.118929011080804e-05], [-4.054114005433311e-05, -4.118929011080804e-05, 0.00012497289991242086]]} + #*EXTRAS*# Step: 4 Bead: 0 +{"friction": [[0.00012453159453860614, -4.1760239475510894e-05, -4.126407323614469e-05], [-4.1760239475510894e-05, 0.000124591785976315, -4.18618000181609e-05], [-4.126407323614469e-05, -4.18618000181609e-05, 0.0001242634657316739]]} + #*EXTRAS*# Step: 5 Bead: 0 +{"friction": [[0.00012410690082153493, -4.210783838978701e-05, -4.1666054988542505e-05], [-4.210783838978701e-05, 0.00012416978581991436, -4.220865587788328e-05], [-4.1666054988542505e-05, -4.220865587788328e-05, 0.00012386209095335458]]} + #*EXTRAS*# Step: 6 Bead: 0 +{"friction": [[0.00012385705139214003, -4.229942800986635e-05, -4.189609244197549e-05], [-4.229942800986635e-05, 0.00012392203984417058, -4.2398442284290914e-05], [-4.189609244197549e-05, -4.2398442284290914e-05, 0.0001236271084636086]]} + #*EXTRAS*# Step: 7 Bead: 0 +{"friction": [[0.00012370176129122324, -4.241353228622466e-05, -4.203600358446615e-05], [-4.241353228622466e-05, 0.00012376805078787145, -4.251080414086017e-05], [-4.203600358446615e-05, -4.251080414086017e-05, 0.00012348140623677362]]} + #*EXTRAS*# Step: 8 Bead: 0 +{"friction": [[0.00012360304445542989, -4.248406094530929e-05, -4.2123558321892614e-05], [-4.248406094530929e-05, 0.00012367010507923949, -4.257994985882027e-05], [-4.2123558321892614e-05, -4.257994985882027e-05, 0.00012338889989924629]]} + #*EXTRAS*# Step: 9 Bead: 0 +{"friction": [[0.00012353910394013773, -4.252890770192973e-05, -4.2179650971995733e-05], [-4.252890770192973e-05, 0.00012360662618533794, -4.262377949672673e-05], [-4.2179650971995733e-05, -4.262377949672673e-05, 0.00012332902344596605]]} + #*EXTRAS*# Step: 10 Bead: 0 +{"friction": [[0.00012349725170453886, -4.255790584165255e-05, -4.221609150611516e-05], [-4.255790584165255e-05, 0.00012356505588193283, -4.2652058266072764e-05], [-4.221609150611516e-05, -4.2652058266072764e-05, 0.00012328984711168573]]} + #*EXTRAS*# Step: 11 Bead: 0 +{"friction": [[0.00012346964840900584, -4.2576877015557237e-05, -4.2240003216563973e-05], [-4.2576877015557237e-05, 0.00012353762860077785, -4.26705312238049e-05], [-4.2240003216563973e-05, -4.26705312238049e-05, 0.00012326401497421126]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 new file mode 100644 index 000000000..53dadbd49 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 1 +{"friction": [[0.0001318960708675288, -3.145359585337808e-05, -3.140499284046311e-05], [-3.145359585337808e-05, 0.00013214032682715794, -3.1420093958772926e-05], [-3.140499284046311e-05, -3.1420093958772926e-05, 0.00013167914079224472]]} + #*EXTRAS*# Step: 1 Bead: 1 +{"friction": [[0.00012930486527308808, -3.624364186203017e-05, -3.5961128719340115e-05], [-3.624364186203017e-05, 0.00012947681871798488, -3.627859614075686e-05], [-3.5961128719340115e-05, -3.627859614075686e-05, 0.0001289638307171534]]} + #*EXTRAS*# Step: 2 Bead: 1 +{"friction": [[0.00012677727532838827, -3.95291769519208e-05, -3.9006493758668574e-05], [-3.95291769519208e-05, 0.00012686750943694891, -3.961083324174769e-05], [-3.9006493758668574e-05, -3.961083324174769e-05, 0.000126434752641205]]} + #*EXTRAS*# Step: 3 Bead: 1 +{"friction": [[0.0001252522044209213, -4.111228799292027e-05, -4.0563165840992805e-05], [-4.111228799292027e-05, 0.00012531383636208075, -4.1210660802913846e-05], [-4.0563165840992805e-05, -4.1210660802913846e-05, 0.00012495138018070654]]} + #*EXTRAS*# Step: 4 Bead: 1 +{"friction": [[0.00012451262225947747, -4.177633752878506e-05, -4.12822648084072e-05], [-4.177633752878506e-05, 0.00012457289294147213, -4.1877916832661114e-05], [-4.12822648084072e-05, -4.1877916832661114e-05, 0.00012424547608927923]]} + #*EXTRAS*# Step: 5 Bead: 1 +{"friction": [[0.0001240895912781255, -4.2121426075714985e-05, -4.168216801064642e-05], [-4.2121426075714985e-05, 0.00012415261611248347, -4.2222155022916904e-05], [-4.168216801064642e-05, -4.2222155022916904e-05, 0.00012384578652790577]]} + #*EXTRAS*# Step: 6 Bead: 1 +{"friction": [[0.0001238406336562388, -4.2311673096820816e-05, -4.191100320291615e-05], [-4.2311673096820816e-05, 0.00012390576239946526, -4.241052700823726e-05], [-4.191100320291615e-05, -4.241052700823726e-05, 0.00012361169285551881]]} + #*EXTRAS*# Step: 7 Bead: 1 +{"friction": [[0.00012368586506925164, -4.242499505517851e-05, -4.205017809637978e-05], [-4.242499505517851e-05, 0.00012375228266420344, -4.2522059161828516e-05], [-4.205017809637978e-05, -4.2522059161828516e-05, 0.00012346650445006457]]} + #*EXTRAS*# Step: 8 Bead: 1 +{"friction": [[0.00012358746769280731, -4.249504681170327e-05, -4.213726912695905e-05], [-4.249504681170327e-05, 0.0001236546439039854, -4.259069691838904e-05], [-4.213726912695905e-05, -4.259069691838904e-05, 0.00012337431037132303]]} + #*EXTRAS*# Step: 9 Bead: 1 +{"friction": [[0.00012352372896883305, -4.253959331620743e-05, -4.219306357588242e-05], [-4.253959331620743e-05, 0.0001235913567927779, -4.263420583935721e-05], [-4.219306357588242e-05, -4.263420583935721e-05, 0.0001233146301200287]]} + #*EXTRAS*# Step: 10 Bead: 1 +{"friction": [[0.00012348200670407654, -4.256839857831431e-05, -4.222930984571026e-05], [-4.256839857831431e-05, 0.00012354990911802243, -4.266227820118861e-05], [-4.222930984571026e-05, -4.266227820118861e-05, 0.00012327557970750935]]} + #*EXTRAS*# Step: 11 Bead: 1 +{"friction": [[0.00012345448820706993, -4.258724413443976e-05, -4.2253093858474775e-05], [-4.258724413443976e-05, 0.0001235225614565618, -4.26806165627e-05], [-4.2253093858474775e-05, -4.26806165627e-05, 0.0001232498295318448]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 new file mode 100644 index 000000000..3d07015a5 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 2 +{"friction": [[0.00013182249801045433, -3.1627039924819494e-05, -3.157597998104187e-05], [-3.1627039924819494e-05, 0.00013206576277603182, -3.1595838794370805e-05], [-3.157597998104187e-05, -3.1595838794370805e-05, 0.0001315990850259919]]} + #*EXTRAS*# Step: 1 Bead: 2 +{"friction": [[0.00012923108930599453, -3.6353652737885806e-05, -3.6062785314018805e-05], [-3.6353652737885806e-05, 0.0001294004836228374, -3.639024281520528e-05], [-3.6062785314018805e-05, -3.639024281520528e-05, 0.00012888869629231863]]} + #*EXTRAS*# Step: 2 Bead: 2 +{"friction": [[0.00012672135259414853, -3.959214072162623e-05, -3.9066178140534965e-05], [-3.959214072162623e-05, 0.00012681011591002486, -3.9674590722181904e-05], [-3.9066178140534965e-05, -3.9674590722181904e-05, 0.00012637977774619612]]} + #*EXTRAS*# Step: 3 Bead: 2 +{"friction": [[0.00012520760809126187, -4.115435311482684e-05, -4.060699073178873e-05], [-4.115435311482684e-05, 0.00012526887374338333, -4.1253033813381775e-05], [-4.060699073178873e-05, -4.1253033813381775e-05, 0.00012490853993662836]]} + #*EXTRAS*# Step: 4 Bead: 2 +{"friction": [[0.0001244748132251995, -4.180826321240631e-05, -4.131846185162289e-05], [-4.180826321240631e-05, 0.00012453525576586218, -4.190986698891169e-05], [-4.131846185162289e-05, -4.190986698891169e-05, 0.00012420964268517511]]} + #*EXTRAS*# Step: 5 Bead: 2 +{"friction": [[0.00012405507440282424, -4.2148382545368785e-05, -4.171422516085467e-05], [-4.2148382545368785e-05, 0.0001241183820760016, -4.224891952595161e-05], [-4.171422516085467e-05, -4.224891952595161e-05, 0.0001238132855627299]]} + #*EXTRAS*# Step: 6 Bead: 2 +{"friction": [[0.00012380788333468055, -4.233597178315575e-05, -4.194066561728076e-05], [-4.233597178315575e-05, 0.00012387329072427913, -4.243448932825025e-05], [-4.194066561728076e-05, -4.243448932825025e-05, 0.00012358095004983145]]} + #*EXTRAS*# Step: 7 Bead: 2 +{"friction": [[0.0001236541480317297, -4.244774511008442e-05, -4.207837405027229e-05], [-4.244774511008442e-05, 0.00012372081705698038, -4.254437773092577e-05], [-4.207837405027229e-05, -4.254437773092577e-05, 0.00012343677817892472]]} + #*EXTRAS*# Step: 8 Bead: 2 +{"friction": [[0.0001235563837097352, -4.251685284128123e-05, -4.2164541506690154e-05], [-4.251685284128123e-05, 0.0001236237846671686, -4.261200917143531e-05], [-4.2164541506690154e-05, -4.261200917143531e-05, 0.00012334520194097132]]} + #*EXTRAS*# Step: 9 Bead: 2 +{"friction": [[0.0001234930449077949, -4.256080500768818e-05, -4.2219742037343975e-05], [-4.256080500768818e-05, 0.00012356087644094634, -4.265488273245225e-05], [-4.2219742037343975e-05, -4.265488273245225e-05, 0.00012328590992971488]]} + #*EXTRAS*# Step: 10 Bead: 2 +{"friction": [[0.00012345158024685302, -4.258922847965072e-05, -4.225560140408513e-05], [-4.258922847965072e-05, 0.00012351967104233012, -4.268254619250217e-05], [-4.225560140408513e-05, -4.268254619250217e-05, 0.0001232471087031815]]} + #*EXTRAS*# Step: 11 Bead: 2 +{"friction": [[0.00012342422983022242, -4.260782538427597e-05, -4.227913109305686e-05], [-4.260782538427597e-05, 0.00012349248068976987, -4.2700617915078515e-05], [-4.227913109305686e-05, -4.2700617915078515e-05, 0.0001232215207278749]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 new file mode 100644 index 000000000..71b6b8635 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 3 +{"friction": [[0.00013171780647812666, -3.186828910318049e-05, -3.181299933918628e-05], [-3.186828910318049e-05, 0.0001319594795236481, -3.184031805657655e-05], [-3.181299933918628e-05, -3.184031805657655e-05, 0.00013148559226403892]]} + #*EXTRAS*# Step: 1 Bead: 3 +{"friction": [[0.00012912386466953438, -3.651174949864347e-05, -3.620876797333617e-05], [-3.651174949864347e-05, 0.00012928953365626408, -3.6550689061982367e-05], [-3.620876797333617e-05, -3.6550689061982367e-05, 0.00012877965463459854]]} + #*EXTRAS*# Step: 2 Bead: 3 +{"friction": [[0.00012663782403959798, -3.9685482502047956e-05, -3.91548788542534e-05], [-3.9685482502047956e-05, 0.00012672443649999797, -3.976909557013233e-05], [-3.91548788542534e-05, -3.976909557013233e-05, 0.0001262977432251237]]} + #*EXTRAS*# Step: 3 Bead: 3 +{"friction": [[0.00012514116867822254, -4.1216558112123804e-05, -4.067216615037439e-05], [-4.1216558112123804e-05, 0.00012520195411322665, -4.13156743574553e-05], [-4.067216615037439e-05, -4.13156743574553e-05, 0.00012484478032243773]]} + #*EXTRAS*# Step: 4 Bead: 3 +{"friction": [[0.00012441843275073537, -4.185548321609393e-05, -4.137229290853237e-05], [-4.185548321609393e-05, 0.00012447916424876646, -4.1957090365569186e-05], [-4.137229290853237e-05, -4.1957090365569186e-05, 0.0001241562506050922]]} + #*EXTRAS*# Step: 5 Bead: 3 +{"friction": [[0.0001240035499461503, -4.2188276255689016e-05, -4.176188936820454e-05], [-4.2188276255689016e-05, 0.00012406728796906093, -4.228848751528499e-05], [-4.176188936820454e-05, -4.228848751528499e-05, 0.00012376479838601323]]} + #*EXTRAS*# Step: 6 Bead: 3 +{"friction": [[0.0001237589666101063, -4.2371946690226304e-05, -4.198476219313653e-05], [-4.2371946690226304e-05, 0.00012382478553567972, -4.246992010928841e-05], [-4.198476219313653e-05, -4.246992010928841e-05, 0.00012353505207201183]]} + #*EXTRAS*# Step: 7 Bead: 3 +{"friction": [[0.00012360675719556453, -4.2481436692528955e-05, -4.212028603587234e-05], [-4.2481436692528955e-05, 0.00012367378999340493, -4.257738168297923e-05], [-4.212028603587234e-05, -4.257738168297923e-05, 0.00012339237760933258]]} + #*EXTRAS*# Step: 8 Bead: 3 +{"friction": [[0.00012350992799244954, -4.254915259527099e-05, -4.22050777331205e-05], [-4.254915259527099e-05, 0.0001235776486247615, -4.2643527456122986e-05], [-4.22050777331205e-05, -4.2643527456122986e-05, 0.00012330171167228263]]} + #*EXTRAS*# Step: 9 Bead: 3 +{"friction": [[0.00012344718004724062, -4.259222851761747e-05, -4.225939359825561e-05], [-4.259222851761747e-05, 0.00012351529720316837, -4.2685463028546076e-05], [-4.225939359825561e-05, -4.2685463028546076e-05, 0.0001232429917578638]]} + #*EXTRAS*# Step: 10 Bead: 3 +{"friction": [[0.00012340609602805956, -4.262008911872689e-05, -4.229467667499026e-05], [-4.262008911872689e-05, 0.00012347444788070354, -4.2712522832756215e-05], [-4.229467667499026e-05, -4.2712522832756215e-05, 0.00012320455776100226]]} + #*EXTRAS*# Step: 11 Bead: 3 +{"friction": [[0.0001233789939929936, -4.2638319441954836e-05, -4.2317827557702834e-05], [-4.2638319441954836e-05, 0.00012344748874023386, -4.27302009242659e-05], [-4.2317827557702834e-05, -4.27302009242659e-05, 0.00012317920883979217]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 new file mode 100644 index 000000000..4ff6a1c04 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 4 +{"friction": [[0.00013158007460812243, -3.217616690285429e-05, -3.2114038906784815e-05], [-3.217616690285429e-05, 0.000131819341634194, -3.215236678795705e-05], [-3.2114038906784815e-05, -3.215236678795705e-05, 0.00013133701434974246]]} + #*EXTRAS*# Step: 1 Bead: 4 +{"friction": [[0.00012898291772121421, -3.6716433290988916e-05, -3.6397607689923824e-05], [-3.6716433290988916e-05, 0.00012914368547612193, -3.675841088072472e-05], [-3.6397607689923824e-05, -3.675841088072472e-05, 0.00012863659666612727]]} + #*EXTRAS*# Step: 2 Bead: 4 +{"friction": [[0.0001265271259074745, -3.980789318497056e-05, -3.927163339661499e-05], [-3.980789318497056e-05, 0.00012661097670782354, -3.989300535611183e-05], [-3.927163339661499e-05, -3.989300535611183e-05, 0.00012618917043421814]]} + #*EXTRAS*# Step: 3 Bead: 4 +{"friction": [[0.0001250534440660516, -4.129783430207893e-05, -4.0758027809534804e-05], [-4.129783430207893e-05, 0.0001251137201572557, -4.1397481961136464e-05], [-4.0758027809534804e-05, -4.1397481961136464e-05, 0.0001247607129091559]]} + #*EXTRAS*# Step: 4 Bead: 4 +{"friction": [[0.00012434386460944902, -4.1917216267443724e-05, -4.14432026786162e-05], [-4.1917216267443724e-05, 0.00012440503331043027, -4.2018763718804665e-05], [-4.14432026786162e-05, -4.2018763718804665e-05, 0.00012408571094530072]]} + #*EXTRAS*# Step: 5 Bead: 4 +{"friction": [[0.00012393530596737666, -4.224047542144724e-05, -4.182465683613586e-05], [-4.224047542144724e-05, 0.00012399962409970336, -4.23401803354425e-05], [-4.182465683613586e-05, -4.23401803354425e-05, 0.00012370062701625023]]} + #*EXTRAS*# Step: 6 Bead: 4 +{"friction": [[0.00012369412256418145, -4.241904562952834e-05, -4.204281851771903e-05], [-4.241904562952834e-05, 0.00012376047377939, -4.2516218357066624e-05], [-4.204281851771903e-05, -4.2516218357066624e-05, 0.00012347424509177052]]} + #*EXTRAS*# Step: 7 Bead: 4 +{"friction": [[0.00012354390369288286, -4.2525564077741897e-05, -4.21754577774553e-05], [-4.2525564077741897e-05, 0.00012361139252186235, -4.262051563249319e-05], [-4.21754577774553e-05, -4.262051563249319e-05, 0.00012333351708737739]]} + #*EXTRAS*# Step: 8 Bead: 4 +{"friction": [[0.0001234482948680593, -4.259146873206048e-05, -4.225843306102053e-05], [-4.259146873206048e-05, 0.00012351640536706058, -4.268472436939185e-05], [-4.225843306102053e-05, -4.268472436939185e-05, 0.00012324403480349784]]} + #*EXTRAS*# Step: 9 Bead: 4 +{"friction": [[0.00012338631823091912, -4.2633404396061115e-05, -4.231158097162441e-05], [-4.2633404396061115e-05, 0.0001234547753377799, -4.2725437014254837e-05], [-4.231158097162441e-05, -4.2725437014254837e-05, 0.00012318605893466955]]} + #*EXTRAS*# Step: 10 Bead: 4 +{"friction": [[0.00012334573119919821, -4.266053254893876e-05, -4.2346103251014005e-05], [-4.266053254893876e-05, 0.0001234143874051681, -4.2751709804351056e-05], [-4.2346103251014005e-05, -4.2751709804351056e-05, 0.0001231481026149281]]} + #*EXTRAS*# Step: 11 Bead: 4 +{"friction": [[0.0001233189535066445, -4.2678285856855534e-05, -4.2368754061403615e-05], [-4.2678285856855534e-05, 0.0001233877278869103, -4.276887470824343e-05], [-4.2368754061403615e-05, -4.276887470824343e-05, 0.00012312306467746685]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 new file mode 100644 index 000000000..a53e9dc5a --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 5 +{"friction": [[0.00013140687508940286, -3.2549089934313045e-05, -3.247646875118131e-05], [-3.2549089934313045e-05, 0.00013164265398424839, -3.25304116398176e-05], [-3.247646875118131e-05, -3.25304116398176e-05, 0.0001311512838181544]]} + #*EXTRAS*# Step: 1 Bead: 5 +{"friction": [[0.0001288079823808037, -3.69657025089011e-05, -3.662739877256669e-05], [-3.69657025089011e-05, 0.00012896267323131622, -3.7011370997848594e-05], [-3.662739877256669e-05, -3.7011370997848594e-05, 0.00012845946804188578]]} + #*EXTRAS*# Step: 2 Bead: 5 +{"friction": [[0.00012638987269691492, -3.995763295503717e-05, -3.941518642172444e-05], [-3.995763295503717e-05, 0.00012647044851603315, -4.004453505428147e-05], [-3.941518642172444e-05, -4.004453505428147e-05, 0.00012605478446619836]]} + #*EXTRAS*# Step: 3 Bead: 5 +{"friction": [[0.00012494519770907947, -4.139676051589508e-05, -4.086370464643624e-05], [-4.139676051589508e-05, 0.00012500505087889932, -4.149699256725794e-05], [-4.086370464643624e-05, -4.149699256725794e-05, 0.0001246571707439191]]} + #*EXTRAS*# Step: 4 Bead: 5 +{"friction": [[0.00012425159436231653, -4.199245515910113e-05, -4.1530454345575415e-05], [-4.199245515910113e-05, 0.00012431337979354113, -4.209382066978967e-05], [-4.1530454345575415e-05, -4.209382066978967e-05, 0.00012399854140743746]]} + #*EXTRAS*# Step: 5 Bead: 5 +{"friction": [[0.00012385070527520133, -4.230416630403199e-05, -4.190185926253294e-05], [-4.230416630403199e-05, 0.0001239157479919052, -4.240311923952935e-05], [-4.190185926253294e-05, -4.240311923952935e-05, 0.00012362114936885374]]} + #*EXTRAS*# Step: 6 Bead: 5 +{"friction": [[0.0001236136512326929, -4.247655794534371e-05, -4.21142054956047e-05], [-4.247655794534371e-05, 0.00012368063208888997, -4.257260620623824e-05], [-4.21142054956047e-05, -4.257260620623824e-05, 0.00012339883551695907]]} + #*EXTRAS*# Step: 7 Bead: 5 +{"friction": [[0.00012346585176892545, -4.257947677329142e-05, -4.2243284384760026e-05], [-4.257947677329142e-05, 0.0001235338555122669, -4.2673060959365136e-05], [-4.2243284384760026e-05, -4.2673060959365136e-05, 0.0001232604623169261]]} + #*EXTRAS*# Step: 8 Bead: 5 +{"friction": [[0.00012337172708157363, -4.26431875003421e-05, -4.232401798430673e-05], [-4.26431875003421e-05, 0.00012344025844271137, -4.2734917633581366e-05], [-4.232401798430673e-05, -4.2734917633581366e-05, 0.00012317241262279352]]} + #*EXTRAS*# Step: 9 Bead: 5 +{"friction": [[0.00012331068879949458, -4.268374204746543e-05, -4.237572460029147e-05], [-4.268374204746543e-05, 0.0001233794974330599, -4.277414538378509e-05], [-4.237572460029147e-05, -4.277414538378509e-05, 0.0001231153375424629]]} + #*EXTRAS*# Step: 10 Bead: 5 +{"friction": [[0.0001232707065476205, -4.2709983060489255e-05, -4.2409308083192204e-05], [-4.2709983060489255e-05, 0.00012333966541455896, -4.2799462598772956e-05], [-4.2409308083192204e-05, -4.2799462598772956e-05, 0.00012307795965188948]]} + #*EXTRAS*# Step: 11 Bead: 5 +{"friction": [[0.00012324432361285022, -4.272715861838104e-05, -4.243134184469237e-05], [-4.272715861838104e-05, 0.0001233133669475951, -4.281600441293335e-05], [-4.243134184469237e-05, -4.281600441293335e-05, 0.00012305329834496885]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 new file mode 100644 index 000000000..3c56bd9b5 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 6 +{"friction": [[0.0001311956103908458, -3.29848470674875e-05, -3.289701440835983e-05], [-3.29848470674875e-05, 0.00013142653940500336, -3.297224398384808e-05], [-3.289701440835983e-05, -3.297224398384808e-05, 0.00013092623268750358]]} + #*EXTRAS*# Step: 1 Bead: 6 +{"friction": [[0.00012859888927482216, -3.7257001864031606e-05, -3.6895794428949855e-05], [-3.7257001864031606e-05, 0.00012874634846699243, -3.730696548405537e-05], [-3.6895794428949855e-05, -3.730696548405537e-05, 0.000128248355257521]]} + #*EXTRAS*# Step: 2 Bead: 6 +{"friction": [[0.00012622688863031512, -4.0132530808662264e-05, -3.958400771033771e-05], [-4.0132530808662264e-05, 0.0001263038061641873, -4.022145586125126e-05], [-3.958400771033771e-05, -4.022145586125126e-05, 0.00012589554316259143]]} + #*EXTRAS*# Step: 3 Bead: 6 +{"friction": [[0.00012481735091779964, -4.15116159669585e-05, -4.098811935632287e-05], [-4.15116159669585e-05, 0.0001248769967590873, -4.161242631137927e-05], [-4.098811935632287e-05, -4.161242631137927e-05, 0.00012453515446699426]]} + #*EXTRAS*# Step: 4 Bead: 6 +{"friction": [[0.0001241421877398454, -4.2079995445984995e-05, -4.163313278744122e-05], [-4.2079995445984995e-05, 0.00012420479241960082, -4.218097779161471e-05], [-4.163313278744122e-05, -4.218097779161471e-05, 0.00012389534114335568]]} + #*EXTRAS*# Step: 5 Bead: 6 +{"friction": [[0.00012375016788001176, -4.237837702137053e-05, -4.199266687931785e-05], [-4.237837702137053e-05, 0.00012381606004076534, -4.2476247163854004e-05], [-4.199266687931785e-05, -4.2476247163854004e-05, 0.00012352679882038405]]} + #*EXTRAS*# Step: 6 Bead: 6 +{"friction": [[0.0001235178981533317, -4.254363578486062e-05, -4.219814241102753e-05], [-4.254363578486062e-05, 0.0001235855654191231, -4.263814846883526e-05], [-4.219814241102753e-05, -4.263814846883526e-05, 0.00012330917200970503]]} + #*EXTRAS*# Step: 7 Bead: 6 +{"friction": [[0.00012337290455990187, -4.264239929089614e-05, -4.2323015424554125e-05], [-4.264239929089614e-05, 0.00012344143003832964, -4.273415404226355e-05], [-4.2323015424554125e-05, -4.273415404226355e-05, 0.00012317351381563153]]} + #*EXTRAS*# Step: 8 Bead: 6 +{"friction": [[0.00012328050232906653, -4.2703577587069285e-05, -4.240110131008834e-05], [-4.2703577587069285e-05, 0.00012334942681435564, -4.2793287517856307e-05], [-4.240110131008834e-05, -4.2793287517856307e-05, 0.00012308711680855648]]} + #*EXTRAS*# Step: 9 Bead: 6 +{"friction": [[0.00012322055360137644, -4.274253799267406e-05, -4.245110573095298e-05], [-4.274253799267406e-05, 0.000123289662541492, -4.283079614488638e-05], [-4.245110573095298e-05, -4.283079614488638e-05, 0.00012303108131523046]]} + #*EXTRAS*# Step: 10 Bead: 6 +{"friction": [[0.0001231812738151995, -4.2767755064023843e-05, -4.2483580554247525e-05], [-4.2767755064023843e-05, 0.00012325046830602415, -4.285500708943536e-05], [-4.2483580554247525e-05, -4.285500708943536e-05, 0.00012299437117173188]]} + #*EXTRAS*# Step: 11 Bead: 6 +{"friction": [[0.00012315534950327965, -4.2784263792314777e-05, -4.250488565202726e-05], [-4.2784263792314777e-05, 0.00012322458413573383, -4.2870827567241156e-05], [-4.250488565202726e-05, -4.2870827567241156e-05, 0.00012297014473573219]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 new file mode 100644 index 000000000..3e9f290de --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 7 +{"friction": [[0.00013094354884002888, -3.34806356918497e-05, -3.337184485038292e-05], [-3.34806356918497e-05, 0.00013116798657021497, -3.347505294528034e-05], [-3.337184485038292e-05, -3.347505294528034e-05, 0.00013065962767836692]]} + #*EXTRAS*# Step: 1 Bead: 7 +{"friction": [[0.00012835562896980067, -3.758722599408891e-05, -3.7200061518953475e-05], [-3.758722599408891e-05, 0.0001284947548057753, -3.764202536847655e-05], [-3.7200061518953475e-05, -3.764202536847655e-05, 0.000128003544495496]]} + #*EXTRAS*# Step: 2 Bead: 7 +{"friction": [[0.00012603924493984162, -4.032998469726831e-05, -3.977631404957128e-05], [-4.032998469726831e-05, 0.0001261122885205976, -4.0421094526221145e-05], [-3.977631404957128e-05, -4.0421094526221145e-05, 0.00012571267142136931]]} + #*EXTRAS*# Step: 3 Bead: 7 +{"friction": [[0.00012467088756795762, -4.164047357812715e-05, -4.1129982724709916e-05], [-4.164047357812715e-05, 0.000124730652614448, -4.174177200663041e-05], [-4.1129982724709916e-05, -4.174177200663041e-05, 0.0001243957269526685]]} + #*EXTRAS*# Step: 4 Bead: 7 +{"friction": [[0.00012401626462540824, -4.21784702134942e-05, -4.1750148725670436e-05], [-4.21784702134942e-05, 0.0001240798956836773, -4.227876628853978e-05], [-4.1750148725670436e-05, -4.227876628853978e-05, 0.00012377676048902083]]} + #*EXTRAS*# Step: 5 Bead: 7 +{"friction": [[0.0001236341498956548, -4.2462006399146805e-05, -4.2096092388679916e-05], [-4.2462006399146805e-05, 0.00012370097429352395, -4.255835518361389e-05], [-4.2096092388679916e-05, -4.255835518361389e-05, 0.00012341803964597417]]} + #*EXTRAS*# Step: 6 Bead: 7 +{"friction": [[0.0001234072358082399, -4.261931985256251e-05, -4.2293700877396644e-05], [-4.261931985256251e-05, 0.0001234755814376183, -4.271177637062584e-05], [-4.2293700877396644e-05, -4.271177637062584e-05, 0.00012320562389735268]]} + #*EXTRAS*# Step: 7 Bead: 7 +{"friction": [[0.00012326538702940397, -4.2713455071846473e-05, -4.241375886949409e-05], [-4.2713455071846473e-05, 0.00012333436389002693, -4.280280838638658e-05], [-4.241375886949409e-05, -4.280280838638658e-05, 0.00012307298707417617]]} + #*EXTRAS*# Step: 8 Bead: 7 +{"friction": [[0.00012317491711091766, -4.277181291553608e-05, -4.2488814102997204e-05], [-4.277181291553608e-05, 0.00012324412267261683, -4.285889797307674e-05], [-4.2488814102997204e-05, -4.285889797307674e-05, 0.00012298843066176158]]} + #*EXTRAS*# Step: 9 Bead: 7 +{"friction": [[0.00012311619142555202, -4.280899795221479e-05, -4.253687035360196e-05], [-4.280899795221479e-05, 0.0001231854608162728, -4.289448512354323e-05], [-4.253687035360196e-05, -4.289448512354323e-05, 0.00012293355354942668]]} + #*EXTRAS*# Step: 10 Bead: 7 +{"friction": [[0.0001230777005045906, -4.283307471242502e-05, -4.2568076413916654e-05], [-4.283307471242502e-05, 0.00012314697224134394, -4.291745962921422e-05], [-4.2568076413916654e-05, -4.291745962921422e-05, 0.00012289758773514404]]} + #*EXTRAS*# Step: 11 Bead: 7 +{"friction": [[0.00012305229136952208, -4.284884084106619e-05, -4.258854766399825e-05], [-4.284884084106619e-05, 0.0001231215465723857, -4.293247391441507e-05], [-4.258854766399825e-05, -4.293247391441507e-05, 0.00012287384616570672]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 new file mode 100644 index 000000000..abd96dcac --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 8 +{"friction": [[0.00013064797267198423, -3.4032980337971224e-05, -3.389659333410311e-05], [-3.4032980337971224e-05, 0.00013086402099283612, -3.4035338460508096e-05], [-3.389659333410311e-05, -3.4035338460508096e-05, 0.00013034931536429637]]} + #*EXTRAS*# Step: 1 Bead: 8 +{"friction": [[0.00012807844777806376, -3.7952690617213006e-05, -3.7537113405919383e-05], [-3.7952690617213006e-05, 0.00012820823778086655, -3.801278499668635e-05], [-3.7537113405919383e-05, -3.801278499668635e-05, 0.00012772561270434643]]} + #*EXTRAS*# Step: 2 Bead: 8 +{"friction": [[0.00012582830157257792, -4.0546962956973825e-05, -3.999009480683545e-05], [-4.0546962956973825e-05, 0.00012589746645040435, -4.064033389794325e-05], [-3.999009480683545e-05, -4.064033389794325e-05, 0.00012550769944875078]]} + #*EXTRAS*# Step: 3 Bead: 8 +{"friction": [[0.00012450684084900325, -4.178123273873033e-05, -4.128780462218461e-05], [-4.178123273873033e-05, 0.00012456713662149682, -4.188281690759607e-05], [-4.128780462218461e-05, -4.188281690759607e-05, 0.00012423999528004116]]} + #*EXTRAS*# Step: 4 Bead: 8 +{"friction": [[0.00012387446933287608, -4.228639016586386e-05, -4.188024386586463e-05], [-4.228639016586386e-05, 0.00012393930866904483, -4.23855686299664e-05], [-4.188024386586463e-05, -4.23855686299664e-05, 0.00012364346639037112]]} + #*EXTRAS*# Step: 5 Bead: 8 +{"friction": [[0.00012350311942539195, -4.255385727120116e-05, -4.221099589317006e-05], [-4.255385727120116e-05, 0.0001235708851367965, -4.2648113153896825e-05], [-4.221099589317006e-05, -4.2648113153896825e-05, 0.00012329533896103358]]} + #*EXTRAS*# Step: 6 Bead: 8 +{"friction": [[0.00012328204245769692, -4.2702569098886565e-05, -4.239980974800376e-05], [-4.2702569098886565e-05, 0.00012335096139176415, -4.279231501217347e-05], [-4.239980974800376e-05, -4.279231501217347e-05, 0.00012308855656145668]]} + #*EXTRAS*# Step: 7 Bead: 8 +{"friction": [[0.0001231436265300466, -4.27916940463016e-05, -4.251448599054845e-05], [-4.27916940463016e-05, 0.00012321287489139567, -4.287794020685383e-05], [-4.251448599054845e-05, -4.287794020685383e-05, 0.00012295918996700454]]} + #*EXTRAS*# Step: 8 Bead: 8 +{"friction": [[0.00012305526835327274, -4.2846998892748e-05, -4.2586154561260595e-05], [-4.2846998892748e-05, 0.0001231245262563514, -4.293072105665344e-05], [-4.2586154561260595e-05, -4.293072105665344e-05, 0.00012287662775687958]]} + #*EXTRAS*# Step: 9 Bead: 8 +{"friction": [[0.00012299788029272214, -4.2882262262130436e-05, -4.263203406479509e-05], [-4.2882262262130436e-05, 0.00012306704928060705, -4.2964219653746374e-05], [-4.263203406479509e-05, -4.2964219653746374e-05, 0.00012282300653855123]]} + #*EXTRAS*# Step: 10 Bead: 8 +{"friction": [[0.00012296025260169076, -4.290510477991387e-05, -4.266182263279629e-05], [-4.290510477991387e-05, 0.000123029319527319, -4.29858502653951e-05], [-4.266182263279629e-05, -4.29858502653951e-05, 0.00012278784810298502]]} + #*EXTRAS*# Step: 11 Bead: 8 +{"friction": [[0.00012293540740692708, -4.2920067152123586e-05, -4.268136234449961e-05], [-4.2920067152123586e-05, 0.00012300438706518878, -4.299998831663051e-05], [-4.268136234449961e-05, -4.299998831663051e-05, 0.00012276463264196565]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 new file mode 100644 index 000000000..5f758efbe --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 9 +{"friction": [[0.00013030641560764987, -3.4637552590400345e-05, -3.4466313676195334e-05], [-3.4637552590400345e-05, 0.0001305119734329694, -3.464872341487375e-05], [-3.4466313676195334e-05, -3.464872341487375e-05, 0.00012999345633835313]]} + #*EXTRAS*# Step: 1 Bead: 9 +{"friction": [[0.00012776797401068684, -3.8349077216357794e-05, -3.79035254551647e-05], [-3.8349077216357794e-05, 0.00012788758740554668, -3.8414823261247424e-05], [-3.79035254551647e-05, -3.8414823261247424e-05, 0.00012741554842222853]]} + #*EXTRAS*# Step: 2 Bead: 9 +{"friction": [[0.00012559575169472087, -4.078000775732315e-05, -4.0223140918395494e-05], [-4.078000775732315e-05, 0.00012566129333089652, -4.087561547057879e-05], [-4.0223140918395494e-05, -4.087561547057879e-05, 0.00012528250339628396]]} + #*EXTRAS*# Step: 3 Bead: 9 +{"friction": [[0.00012432625074114097, -4.193167762857872e-05, -4.145990195968369e-05], [-4.193167762857872e-05, 0.00012438753110084288, -4.2033199826540666e-05], [-4.145990195968369e-05, -4.2033199826540666e-05, 0.00012406906102205601]]} + #*EXTRAS*# Step: 4 Bead: 9 +{"friction": [[0.00012371743794364442, -4.24021881917188e-05, -4.20219971389201e-05], [-4.24021881917188e-05, 0.00012378359988663142, -4.249965942919821e-05], [-4.20219971389201e-05, -4.249965942919821e-05, 0.0001234961044184532]]} + #*EXTRAS*# Step: 5 Bead: 9 +{"friction": [[0.00012335753008389734, -4.2652673509186896e-05, -4.233609091047655e-05], [-4.2652673509186896e-05, 0.00012342613083111606, -4.274410392905341e-05], [-4.233609091047655e-05, -4.274410392905341e-05, 0.0001231591359317254]]} + #*EXTRAS*# Step: 6 Bead: 9 +{"friction": [[0.00012314267895042084, -4.2792293690292754e-05, -4.2515261069752305e-05], [-4.2792293690292754e-05, 0.0001232119282989515, -4.287851400310903e-05], [-4.2515261069752305e-05, -4.287851400310903e-05, 0.00012295830449258265]]} + #*EXTRAS*# Step: 7 Bead: 9 +{"friction": [[0.00012300793153976268, -4.287612321072019e-05, -4.262403726599533e-05], [-4.287612321072019e-05, 0.00012307712181756268, -4.295839694642385e-05], [-4.262403726599533e-05, -4.295839694642385e-05, 0.00012283239805985823]]} + #*EXTRAS*# Step: 8 Bead: 9 +{"friction": [[0.00012292183332471136, -4.2928201513483356e-05, -4.2691993892038415e-05], [-4.2928201513483356e-05, 0.00012299075844019198, -4.300766414490546e-05], [-4.2691993892038415e-05, -4.300766414490546e-05, 0.00012275194863020398]]} + #*EXTRAS*# Step: 9 Bead: 9 +{"friction": [[0.0001228658781173968, -4.296143404455383e-05, -4.273548791877964e-05], [-4.296143404455383e-05, 0.00012293452546981973, -4.30389449619081e-05], [-4.273548791877964e-05, -4.30389449619081e-05, 0.00012269965913350484]]} + #*EXTRAS*# Step: 10 Bead: 9 +{"friction": [[0.00012282917571765416, -4.29829722302754e-05, -4.276372323649392e-05], [-4.29829722302754e-05, 0.00012289759293663275, -4.3059148589429764e-05], [-4.276372323649392e-05, -4.3059148589429764e-05, 0.00012266535735807075]]} + #*EXTRAS*# Step: 11 Bead: 9 +{"friction": [[0.00012280493526961627, -4.299708521284219e-05, -4.278224226318586e-05], [-4.299708521284219e-05, 0.00012287317887180066, -4.307235625533982e-05], [-4.278224226318586e-05, -4.307235625533982e-05, 0.0001226427003506479]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 new file mode 100644 index 000000000..51f3d17a2 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 10 +{"friction": [[0.00012991703273927124, -3.528883604745308e-05, -3.507531490942497e-05], [-3.528883604745308e-05, 0.00013010988907306278, -3.530960766886239e-05], [-3.507531490942497e-05, -3.530960766886239e-05, 0.00012959089167726413]]} + #*EXTRAS*# Step: 1 Bead: 10 +{"friction": [[0.00012742539155316816, -3.8771335543429635e-05, -3.8295516641351626e-05], [-3.8771335543429635e-05, 0.00012753423046271491, -3.884296188867691e-05], [-3.8295516641351626e-05, -3.884296188867691e-05, 0.00012707491852690858]]} + #*EXTRAS*# Step: 2 Bead: 10 +{"friction": [[0.00012534366717780842, -4.102524135119598e-05, -4.04730769542187e-05], [-4.102524135119598e-05, 0.00012540615664225692, -4.112294476480821e-05], [-4.04730769542187e-05, -4.112294476480821e-05, 0.0001250393466387531]]} + #*EXTRAS*# Step: 3 Bead: 10 +{"friction": [[0.00012413011502413723, -4.208954296022476e-05, -4.1644407568842224e-05], [-4.208954296022476e-05, 0.00012419281485011302, -4.219047124071295e-05], [-4.1644407568842224e-05, -4.219047124071295e-05, 0.0001238839633815352]]} + #*EXTRAS*# Step: 4 Bead: 10 +{"friction": [[0.00012354576358908833, -4.252426743214523e-05, -4.217383215084322e-05], [-4.252426743214523e-05, 0.0001236132394121735, -4.2619249743472965e-05], [-4.217383215084322e-05, -4.2619249743472965e-05, 0.0001233352584098023]]} + #*EXTRAS*# Step: 5 Bead: 10 +{"friction": [[0.00012319779289495726, -4.275717995655686e-05, -4.2469951573945315e-05], [-4.275717995655686e-05, 0.0001232669549616819, -4.2844860463195404e-05], [-4.2469951573945315e-05, -4.2844860463195404e-05, 0.00012300980912272966]]} + #*EXTRAS*# Step: 6 Bead: 10 +{"friction": [[0.00012298946417810597, -4.2887390510741024e-05, -4.263871716582828e-05], [-4.2887390510741024e-05, 0.0001230586134236721, -4.296908063385957e-05], [-4.263871716582828e-05, -4.296908063385957e-05, 0.00012281514279489683]]} + #*EXTRAS*# Step: 7 Bead: 10 +{"friction": [[0.00012285856919798114, -4.296573951758017e-05, -4.274112938323291e-05], [-4.296573951758017e-05, 0.00012292717381312678, -4.3042988127908014e-05], [-4.274112938323291e-05, -4.3042988127908014e-05, 0.0001226928285482115]]} + #*EXTRAS*# Step: 8 Bead: 10 +{"friction": [[0.00012277484844699785, -4.301447864268962e-05, -4.280508325625387e-05], [-4.301447864268962e-05, 0.00012284285195297435, -4.308859935578991e-05], [-4.280508325625387e-05, -4.308859935578991e-05, 0.00012261457620868174]]} + #*EXTRAS*# Step: 9 Bead: 10 +{"friction": [[0.00012272040232302414, -4.3045609472226036e-05, -4.284600533289691e-05], [-4.3045609472226036e-05, 0.00012278789978531225, -4.31175726831689e-05], [-4.284600533289691e-05, -4.31175726831689e-05, 0.00012256367311203086]]} + #*EXTRAS*# Step: 10 Bead: 10 +{"friction": [[0.00012268467522164476, -4.306579782479984e-05, -4.2872566184039735e-05], [-4.306579782479984e-05, 0.00012275178879229387, -4.3136291668084726e-05], [-4.2872566184039735e-05, -4.3136291668084726e-05, 0.00012253026387990798]]} + #*EXTRAS*# Step: 11 Bead: 10 +{"friction": [[0.00012266107254071265, -4.307903178963066e-05, -4.288998495556303e-05], [-4.307903178963066e-05, 0.00012272790926048976, -4.314853138009429e-05], [-4.288998495556303e-05, -4.314853138009429e-05, 0.00012250818902632428]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 new file mode 100644 index 000000000..4ca48ffd7 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 11 +{"friction": [[0.00012947879542120336, -3.5980173125907095e-05, -3.571737595016751e-05], [-3.5980173125907095e-05, 0.00012965675992702663, -3.6011208770852356e-05], [-3.571737595016751e-05, -3.6011208770852356e-05, 0.00012914132189854633]]} + #*EXTRAS*# Step: 1 Bead: 11 +{"friction": [[0.00012705252970230646, -3.921370812438338e-05, -3.870904648826126e-05], [-3.921370812438338e-05, 0.00012715033668483504, -3.92912874103169e-05], [-3.870904648826126e-05, -3.92912874103169e-05, 0.00012670595014234248]]} + #*EXTRAS*# Step: 2 Bead: 11 +{"friction": [[0.00012507454308038747, -4.127837593086452e-05, -4.073739587222327e-05], [-4.127837593086452e-05, 0.0001251349283747576, -4.137790040614989e-05], [-4.073739587222327e-05, -4.137790040614989e-05, 0.0001247809197922315]]} + #*EXTRAS*# Step: 3 Bead: 11 +{"friction": [[0.0001239193385280136, -4.2252582988567965e-05, -4.183928074955836e-05], [-4.2252582988567965e-05, 0.00012398379333133434, -4.2352156707860356e-05], [-4.183928074955836e-05, -4.2352156707860356e-05, 0.000123685620353021]]} + #*EXTRAS*# Step: 4 Bead: 11 +{"friction": [[0.000123359960663602, -4.265105176475702e-05, -4.233402595741703e-05], [-4.265105176475702e-05, 0.0001234285497355096, -4.2742533876065804e-05], [-4.233402595741703e-05, -4.2742533876065804e-05, 0.00012316140888372288]]} + #*EXTRAS*# Step: 5 Bead: 11 +{"friction": [[0.00012302424738712202, -4.2866124341593966e-05, -4.261102112152255e-05], [-4.2866124341593966e-05, 0.00012309346699192005, -4.2948905006687425e-05], [-4.261102112152255e-05, -4.2948905006687425e-05, 0.00012284764294760882]]} + #*EXTRAS*# Step: 6 Bead: 11 +{"friction": [[0.00012282264991463675, -4.298678035557154e-05, -4.276871893318173e-05], [-4.298678035557154e-05, 0.00012289102210902726, -4.306271487081847e-05], [-4.276871893318173e-05, -4.306271487081847e-05, 0.00012265925800972037]]} + #*EXTRAS*# Step: 7 Bead: 11 +{"friction": [[0.000122695742333527, -4.3059564289629945e-05, -4.286436340902654e-05], [-4.3059564289629945e-05, 0.00012276297930847354, -4.313051786946066e-05], [-4.286436340902654e-05, -4.313051786946066e-05, 0.00012254061363862887]]} + #*EXTRAS*# Step: 8 Bead: 11 +{"friction": [[0.00012261448766159858, -4.310491272030069e-05, -4.2924061852190495e-05], [-4.310491272030069e-05, 0.0001226807221796435, -4.317239453641315e-05], [-4.2924061852190495e-05, -4.317239453641315e-05, 0.00012246461075579693]]} + #*EXTRAS*# Step: 9 Bead: 11 +{"friction": [[0.00012256160905263074, -4.3133909391350406e-05, -4.2962250112511566e-05], [-4.3133909391350406e-05, 0.00012262706748494855, -4.319901088073911e-05], [-4.2962250112511566e-05, -4.319901088073911e-05, 0.00012241512911120248]]} + #*EXTRAS*# Step: 10 Bead: 11 +{"friction": [[0.00012252689599436746, -4.3152727047498306e-05, -4.298703135321873e-05], [-4.3152727047498306e-05, 0.00012259178972210728, -4.321621343798132e-05], [-4.298703135321873e-05, -4.321621343798132e-05, 0.0001223826359117054]]} + #*EXTRAS*# Step: 11 Bead: 11 +{"friction": [[0.00012250395683968717, -4.3165068397720224e-05, -4.300328088168336e-05], [-4.3165068397720224e-05, 0.0001225684527624527, -4.322746449495209e-05], [-4.300328088168336e-05, -4.322746449495209e-05, 0.00012236115893254023]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 new file mode 100644 index 000000000..70925dcda --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 12 +{"friction": [[0.0001289917032280999, -3.670377679754094e-05, -3.638593541360157e-05], [-3.670377679754094e-05, 0.00012915277647290737, -3.674556669422962e-05], [-3.638593541360157e-05, -3.674556669422962e-05, 0.0001286455046890979]]} + #*EXTRAS*# Step: 1 Bead: 12 +{"friction": [[0.00012665195793878069, -3.9669747200622883e-05, -3.913990676753965e-05], [-3.9669747200622883e-05, 0.00012673893038559495, -3.975316537486622e-05], [-3.913990676753965e-05, -3.975316537486622e-05, 0.00012631161770769217]]} + #*EXTRAS*# Step: 2 Bead: 12 +{"friction": [[0.00012479123031580464, -4.1534812321540836e-05, -4.101347659243908e-05], [-4.1534812321540836e-05, 0.00012485087063073363, -4.163572419670373e-05], [-4.101347659243908e-05, -4.163572419670373e-05, 0.000124510261111306]]} + #*EXTRAS*# Step: 3 Bead: 12 +{"friction": [[0.0001236946820485437, -4.241864213236119e-05, -4.2042319593186064e-05], [-4.241864213236119e-05, 0.0001237610287533441, -4.2515822164381005e-05], [-4.2042319593186064e-05, -4.2515822164381005e-05, 0.0001234747695788012]]} + #*EXTRAS*# Step: 4 Bead: 12 +{"friction": [[0.00012316042903819476, -4.278103751895841e-05, -4.250071928665974e-05], [-4.278103751895841e-05, 0.0001232296568580921, -4.2867737676748985e-05], [-4.250071928665974e-05, -4.2867737676748985e-05, 0.00012297489148755517]]} + #*EXTRAS*# Step: 5 Bead: 12 +{"friction": [[0.00012283713278045074, -4.2978320154446276e-05, -4.27576217716483e-05], [-4.2978320154446276e-05, 0.00012290560320630433, -4.305478953345787e-05], [-4.27576217716483e-05, -4.305478953345787e-05, 0.00012267279426988266]]} + #*EXTRAS*# Step: 6 Bead: 12 +{"friction": [[0.00012264239584141093, -4.3089445900652e-05, -4.29036954360305e-05], [-4.3089445900652e-05, 0.0001227090001158148, -4.315814539096394e-05], [-4.29036954360305e-05, -4.315814539096394e-05, 0.00012249071919843307]]} + #*EXTRAS*# Step: 7 Bead: 12 +{"friction": [[0.00012251956673121504, -4.315667829969557e-05, -4.299223419891966e-05], [-4.315667829969557e-05, 0.00012258433550796455, -4.321981832695115e-05], [-4.299223419891966e-05, -4.321981832695115e-05, 0.00012237577424942128]]} + #*EXTRAS*# Step: 8 Bead: 12 +{"friction": [[0.0001224408410652038, -4.319864406557981e-05, -4.304746620210496e-05], [-4.319864406557981e-05, 0.00012250413857150283, -4.325794510944247e-05], [-4.304746620210496e-05, -4.325794510944247e-05, 0.00012230204517123247]]} + #*EXTRAS*# Step: 9 Bead: 12 +{"friction": [[0.00012238957266676336, -4.3225511502859485e-05, -4.308278565561852e-05], [-4.3225511502859485e-05, 0.0001224517813035304, -4.3282194881450844e-05], [-4.308278565561852e-05, -4.3282194881450844e-05, 0.0001222540029344652]]} + #*EXTRAS*# Step: 10 Bead: 12 +{"friction": [[0.00012235590248029337, -4.324296156254507e-05, -4.310569969033522e-05], [-4.324296156254507e-05, 0.00012241733805664845, -4.329787488904623e-05], [-4.310569969033522e-05, -4.329787488904623e-05, 0.00012222243851486058]]} + #*EXTRAS*# Step: 11 Bead: 12 +{"friction": [[0.00012233364623565895, -4.3254412286209014e-05, -4.3120722539237446e-05], [-4.3254412286209014e-05, 0.00012239454507612698, -4.330813331607712e-05], [-4.3120722539237446e-05, -4.330813331607712e-05, 0.00012220156823806015]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 new file mode 100644 index 000000000..ed4f1acb0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 13 +{"friction": [[0.00012845706441002837, -3.745063354531244e-05, -3.70741901275435e-05], [-3.745063354531244e-05, 0.00012859965202404274, -3.75034377235823e-05], [-3.70741901275435e-05, -3.75034377235823e-05, 0.00012810552361980438]]} + #*EXTRAS*# Step: 1 Bead: 13 +{"friction": [[0.0001262271027058798, -4.013230315464137e-05, -3.95837870886085e-05], [-4.013230315464137e-05, 0.00012630402487175663, -4.022122562515816e-05], [-3.95837870886085e-05, -4.022122562515816e-05, 0.00012589575207885725]]} + #*EXTRAS*# Step: 2 Bead: 13 +{"friction": [[0.00012449576835121953, -4.179059448015686e-05, -4.129840952753301e-05], [-4.179059448015686e-05, 0.00012455611338617396, -4.189218684234193e-05], [-4.129840952753301e-05, -4.189218684234193e-05, 0.0001242295000003705]]} + #*EXTRAS*# Step: 3 Bead: 13 +{"friction": [[0.00012345671247295615, -4.2585725412707144e-05, -4.225117511565929e-05], [-4.2585725412707144e-05, 0.0001235247722350038, -4.267913954722775e-05], [-4.225117511565929e-05, -4.267913954722775e-05, 0.00012325191069685452]]} + #*EXTRAS*# Step: 4 Bead: 13 +{"friction": [[0.00012294741939698566, -4.291284516411205e-05, -4.267192834907532e-05], [-4.291284516411205e-05, 0.00012301644325730991, -4.299316727370822e-05], [-4.267192834907532e-05, -4.299316727370822e-05, 0.0001227758567867178]]} + #*EXTRAS*# Step: 5 Bead: 13 +{"friction": [[0.0001226365602128012, -4.3092689398073716e-05, -4.290796607493997e-05], [-4.3092689398073716e-05, 0.00012270308940558696, -4.3161136465297886e-05], [-4.290796607493997e-05, -4.3161136465297886e-05, 0.00012248526026731912]]} + #*EXTRAS*# Step: 6 Bead: 13 +{"friction": [[0.00012244874560659737, -4.319446946550274e-05, -4.30419748669891e-05], [-4.319446946550274e-05, 0.00012251220168642827, -4.325416581287509e-05], [-4.30419748669891e-05, -4.325416581287509e-05, 0.00012230945027908902]]} + #*EXTRAS*# Step: 7 Bead: 13 +{"friction": [[0.0001223300494252409, -4.325625659939129e-05, -4.3123141107067376e-05], [-4.325625659939129e-05, 0.000122390859580582, -4.330978327428848e-05], [-4.3123141107067376e-05, -4.330978327428848e-05, 0.00012219819495481467]]} + #*EXTRAS*# Step: 8 Bead: 13 +{"friction": [[0.000122253894565434, -4.3294903904359764e-05, -4.317374069674106e-05], [-4.3294903904359764e-05, 0.0001223126977418057, -4.334420602269342e-05], [-4.317374069674106e-05, -4.334420602269342e-05, 0.00012212674152514564]]} + #*EXTRAS*# Step: 9 Bead: 13 +{"friction": [[0.00012220426625646682, -4.331968225091323e-05, -4.320608538798865e-05], [-4.331968225091323e-05, 0.00012226162574633954, -4.336611819304311e-05], [-4.320608538798865e-05, -4.336611819304311e-05, 0.00012208014308652608]]} + #*EXTRAS*# Step: 10 Bead: 13 +{"friction": [[0.00012217165975116304, -4.333579036922635e-05, -4.322706357268622e-05], [-4.333579036922635e-05, 0.00012222801089173543, -4.3380294316146807e-05], [-4.322706357268622e-05, -4.3380294316146807e-05, 0.00012204951174641371]]} + #*EXTRAS*# Step: 11 Bead: 13 +{"friction": [[0.00012215010066933093, -4.334636711442955e-05, -4.324081477763576e-05], [-4.334636711442955e-05, 0.0001222057586301239, -4.338957228880028e-05], [-4.324081477763576e-05, -4.338957228880028e-05, 0.00012202925161266956]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 new file mode 100644 index 000000000..1fe6424a9 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 14 +{"friction": [[0.0001278780787535134, -3.82100307641886e-05, -3.7774858450361775e-05], [-3.82100307641886e-05, 0.00012800126167604204, -3.8273806917358165e-05], [-3.7774858450361775e-05, -3.8273806917358165e-05, 0.0001275253587009841]]} + #*EXTRAS*# Step: 1 Bead: 14 +{"friction": [[0.00012578246331836646, -4.059341152208736e-05, -4.0036238382891376e-05], [-4.059341152208736e-05, 0.00012585085738073384, -4.06872452092589e-05], [-4.0036238382891376e-05, -4.06872452092589e-05, 0.0001254632457589615]]} + #*EXTRAS*# Step: 2 Bead: 14 +{"friction": [[0.00012418931039763145, -4.204251499751554e-05, -4.15890169615444e-05], [-4.204251499751554e-05, 0.0001242515520984264, -4.214368559323861e-05], [-4.15890169615444e-05, -4.214368559323861e-05, 0.00012393977019774295]]} + #*EXTRAS*# Step: 3 Bead: 14 +{"friction": [[0.00012320575625420508, -4.275206650693605e-05, -4.246336674785786e-05], [-4.275206650693605e-05, 0.00012327490083350706, -4.283995078908281e-05], [-4.246336674785786e-05, -4.283995078908281e-05, 0.00012301725153761117]]} + #*EXTRAS*# Step: 4 Bead: 14 +{"friction": [[0.0001227210006965545, -4.304526973926057e-05, -4.284555849963817e-05], [-4.304526973926057e-05, 0.00012278850423350817, -4.3117257196333533e-05], [-4.284555849963817e-05, -4.3117257196333533e-05, 0.0001225642326145286]]} + #*EXTRAS*# Step: 5 Bead: 14 +{"friction": [[0.0001224224869903457, -4.320830406661538e-05, -4.306016981507952e-05], [-4.320830406661538e-05, 0.00012248540676616353, -4.326667870544688e-05], [-4.306016981507952e-05, -4.326667870544688e-05, 0.0001222848487138715]]} + #*EXTRAS*# Step: 6 Bead: 14 +{"friction": [[0.00012224160479492024, -4.330106954237184e-05, -4.3181796932756195e-05], [-4.330106954237184e-05, 0.00012230006058893702, -4.3349670235917054e-05], [-4.3181796932756195e-05, -4.3349670235917054e-05, 0.00012211520464433002]]} + #*EXTRAS*# Step: 7 Bead: 14 +{"friction": [[0.00012212706883186822, -4.335760213904237e-05, -4.325540004361911e-05], [-4.335760213904237e-05, 0.0001221819627156497, -4.339940099254343e-05], [-4.325540004361911e-05, -4.339940099254343e-05, 0.00012200760112498288]]} + #*EXTRAS*# Step: 8 Bead: 14 +{"friction": [[0.0001220535113296791, -4.339304620496759e-05, -4.330124943885356e-05], [-4.339304620496759e-05, 0.00012210579935207461, -4.343022300927331e-05], [-4.330124943885356e-05, -4.343022300927331e-05, 0.00012193840973297636]]} + #*EXTRAS*# Step: 9 Bead: 14 +{"friction": [[0.00012200554391917203, -4.3415807532017956e-05, -4.3330544466172255e-05], [-4.3415807532017956e-05, 0.00012205599412484769, -4.344986273376658e-05], [-4.3330544466172255e-05, -4.344986273376658e-05, 0.0001218932504125687]]} + #*EXTRAS*# Step: 10 Bead: 14 +{"friction": [[0.00012197401631245756, -4.343061978561974e-05, -4.334953841863052e-05], [-4.343061978561974e-05, 0.00012202319786107986, -4.346257688449717e-05], [-4.334953841863052e-05, -4.346257688449717e-05, 0.00012186355091694459]]} + #*EXTRAS*# Step: 11 Bead: 14 +{"friction": [[0.00012195316510467573, -4.3440352462524354e-05, -4.336198634638677e-05], [-4.3440352462524354e-05, 0.00012200148083516266, -4.347090171953936e-05], [-4.336198634638677e-05, -4.347090171953936e-05, 0.00012184390088759481]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 new file mode 100644 index 000000000..ec5aaf637 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 15 +{"friction": [[0.00012726027358761464, -3.896940372900226e-05, -3.8480234708173996e-05], [-3.896940372900226e-05, 0.00012736412762627062, -3.9043725441288e-05], [-3.8480234708173996e-05, -3.9043725441288e-05, 0.00012691129785582055]]} + #*EXTRAS*# Step: 1 Bead: 15 +{"friction": [[0.00012532374853239491, -4.104428662184295e-05, -4.049272120305384e-05], [-4.104428662184295e-05, 0.00012538603933726745, -4.1142140091990166e-05], [-4.049272120305384e-05, -4.1142140091990166e-05, 0.0001250201774848244]]} + #*EXTRAS*# Step: 2 Bead: 15 +{"friction": [[0.00012387257592657113, -4.228780976666489e-05, -4.1881968130470805e-05], [-4.228780976666489e-05, 0.00012393743148223153, -4.238697067699562e-05], [-4.1881968130470805e-05, -4.238697067699562e-05, 0.0001236416880526651]]} + #*EXTRAS*# Step: 3 Bead: 15 +{"friction": [[0.00012294185777681589, -4.291619175755203e-05, -4.267629936031752e-05], [-4.291619175755203e-05, 0.00012301086164234008, -4.299632878874585e-05], [-4.267629936031752e-05, -4.299632878874585e-05, 0.00012277065996541735]]} + #*EXTRAS*# Step: 4 Bead: 15 +{"friction": [[0.00012248103095928578, -4.317732859583495e-05, -4.3019419811348176e-05], [-4.317732859583495e-05, 0.00012254510936925055, -4.323861665018421e-05], [-4.3019419811348176e-05, -4.323861665018421e-05, 0.00012233969039986793]]} + #*EXTRAS*# Step: 5 Bead: 15 +{"friction": [[0.0001221946938609292, -4.3324425170868924e-05, -4.3212266510874424e-05], [-4.3324425170868924e-05, 0.00012225176229110112, -4.337029795808152e-05], [-4.3212266510874424e-05, -4.337029795808152e-05, 0.00012207115184934312]]} + #*EXTRAS*# Step: 6 Bead: 15 +{"friction": [[0.00012202072169296155, -4.3408635037250346e-05, -4.3321326701368724e-05], [-4.3408635037250346e-05, 0.00012207176540496816, -4.3443687170979784e-05], [-4.3321326701368724e-05, -4.3443687170979784e-05, 0.00012190754309742539]]} + #*EXTRAS*# Step: 7 Bead: 15 +{"friction": [[0.0001219103575391437, -4.346017719972109e-05, -4.3387256907824e-05], [-4.346017719972109e-05, 0.00012195682821020236, -4.348778561460905e-05], [-4.3387256907824e-05, -4.348778561460905e-05, 0.00012180353921987073]]} + #*EXTRAS*# Step: 8 Bead: 15 +{"friction": [[0.00012183941580338053, -4.349257738995842e-05, -4.3428289408522766e-05], [-4.349257738995842e-05, 0.00012188262589594939, -4.351516234413921e-05], [-4.3428289408522766e-05, -4.351516234413921e-05, 0.00012173658928011548]]} + #*EXTRAS*# Step: 9 Bead: 15 +{"friction": [[0.00012179312554758328, -4.3513421321194995e-05, -4.345449276775801e-05], [-4.3513421321194995e-05, 0.00012183406940355936, -4.353262758497828e-05], [-4.345449276775801e-05, -4.353262758497828e-05, 0.00012169286072035449]]} + #*EXTRAS*# Step: 10 Bead: 15 +{"friction": [[0.0001217626893860185, -4.352700137634921e-05, -4.3471475562486856e-05], [-4.352700137634921e-05, 0.0001218020826636864, -4.3543942735527616e-05], [-4.3471475562486856e-05, -4.3543942735527616e-05, 0.00012166408978763266]]} + #*EXTRAS*# Step: 11 Bead: 15 +{"friction": [[0.0001217425551325182, -4.353593130392902e-05, -4.3482602693597565e-05], [-4.353593130392902e-05, 0.00012178089605365459, -4.355135545973759e-05], [-4.3482602693597565e-05, -4.355135545973759e-05, 0.00012164504862631244]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 new file mode 100644 index 000000000..c47846f62 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 16 +{"friction": [[0.00012661143308844656, -3.971479929521334e-05, -3.9182795101576245e-05], [-3.971479929521334e-05, 0.00012669737778386712, -3.979877417067022e-05], [-3.9182795101576245e-05, -3.979877417067022e-05, 0.00012627184388542937]]} + #*EXTRAS*# Step: 1 Bead: 16 +{"friction": [[0.00012485779285589202, -4.147551960731289e-05, -4.0948815471506864e-05], [-4.147551960731289e-05, 0.00012491747138266817, -4.157616122914629e-05], [-4.0948815471506864e-05, -4.157616122914629e-05, 0.00012457372023348448]]} + #*EXTRAS*# Step: 2 Bead: 16 +{"friction": [[0.00012354579417121362, -4.252424610685229e-05, -4.217380541720183e-05], [-4.252424610685229e-05, 0.00012361326978017884, -4.261922892320737e-05], [-4.217380541720183e-05, -4.261922892320737e-05, 0.00012333528704243385]]} + #*EXTRAS*# Step: 3 Bead: 16 +{"friction": [[0.0001226647439240126, -4.3076978625894126e-05, -4.2887282218615385e-05], [-4.3076978625894126e-05, 0.00012273162494002326, -4.314663410699337e-05], [-4.2887282218615385e-05, -4.314663410699337e-05, 0.00012251162294685874]]} + #*EXTRAS*# Step: 4 Bead: 16 +{"friction": [[0.00012222713268466773, -4.3308304966741746e-05, -4.3191244528735084e-05], [-4.3308304966741746e-05, 0.00012228517089435208, -4.3356072643850946e-05], [-4.3191244528735084e-05, -4.3356072643850946e-05, 0.00012210161695559905]]} + #*EXTRAS*# Step: 5 Bead: 16 +{"friction": [[0.00012195276629704154, -4.344053812346781e-05, -4.3362223544278977e-05], [-4.344053812346781e-05, 0.00012200106525855596, -4.3471060296492975e-05], [-4.3362223544278977e-05, -4.3471060296492975e-05, 0.00012184352499222377]]} + #*EXTRAS*# Step: 6 Bead: 16 +{"friction": [[0.00012178567172013534, -4.3516756167033884e-05, -4.345866992309634e-05], [-4.3516756167033884e-05, 0.00012182624029939764, -4.3535410937610724e-05], [-4.345866992309634e-05, -4.3535410937610724e-05, 0.00012168581612521065]]} + #*EXTRAS*# Step: 7 Bead: 16 +{"friction": [[0.00012167948855490207, -4.356363165957137e-05, -4.351690240150563e-05], [-4.356363165957137e-05, 0.00012171439472691409, -4.357420606666969e-05], [-4.351690240150563e-05, -4.357420606666969e-05, 0.00012158536117482042]]} + #*EXTRAS*# Step: 8 Bead: 16 +{"friction": [[0.00012161118105668094, -4.359318299385875e-05, -4.355310495040823e-05], [-4.359318299385875e-05, 0.00012164212745857588, -4.359833827928824e-05], [-4.355310495040823e-05, -4.359833827928824e-05, 0.00012152063488480735]]} + #*EXTRAS*# Step: 9 Bead: 16 +{"friction": [[0.00012156658486373061, -4.361223131580249e-05, -4.357620916622884e-05], [-4.361223131580249e-05, 0.0001215948098975108, -4.3613755474880615e-05], [-4.357620916622884e-05, -4.3613755474880615e-05, 0.0001214783312422077]]} + #*EXTRAS*# Step: 10 Bead: 16 +{"friction": [[0.0001215372533837494, -4.362465694462225e-05, -4.359117638981338e-05], [-4.362465694462225e-05, 0.00012156362936073852, -4.36237528581027e-05], [-4.359117638981338e-05, -4.36237528581027e-05, 0.00012145048754327093]]} + #*EXTRAS*# Step: 11 Bead: 16 +{"friction": [[0.0001215178457297046, -4.363283457276851e-05, -4.360098000899406e-05], [-4.363283457276851e-05, 0.00012154297228550594, -4.363030637763299e-05], [-4.360098000899406e-05, -4.363030637763299e-05, 0.00012143205542935452]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 new file mode 100644 index 000000000..b83b8d565 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 17 +{"friction": [[0.00012594185509922254, -4.0430818480279955e-05, -3.987531491748839e-05], [-4.0430818480279955e-05, 0.0001260130421325445, -4.052299864131734e-05], [-3.987531491748839e-05, -4.052299864131734e-05, 0.00012561795751016416]]} + #*EXTRAS*# Step: 1 Bead: 17 +{"friction": [[0.00012438959864401357, -4.1879451907979675e-05, -4.139975238174502e-05], [-4.1879451907979675e-05, 0.00012445049212081701, -4.198104486218396e-05], [-4.139975238174502e-05, -4.198104486218396e-05, 0.00012412896409157506]]} + #*EXTRAS*# Step: 2 Bead: 17 +{"friction": [[0.00012320865033165957, -4.275020565511822e-05, -4.246097130418611e-05], [-4.275020565511822e-05, 0.00012327778826046055, -4.283816354740649e-05], [-4.246097130418611e-05, -4.283816354740649e-05, 0.0001230199563312979]]} + #*EXTRAS*# Step: 3 Bead: 17 +{"friction": [[0.00012237379645341692, -4.323370686238187e-05, -4.309354999720255e-05], [-4.323370686238187e-05, 0.00012243564866549968, -4.328956592367749e-05], [-4.309354999720255e-05, -4.328956592367749e-05, 0.0001222392147070845]]} + #*EXTRAS*# Step: 4 Bead: 17 +{"friction": [[0.00012195867403475409, -4.343778595839776e-05, -4.335870641051787e-05], [-4.343778595839776e-05, 0.00012200722059935485, -4.346870873672655e-05], [-4.335870641051787e-05, -4.346870873672655e-05, 0.0001218490930804006]]} + #*EXTRAS*# Step: 5 Bead: 17 +{"friction": [[0.00012169608073478002, -4.355638331953843e-05, -4.3507959906463095e-05], [-4.355638331953843e-05, 0.00012173191101000938, -4.3568247953976755e-05], [-4.3507959906463095e-05, -4.3568247953976755e-05, 0.00012160107100297852]]} + #*EXTRAS*# Step: 6 Bead: 17 +{"friction": [[0.00012153584635522432, -4.3625250982375524e-05, -4.3591889807296926e-05], [-4.3625250982375524e-05, 0.0001215621324472966, -4.3624229616322105e-05], [-4.3591889807296926e-05, -4.3624229616322105e-05, 0.00012144915147878073]]} + #*EXTRAS*# Step: 7 Bead: 17 +{"friction": [[0.00012143386577427496, -4.366782714310562e-05, -4.3642488199643905e-05], [-4.366782714310562e-05, 0.00012145334579958563, -4.365811176322798e-05], [-4.3642488199643905e-05, -4.365811176322798e-05, 0.0001213522137684051]]} + #*EXTRAS*# Step: 8 Bead: 17 +{"friction": [[0.00012136822017854234, -4.369475036426348e-05, -4.367390355635056e-05], [-4.369475036426348e-05, 0.0001213830124681712, -4.367923735615852e-05], [-4.367390355635056e-05, -4.367923735615852e-05, 0.00012128970694034944]]} + #*EXTRAS*# Step: 9 Bead: 17 +{"friction": [[0.00012132534139071193, -4.3712140725117625e-05, -4.369393706176951e-05], [-4.3712140725117625e-05, 0.00012133694079897278, -4.369275621844458e-05], [-4.369393706176951e-05, -4.369275621844458e-05, 0.0001212488317468092]]} + #*EXTRAS*# Step: 10 Bead: 17 +{"friction": [[0.00012129713224782773, -4.3723499736472284e-05, -4.370690770312432e-05], [-4.3723499736472284e-05, 0.00012130657439601862, -4.370153196718018e-05], [-4.370690770312432e-05, -4.370153196718018e-05, 0.00012122192033112598]]} + #*EXTRAS*# Step: 11 Bead: 17 +{"friction": [[0.0001212784638381476, -4.373098198701315e-05, -4.3715400480677494e-05], [-4.373098198701315e-05, 0.0001212864535082251, -4.370728887107541e-05], [-4.3715400480677494e-05, -4.370728887107541e-05, 0.00012120410174994968]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 new file mode 100644 index 000000000..dca22809c --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 18 +{"friction": [[0.00012526486252094083, -4.1100303058221635e-05, -4.0550714905083066e-05], [-4.1100303058221635e-05, 0.00012532660471124878, -4.119858624384984e-05], [-4.0550714905083066e-05, -4.119858624384984e-05, 0.00012496354601260095]]} + #*EXTRAS*# Step: 1 Bead: 18 +{"friction": [[0.0001239188276642438, -4.2252969695188683e-05, -4.183974823014191e-05], [-4.2252969695188683e-05, 0.00012398328684323833, -4.235253913582912e-05], [-4.183974823014191e-05, -4.235253913582912e-05, 0.00012368514027657725]]} + #*EXTRAS*# Step: 2 Bead: 18 +{"friction": [[0.0001228602460114463, -4.296475247559434e-05, -4.273983593574023e-05], [-4.296475247559434e-05, 0.00012292886056593209, -4.304206141594908e-05], [-4.273983593574023e-05, -4.304206141594908e-05, 0.00012269439563349538]]} + #*EXTRAS*# Step: 3 Bead: 18 +{"friction": [[0.00012206803309219933, -4.338610103771562e-05, -4.3292286425981794e-05], [-4.338610103771562e-05, 0.0001221208557713237, -4.342420612349431e-05], [-4.3292286425981794e-05, -4.342420612349431e-05, 0.0001219520751759214]]} + #*EXTRAS*# Step: 4 Bead: 18 +{"friction": [[0.00012167475687090212, -4.356569362280953e-05, -4.35194419282963e-05], [-4.356569362280953e-05, 0.000121709396820621, -4.357589821773643e-05], [-4.35194419282963e-05, -4.357589821773643e-05, 0.00012158088023334547]]} + #*EXTRAS*# Step: 5 Bead: 18 +{"friction": [[0.00012142379664401083, -4.3671980805157275e-05, -4.3647365516341516e-05], [-4.3671980805157275e-05, 0.00012144257331291909, -4.3661386350578335e-05], [-4.3647365516341516e-05, -4.3661386350578335e-05, 0.0001213426316208139]]} + #*EXTRAS*# Step: 6 Bead: 18 +{"friction": [[0.00012127044732088058, -4.3734186540719725e-05, -4.371902520353982e-05], [-4.3734186540719725e-05, 0.00012127780719164214, -4.3709748683593e-05], [-4.371902520353982e-05, -4.3709748683593e-05, 0.00012119644795294669]]} + #*EXTRAS*# Step: 7 Bead: 18 +{"friction": [[0.00012117271936793818, -4.377285615018617e-05, -4.376214442477691e-05], [-4.377285615018617e-05, 0.00012117210657417093, -4.373915424778001e-05], [-4.376214442477691e-05, -4.373915424778001e-05, 0.00012110303379184989]]} + #*EXTRAS*# Step: 8 Bead: 18 +{"friction": [[0.00012110978698251192, -4.3797381344074104e-05, -4.378887442151027e-05], [-4.3797381344074104e-05, 0.00012110375353977132, -4.375753607540866e-05], [-4.378887442151027e-05, -4.375753607540866e-05, 0.00012104277286761216]]} + #*EXTRAS*# Step: 9 Bead: 18 +{"friction": [[0.00012106867527229401, -4.381324471044223e-05, -4.3805907198902106e-05], [-4.381324471044223e-05, 0.0001210589848600004, -4.37693154426202e-05], [-4.3805907198902106e-05, -4.37693154426202e-05, 0.00012100336231749422]]} + #*EXTRAS*# Step: 10 Bead: 18 +{"friction": [[0.00012104163126097949, -4.3823611481724485e-05, -4.3816929914050936e-05], [-4.3823611481724485e-05, 0.00012102948729823076, -4.3776966741329203e-05], [-4.3816929914050936e-05, -4.3776966741329203e-05, 0.00012097741881566642]]} + #*EXTRAS*# Step: 11 Bead: 18 +{"friction": [[0.00012102373565946622, -4.383044145622314e-05, -4.382414545838014e-05], [-4.383044145622314e-05, 0.00012100994777267574, -4.378198763077536e-05], [-4.382414545838014e-05, -4.378198763077536e-05, 0.00012096024347267427]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 new file mode 100644 index 000000000..6f76db57e --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 19 +{"friction": [[0.00012459632602131336, -4.170492542491858e-05, -4.120187097266213e-05], [-4.170492542491858e-05, 0.00012465628415804492, -4.1806390624578615e-05], [-4.120187097266213e-05, -4.1806390624578615e-05, 0.00012432488906652224]]} + #*EXTRAS*# Step: 1 Bead: 19 +{"friction": [[0.00012344341606437893, -4.2594792313237465e-05, -4.226263546021848e-05], [-4.2594792313237465e-05, 0.00012351155558679326, -4.2687955260761484e-05], [-4.226263546021848e-05, -4.2687955260761484e-05, 0.00012323947016404854]]} + #*EXTRAS*# Step: 2 Bead: 19 +{"friction": [[0.0001224990773896943, -4.316768398975024e-05, -4.300672431795472e-05], [-4.316768398975024e-05, 0.00012256348613050858, -4.32298457976013e-05], [-4.300672431795472e-05, -4.32298457976013e-05, 0.00012235658999764628]]} + #*EXTRAS*# Step: 3 Bead: 19 +{"friction": [[0.00012174609791396609, -4.353436308218889e-05, -4.3480650988786034e-05], [-4.353436308218889e-05, 0.00012178462554804798, -4.355005529363577e-05], [-4.3480650988786034e-05, -4.355005529363577e-05, 0.00012164839956465362]]} + #*EXTRAS*# Step: 4 Bead: 19 +{"friction": [[0.00012137421260250509, -4.3692307869037394e-05, -4.367107323894586e-05], [-4.3692307869037394e-05, 0.0001213894428461508, -4.367733060110526e-05], [-4.367107323894586e-05, -4.367733060110526e-05, 0.00012129541640312762]]} + #*EXTRAS*# Step: 5 Bead: 19 +{"friction": [[0.00012113485643045337, -4.3787646628226176e-05, -4.377832243325158e-05], [-4.3787646628226176e-05, 0.00012113100855893098, -4.375026470298071e-05], [-4.377832243325158e-05, -4.375026470298071e-05, 0.00012106678800552513]]} + #*EXTRAS*# Step: 6 Bead: 19 +{"friction": [[0.00012098857876750774, -4.384378969877826e-05, -4.383814076658575e-05], [-4.384378969877826e-05, 0.00012097151526909515, -4.379175444989424e-05], [-4.383814076658575e-05, -4.379175444989424e-05, 0.00012092648333040016]]} + #*EXTRAS*# Step: 7 Bead: 19 +{"friction": [[0.00012089540608882924, -4.387871672039968e-05, -4.387409805930765e-05], [-4.387871672039968e-05, 0.00012086937996559985, -4.381702496214579e-05], [-4.387409805930765e-05, -4.381702496214579e-05, 0.00012083689826103156]]} + #*EXTRAS*# Step: 8 Bead: 19 +{"friction": [[0.00012083548205169441, -4.390083377314648e-05, -4.389637471563365e-05], [-4.390083377314648e-05, 0.00012080348850204614, -4.3832814873784745e-05], [-4.389637471563365e-05, -4.3832814873784745e-05, 0.00012077919682483574]]} + #*EXTRAS*# Step: 9 Bead: 19 +{"friction": [[0.00012079636313107244, -4.391512476239298e-05, -4.39105667510141e-05], [-4.391512476239298e-05, 0.00012076039364198491, -4.3842930450409304e-05], [-4.39105667510141e-05, -4.3842930450409304e-05, 0.00012074149417647374]]} + #*EXTRAS*# Step: 10 Bead: 19 +{"friction": [[0.00012077064306673696, -4.392445721663701e-05, -4.3919749224597155e-05], [-4.392445721663701e-05, 0.00012073202634962098, -4.384949941703018e-05], [-4.3919749224597155e-05, -4.384949941703018e-05, 0.00012071669067790518]]} + #*EXTRAS*# Step: 11 Bead: 19 +{"friction": [[0.00012075362873120946, -4.393060299194752e-05, -4.392575946645879e-05], [-4.393060299194752e-05, 0.00012071324679783699, -4.385380946925693e-05], [-4.392575946645879e-05, -4.385380946925693e-05, 0.0001207002763850438]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 new file mode 100644 index 000000000..b6d7a85e0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 20 +{"friction": [[0.0001239405986518248, -4.2236453288719934e-05, -4.1819804194371584e-05], [-4.2236453288719934e-05, 0.0001240048715323352, -4.2336200609474876e-05], [-4.1819804194371584e-05, -4.2336200609474876e-05, 0.00012370560188273736]]} + #*EXTRAS*# Step: 1 Bead: 20 +{"friction": [[0.00012295984495349003, -4.290535104625566e-05, -4.2662144065700354e-05], [-4.290535104625566e-05, 0.0001230289105766293, -4.298608316206368e-05], [-4.2662144065700354e-05, -4.298608316206368e-05, 0.00012278746720004207]]} + #*EXTRAS*# Step: 2 Bead: 20 +{"friction": [[0.0001221230305038373, -4.335956525671425e-05, -4.325794614403937e-05], [-4.335956525671425e-05, 0.0001221777878931933, -4.3401115523885014e-05], [-4.325794614403937e-05, -4.3401115523885014e-05, 0.00012200380431317677]]} + #*EXTRAS*# Step: 3 Bead: 20 +{"friction": [[0.00012140626289656152, -4.36791927969543e-05, -4.3655807820111423e-05], [-4.36791927969543e-05, 0.00012142380124915721, -4.366705874410578e-05], [-4.3655807820111423e-05, -4.366705874410578e-05, 0.00012132594110624523]]} + #*EXTRAS*# Step: 4 Bead: 20 +{"friction": [[0.00012105563210146888, -4.38182513360711e-05, -4.381124127146911e-05], [-4.38182513360711e-05, 0.00012104476302488789, -4.377301521743328e-05], [-4.381124127146911e-05, -4.377301521743328e-05, 0.00012099085173621321]]} + #*EXTRAS*# Step: 5 Bead: 20 +{"friction": [[0.00012082854503067202, -4.390337651941366e-05, -4.389891143736767e-05], [-4.390337651941366e-05, 0.00012079585094469738, -4.383461969740494e-05], [-4.389891143736767e-05, -4.383461969740494e-05, 0.00012077251292849089]]} + #*EXTRAS*# Step: 6 Bead: 20 +{"friction": [[0.00012069028608537877, -4.3953287521160523e-05, -4.3947691463224126e-05], [-4.3953287521160523e-05, 0.00012064323796382602, -4.386960932220906e-05], [-4.3947691463224126e-05, -4.386960932220906e-05, 0.0001206391244137673]]} + #*EXTRAS*# Step: 7 Bead: 20 +{"friction": [[0.00012060234710547045, -4.398426625409771e-05, -4.39770028188763e-05], [-4.398426625409771e-05, 0.00012054581234529774, -4.3890909826330555e-05], [-4.39770028188763e-05, -4.3890909826330555e-05, 0.00012055411688115091]]} + #*EXTRAS*# Step: 8 Bead: 20 +{"friction": [[0.00012054586162770552, -4.400384681944954e-05, -4.3995149298204463e-05], [-4.400384681944954e-05, 0.00012048310218290587, -4.390420876579431e-05], [-4.3995149298204463e-05, -4.390420876579431e-05, 0.00012049944923572026]]} + #*EXTRAS*# Step: 9 Bead: 20 +{"friction": [[0.00012050901068040135, -4.401648615800542e-05, -4.4006706639780997e-05], [-4.401648615800542e-05, 0.00012044213892242864, -4.391272566863104e-05], [-4.4006706639780997e-05, -4.391272566863104e-05, 0.00012046375759012989]]} + #*EXTRAS*# Step: 10 Bead: 20 +{"friction": [[0.00012048479320915928, -4.402473410054979e-05, -4.4014182389584205e-05], [-4.402473410054979e-05, 0.00012041519794768444, -4.391825484457878e-05], [-4.4014182389584205e-05, -4.391825484457878e-05, 0.00012044029074267317]]} + #*EXTRAS*# Step: 11 Bead: 20 +{"friction": [[0.00012046877729835047, -4.4030163292280214e-05, -4.401907477694183e-05], [-4.4030163292280214e-05, 0.0001203973720374864, -4.3921882067007375e-05], [-4.401907477694183e-05, -4.3921882067007375e-05, 0.00012042476641174526]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 new file mode 100644 index 000000000..790d1a468 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 21 +{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} + #*EXTRAS*# Step: 1 Bead: 21 +{"friction": [[0.00012246308505234, -4.318687430765704e-05, -4.303198209536257e-05], [-4.318687430765704e-05, 0.00012252682254249207, -4.32472821375287e-05], [-4.303198209536257e-05, -4.32472821375287e-05, 0.00012232288238727613]]} + #*EXTRAS*# Step: 2 Bead: 21 +{"friction": [[0.00012172939169122137, -4.3541746717750115e-05, -4.348983117499435e-05], [-4.3541746717750115e-05, 0.0001217670330810301, -4.355617081143887e-05], [-4.348983117499435e-05, -4.355617081143887e-05, 0.00012163259612644521]]} + #*EXTRAS*# Step: 3 Bead: 21 +{"friction": [[0.0001210464730957474, -4.382175946205089e-05, -4.38149669713396e-05], [-4.382175946205089e-05, 0.00012103477114590811, -4.377560253298005e-05], [-4.38149669713396e-05, -4.377560253298005e-05, 0.00012098206469008646]]} + #*EXTRAS*# Step: 4 Bead: 21 +{"friction": [[0.00012071850496068567, -4.394321981597958e-05, -4.393800669511929e-05], [-4.394321981597958e-05, 0.00012067444464194389, -4.3862618263766004e-05], [-4.393800669511929e-05, -4.3862618263766004e-05, 0.00012066637569714348]]} + #*EXTRAS*# Step: 5 Bead: 21 +{"friction": [[0.00012050554498062824, -4.401766933926631e-05, -4.4007782257430294e-05], [-4.401766933926631e-05, 0.00012043828447249314, -4.3913520227573155e-05], [-4.4007782257430294e-05, -4.3913520227573155e-05, 0.00012046039985312542]]} + #*EXTRAS*# Step: 6 Bead: 21 +{"friction": [[0.00012037642364680413, -4.406107217807297e-05, -4.404649588006806e-05], [-4.406107217807297e-05, 0.00012029445185690897, -4.394234509684928e-05], [-4.404649588006806e-05, -4.394234509684928e-05, 0.00012033517389078765]]} + #*EXTRAS*# Step: 7 Bead: 21 +{"friction": [[0.00012029439420672766, -4.408795270428611e-05, -4.406974456438949e-05], [-4.408795270428611e-05, 0.00012020286821421504, -4.395988150617115e-05], [-4.406974456438949e-05, -4.395988150617115e-05, 0.00012025549506331134]]} + #*EXTRAS*# Step: 8 Bead: 21 +{"friction": [[0.00012024176891754239, -4.4104911100511086e-05, -4.4084123911558525e-05], [-4.4104911100511086e-05, 0.00012014403909831063, -4.3970819888037813e-05], [-4.4084123911558525e-05, -4.3970819888037813e-05, 0.00012020432916720873]]} + #*EXTRAS*# Step: 9 Bead: 21 +{"friction": [[0.0001202074553747348, -4.411584706086809e-05, -4.40932780938064e-05], [-4.411584706086809e-05, 0.00012010565195146894, -4.3977822149084234e-05], [-4.40932780938064e-05, -4.3977822149084234e-05, 0.0001201709472870358]]} + #*EXTRAS*# Step: 10 Bead: 21 +{"friction": [[0.00012018491528648401, -4.412297829658066e-05, -4.409919716884625e-05], [-4.412297829658066e-05, 0.00012008042450668626, -4.398236638329607e-05], [-4.409919716884625e-05, -4.398236638329607e-05, 0.00012014901079214064]]} + #*EXTRAS*# Step: 11 Bead: 21 +{"friction": [[0.00012017001237899396, -4.4127670372561816e-05, -4.410306998531786e-05], [-4.4127670372561816e-05, 0.00012006374001821727, -4.3985346866267195e-05], [-4.410306998531786e-05, -4.3985346866267195e-05, 0.00012013450334813203]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 new file mode 100644 index 000000000..6ccd7a0e5 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 22 +{"friction": [[0.000122630467543474, -4.3096070467800976e-05, -4.2912418060752e-05], [-4.3096070467800976e-05, 0.00012269691709164998, -4.316425275719657e-05], [-4.2912418060752e-05, -4.316425275719657e-05, 0.00012247956068148197]]} + #*EXTRAS*# Step: 1 Bead: 22 +{"friction": [[0.00012194669748663574, -4.3443361139222514e-05, -4.336582897212374e-05], [-4.3443361139222514e-05, 0.00012199474029708691, -4.3473470436813117e-05], [-4.336582897212374e-05, -4.3473470436813117e-05, 0.0001218378045578662]]} + #*EXTRAS*# Step: 2 Bead: 22 +{"friction": [[0.00012131487424833561, -4.37163630266614e-05, -4.369876921378231e-05], [-4.37163630266614e-05, 0.00012132567845787345, -4.369602334073665e-05], [-4.369876921378231e-05, -4.369602334073665e-05, 0.00012123884803271955]]} + #*EXTRAS*# Step: 3 Bead: 22 +{"friction": [[0.00012066593796395938, -4.396192481976961e-05, -4.395593804873556e-05], [-4.396192481976961e-05, 0.00012061628932321865, -4.3875580245758e-05], [-4.395593804873556e-05, -4.3875580245758e-05, 0.00012061560054086454]]} + #*EXTRAS*# Step: 4 Bead: 22 +{"friction": [[0.00012036392554305523, -4.406520269132847e-05, -4.40501045936719e-05], [-4.406520269132847e-05, 0.00012028050779383473, -4.394505551998687e-05], [-4.40501045936719e-05, -4.394505551998687e-05, 0.00012032304001129696]]} + #*EXTRAS*# Step: 5 Bead: 22 +{"friction": [[0.00012016698285011312, -4.4128621964308644e-05, -4.4103853320059356e-05], [-4.4128621964308644e-05, 0.00012006034786902398, -4.3985950416692084e-05], [-4.4103853320059356e-05, -4.3985950416692084e-05, 0.00012013155386104235]]} + #*EXTRAS*# Step: 6 Bead: 22 +{"friction": [[0.00012004807480571842, -4.4165371731788155e-05, -4.4133559065104784e-05], [-4.4165371731788155e-05, 0.00011992709693486659, -4.400902115726393e-05], [-4.4133559065104784e-05, -4.400902115726393e-05, 0.00012001569613072604]]} + #*EXTRAS*# Step: 7 Bead: 22 +{"friction": [[0.00011997260349447188, -4.418808455533306e-05, -4.415138096771235e-05], [-4.418808455533306e-05, 0.00011984242598707372, -4.402304531694719e-05], [-4.415138096771235e-05, -4.402304531694719e-05, 0.0001199420714095638]]} + #*EXTRAS*# Step: 8 Bead: 22 +{"friction": [[0.00011992424241303526, -4.420238588686296e-05, -4.416238910907455e-05], [-4.420238588686296e-05, 0.00011978813817710694, -4.403178241143715e-05], [-4.416238910907455e-05, -4.403178241143715e-05, 0.00011989485851006993]]} + #*EXTRAS*# Step: 9 Bead: 22 +{"friction": [[0.00011989272422391818, -4.4211599408873747e-05, -4.416939270467742e-05], [-4.4211599408873747e-05, 0.00011975274603913486, -4.4037372575406655e-05], [-4.416939270467742e-05, -4.4037372575406655e-05, 0.00011986407424201441]]} + #*EXTRAS*# Step: 10 Bead: 22 +{"friction": [[0.00011987202875243032, -4.4217603034971026e-05, -4.4173918809321174e-05], [-4.4217603034971026e-05, 0.00011972950253295618, -4.404099875873893e-05], [-4.4173918809321174e-05, -4.404099875873893e-05, 0.00011984385460769357]]} + #*EXTRAS*# Step: 11 Bead: 22 +{"friction": [[0.00011985834842902656, -4.422155146077291e-05, -4.4176879293330155e-05], [-4.422155146077291e-05, 0.00011971413615608172, -4.404337649945583e-05], [-4.4176879293330155e-05, -4.404337649945583e-05, 0.00011983048621378702]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 new file mode 100644 index 000000000..af927f9d8 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 23 +{"friction": [[0.00012194919365104008, -4.3442200516587006e-05, -4.336434695504495e-05], [-4.3442200516587006e-05, 0.0001219973420398065, -4.3472479799487785e-05], [-4.336434695504495e-05, -4.3472479799487785e-05, 0.00012184015749727416]]} + #*EXTRAS*# Step: 1 Bead: 23 +{"friction": [[0.00012140306870047774, -4.3680503790516874e-05, -4.365733885162047e-05], [-4.3680503790516874e-05, 0.00012142037960948291, -4.366808805533885e-05], [-4.365733885162047e-05, -4.366808805533885e-05, 0.00012132289987064997]]} + #*EXTRAS*# Step: 2 Bead: 23 +{"friction": [[0.00012087602834354934, -4.3885898521890074e-05, -4.388137343609205e-05], [-4.3885898521890074e-05, 0.00012084808926681702, -4.382217022019373e-05], [-4.388137343609205e-05, -4.382217022019373e-05, 0.00012081824636522506]]} + #*EXTRAS*# Step: 3 Bead: 23 +{"friction": [[0.00012026618868236042, -4.4097069863936774e-05, -4.4077502929709304e-05], [-4.4097069863936774e-05, 0.0001201713444342548, -4.396577425140728e-05], [-4.4077502929709304e-05, -4.396577425140728e-05, 0.00012022807637008312]]} + #*EXTRAS*# Step: 4 Bead: 23 +{"friction": [[0.0001199933720791207, -4.418188212195927e-05, -4.414655529086958e-05], [-4.418188212195927e-05, 0.00011986573259403375, -4.401923356093502e-05], [-4.414655529086958e-05, -4.401923356093502e-05, 0.00011996233857254168]]} + #*EXTRAS*# Step: 5 Bead: 23 +{"friction": [[0.00011981422392868484, -4.423417701195779e-05, -4.418625889307503e-05], [-4.423417701195779e-05, 0.00011966456508816849, -4.405094150992665e-05], [-4.418625889307503e-05, -4.405094150992665e-05, 0.0001197873538210701]]} + #*EXTRAS*# Step: 6 Bead: 23 +{"friction": [[0.0001197065371053325, -4.4264281203920326e-05, -4.4208081627103034e-05], [-4.4264281203920326e-05, 0.0001195435453875495, -4.406874155192904e-05], [-4.4208081627103034e-05, -4.406874155192904e-05, 0.00011968200101942822]]} + #*EXTRAS*# Step: 7 Bead: 23 +{"friction": [[0.00011963823068311246, -4.4282849656501474e-05, -4.4221153181210326e-05], [-4.4282849656501474e-05, 0.0001194667649172386, -4.407954970692526e-05], [-4.4221153181210326e-05, -4.407954970692526e-05, 0.00011961511324998141]]} + #*EXTRAS*# Step: 8 Bead: 23 +{"friction": [[0.00011959451121760073, -4.4294517383930295e-05, -4.422921144602003e-05], [-4.4294517383930295e-05, 0.00011941761987982661, -4.408627265918653e-05], [-4.422921144602003e-05, -4.408627265918653e-05, 0.00011957227752031245]]} + #*EXTRAS*# Step: 9 Bead: 23 +{"friction": [[0.00011956602914040096, -4.430202683954372e-05, -4.423433331283966e-05], [-4.430202683954372e-05, 0.00011938560380489902, -4.409057114661542e-05], [-4.423433331283966e-05, -4.409057114661542e-05, 0.00011954436122375053]]} + #*EXTRAS*# Step: 10 Bead: 23 +{"friction": [[0.00011954733427817141, -4.430691630523866e-05, -4.42376407336422e-05], [-4.430691630523866e-05, 0.0001193645899625526, -4.4093357793867836e-05], [-4.42376407336422e-05, -4.4093357793867836e-05, 0.00011952603352323464]]} + #*EXTRAS*# Step: 11 Bead: 23 +{"friction": [[0.00011953497871439692, -4.4310130536089405e-05, -4.423980306851748e-05], [-4.4310130536089405e-05, 0.00011935070215339982, -4.4095184420353985e-05], [-4.423980306851748e-05, -4.4095184420353985e-05, 0.00011951391881026372]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 new file mode 100644 index 000000000..e391ebc7c --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 24 +{"friction": [[0.0001212275207465149, -4.375126119893523e-05, -4.373820812440936e-05], [-4.375126119893523e-05, 0.00012123144588354693, -4.372279618309253e-05], [-4.373820812440936e-05, -4.372279618309253e-05, 0.00012115544091225404]]} + #*EXTRAS*# Step: 1 Bead: 24 +{"friction": [[0.00012082396073671184, -4.390505487040522e-05, -4.390058306325644e-05], [-4.390505487040522e-05, 0.00012079080262449425, -4.38358097942225e-05], [-4.390058306325644e-05, -4.38358097942225e-05, 0.00012076809544127083]]} + #*EXTRAS*# Step: 2 Bead: 24 +{"friction": [[0.00012041306569266984, -4.404889021387063e-05, -4.4035776290729826e-05], [-4.404889021387063e-05, 0.00012033531177908212, -4.393431814702446e-05], [-4.4035776290729826e-05, -4.393431814702446e-05, 0.00012037073525325993]]} + #*EXTRAS*# Step: 3 Bead: 24 +{"friction": [[0.00011984926901622147, -4.4224163095564996e-05, -4.4178830372939526e-05], [-4.4224163095564996e-05, 0.00011970393702232657, -4.404494611606638e-05], [-4.4178830372939526e-05, -4.404494611606638e-05, 0.00011982161268363976]]} + #*EXTRAS*# Step: 4 Bead: 24 +{"friction": [[0.00011960859361100139, -4.4290777697296655e-05, -4.422664185917218e-05], [-4.4290777697296655e-05, 0.00011943344985139849, -4.4084123676925905e-05], [-4.422664185917218e-05, -4.4084123676925905e-05, 0.00011958607728930887]]} + #*EXTRAS*# Step: 5 Bead: 24 +{"friction": [[0.00011944886155197352, -4.433214979378633e-05, -4.425435844759494e-05], [-4.433214979378633e-05, 0.0001192539184728417, -4.410758374623853e-05], [-4.425435844759494e-05, -4.410758374623853e-05, 0.0001194294411714044]]} + #*EXTRAS*# Step: 6 Bead: 24 +{"friction": [[0.00011935331231028884, -4.435578741860952e-05, -4.4269468267305295e-05], [-4.435578741860952e-05, 0.00011914657668446676, -4.412066589494962e-05], [-4.4269468267305295e-05, -4.412066589494962e-05, 0.00011933563347937368]]} + #*EXTRAS*# Step: 7 Bead: 24 +{"friction": [[0.0001192927215479473, -4.437033878343526e-05, -4.4278493864083565e-05], [-4.437033878343526e-05, 0.00011907854132262548, -4.412859656757082e-05], [-4.4278493864083565e-05, -4.412859656757082e-05, 0.00011927610659844549]]} + #*EXTRAS*# Step: 8 Bead: 24 +{"friction": [[0.00011925398575914356, -4.437946148667519e-05, -4.4284041189802117e-05], [-4.437946148667519e-05, 0.00011903506315200893, -4.4133519046184375e-05], [-4.4284041189802117e-05, -4.4133519046184375e-05, 0.00011923803505204551]]} + #*EXTRAS*# Step: 9 Bead: 24 +{"friction": [[0.00011922875782295523, -4.438532692695456e-05, -4.4287561515943576e-05], [-4.438532692695456e-05, 0.00011900675459934558, -4.4136663279016176e-05], [-4.4287561515943576e-05, -4.4136663279016176e-05, 0.00011921323320660534]]} + #*EXTRAS*# Step: 10 Bead: 24 +{"friction": [[0.00011921220474778592, -4.438914275623046e-05, -4.4289831917718994e-05], [-4.438914275623046e-05, 0.0001189881838886159, -4.413869995666427e-05], [-4.4289831917718994e-05, -4.413869995666427e-05, 0.00011919695695409515]]} + #*EXTRAS*# Step: 11 Bead: 24 +{"friction": [[0.00011920126638018202, -4.4391650007737524e-05, -4.429131513619347e-05], [-4.4391650007737524e-05, 0.00011897591392723124, -4.4140034350521716e-05], [-4.429131513619347e-05, -4.4140034350521716e-05, 0.0001191862003271652]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 new file mode 100644 index 000000000..9aa1699a0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 25 +{"friction": [[0.00012044952884396826, -4.403666137295798e-05, -4.402490059939584e-05], [-4.403666137295798e-05, 0.00012037593919233641, -4.3926210514548074e-05], [-4.402490059939584e-05, -4.3926210514548074e-05, 0.00012040610370999929]]} + #*EXTRAS*# Step: 1 Bead: 25 +{"friction": [[0.00012020886497248827, -4.411539970860818e-05, -4.409290545749114e-05], [-4.411539970860818e-05, 0.00012010722931354498, -4.397753650665045e-05], [-4.409290545749114e-05, -4.397753650665045e-05, 0.00012017231891747126]]} + #*EXTRAS*# Step: 2 Bead: 25 +{"friction": [[0.00011992892872572898, -4.42010087376678e-05, -4.416133631508996e-05], [-4.42010087376678e-05, 0.00011979339976457563, -4.403094423701325e-05], [-4.416133631508996e-05, -4.403094423701325e-05, 0.00011989943473693642]]} + #*EXTRAS*# Step: 3 Bead: 25 +{"friction": [[0.00011941755074156832, -4.4339988172585734e-05, -4.425942919018159e-05], [-4.4339988172585734e-05, 0.00011921873735756763, -4.4111948607555305e-05], [-4.425942919018159e-05, -4.4111948607555305e-05, 0.00011939870985521936]]} + #*EXTRAS*# Step: 4 Bead: 25 +{"friction": [[0.0001192115909373238, -4.4389283752587377e-05, -4.428991550847317e-05], [-4.4389283752587377e-05, 0.00011898749531957892, -4.41387750779459e-05], [-4.428991550847317e-05, -4.41387750779459e-05, 0.00011919635336697778]]} + #*EXTRAS*# Step: 5 Bead: 25 +{"friction": [[0.00011907270065021501, -4.442026072362427e-05, -4.43077414443862e-05], [-4.442026072362427e-05, 0.00011883180918050381, -4.415503787138325e-05], [-4.43077414443862e-05, -4.415503787138325e-05, 0.00011905970203646759]]} + #*EXTRAS*# Step: 6 Bead: 25 +{"friction": [[0.00011899009128511937, -4.4437798632849395e-05, -4.431733221866311e-05], [-4.4437798632849395e-05, 0.00011873934134613834, -4.416401991884375e-05], [-4.431733221866311e-05, -4.416401991884375e-05, 0.00011897835704853841]]} + #*EXTRAS*# Step: 7 Bead: 25 +{"friction": [[0.00011893769760593897, -4.444857358748443e-05, -4.432303139683909e-05], [-4.444857358748443e-05, 0.00011868075437105062, -4.416945119899113e-05], [-4.432303139683909e-05, -4.416945119899113e-05, 0.00011892674061190132]]} + #*EXTRAS*# Step: 8 Bead: 25 +{"friction": [[0.00011890424397340144, -4.445531067741955e-05, -4.4326516391480475e-05], [-4.445531067741955e-05, 0.00011864337246873536, -4.417281167607884e-05], [-4.4326516391480475e-05, -4.417281167607884e-05, 0.00011889377356782563]]} + #*EXTRAS*# Step: 9 Bead: 25 +{"friction": [[0.00011888246026152235, -4.4459637407553695e-05, -4.432872164816807e-05], [-4.4459637407553695e-05, 0.0001186190423532978, -4.417495496745889e-05], [-4.432872164816807e-05, -4.417495496745889e-05, 0.00011887230273336393]]} + #*EXTRAS*# Step: 10 Bead: 25 +{"friction": [[0.00011886817197196801, -4.4462449485870544e-05, -4.4330140810088684e-05], [-4.4462449485870544e-05, 0.00011860308893275855, -4.4176341568318373e-05], [-4.4330140810088684e-05, -4.4176341568318373e-05, 0.00011885821798867321]]} + #*EXTRAS*# Step: 11 Bead: 25 +{"friction": [[0.00011885873130129654, -4.446429621892357e-05, -4.433106665942791e-05], [-4.446429621892357e-05, 0.00011859255032314837, -4.417724938713289e-05], [-4.433106665942791e-05, -4.417724938713289e-05, 0.00011884891108389906]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 new file mode 100644 index 000000000..fa589dfbe --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 26 +{"friction": [[0.00011962164781834676, -4.428729526742142e-05, -4.422423780727485e-05], [-4.428729526742142e-05, 0.00011944812410604063, -4.4082117571065435e-05], [-4.422423780727485e-05, -4.4082117571065435e-05, 0.00011959886778569174]]} + #*EXTRAS*# Step: 1 Bead: 26 +{"friction": [[0.00011956420958774032, -4.430250410507531e-05, -4.423465711124019e-05], [-4.430250410507531e-05, 0.00011938355852155563, -4.409084357716244e-05], [-4.423465711124019e-05, -4.409084357716244e-05, 0.00011954257755208874]]} + #*EXTRAS*# Step: 2 Bead: 26 +{"friction": [[0.00011942704637695186, -4.433762051480021e-05, -4.425790374945869e-05], [-4.433762051480021e-05, 0.00011922940619548024, -4.411063292095287e-05], [-4.425790374945869e-05, -4.411063292095287e-05, 0.00011940803066550242]]} + #*EXTRAS*# Step: 3 Bead: 26 +{"friction": [[0.00011897369986408245, -4.444119880700896e-05, -4.431914699935431e-05], [-4.444119880700896e-05, 0.00011872100714445573, -4.4165741203132435e-05], [-4.431914699935431e-05, -4.4165741203132435e-05, 0.00011896221080665896]]} + #*EXTRAS*# Step: 4 Bead: 26 +{"friction": [[0.00011880459115871713, -4.4474712593060996e-05, -4.4336195345046715e-05], [-4.4474712593060996e-05, 0.00011853214963040642, -4.4182327422280245e-05], [-4.4336195345046715e-05, -4.4182327422280245e-05, 0.00011879552714498319]]} + #*EXTRAS*# Step: 5 Bead: 26 +{"friction": [[0.00011868773575170423, -4.449617260932374e-05, -4.434622746209159e-05], [-4.449617260932374e-05, 0.00011840200551266024, -4.419254608982146e-05], [-4.434622746209159e-05, -4.419254608982146e-05, 0.00011868024293753555]]} + #*EXTRAS*# Step: 6 Bead: 26 +{"friction": [[0.00011861873395827795, -4.450817842427834e-05, -4.4351495513239337e-05], [-4.450817842427834e-05, 0.0001183253140265147, -4.419810549076173e-05], [-4.4351495513239337e-05, -4.419810549076173e-05, 0.00011861213178104821]]} + #*EXTRAS*# Step: 7 Bead: 26 +{"friction": [[0.00011857493725671562, -4.451553843459481e-05, -4.435459021320624e-05], [-4.451553843459481e-05, 0.00011827670200952476, -4.420145175475154e-05], [-4.435459021320624e-05, -4.420145175475154e-05, 0.00011856888680365574]]} + #*EXTRAS*# Step: 8 Bead: 26 +{"friction": [[0.00011854701317825116, -4.452012458834187e-05, -4.4356463253255004e-05], [-4.452012458834187e-05, 0.00011824573553493671, -4.420351142815802e-05], [-4.4356463253255004e-05, -4.420351142815802e-05, 0.00011854130916918456]]} + #*EXTRAS*# Step: 9 Bead: 26 +{"friction": [[0.00011852883107900232, -4.452306592903546e-05, -4.435764116865877e-05], [-4.452306592903546e-05, 0.00011822558440611744, -4.420482164333959e-05], [-4.435764116865877e-05, -4.420482164333959e-05, 0.0001185233504665207]]} + #*EXTRAS*# Step: 10 Bead: 26 +{"friction": [[0.00011851690933273039, -4.4524975263019346e-05, -4.4358395733372976e-05], [-4.4524975263019346e-05, 0.00011821237680381056, -4.420566751273579e-05], [-4.4358395733372976e-05, -4.420566751273579e-05, 0.00011851157427706811]]} + #*EXTRAS*# Step: 11 Bead: 26 +{"friction": [[0.0001185090329255519, -4.452622832366421e-05, -4.435888654879616e-05], [-4.452622832366421e-05, 0.00011820365315210676, -4.420622061516671e-05], [-4.435888654879616e-05, -4.420622061516671e-05, 0.00011850379363918162]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 new file mode 100644 index 000000000..7736313c0 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 27 +{"friction": [[0.00011875913034376447, -4.4483228394450665e-05, -4.434026563858943e-05], [-4.4483228394450665e-05, 0.00011848148125785116, -4.418642315217651e-05], [-4.434026563858943e-05, -4.418642315217651e-05, 0.0001187506872749722]]} + #*EXTRAS*# Step: 1 Bead: 27 +{"friction": [[0.00011889754303883965, -4.4456646700982576e-05, -4.432720011949088e-05], [-4.4456646700982576e-05, 0.0001186358872430357, -4.417347474909975e-05], [-4.432720011949088e-05, -4.417347474909975e-05, 0.00011888716920890355]]} + #*EXTRAS*# Step: 2 Bead: 27 +{"friction": [[0.00011891124627343716, -4.445390976398518e-05, -4.432579681108149e-05], [-4.445390976398518e-05, 0.00011865119525684976, -4.4172115200751746e-05], [-4.432579681108149e-05, -4.4172115200751746e-05, 0.00011890067463300128]]} + #*EXTRAS*# Step: 3 Bead: 27 +{"friction": [[0.00011852063630896816, -4.452438000901119e-05, -4.435816135188714e-05], [-4.452438000901119e-05, 0.00011821650531754549, -4.4205404201912454e-05], [-4.435816135188714e-05, -4.4205404201912454e-05, 0.00011851525582722269]]} + #*EXTRAS*# Step: 4 Bead: 27 +{"friction": [[0.00011839001607548813, -4.454434282367058e-05, -4.436556264881523e-05], [-4.454434282367058e-05, 0.00011807206488202185, -4.421402249739068e-05], [-4.436556264881523e-05, -4.421402249739068e-05, 0.00011838618681243794]]} + #*EXTRAS*# Step: 5 Bead: 27 +{"friction": [[0.00011829612387727394, -4.45575320587298e-05, -4.436986170150084e-05], [-4.45575320587298e-05, 0.00011796858021705418, -4.421944224516458e-05], [-4.436986170150084e-05, -4.421944224516458e-05, 0.00011829336058556301]]} + #*EXTRAS*# Step: 6 Bead: 27 +{"friction": [[0.00011824124476680616, -4.456478314321945e-05, -4.4371985110537326e-05], [-4.456478314321945e-05, 0.00011790823687257927, -4.422230990345265e-05], [-4.4371985110537326e-05, -4.422230990345265e-05, 0.00011823908691204161]]} + #*EXTRAS*# Step: 7 Bead: 27 +{"friction": [[0.000118206352754207, -4.4569215486619616e-05, -4.4373187281910205e-05], [-4.4569215486619616e-05, 0.0001178699279420633, -4.4224017990701657e-05], [-4.4373187281910205e-05, -4.4224017990701657e-05, 0.00011820457342555049]]} + #*EXTRAS*# Step: 8 Bead: 27 +{"friction": [[0.00011818414799400393, -4.4571963610244567e-05, -4.437389282420149e-05], [-4.4571963610244567e-05, 0.00011784557250768474, -4.422505836706408e-05], [-4.437389282420149e-05, -4.422505836706408e-05, 0.00011818260704496809]]} + #*EXTRAS*# Step: 9 Bead: 27 +{"friction": [[0.00011816968805519664, -4.457372272219616e-05, -4.437432749127666e-05], [-4.457372272219616e-05, 0.00011782972215492802, -4.4225716367651537e-05], [-4.437432749127666e-05, -4.4225716367651537e-05, 0.00011816830131475525]]} + #*EXTRAS*# Step: 10 Bead: 27 +{"friction": [[0.00011816021069794609, -4.45748625932287e-05, -4.4374601799984085e-05], [-4.45748625932287e-05, 0.00011781933786982312, -4.422613928911364e-05], [-4.4374601799984085e-05, -4.422613928911364e-05, 0.00011815892459624705]]} + #*EXTRAS*# Step: 11 Bead: 27 +{"friction": [[0.00011815394944373662, -4.457560995606988e-05, -4.4374778434002464e-05], [-4.457560995606988e-05, 0.00011781247936593324, -4.422641506796233e-05], [-4.4374778434002464e-05, -4.422641506796233e-05, 0.00011815272964316132]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 new file mode 100644 index 000000000..53db434d5 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 28 +{"friction": [[0.00011787887860218989, -4.4603875439562205e-05, -4.437898686966099e-05], [-4.4603875439562205e-05, 0.00011751277754076018, -4.4235677964967273e-05], [-4.437898686966099e-05, -4.4235677964967273e-05, 0.00011788043866959533]]} + #*EXTRAS*# Step: 1 Bead: 28 +{"friction": [[0.00011821716815919634, -4.456785647027198e-05, -4.437282688981072e-05], [-4.456785647027198e-05, 0.00011788179763208274, -4.4223498113881176e-05], [-4.437282688981072e-05, -4.4223498113881176e-05, 0.00011821527202003079]]} + #*EXTRAS*# Step: 2 Bead: 28 +{"friction": [[0.00011838569138740155, -4.454497183562904e-05, -4.436577928393003e-05], [-4.454497183562904e-05, 0.00011806729185287206, -4.4214286372228455e-05], [-4.436577928393003e-05, -4.4214286372228455e-05, 0.00011838191209280875]]} + #*EXTRAS*# Step: 3 Bead: 28 +{"friction": [[0.00011806148666091202, -4.458611480001459e-05, -4.437696412294825e-05], [-4.458611480001459e-05, 0.00011771137868652827, -4.423015156027718e-05], [-4.437696412294825e-05, -4.423015156027718e-05, 0.00011806122929420302]]} + #*EXTRAS*# Step: 4 Bead: 28 +{"friction": [[0.00011797044514981993, -4.459547167406276e-05, -4.4378349868520603e-05], [-4.459547167406276e-05, 0.00011761217959256026, -4.4233214813589336e-05], [-4.4378349868520603e-05, -4.4233214813589336e-05, 0.00011797110680819052]]} + #*EXTRAS*# Step: 5 Bead: 28 +{"friction": [[0.00011790015293083769, -4.460201406123035e-05, -4.4378906029532975e-05], [-4.460201406123035e-05, 0.00011753583820886205, -4.4235161024597545e-05], [-4.4378906029532975e-05, -4.4235161024597545e-05, 0.0001179015064396536]]} + #*EXTRAS*# Step: 6 Bead: 28 +{"friction": [[0.00011785974412410197, -4.4605502089579566e-05, -4.437902503330294e-05], [-4.4605502089579566e-05, 0.00011749205445605932, -4.4236114258129916e-05], [-4.437902503330294e-05, -4.4236114258129916e-05, 0.0001178614888993328]]} + #*EXTRAS*# Step: 7 Bead: 28 +{"friction": [[0.00011783396351394781, -4.46076222452649e-05, -4.437902487515595e-05], [-4.46076222452649e-05, 0.00011746416086048637, -4.423665914825199e-05], [-4.437902487515595e-05, -4.423665914825199e-05, 0.00011783595558926046]]} + #*EXTRAS*# Step: 8 Bead: 28 +{"friction": [[0.00011781760479149767, -4.4608924804798216e-05, -4.437899415521877e-05], [-4.4608924804798216e-05, 0.00011744647788888599, -4.423697931407515e-05], [-4.437899415521877e-05, -4.423697931407515e-05, 0.00011781975288148242]]} + #*EXTRAS*# Step: 9 Bead: 28 +{"friction": [[0.00011780694729995558, -4.4609755476478894e-05, -4.437896138291455e-05], [-4.4609755476478894e-05, 0.0001174349646375853, -4.4237177203120094e-05], [-4.437896138291455e-05, -4.4237177203120094e-05, 0.0001178091966619199]]} + #*EXTRAS*# Step: 10 Bead: 28 +{"friction": [[0.00011779996606323877, -4.461029192429088e-05, -4.4378934466950035e-05], [-4.461029192429088e-05, 0.00011742742583315106, -4.423730225504211e-05], [-4.4378934466950035e-05, -4.423730225504211e-05, 0.00011780228160828536]]} + #*EXTRAS*# Step: 11 Bead: 28 +{"friction": [[0.00011779535373799366, -4.4610642997903614e-05, -4.43789143206899e-05], [-4.4610642997903614e-05, 0.00011742244644622176, -4.4237382885828976e-05], [-4.43789143206899e-05, -4.4237382885828976e-05, 0.00011779771294165908]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 new file mode 100644 index 000000000..9b811c0f4 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 29 +{"friction": [[0.0001169988017405095, -4.4628706812311107e-05, -4.434812841942771e-05], [-4.4628706812311107e-05, 0.00011658072617402499, -4.422718506529086e-05], [-4.434812841942771e-05, -4.422718506529086e-05, 0.00011700820795224204]]} + #*EXTRAS*# Step: 1 Bead: 29 +{"friction": [[0.00011753189974625173, -4.4626185785848615e-05, -4.4374678762031694e-05], [-4.4626185785848615e-05, 0.00011713984978702145, -4.423935106572228e-05], [-4.4374678762031694e-05, -4.423935106572228e-05, 0.0001175366758387438]]} + #*EXTRAS*# Step: 2 Bead: 29 +{"friction": [[0.00011785480746316499, -4.460591443703884e-05, -4.4379029581375005e-05], [-4.460591443703884e-05, 0.00011748671073803878, -4.423622241511476e-05], [-4.4379029581375005e-05, -4.423622241511476e-05, 0.00011785659973074332]]} + #*EXTRAS*# Step: 3 Bead: 29 +{"friction": [[0.00011759953086947621, -4.462305479111253e-05, -4.437633968264983e-05], [-4.462305479111253e-05, 0.00011721203991483914, -4.4239342201802445e-05], [-4.437633968264983e-05, -4.4239342201802445e-05, 0.00011760369937668614]]} + #*EXTRAS*# Step: 4 Bead: 29 +{"friction": [[0.00011754857393602378, -4.462547003010778e-05, -4.4375124686233114e-05], [-4.462547003010778e-05, 0.00011715762415018113, -4.4239380883758826e-05], [-4.4375124686233114e-05, -4.4239380883758826e-05, 0.00011755320093169063]]} + #*EXTRAS*# Step: 5 Bead: 29 +{"friction": [[0.00011750220634373885, -4.462736866459116e-05, -4.437382585284434e-05], [-4.462736866459116e-05, 0.00011710823649482514, -4.423924599519867e-05], [-4.437382585284434e-05, -4.423924599519867e-05, 0.000117507246891289]]} + #*EXTRAS*# Step: 6 Bead: 29 +{"friction": [[0.00011747643658614995, -4.462829945346136e-05, -4.4373024768115825e-05], [-4.462829945346136e-05, 0.00011708084186528402, -4.4239100768079964e-05], [-4.4373024768115825e-05, -4.4239100768079964e-05, 0.00011748170560821562]]} + #*EXTRAS*# Step: 7 Bead: 29 +{"friction": [[0.00011745986638223633, -4.462885066878213e-05, -4.4372479862216465e-05], [-4.462885066878213e-05, 0.0001170632473995152, -4.423898081370372e-05], [-4.4372479862216465e-05, -4.423898081370372e-05, 0.00011746528183714778]]} + #*EXTRAS*# Step: 8 Bead: 29 +{"friction": [[0.00011744941326375558, -4.462917927445722e-05, -4.437212414001567e-05], [-4.462917927445722e-05, 0.00011705215648754886, -4.4238894429508836e-05], [-4.437212414001567e-05, -4.4238894429508836e-05, 0.00011745492091031024]]} + #*EXTRAS*# Step: 9 Bead: 29 +{"friction": [[0.0001174425956520085, -4.462938560135049e-05, -4.4371887149921774e-05], [-4.462938560135049e-05, 0.0001170449264028491, -4.42388336200355e-05], [-4.4371887149921774e-05, -4.42388336200355e-05, 0.00011744816335248383]]} + #*EXTRAS*# Step: 10 Bead: 29 +{"friction": [[0.00011743813448525062, -4.462951719175473e-05, -4.437172994471009e-05], [-4.462951719175473e-05, 0.00011704019683257886, -4.423879191801523e-05], [-4.437172994471009e-05, -4.423879191801523e-05, 0.00011744374145148282]]} + #*EXTRAS*# Step: 11 Bead: 29 +{"friction": [[0.00011743518666439092, -4.462960265636111e-05, -4.437162514423069e-05], [-4.462960265636111e-05, 0.00011703707231134586, -4.423876353273301e-05], [-4.437162514423069e-05, -4.423876353273301e-05, 0.00011744081956309121]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 new file mode 100644 index 000000000..c4f6066c6 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 30 +{"friction": [[0.00011613512964090057, -4.4542480960535e-05, -4.4255686347443705e-05], [-4.4542480960535e-05, 0.00011571790314066553, -4.415921694916118e-05], [-4.4255686347443705e-05, -4.415921694916118e-05, 0.00011615221676811073]]} + #*EXTRAS*# Step: 1 Bead: 30 +{"friction": [[0.0001168508521955774, -4.462198079338802e-05, -4.433662780422844e-05], [-4.462198079338802e-05, 0.00011642908619130902, -4.421986823821559e-05], [-4.433662780422844e-05, -4.421986823821559e-05, 0.00011686153884928971]]} + #*EXTRAS*# Step: 2 Bead: 30 +{"friction": [[0.00011732320280343508, -4.463196453028039e-05, -4.436710209384723e-05], [-4.463196453028039e-05, 0.00011691876908673685, -4.423719474814293e-05], [-4.436710209384723e-05, -4.423719474814293e-05, 0.00011732981391897723]]} + #*EXTRAS*# Step: 3 Bead: 30 +{"friction": [[0.00011713814468780041, -4.463199273868092e-05, -4.4357337498689066e-05], [-4.463199273868092e-05, 0.00011672503648143685, -4.4232489528430636e-05], [-4.4357337498689066e-05, -4.4232489528430636e-05, 0.00011714635268094946]]} + #*EXTRAS*# Step: 4 Bead: 30 +{"friction": [[0.00011712716904114754, -4.4631838748797657e-05, -4.435666964536891e-05], [-4.4631838748797657e-05, 0.0001167136192376424, -4.423212698397402e-05], [-4.435666964536891e-05, -4.423212698397402e-05, 0.00011713547137529799]]} + #*EXTRAS*# Step: 5 Bead: 30 +{"friction": [[0.00011710472485968075, -4.463146856013476e-05, -4.4355273228645355e-05], [-4.463146856013476e-05, 0.00011669029836540867, -4.423135629913294e-05], [-4.4355273228645355e-05, -4.423135629913294e-05, 0.00011711322008420053]]} + #*EXTRAS*# Step: 6 Bead: 30 +{"friction": [[0.00011709357650357364, -4.463125696736904e-05, -4.4354564291257306e-05], [-4.463125696736904e-05, 0.00011667872778860107, -4.423095882930775e-05], [-4.4354564291257306e-05, -4.423095882930775e-05, 0.00011710216753577108]]} + #*EXTRAS*# Step: 7 Bead: 30 +{"friction": [[0.00011708620359525206, -4.4631106889663855e-05, -4.4354089861031955e-05], [-4.4631106889663855e-05, 0.00011667108050855097, -4.423069061165197e-05], [-4.4354089861031955e-05, -4.423069061165197e-05, 0.00011709485799143094]]} + #*EXTRAS*# Step: 8 Bead: 30 +{"friction": [[0.00011708164581272938, -4.463101006790052e-05, -4.435379435815152e-05], [-4.463101006790052e-05, 0.00011666635505827255, -4.423052267155863e-05], [-4.435379435815152e-05, -4.423052267155863e-05, 0.00011709033938083567]]} + #*EXTRAS*# Step: 9 Bead: 30 +{"friction": [[0.00011707866097182768, -4.463094498275846e-05, -4.435359991799847e-05], [-4.463094498275846e-05, 0.0001166632612201497, -4.4230411805726484e-05], [-4.435359991799847e-05, -4.4230411805726484e-05, 0.00011708738019406158]]} + #*EXTRAS*# Step: 10 Bead: 30 +{"friction": [[0.00011707671495970156, -4.463090183388839e-05, -4.4353472758388596e-05], [-4.463090183388839e-05, 0.0001166612444899166, -4.42303391482841e-05], [-4.4353472758388596e-05, -4.42303391482841e-05, 0.00011708545090795862]]} + #*EXTRAS*# Step: 11 Bead: 30 +{"friction": [[0.00011707542831335341, -4.463087299474888e-05, -4.4353388514538216e-05], [-4.463087299474888e-05, 0.00011665991123620533, -4.4230290945946367e-05], [-4.4353388514538216e-05, -4.4230290945946367e-05, 0.00011708417532056929]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 new file mode 100644 index 000000000..e085b0737 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 31 +{"friction": [[0.00011529316548301044, -4.435439121512612e-05, -4.41050010482841e-05], [-4.435439121512612e-05, 0.00011492181793038626, -4.403170578939231e-05], [-4.41050010482841e-05, -4.403170578939231e-05, 0.00011531825069130156]]} + #*EXTRAS*# Step: 1 Bead: 31 +{"friction": [[0.00011618143560430524, -4.454992602515317e-05, -4.4262212197190304e-05], [-4.454992602515317e-05, 0.00011576286740312808, -4.4164436366442505e-05], [-4.4262212197190304e-05, -4.4164436366442505e-05, 0.00011619809791954101]]} + #*EXTRAS*# Step: 2 Bead: 31 +{"friction": [[0.00011679557074895778, -4.461859976467617e-05, -4.4331876407486066e-05], [-4.461859976467617e-05, 0.00011637285338915298, -4.4216683724111655e-05], [-4.4331876407486066e-05, -4.4216683724111655e-05, 0.00011680673943670854]]} + #*EXTRAS*# Step: 3 Bead: 31 +{"friction": [[0.00011668067469725762, -4.4610072617390604e-05, -4.432120616723605e-05], [-4.4610072617390604e-05, 0.00011625670864088914, -4.420927382725791e-05], [-4.432120616723605e-05, -4.420927382725791e-05, 0.00011669285170427029]]} + #*EXTRAS*# Step: 4 Bead: 31 +{"friction": [[0.00011670897606248251, -4.461236036127493e-05, -4.4323934401912875e-05], [-4.461236036127493e-05, 0.00011628522725521543, -4.4211198612397986e-05], [-4.4323934401912875e-05, -4.4211198612397986e-05, 0.00011672090388378314]]} + #*EXTRAS*# Step: 5 Bead: 31 +{"friction": [[0.00011671012240289376, -4.461245045141217e-05, -4.4324043529746896e-05], [-4.461245045141217e-05, 0.00011628638363122736, -4.421127520065163e-05], [-4.4324043529746896e-05, -4.421127520065163e-05, 0.00011672204014224594]]} + #*EXTRAS*# Step: 6 Bead: 31 +{"friction": [[0.00011671338992993012, -4.4612706143352436e-05, -4.4324353998906704e-05], [-4.4612706143352436e-05, 0.0001162896802931441, -4.421149292088838e-05], [-4.4324353998906704e-05, -4.421149292088838e-05, 0.00011672527893651709]]} + #*EXTRAS*# Step: 7 Bead: 31 +{"friction": [[0.00011671508811696076, -4.461283838685081e-05, -4.4324515010642386e-05], [-4.461283838685081e-05, 0.00011629139393174298, -4.421160573059622e-05], [-4.4324515010642386e-05, -4.421160573059622e-05, 0.00011672696219347092]]} + #*EXTRAS*# Step: 8 Bead: 31 +{"friction": [[0.0001167163451180329, -4.461293599009261e-05, -4.432463404023682e-05], [-4.461293599009261e-05, 0.00011629266250658357, -4.421168908145511e-05], [-4.432463404023682e-05, -4.421168908145511e-05, 0.0001167282081445108]]} + #*EXTRAS*# Step: 9 Bead: 31 +{"friction": [[0.00011671714112046479, -4.461299767305991e-05, -4.4324709349663716e-05], [-4.461299767305991e-05, 0.00011629346589822784, -4.4211741797356404e-05], [-4.4324709349663716e-05, -4.4211741797356404e-05, 0.00011672899714999678]]} + #*EXTRAS*# Step: 10 Bead: 31 +{"friction": [[0.00011671767632078693, -4.461303909182102e-05, -4.4324759955653194e-05], [-4.461303909182102e-05, 0.00011629400609295324, -4.421177721245518e-05], [-4.4324759955653194e-05, -4.421177721245518e-05, 0.00011672952764608852]]} + #*EXTRAS*# Step: 11 Bead: 31 +{"friction": [[0.00011671802851105306, -4.4613066323699734e-05, -4.432479324433376e-05], [-4.4613066323699734e-05, 0.00011629436158129287, -4.4211800504764215e-05], [-4.432479324433376e-05, -4.4211800504764215e-05, 0.00011672987674082499]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 new file mode 100644 index 000000000..1950b59c1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 32 +{"friction": [[0.00011447442737646712, -4.4082214189905e-05, -4.389842451436581e-05], [-4.4082214189905e-05, 0.00011417821453784439, -4.384566898769395e-05], [-4.389842451436581e-05, -4.384566898769395e-05, 0.0001145078200454766]]} + #*EXTRAS*# Step: 1 Bead: 32 +{"friction": [[0.00011552592376511203, -4.441613809123734e-05, -4.415280344343716e-05], [-4.441613809123734e-05, 0.00011513814426212077, -4.4073247851896053e-05], [-4.415280344343716e-05, -4.4073247851896053e-05, 0.00011554874474127439]]} + #*EXTRAS*# Step: 2 Bead: 32 +{"friction": [[0.00011627546015973217, -4.456408067743581e-05, -4.427490821314602e-05], [-4.456408067743581e-05, 0.00011585459018543612, -4.417447430350005e-05], [-4.427490821314602e-05, -4.417447430350005e-05, 0.00011629126455004889]]} + #*EXTRAS*# Step: 3 Bead: 32 +{"friction": [[0.00011622924232197253, -4.455728463130126e-05, -4.4268760211181105e-05], [-4.455728463130126e-05, 0.00011580943235948906, -4.4169633704368606e-05], [-4.4268760211181105e-05, -4.4169633704368606e-05, 0.00011624546764852702]]} + #*EXTRAS*# Step: 4 Bead: 32 +{"friction": [[0.00011629581905243802, -4.4566974781535756e-05, -4.427755963555833e-05], [-4.4566974781535756e-05, 0.00011587452645299433, -4.417654936810728e-05], [-4.427755963555833e-05, -4.417654936810728e-05, 0.00011631143849577973]]} + #*EXTRAS*# Step: 5 Bead: 32 +{"friction": [[0.00011632000898392532, -4.4570334116205896e-05, -4.428066493784767e-05], [-4.4570334116205896e-05, 0.00011589824976753216, -4.417896953455571e-05], [-4.428066493784767e-05, -4.417896953455571e-05, 0.00011633540905410704]]} + #*EXTRAS*# Step: 6 Bead: 32 +{"friction": [[0.00011633737206515648, -4.457269214403897e-05, -4.428286373857454e-05], [-4.457269214403897e-05, 0.00011591530185143721, -4.4180676358009666e-05], [-4.428286373857454e-05, -4.4180676358009666e-05, 0.00011635261492470085]]} + #*EXTRAS*# Step: 7 Bead: 32 +{"friction": [[0.00011634794511972351, -4.4574106207910194e-05, -4.4284190352205886e-05], [-4.4574106207910194e-05, 0.00011592569537308618, -4.4181703311332177e-05], [-4.4284190352205886e-05, -4.4181703311332177e-05, 0.00011636309235029273]]} + #*EXTRAS*# Step: 8 Bead: 32 +{"friction": [[0.00011635489317975355, -4.457502644967249e-05, -4.4285057058525385e-05], [-4.457502644967249e-05, 0.00011593252952448775, -4.418237306660518e-05], [-4.4285057058525385e-05, -4.418237306660518e-05, 0.00011636997761021585]]} + #*EXTRAS*# Step: 9 Bead: 32 +{"friction": [[0.0001163593905113958, -4.4575618291564234e-05, -4.4285615914194125e-05], [-4.4575618291564234e-05, 0.00011593695485035164, -4.418280442779502e-05], [-4.4285615914194125e-05, -4.418280442779502e-05, 0.00011637443431054037]]} + #*EXTRAS*# Step: 10 Bead: 32 +{"friction": [[0.00011636235513783233, -4.457600679322332e-05, -4.428598338846941e-05], [-4.457600679322332e-05, 0.0001159398727530949, -4.418308785297056e-05], [-4.428598338846941e-05, -4.418308785297056e-05, 0.00011637737216061435]]} + #*EXTRAS*# Step: 11 Bead: 32 +{"friction": [[0.00011636431213710674, -4.457626253600785e-05, -4.428622556318936e-05], [-4.457626253600785e-05, 0.00011594179923274342, -4.4183274543268836e-05], [-4.428622556318936e-05, -4.4183274543268836e-05, 0.00011637931148770446]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 new file mode 100644 index 000000000..624bc9d81 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 33 +{"friction": [[0.00011368019507082692, -4.37444711227787e-05, -4.363905558610621e-05], [-4.37444711227787e-05, 0.00011347259446525294, -4.36029403928641e-05], [-4.363905558610621e-05, -4.36029403928641e-05, 0.00011372219122617184]]} + #*EXTRAS*# Step: 1 Bead: 33 +{"friction": [[0.00011488557065104784, -4.4229252911492665e-05, -4.4009723651564715e-05], [-4.4229252911492665e-05, 0.00011454868533191005, -4.394698891570549e-05], [-4.4009723651564715e-05, -4.394698891570549e-05, 0.00011491472330333603]]} + #*EXTRAS*# Step: 2 Bead: 33 +{"friction": [[0.00011576416381858035, -4.447173641787124e-05, -4.419683527688875e-05], [-4.447173641787124e-05, 0.0001153623837463286, -4.4110739881217473e-05], [-4.419683527688875e-05, -4.4110739881217473e-05, 0.00011578470989628958]]} + #*EXTRAS*# Step: 3 Bead: 33 +{"friction": [[0.00011578484216243536, -4.447619208442007e-05, -4.420042552191256e-05], [-4.447619208442007e-05, 0.000115381990907153, -4.411375724972794e-05], [-4.420042552191256e-05, -4.411375724972794e-05, 0.00011580519278670521]]} + #*EXTRAS*# Step: 4 Bead: 33 +{"friction": [[0.00011588863698785958, -4.449765178982637e-05, -4.421789168091407e-05], [-4.449765178982637e-05, 0.00011548077293943289, -4.412833703042674e-05], [-4.421789168091407e-05, -4.412833703042674e-05, 0.00011590801129524293]]} + #*EXTRAS*# Step: 5 Bead: 33 +{"friction": [[0.00011593527522988086, -4.4506799468546096e-05, -4.4225439301514597e-05], [-4.4506799468546096e-05, 0.00011552536058491374, -4.413458229274719e-05], [-4.4225439301514597e-05, -4.413458229274719e-05, 0.00011595421341667227]]} + #*EXTRAS*# Step: 6 Bead: 33 +{"friction": [[0.00011596638376652037, -4.451272942544407e-05, -4.423037046716735e-05], [-4.451272942544407e-05, 0.00011555517240377913, -4.4138643061589455e-05], [-4.423037046716735e-05, -4.4138643061589455e-05, 0.00011598503193279866]]} + #*EXTRAS*# Step: 7 Bead: 33 +{"friction": [[0.00011598561623572341, -4.4516326575025816e-05, -4.4233377849592714e-05], [-4.4516326575025816e-05, 0.00011557363195886409, -4.414111168660611e-05], [-4.4233377849592714e-05, -4.414111168660611e-05, 0.00011600408545127837]]} + #*EXTRAS*# Step: 8 Bead: 33 +{"friction": [[0.00011599811925141648, -4.451863674988514e-05, -4.423531606131457e-05], [-4.451863674988514e-05, 0.00011558564437634655, -4.414269939740096e-05], [-4.423531606131457e-05, -4.414269939740096e-05, 0.00011601647227469133]]} + #*EXTRAS*# Step: 9 Bead: 33 +{"friction": [[0.00011600623030456794, -4.452012347000192e-05, -4.423656632293723e-05], [-4.452012347000192e-05, 0.000115593442190146, -4.414372217435727e-05], [-4.423656632293723e-05, -4.414372217435727e-05, 0.00011602450801105388]]} + #*EXTRAS*# Step: 10 Bead: 33 +{"friction": [[0.00011601156724903985, -4.452109657223465e-05, -4.423738592475621e-05], [-4.452109657223465e-05, 0.00011559857519141815, -4.414439205049982e-05], [-4.423738592475621e-05, -4.414439205049982e-05, 0.00011602979542415938]]} + #*EXTRAS*# Step: 11 Bead: 33 +{"friction": [[0.00011601509150879722, -4.452173692571863e-05, -4.423792582319335e-05], [-4.452173692571863e-05, 0.00011560196572003811, -4.414483305824063e-05], [-4.423792582319335e-05, -4.414483305824063e-05, 0.00011603328698705741]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 new file mode 100644 index 000000000..14fb9b945 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 34 +{"friction": [[0.0001129115705507499, -4.335986330177095e-05, -4.33306885948054e-05], [-4.335986330177095e-05, 0.00011279080035366944, -4.3306160132593466e-05], [-4.33306885948054e-05, -4.3306160132593466e-05, 0.00011296244664467974]]} + #*EXTRAS*# Step: 1 Bead: 34 +{"friction": [[0.00011426150772254876, -4.399832285946132e-05, -4.3834685021937484e-05], [-4.399832285946132e-05, 0.00011398810605570284, -4.378676893980419e-05], [-4.3834685021937484e-05, -4.378676893980419e-05, 0.00011429715231755915]]} + #*EXTRAS*# Step: 2 Bead: 34 +{"friction": [[0.00011526264338286579, -4.434576130918476e-05, -4.409837880774723e-05], [-4.434576130918476e-05, 0.00011489363744283414, -4.402589337720955e-05], [-4.409837880774723e-05, -4.402589337720955e-05, 0.00011528802861583142]]} + #*EXTRAS*# Step: 3 Bead: 34 +{"friction": [[0.00011534836302830751, -4.4369686628347246e-05, -4.411676802902943e-05], [-4.4369686628347246e-05, 0.00011497288763174257, -4.4042001353587696e-05], [-4.411676802902943e-05, -4.4042001353587696e-05, 0.00011537290750191765]]} + #*EXTRAS*# Step: 4 Bead: 34 +{"friction": [[0.00011548827852440699, -4.4406643370886556e-05, -4.4145394204292986e-05], [-4.4406643370886556e-05, 0.00011510297961325047, -4.406686059320522e-05], [-4.4145394204292986e-05, -4.406686059320522e-05, 0.00011551146288650336]]} + #*EXTRAS*# Step: 5 Bead: 34 +{"friction": [[0.00011555673708213701, -4.442376682210013e-05, -4.415877597355805e-05], [-4.442376682210013e-05, 0.00011516698007694079, -4.407838138163964e-05], [-4.415877597355805e-05, -4.407838138163964e-05, 0.00011557926142255594]]} + #*EXTRAS*# Step: 6 Bead: 34 +{"friction": [[0.00011560121878781194, -4.443455165335257e-05, -4.4167251958182236e-05], [-4.443455165335257e-05, 0.00011520869247353871, -4.4085642394160214e-05], [-4.4167251958182236e-05, -4.4085642394160214e-05, 0.00011562331617730565]]} + #*EXTRAS*# Step: 7 Bead: 34 +{"friction": [[0.00011562888057639166, -4.444112203691841e-05, -4.417243614823435e-05], [-4.444112203691841e-05, 0.00011523468373871902, -4.409006884789824e-05], [-4.417243614823435e-05, -4.409006884789824e-05, 0.0001156507132114404]]} + #*EXTRAS*# Step: 8 Bead: 34 +{"friction": [[0.0001156467928275793, -4.444532066964563e-05, -4.41757577114203e-05], [-4.444532066964563e-05, 0.00011525153563379555, -4.4092898879145275e-05], [-4.41757577114203e-05, -4.4092898879145275e-05, 0.00011566845432926164]]} + #*EXTRAS*# Step: 9 Bead: 34 +{"friction": [[0.00011565842365222586, -4.444802331617e-05, -4.41778995776946e-05], [-4.444802331617e-05, 0.00011526248701662714, -4.4094721227055774e-05], [-4.41778995776946e-05, -4.4094721227055774e-05, 0.00011567997416215917]]} + #*EXTRAS*# Step: 10 Bead: 34 +{"friction": [[0.00011566607160918241, -4.4449790316441855e-05, -4.4179301593005485e-05], [-4.4449790316441855e-05, 0.00011526969211234302, -4.409591298963699e-05], [-4.4179301593005485e-05, -4.409591298963699e-05, 0.00011568754919072312]]} + #*EXTRAS*# Step: 11 Bead: 34 +{"friction": [[0.00011567112279363183, -4.4450952932775206e-05, -4.418022479251847e-05], [-4.4450952932775206e-05, 0.00011527445251132792, -4.409669726038635e-05], [-4.418022479251847e-05, -4.409669726038635e-05, 0.00011569255223276694]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 new file mode 100644 index 000000000..64e38053a --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 35 +{"friction": [[0.00011216920631531552, -4.2946540772708485e-05, -4.2977592964064865e-05], [-4.2946540772708485e-05, 0.00011211926994815254, -4.2958595375337326e-05], [-4.2977592964064865e-05, -4.2958595375337326e-05, 0.0001122292163872923]]} + #*EXTRAS*# Step: 1 Bead: 35 +{"friction": [[0.0001136546357097823, -4.3732527334955156e-05, -4.36297190113692e-05], [-4.3732527334955156e-05, 0.00011344998512729614, -4.359406880400897e-05], [-4.36297190113692e-05, -4.359406880400897e-05, 0.00011369691815731713]]} + #*EXTRAS*# Step: 2 Bead: 35 +{"friction": [[0.00011477177945060752, -4.419059042821466e-05, -4.3980460193950474e-05], [-4.419059042821466e-05, 0.00011444563041758137, -4.3920562977080135e-05], [-4.3980460193950474e-05, -4.3920562977080135e-05, 0.00011480209156060453]]} + #*EXTRAS*# Step: 3 Bead: 35 +{"friction": [[0.00011492062709614939, -4.42408424664992e-05, -4.401850323772993e-05], [-4.42408424664992e-05, 0.00011458052432246342, -4.395488372987467e-05], [-4.401850323772993e-05, -4.395488372987467e-05, 0.00011494942467794017]]} + #*EXTRAS*# Step: 4 Bead: 35 +{"friction": [[0.00011509553462571892, -4.4296364911419025e-05, -4.4060656826133835e-05], [-4.4296364911419025e-05, 0.00011474006240818068, -4.3992553617294235e-05], [-4.4060656826133835e-05, -4.3992553617294235e-05, 0.00011512257548156689]]} + #*EXTRAS*# Step: 5 Bead: 35 +{"friction": [[0.00011518515847088456, -4.4323306500694605e-05, -4.408119656464824e-05], [-4.4323306500694605e-05, 0.00011482228076313524, -4.4010754248877724e-05], [-4.408119656464824e-05, -4.4010754248877724e-05, 0.00011521130864124455]]} + #*EXTRAS*# Step: 6 Bead: 35 +{"friction": [[0.0001152426223086565, -4.434003423675883e-05, -4.409399014926263e-05], [-4.434003423675883e-05, 0.00011487517479454032, -4.402203441061126e-05], [-4.409399014926263e-05, -4.402203441061126e-05, 0.00011526820473958935]]} + #*EXTRAS*# Step: 7 Bead: 35 +{"friction": [[0.0001152784708170027, -4.435025165654924e-05, -4.4101823098831026e-05], [-4.435025165654924e-05, 0.00011490824542940928, -4.4028918071838894e-05], [-4.4101823098831026e-05, -4.4028918071838894e-05, 0.00011530370037937012]]} + #*EXTRAS*# Step: 8 Bead: 35 +{"friction": [[0.0001153016383234253, -4.435676515864481e-05, -4.410682475690998e-05], [-4.435676515864481e-05, 0.00011492964814736439, -4.403330420483617e-05], [-4.410682475690998e-05, -4.403330420483617e-05, 0.00011532664037474344]]} + #*EXTRAS*# Step: 9 Bead: 35 +{"friction": [[0.00011531668950274123, -4.4360958936414204e-05, -4.411004876236915e-05], [-4.4360958936414204e-05, 0.00011494356577302316, -4.4036127484589396e-05], [-4.411004876236915e-05, -4.4036127484589396e-05, 0.00011534154397167577]]} + #*EXTRAS*# Step: 10 Bead: 35 +{"friction": [[0.00011532658354057343, -4.436369948839236e-05, -4.4112157200386606e-05], [-4.436369948839236e-05, 0.00011495272026976636, -4.4037972146706877e-05], [-4.4112157200386606e-05, -4.4037972146706877e-05, 0.00011535134109082609]]} + #*EXTRAS*# Step: 11 Bead: 35 +{"friction": [[0.00011533311890263997, -4.436550263252077e-05, -4.4113545162007574e-05], [-4.436550263252077e-05, 0.00011495876959285213, -4.403918572198884e-05], [-4.4113545162007574e-05, -4.403918572198884e-05, 0.00011535781247639964]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 new file mode 100644 index 000000000..85b5e1cf1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 36 +{"friction": [[0.00011145322627121049, -4.2518769308164815e-05, -4.2584527045753256e-05], [-4.2518769308164815e-05, 0.00011144842873098494, -4.2564924963892915e-05], [-4.2584527045753256e-05, -4.2564924963892915e-05, 0.00011152215281971272]]} + #*EXTRAS*# Step: 1 Bead: 36 +{"friction": [[0.00011306563078114409, -4.344090953553081e-05, -4.339710820279744e-05], [-4.344090953553081e-05, 0.00011292807044108663, -4.3370685622427525e-05], [-4.339710820279744e-05, -4.3370685622427525e-05, 0.00011311468129920366]]} + #*EXTRAS*# Step: 2 Bead: 36 +{"friction": [[0.0001142923764596724, -4.401080067793624e-05, -4.384418637177919e-05], [-4.401080067793624e-05, 0.00011401560861421836, -4.3795584152071336e-05], [-4.384418637177919e-05, -4.3795584152071336e-05, 0.00011432769215063264]]} + #*EXTRAS*# Step: 3 Bead: 36 +{"friction": [[0.00011450239290209676, -4.409284940694744e-05, -4.390648502956183e-05], [-4.409284940694744e-05, 0.00011420326118287328, -4.385307600388265e-05], [-4.390648502956183e-05, -4.385307600388265e-05, 0.00011453549268036254]]} + #*EXTRAS*# Step: 4 Bead: 36 +{"friction": [[0.00011471114047469993, -4.416934312795027e-05, -4.3964386101475195e-05], [-4.416934312795027e-05, 0.00011439088621581625, -4.390597850728574e-05], [-4.3964386101475195e-05, -4.390597850728574e-05, 0.00011474207480922138]]} + #*EXTRAS*# Step: 5 Bead: 36 +{"friction": [[0.00011482125269717975, -4.420759477649007e-05, -4.399332717107384e-05], [-4.420759477649007e-05, 0.00011449038217252451, -4.3932202884685816e-05], [-4.399332717107384e-05, -4.3932202884685816e-05, 0.00011485105940274622]]} + #*EXTRAS*# Step: 6 Bead: 36 +{"friction": [[0.00011489129203615494, -4.423115479057045e-05, -4.401116409284453e-05], [-4.423115479057045e-05, 0.00011455387862953963, -4.3948285289705684e-05], [-4.401116409284453e-05, -4.3948285289705684e-05, 0.00011492038667090782]]} + #*EXTRAS*# Step: 7 Bead: 36 +{"friction": [[0.00011493507413673813, -4.4245574168250956e-05, -4.4022089144747485e-05], [-4.4245574168250956e-05, 0.0001145936582646026, -4.395810361504382e-05], [-4.4022089144747485e-05, -4.395810361504382e-05, 0.0001149637256816248]]} + #*EXTRAS*# Step: 8 Bead: 36 +{"friction": [[0.00011496333591687868, -4.4254755159515635e-05, -4.402904969073398e-05], [-4.4254755159515635e-05, 0.00011461937337498437, -4.39643458154026e-05], [-4.402904969073398e-05, -4.39643458154026e-05, 0.00011499170226842742]]} + #*EXTRAS*# Step: 9 Bead: 36 +{"friction": [[0.0001149817033813361, -4.426066831404615e-05, -4.40335348761301e-05], [-4.426066831404615e-05, 0.00011463610161180177, -4.396836252045649e-05], [-4.40335348761301e-05, -4.396836252045649e-05, 0.00011500988473053973]]} + #*EXTRAS*# Step: 10 Bead: 36 +{"friction": [[0.00011499377547445366, -4.426453168590876e-05, -4.4036466278280225e-05], [-4.426453168590876e-05, 0.00011464710321071942, -4.3970985324617776e-05], [-4.4036466278280225e-05, -4.3970985324617776e-05, 0.0001150218353782984]]} + #*EXTRAS*# Step: 11 Bead: 36 +{"friction": [[0.0001150017502061887, -4.426707374149145e-05, -4.403839556425337e-05], [-4.426707374149145e-05, 0.0001146543738069237, -4.397271045682178e-05], [-4.403839556425337e-05, -4.397271045682178e-05, 0.00011502972994855528]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 new file mode 100644 index 000000000..aefeed0dc --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 37 +{"friction": [[0.00011076333879039023, -4.207916178846279e-05, -4.2157344930675944e-05], [-4.207916178846279e-05, 0.00011078149553564103, -4.213391549981982e-05], [-4.2157344930675944e-05, -4.213391549981982e-05, 0.0001108388141904826]]} + #*EXTRAS*# Step: 1 Bead: 37 +{"friction": [[0.00011249510520123627, -4.3132228951610966e-05, -4.313938726228368e-05], [-4.3132228951610966e-05, 0.00011241659005309463, -4.3118741832230955e-05], [-4.313938726228368e-05, -4.3118741832230955e-05, 0.00011255103545476299]]} + #*EXTRAS*# Step: 2 Bead: 37 +{"friction": [[0.00011382516907134414, -4.381101493885735e-05, -4.3690833891754304e-05], [-4.381101493885735e-05, 0.00011360087282623942, -4.365198980160124e-05], [-4.3690833891754304e-05, -4.365198980160124e-05, 0.00011386555272349105]]} + #*EXTRAS*# Step: 3 Bead: 37 +{"friction": [[0.0001140943587468416, -4.3928947846054306e-05, -4.378169328230424e-05], [-4.3928947846054306e-05, 0.00011383947405285343, -4.373739521468227e-05], [-4.378169328230424e-05, -4.373739521468227e-05, 0.00011413179876360064]]} + #*EXTRAS*# Step: 4 Bead: 37 +{"friction": [[0.00011433577777791734, -4.402816520886982e-05, -4.3857395477162896e-05], [-4.402816520886982e-05, 0.0001140543089283237, -4.380781945673494e-05], [-4.3857395477162896e-05, -4.380781945673494e-05, 0.00011437063242792666]]} + #*EXTRAS*# Step: 5 Bead: 37 +{"friction": [[0.00011446568418166232, -4.407887067105941e-05, -4.389588968030583e-05], [-4.407887067105941e-05, 0.00011417038788107097, -4.384333764470163e-05], [-4.389588968030583e-05, -4.384333764470163e-05, 0.00011449916855702952]]} + #*EXTRAS*# Step: 6 Bead: 37 +{"friction": [[0.00011454787965400728, -4.410995427484038e-05, -4.391944204716221e-05], [-4.410995427484038e-05, 0.00011424404287673417, -4.386496167893767e-05], [-4.391944204716221e-05, -4.386496167893767e-05, 0.00011458050445314908]]} + #*EXTRAS*# Step: 7 Bead: 37 +{"friction": [[0.00011459933349353848, -4.412901170508542e-05, -4.393386988874646e-05], [-4.412901170508542e-05, 0.00011429024076784554, -4.387816537862105e-05], [-4.393386988874646e-05, -4.387816537862105e-05, 0.00011463142310961346]]} + #*EXTRAS*# Step: 8 Bead: 37 +{"friction": [[0.00011463252271719959, -4.41411389362879e-05, -4.3943047614399236e-05], [-4.41411389362879e-05, 0.00011432007871555885, -4.388654676499809e-05], [-4.3943047614399236e-05, -4.388654676499809e-05, 0.00011466426830492323]]} + #*EXTRAS*# Step: 9 Bead: 37 +{"friction": [[0.00011465409849182818, -4.4148952654288014e-05, -4.394895988654351e-05], [-4.4148952654288014e-05, 0.00011433949281595958, -4.389193857680145e-05], [-4.394895988654351e-05, -4.389193857680145e-05, 0.00011468562092692053]]} + #*EXTRAS*# Step: 10 Bead: 37 +{"friction": [[0.00011466827800980202, -4.415405764359672e-05, -4.395282225816139e-05], [-4.415405764359672e-05, 0.00011435225910803007, -4.389545773017858e-05], [-4.395282225816139e-05, -4.389545773017858e-05, 0.00011469965400153468]]} + #*EXTRAS*# Step: 11 Bead: 37 +{"friction": [[0.00011467764556483789, -4.415741704800082e-05, -4.395536382985509e-05], [-4.415741704800082e-05, 0.00011436069630016796, -4.389777205219173e-05], [-4.395536382985509e-05, -4.389777205219173e-05, 0.00011470892490221093]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 new file mode 100644 index 000000000..266dadb14 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 38 +{"friction": [[0.0001100992324223387, -4.1627963427024275e-05, -4.170223714900381e-05], [-4.1627963427024275e-05, 0.00011012443903750724, -4.167507154046895e-05], [-4.170223714900381e-05, -4.167507154046895e-05, 0.00011017661577495691]]} + #*EXTRAS*# Step: 1 Bead: 38 +{"friction": [[0.00011194363333834211, -4.2814715023164674e-05, -4.285932844207568e-05], [-4.2814715023164674e-05, 0.00011191051645482177, -4.2840704463731256e-05], [-4.285932844207568e-05, -4.2840704463731256e-05, 0.00011200651946843509]]} + #*EXTRAS*# Step: 2 Bead: 38 +{"friction": [[0.0001133708327200139, -4.359581312965394e-05, -4.35218334272684e-05], [-4.359581312965394e-05, 0.00011319886428033085, -4.349100010359989e-05], [-4.35218334272684e-05, -4.349100010359989e-05, 0.00011341633502409409]]} + #*EXTRAS*# Step: 3 Bead: 38 +{"friction": [[0.0001136971663963983, -4.3752367060687974e-05, -4.3645220546303374e-05], [-4.3752367060687974e-05, 0.00011348760759764768, -4.3608793884598034e-05], [-4.3645220546303374e-05, -4.3608793884598034e-05, 0.00011373897278784109]]} + #*EXTRAS*# Step: 4 Bead: 38 +{"friction": [[0.0001139700773749525, -4.3875430249148906e-05, -4.374059441868975e-05], [-4.3875430249148906e-05, 0.00011372922260780362, -4.36988741893795e-05], [-4.374059441868975e-05, -4.36988741893795e-05, 0.00011400886835468954]]} + #*EXTRAS*# Step: 5 Bead: 38 +{"friction": [[0.00011411907050544158, -4.3939394528734756e-05, -4.378969231863727e-05], [-4.3939394528734756e-05, 0.00011386142026698746, -4.3744870003721734e-05], [-4.378969231863727e-05, -4.3744870003721734e-05, 0.00011415624353503611]]} + #*EXTRAS*# Step: 6 Bead: 38 +{"friction": [[0.00011421299255285906, -4.397849962328956e-05, -4.381957285514968e-05], [-4.397849962328956e-05, 0.0001139449172181694, -4.377272405136132e-05], [-4.381957285514968e-05, -4.377272405136132e-05, 0.00011424915574927427]]} + #*EXTRAS*# Step: 7 Bead: 38 +{"friction": [[0.00011427184917235624, -4.400251485154205e-05, -4.383787797646911e-05], [-4.400251485154205e-05, 0.00011399731775600461, -4.3789732634374456e-05], [-4.383787797646911e-05, -4.3789732634374456e-05, 0.0001143073834878137]]} + #*EXTRAS*# Step: 8 Bead: 38 +{"friction": [[0.00011430979420167188, -4.401779462863303e-05, -4.384950843679059e-05], [-4.401779462863303e-05, 0.00011403113518784377, -4.3800516679241445e-05], [-4.384950843679059e-05, -4.3800516679241445e-05, 0.00011434492467268716]]} + #*EXTRAS*# Step: 9 Bead: 38 +{"friction": [[0.0001143344670829111, -4.4027643892669276e-05, -4.3856999129762237e-05], [-4.4027643892669276e-05, 0.00011405313963769317, -4.3807452671242466e-05], [-4.3856999129762237e-05, -4.3807452671242466e-05, 0.00011436933563224784]]} + #*EXTRAS*# Step: 10 Bead: 38 +{"friction": [[0.00011435068123430704, -4.40340793579039e-05, -4.386189100233078e-05], [-4.40340793579039e-05, 0.00011406760705656692, -4.381197817741783e-05], [-4.386189100233078e-05, -4.381197817741783e-05, 0.00011438537794414508]]} + #*EXTRAS*# Step: 11 Bead: 38 +{"friction": [[0.00011436139362077341, -4.4038314940364235e-05, -4.3865109603655424e-05], [-4.4038314940364235e-05, 0.00011407716846537999, -4.381495393552605e-05], [-4.3865109603655424e-05, -4.381495393552605e-05, 0.00011439597692378767]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 new file mode 100644 index 000000000..aee28f65f --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 39 +{"friction": [[0.00010946055557351727, -4.116585373381819e-05, -4.12253165138265e-05], [-4.116585373381819e-05, 0.00010948261620819361, -4.119736995851763e-05], [-4.12253165138265e-05, -4.119736995851763e-05, 0.0001095333241093075]]} + #*EXTRAS*# Step: 1 Bead: 39 +{"friction": [[0.00011141159638801519, -4.2493033750126976e-05, -4.2560088914835746e-05], [-4.2493033750126976e-05, 0.00011140871432497702, -4.2540315164077124e-05], [-4.2560088914835746e-05, -4.2540315164077124e-05, 0.0001114810014116761]]} + #*EXTRAS*# Step: 2 Bead: 39 +{"friction": [[0.00011292999421529916, -4.336965081821405e-05, -4.3338754470814793e-05], [-4.336965081821405e-05, 0.00011280724275856742, -4.3314011866908754e-05], [-4.3338754470814793e-05, -4.3314011866908754e-05, 0.0001129806507574064]]} + #*EXTRAS*# Step: 3 Bead: 39 +{"friction": [[0.00011331140497466551, -4.356626803399791e-05, -4.349825801789088e-05], [-4.356626803399791e-05, 0.00011314622335372278, -4.346834882600959e-05], [-4.349825801789088e-05, -4.346834882600959e-05, 0.00011335759114211881]]} + #*EXTRAS*# Step: 4 Bead: 39 +{"friction": [[0.00011361462206565993, -4.371370393907156e-05, -4.361497690093434e-05], [-4.371370393907156e-05, 0.00011341459091107873, -4.358004463654571e-05], [-4.361497690093434e-05, -4.358004463654571e-05, 0.00011365735392300711]]} + #*EXTRAS*# Step: 5 Bead: 39 +{"friction": [[0.0001137819846701434, -4.3791409177305185e-05, -4.3675619607273276e-05], [-4.3791409177305185e-05, 0.0001135626522477285, -4.363760436114409e-05], [-4.3675619607273276e-05, -4.363760436114409e-05, 0.00011382284663834568]]} + #*EXTRAS*# Step: 6 Bead: 39 +{"friction": [[0.00011388719577663617, -4.383884859220974e-05, -4.3712376761074234e-05], [-4.383884859220974e-05, 0.00011365579065055473, -4.367231918343187e-05], [-4.3712376761074234e-05, -4.367231918343187e-05, 0.0001139268953782979]]} + #*EXTRAS*# Step: 7 Bead: 39 +{"friction": [[0.00011395318054620925, -4.386802970241525e-05, -4.3734894436463085e-05], [-4.386802970241525e-05, 0.00011371424695943752, -4.3693516914553645e-05], [-4.3734894436463085e-05, -4.3693516914553645e-05, 0.00011399215626277792]]} + #*EXTRAS*# Step: 8 Bead: 39 +{"friction": [[0.00011399570586264119, -4.388659868164089e-05, -4.3749188541682515e-05], [-4.388659868164089e-05, 0.00011375194286914677, -4.370694490374824e-05], [-4.3749188541682515e-05, -4.370694490374824e-05, 0.00011403421712854468]]} + #*EXTRAS*# Step: 9 Bead: 39 +{"friction": [[0.00011402336202303768, -4.3898573996878015e-05, -4.375839318733072e-05], [-4.3898573996878015e-05, 0.00011377646898687425, -4.371557991114739e-05], [-4.375839318733072e-05, -4.371557991114739e-05, 0.00011406157210326666]]} + #*EXTRAS*# Step: 10 Bead: 39 +{"friction": [[0.00011404153625273443, -4.3906399952986944e-05, -4.3764402816469894e-05], [-4.3906399952986944e-05, 0.00011379259127704848, -4.372121250950688e-05], [-4.3764402816469894e-05, -4.372121250950688e-05, 0.00011407954878028764]]} + #*EXTRAS*# Step: 11 Bead: 39 +{"friction": [[0.00011405354429581377, -4.391155164169097e-05, -4.376835644624532e-05], [-4.391155164169097e-05, 0.00011380324582853161, -4.3724915866887684e-05], [-4.376835644624532e-05, -4.3724915866887684e-05, 0.00011409142645798362]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 new file mode 100644 index 000000000..29fbd9244 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 40 +{"friction": [[0.00010884671416050972, -4.069374642795891e-05, -4.0732312774585544e-05], [-4.069374642795891e-05, 0.00010886046575184648, -4.0708913362173936e-05], [-4.0732312774585544e-05, -4.0708913362173936e-05, 0.00010890687369275164]]} + #*EXTRAS*# Step: 1 Bead: 40 +{"friction": [[0.00011089909566692243, -4.216792896085031e-05, -4.224511885169162e-05], [-4.216792896085031e-05, 0.0001109141311362888, -4.222254660426497e-05], [-4.224511885169162e-05, -4.222254660426497e-05, 0.000110973566417452]]} + #*EXTRAS*# Step: 2 Bead: 40 +{"friction": [[0.00011250323854750766, -4.3136784260261586e-05, -4.314328865778931e-05], [-4.3136784260261586e-05, 0.00011242395300991247, -4.31225858047955e-05], [-4.314328865778931e-05, -4.31225858047955e-05, 0.00011255906840103084]]} + #*EXTRAS*# Step: 3 Bead: 40 +{"friction": [[0.00011293761530599875, -4.3373692048372174e-05, -4.3342081202539734e-05], [-4.3373692048372174e-05, 0.00011281404202533606, -4.331724901984381e-05], [-4.3342081202539734e-05, -4.331724901984381e-05, 0.00011298818112737397]]} + #*EXTRAS*# Step: 4 Bead: 40 +{"friction": [[0.00011326994957288292, -4.354547733159545e-05, -4.3481609454229555e-05], [-4.354547733159545e-05, 0.00011310948203986136, -4.3452326700399274e-05], [-4.3481609454229555e-05, -4.3452326700399274e-05, 0.00011331661478731689]]} + #*EXTRAS*# Step: 5 Bead: 40 +{"friction": [[0.00011345495750738493, -4.363710438015204e-05, -4.355462189166924e-05], [-4.363710438015204e-05, 0.00011327333537733923, -4.3522429027447406e-05], [-4.355462189166924e-05, -4.3522429027447406e-05, 0.00011349949748764563]]} + #*EXTRAS*# Step: 6 Bead: 40 +{"friction": [[0.0001135710141222771, -4.369301746423191e-05, -4.359873581377076e-05], [-4.369301746423191e-05, 0.00011337601683920186, -4.356457187082932e-05], [-4.359873581377076e-05, -4.356457187082932e-05, 0.00011361423745210462]]} + #*EXTRAS*# Step: 7 Bead: 40 +{"friction": [[0.00011364384799171142, -4.3727467520558064e-05, -4.362575961592783e-05], [-4.3727467520558064e-05, 0.00011344044273669363, -4.359030417453505e-05], [-4.362575961592783e-05, -4.359030417453505e-05, 0.00011368625145450186]]} + #*EXTRAS*# Step: 8 Bead: 40 +{"friction": [[0.00011369077500922488, -4.3749396717907234e-05, -4.3642902057053646e-05], [-4.3749396717907234e-05, 0.00011348195359460239, -4.36065929475844e-05], [-4.3642902057053646e-05, -4.36065929475844e-05, 0.00011373265283442789]]} + #*EXTRAS*# Step: 9 Bead: 40 +{"friction": [[0.0001137212985299091, -4.376354661236526e-05, -4.365393936885328e-05], [-4.376354661236526e-05, 0.00011350895648467105, -4.3617066116951946e-05], [-4.365393936885328e-05, -4.3617066116951946e-05, 0.00011376283554602615]]} + #*EXTRAS*# Step: 10 Bead: 40 +{"friction": [[0.00011374135686978036, -4.3772795827031106e-05, -4.366114407076693e-05], [-4.3772795827031106e-05, 0.00011352670275218304, -4.362389633891404e-05], [-4.366114407076693e-05, -4.362389633891404e-05, 0.00011378267039167405]]} + #*EXTRAS*# Step: 11 Bead: 40 +{"friction": [[0.00011375461044379085, -4.3778885683923425e-05, -4.366588354584625e-05], [-4.3778885683923425e-05, 0.00011353842941185629, -4.3628386755756025e-05], [-4.366588354584625e-05, -4.3628386755756025e-05, 0.00011379577649407882]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 new file mode 100644 index 000000000..0dcbc3cc5 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 41 +{"friction": [[0.00010825727003808276, -4.0213019041528475e-05, -4.022875126678125e-05], [-4.0213019041528475e-05, 0.00010826184840136975, -4.021709341324004e-05], [-4.022875126678125e-05, -4.021709341324004e-05, 0.00010829577020577766]]} + #*EXTRAS*# Step: 1 Bead: 41 +{"friction": [[0.00011040625247218961, -4.1840129505126145e-05, -4.1917903577703516e-05], [-4.1840129505126145e-05, 0.00011042976778296876, -4.189227853829798e-05], [-4.1917903577703516e-05, -4.189227853829798e-05, 0.0001104834514098337]]} + #*EXTRAS*# Step: 2 Bead: 41 +{"friction": [[0.00011209111177315083, -4.290119848267727e-05, -4.293723114306271e-05], [-4.290119848267727e-05, 0.00011204728227433164, -4.291843196524452e-05], [-4.293723114306271e-05, -4.291843196524452e-05, 0.0001121521155816934]]} + #*EXTRAS*# Step: 3 Bead: 41 +{"friction": [[0.00011257629475231057, -4.317751602844343e-05, -4.3178035649156925e-05], [-4.317751602844343e-05, 0.0001124899794579598, -4.3156782918712166e-05], [-4.3178035649156925e-05, -4.3156782918712166e-05, 0.00011263122584100714]]} + #*EXTRAS*# Step: 4 Bead: 41 +{"friction": [[0.00011293655556409973, -4.337313036171858e-05, -4.334161895022815e-05], [-4.337313036171858e-05, 0.00011281309663940101, -4.331679925864623e-05], [-4.334161895022815e-05, -4.331679925864623e-05, 0.00011298713399709048]]} + #*EXTRAS*# Step: 5 Bead: 41 +{"friction": [[0.0001131384801725285, -4.3478585160423066e-05, -4.342770460388564e-05], [-4.3478585160423066e-05, 0.0001129928238082936, -4.3400306526684566e-05], [-4.342770460388564e-05, -4.3400306526684566e-05, 0.0001131866755645502]]} + #*EXTRAS*# Step: 6 Bead: 41 +{"friction": [[0.00011326493433405845, -4.354295213353791e-05, -4.3479584001287794e-05], [-4.354295213353791e-05, 0.00011310503584554575, -4.345037600456423e-05], [-4.3479584001287794e-05, -4.345037600456423e-05, 0.00011331165761501973]]} + #*EXTRAS*# Step: 7 Bead: 41 +{"friction": [[0.00011334433490410115, -4.358267748749164e-05, -4.3511363847851754e-05], [-4.358267748749164e-05, 0.0001131753964620428, -4.3480946342953935e-05], [-4.3511363847851754e-05, -4.3480946342953935e-05, 0.00011339014171491427]]} + #*EXTRAS*# Step: 8 Bead: 41 +{"friction": [[0.0001133954826710941, -4.360797732562427e-05, -4.353151185616141e-05], [-4.360797732562427e-05, 0.00011322069051261455, -4.350028633128355e-05], [-4.353151185616141e-05, -4.350028633128355e-05, 0.0001134407023034787]]} + #*EXTRAS*# Step: 9 Bead: 41 +{"friction": [[0.00011342875600348206, -4.362431151246092e-05, -4.35444829268315e-05], [-4.362431151246092e-05, 0.00011325014548892111, -4.3512719861044315e-05], [-4.35444829268315e-05, -4.3512719861044315e-05, 0.00011347359499047108]]} + #*EXTRAS*# Step: 10 Bead: 41 +{"friction": [[0.00011345062137730059, -4.36349915314057e-05, -4.3552948553552395e-05], [-4.36349915314057e-05, 0.00011326949790887406, -4.3520827210292035e-05], [-4.3552948553552395e-05, -4.3520827210292035e-05, 0.00011349521079590209]]} + #*EXTRAS*# Step: 11 Bead: 41 +{"friction": [[0.00011346506960783513, -4.3642025068023354e-05, -4.355851716295946e-05], [-4.3642025068023354e-05, 0.0001132822841914115, -4.352615690525228e-05], [-4.355851716295946e-05, -4.352615690525228e-05, 0.00011350949436400676]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 new file mode 100644 index 000000000..1a63d95c6 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 42 +{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} + #*EXTRAS*# Step: 1 Bead: 42 +{"friction": [[0.00010993324022054, -4.1510606123928054e-05, -4.158192119432386e-05], [-4.1510606123928054e-05, 0.00010995839913419749, -4.1554170665025e-05], [-4.158192119432386e-05, -4.1554170665025e-05, 0.0001100101287696102]]} + #*EXTRAS*# Step: 2 Bead: 42 +{"friction": [[0.00011169409557077084, -4.266576691444841e-05, -4.272251905166439e-05], [-4.266576691444841e-05, 0.00011167674727532415, -4.270366298541051e-05], [-4.272251905166439e-05, -4.270366298541051e-05, 0.00011176012685035594]]} + #*EXTRAS*# Step: 3 Bead: 42 +{"friction": [[0.00011222790196517527, -4.2980415014047385e-05, -4.300752283128825e-05], [-4.2980415014047385e-05, 0.00011217317540199615, -4.2988325249378214e-05], [-4.300752283128825e-05, -4.2988325249378214e-05, 0.00011228716898775013]]} + #*EXTRAS*# Step: 4 Bead: 42 +{"friction": [[0.000112614896664197, -4.319890063184607e-05, -4.319618030214452e-05], [-4.319890063184607e-05, 0.0001125247902299898, -4.3174612569470535e-05], [-4.319618030214452e-05, -4.3174612569470535e-05, 0.00011266935507219712]]} + #*EXTRAS*# Step: 5 Bead: 42 +{"friction": [[0.00011283300666341234, -4.331784444640506e-05, -4.329591740968143e-05], [-4.331784444640506e-05, 0.00011272059375373359, -4.327226335276752e-05], [-4.329591740968143e-05, -4.327226335276752e-05, 0.00011288482278697955]]} + #*EXTRAS*# Step: 6 Bead: 42 +{"friction": [[0.00011296940733866869, -4.339050298382681e-05, -4.335589725499729e-05], [-4.339050298382681e-05, 0.00011284239189440307, -4.333068513247618e-05], [-4.335589725499729e-05, -4.333068513247618e-05, 0.0001130195953318484]]} + #*EXTRAS*# Step: 7 Bead: 42 +{"friction": [[0.00011305508976122487, -4.3435422935141966e-05, -4.339263797920654e-05], [-4.3435422935141966e-05, 0.0001129186932703127, -4.3366352376612127e-05], [-4.339263797920654e-05, -4.3366352376612127e-05, 0.00011310426444253478]]} + #*EXTRAS*# Step: 8 Bead: 42 +{"friction": [[0.00011311027555584516, -4.346404913652198e-05, -4.341592041478201e-05], [-4.346404913652198e-05, 0.00011296776419240363, -4.3388905951867174e-05], [-4.341592041478201e-05, -4.3388905951867174e-05, 0.0001131588014066439]]} + #*EXTRAS*# Step: 9 Bead: 42 +{"friction": [[0.00011314617991533306, -4.348254221761609e-05, -4.34309081247133e-05], [-4.348254221761609e-05, 0.00011299966279453225, -4.3403404031532404e-05], [-4.34309081247133e-05, -4.3403404031532404e-05, 0.00011319428522809608]]} + #*EXTRAS*# Step: 10 Bead: 42 +{"friction": [[0.00011316977439961201, -4.349463774127436e-05, -4.344068867630582e-05], [-4.349463774127436e-05, 0.00011302061405453579, -4.3412856293390893e-05], [-4.344068867630582e-05, -4.3412856293390893e-05, 0.00011321760403943933]]} + #*EXTRAS*# Step: 11 Bead: 42 +{"friction": [[0.00011318536583682293, -4.3502605464990886e-05, -4.3447121925214546e-05], [-4.3502605464990886e-05, 0.00011303445436029258, -4.3419069789775554e-05], [-4.3447121925214546e-05, -4.3419069789775554e-05, 0.00011323301360608451]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 new file mode 100644 index 000000000..7e5f61bf6 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 43 +{"friction": [[0.00010715217792801399, -3.923464312552263e-05, -3.921096682771662e-05], [-3.923464312552263e-05, 0.00010714750227249788, -3.92473297219389e-05], [-3.921096682771662e-05, -3.92473297219389e-05, 0.00010711974146902487]]} + #*EXTRAS*# Step: 1 Bead: 43 +{"friction": [[0.00010948025470431537, -4.118054066676035e-05, -4.124058528015529e-05], [-4.118054066676035e-05, 0.00010950251734778074, -4.1212593281823386e-05], [-4.124058528015529e-05, -4.1212593281823386e-05, 0.0001095532834096008]]} + #*EXTRAS*# Step: 2 Bead: 43 +{"friction": [[0.0001113125816801122, -4.2431425110308745e-05, -4.2501269026520284e-05], [-4.2431425110308745e-05, 0.00011131396573999718, -4.248104440444911e-05], [-4.2501269026520284e-05, -4.248104440444911e-05, 0.00011138309191497685]]} + #*EXTRAS*# Step: 3 Bead: 43 +{"friction": [[0.00011189285520231655, -4.278467499741953e-05, -4.283199771331931e-05], [-4.278467499741953e-05, 0.00011186318356606287, -4.2813377530400325e-05], [-4.283199771331931e-05, -4.2813377530400325e-05, 0.00011195638782515919]]} + #*EXTRAS*# Step: 4 Bead: 43 +{"friction": [[0.0001123053936830362, -4.302485797551433e-05, -4.304650438206026e-05], [-4.302485797551433e-05, 0.00011224409017596692, -4.3026976375147295e-05], [-4.304650438206026e-05, -4.3026976375147295e-05, 0.00011236368529888479]]} + #*EXTRAS*# Step: 5 Bead: 43 +{"friction": [[0.00011253895631141721, -4.315674035219836e-05, -4.316034338139598e-05], [-4.315674035219836e-05, 0.00011245625821964694, -4.313937931735147e-05], [-4.316034338139598e-05, -4.313937931735147e-05, 0.00011259434606480611]]} + #*EXTRAS*# Step: 6 Bead: 43 +{"friction": [[0.00011268485047286811, -4.323740385147962e-05, -4.322868345207957e-05], [-4.323740385147962e-05, 0.00011258774696480869, -4.320650263156654e-05], [-4.322868345207957e-05, -4.320650263156654e-05, 0.00011273845617563499]]} + #*EXTRAS*# Step: 7 Bead: 43 +{"friction": [[0.00011277652819105508, -4.3287361337701094e-05, -4.327054388163123e-05], [-4.3287361337701094e-05, 0.0001126700249517739, -4.324747893799289e-05], [-4.327054388163123e-05, -4.324747893799289e-05, 0.00011282902390733458]]} + #*EXTRAS*# Step: 8 Bead: 43 +{"friction": [[0.00011283556801626963, -4.3319221464131874e-05, -4.329706064134774e-05], [-4.3319221464131874e-05, 0.00011272288508207029, -4.3273379077922844e-05], [-4.329706064134774e-05, -4.3273379077922844e-05, 0.00011288735339555057]]} + #*EXTRAS*# Step: 9 Bead: 43 +{"friction": [[0.00011287398371179234, -4.333981704873077e-05, -4.3314129271872164e-05], [-4.333981704873077e-05, 0.00011275723081100484, -4.3290027030892404e-05], [-4.3314129271872164e-05, -4.3290027030892404e-05, 0.00011292530876957146]]} + #*EXTRAS*# Step: 10 Bead: 43 +{"friction": [[0.0001128992287549963, -4.3353292579015936e-05, -4.332526664179543e-05], [-4.3353292579015936e-05, 0.00011277978137202653, -4.3300879714012006e-05], [-4.332526664179543e-05, -4.3300879714012006e-05, 0.00011295025211289417]]} + #*EXTRAS*# Step: 11 Bead: 43 +{"friction": [[0.00011291591151958682, -4.336217171669909e-05, -4.333259208289634e-05], [-4.336217171669909e-05, 0.0001127946752036013, -4.330801347276635e-05], [-4.333259208289634e-05, -4.330801347276635e-05, 0.00011296673585251566]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 new file mode 100644 index 000000000..4af0b356b --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 44 +{"friction": [[0.00010664017028987908, -3.874471502576407e-05, -3.8706267883039e-05], [-3.874471502576407e-05, 0.00010663532824109419, -3.87745976441682e-05], [-3.8706267883039e-05, -3.87745976441682e-05, 0.00010656312142689027]]} + #*EXTRAS*# Step: 1 Bead: 44 +{"friction": [[0.00010904737738839252, -4.085120170975111e-05, -4.0897096206283396e-05], [-4.085120170975111e-05, 0.00010906417370562769, -4.087147447821876e-05], [-4.0897096206283396e-05, -4.087147447821876e-05, 0.00010911267385246929]]} + #*EXTRAS*# Step: 2 Bead: 44 +{"friction": [[0.00011094693640705304, -4.219894036793211e-05, -4.227561954073473e-05], [-4.219894036793211e-05, 0.00011096071872304386, -4.225334439227173e-05], [-4.227561954073473e-05, -4.225334439227173e-05, 0.00011102101389672582]]} + #*EXTRAS*# Step: 3 Bead: 44 +{"friction": [[0.00011157150557892233, -4.259135599678139e-05, -4.265301501561713e-05], [-4.259135599678139e-05, 0.00011156086234360825, -4.263383542704127e-05], [-4.265301501561713e-05, -4.263383542704127e-05, 0.00011163903445492691]]} + #*EXTRAS*# Step: 4 Bead: 44 +{"friction": [[0.00011200843399025782, -4.2852854156760386e-05, -4.2893828720818075e-05], [-4.2852854156760386e-05, 0.00011197074061968918, -4.2875158705624006e-05], [-4.2893828720818075e-05, -4.2875158705624006e-05, 0.00011207049315576282]]} + #*EXTRAS*# Step: 5 Bead: 44 +{"friction": [[0.00011225671624411899, -4.299697829896951e-05, -4.3022088347372464e-05], [-4.299697829896951e-05, 0.00011219957694884776, -4.300277664689704e-05], [-4.3022088347372464e-05, -4.300277664689704e-05, 0.00011231561983366092]]} + #*EXTRAS*# Step: 6 Bead: 44 +{"friction": [[0.00011241164966193397, -4.308525524765625e-05, -4.3098972534271776e-05], [-4.308525524765625e-05, 0.00011234089010457118, -4.307887161468411e-05], [-4.3098972534271776e-05, -4.307887161468411e-05, 0.0001124686140726275]]} + #*EXTRAS*# Step: 7 Bead: 44 +{"friction": [[0.00011250903500309559, -4.3140028233207395e-05, -4.314606505603423e-05], [-4.3140028233207395e-05, 0.000112429198897059, -4.312532081162802e-05], [-4.314606505603423e-05, -4.312532081162802e-05, 0.00011256479334548633]]} + #*EXTRAS*# Step: 8 Bead: 44 +{"friction": [[0.00011257174398923852, -4.317498866916781e-05, -4.317588678733464e-05], [-4.317498866916781e-05, 0.00011248587221726391, -4.315467008641508e-05], [-4.317588678733464e-05, -4.315467008641508e-05, 0.00011262673090274341]]} + #*EXTRAS*# Step: 9 Bead: 44 +{"friction": [[0.00011261255069344947, -4.3197603779472884e-05, -4.319508183025607e-05], [-4.3197603779472884e-05, 0.00011252267611733422, -4.317353371825003e-05], [-4.319508183025607e-05, -4.317353371825003e-05, 0.00011266703778432683]]} + #*EXTRAS*# Step: 10 Bead: 44 +{"friction": [[0.00011263936729658601, -4.3212406454093194e-05, -4.320760567839105e-05], [-4.3212406454093194e-05, 0.00011254683137361447, -4.3185829629857584e-05], [-4.320760567839105e-05, -4.3185829629857584e-05, 0.00011269352685115272]]} + #*EXTRAS*# Step: 11 Bead: 44 +{"friction": [[0.00011265708920044922, -4.3222162799328774e-05, -4.32158428270747e-05], [-4.3222162799328774e-05, 0.00011256278148570468, -4.3193911770208594e-05], [-4.32158428270747e-05, -4.3193911770208594e-05, 0.00011271103270363154]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 new file mode 100644 index 000000000..190789347 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 45 +{"friction": [[0.00010615791386994777, -3.8259948801847704e-05, -3.820990102880373e-05], [-3.8259948801847704e-05, 0.0001061542815691971, -3.831149517488624e-05], [-3.820990102880373e-05, -3.831149517488624e-05, 0.000106034172149726]]} + #*EXTRAS*# Step: 1 Bead: 45 +{"friction": [[0.00010863469602018364, -4.052399813395291e-05, -4.055448700123146e-05], [-4.052399813395291e-05, 0.00010864509081510968, -4.05343510809212e-05], [-4.055448700123146e-05, -4.05343510809212e-05, 0.00010868824489182309]]} + #*EXTRAS*# Step: 2 Bead: 45 +{"friction": [[0.00011059750715570393, -4.196916716171967e-05, -4.204768466388029e-05], [-4.196916716171967e-05, 0.00011061864402767053, -4.2023208820699584e-05], [-4.204768466388029e-05, -4.2023208820699584e-05, 0.00011067396209392366]]} + #*EXTRAS*# Step: 3 Bead: 45 +{"friction": [[0.0001112641688837344, -4.24010960550294e-05, -4.247215373462893e-05], [-4.24010960550294e-05, 0.00011126749310831239, -4.245168891995276e-05], [-4.247215373462893e-05, -4.245168891995276e-05, 0.00011133520091907473]]} + #*EXTRAS*# Step: 4 Bead: 45 +{"friction": [[0.00011172435580959319, -4.268400770341092e-05, -4.273944323230246e-05], [-4.268400770341092e-05, 0.00011170524875038996, -4.272064725443229e-05], [-4.273944323230246e-05, -4.272064725443229e-05, 0.00011179001133822722]]} + #*EXTRAS*# Step: 5 Bead: 45 +{"friction": [[0.00011198664235724837, -4.28400529230893e-05, -4.2882274027017454e-05], [-4.28400529230893e-05, 0.00011195051066232454, -4.2863624771099615e-05], [-4.2882274027017454e-05, -4.2863624771099615e-05, 0.00011204897975709736]]} + #*EXTRAS*# Step: 6 Bead: 45 +{"friction": [[0.00011215016152124495, -4.293551184641547e-05, -4.2967806857432826e-05], [-4.293551184641547e-05, 0.00011210174255055643, -4.294886471572819e-05], [-4.2967806857432826e-05, -4.294886471572819e-05, 0.00011221041346661001]]} + #*EXTRAS*# Step: 7 Bead: 45 +{"friction": [[0.00011225296614996207, -4.299482513787121e-05, -4.30201974310676e-05], [-4.299482513787121e-05, 0.0001121961430951405, -4.300090117197603e-05], [-4.30201974310676e-05, -4.300090117197603e-05, 0.00011231191698952628]]} + #*EXTRAS*# Step: 8 Bead: 45 +{"friction": [[0.00011231915887350306, -4.3032718317650015e-05, -4.30533655344622e-05], [-4.3032718317650015e-05, 0.00011225665817841294, -4.303377104961898e-05], [-4.30533655344622e-05, -4.303377104961898e-05, 0.0001123772778858554]]} + #*EXTRAS*# Step: 9 Bead: 45 +{"friction": [[0.00011236223583898793, -4.305724795473915e-05, -4.307471368708211e-05], [-4.305724795473915e-05, 0.00011229593438914257, -4.305489620094858e-05], [-4.307471368708211e-05, -4.305489620094858e-05, 0.00011241981598934233]]} + #*EXTRAS*# Step: 10 Bead: 45 +{"friction": [[0.00011239054470102075, -4.307331048744947e-05, -4.3088641433501954e-05], [-4.307331048744947e-05, 0.00011232170180686712, -4.3068665155153757e-05], [-4.3088641433501954e-05, -4.3068665155153757e-05, 0.00011244777178607453]]} + #*EXTRAS*# Step: 11 Bead: 45 +{"friction": [[0.0001124092533447522, -4.308390031806745e-05, -4.30978017623542e-05], [-4.308390031806745e-05, 0.00011233871234142084, -4.307771526258414e-05], [-4.30978017623542e-05, -4.307771526258414e-05, 0.00011246624755686012]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 new file mode 100644 index 000000000..5f3303c46 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 46 +{"friction": [[0.00010570677276922272, -3.778420803142114e-05, -3.7725549753719546e-05], [-3.778420803142114e-05, 0.0001057047887977086, -3.7859417660977375e-05], [-3.7725549753719546e-05, -3.7859417660977375e-05, 0.00010553660403377729]]} + #*EXTRAS*# Step: 1 Bead: 46 +{"friction": [[0.00010824233242971631, -4.0200475562310954e-05, -4.0215623482820447e-05], [-4.0200475562310954e-05, 0.00010824669528540214, -4.020437836892297e-05], [-4.0215623482820447e-05, -4.020437836892297e-05, 0.00010828014508954347]]} + #*EXTRAS*# Step: 2 Bead: 46 +{"friction": [[0.00011026462014657351, -4.174303422146751e-05, -4.181952937569787e-05], [-4.174303422146751e-05, 0.00011028922221048206, -4.1793133448417936e-05], [-4.181952937569787e-05, -4.1793133448417936e-05, 0.00011034207011276024]]} + #*EXTRAS*# Step: 3 Bead: 46 +{"friction": [[0.00011097114489146206, -4.2214579690599524e-05, -4.229096778242044e-05], [-4.2214579690599524e-05, 0.00011098426184669523, -4.2268841391150894e-05], [-4.229096778242044e-05, -4.2268841391150894e-05, 0.00011104501609383273]]} + #*EXTRAS*# Step: 4 Bead: 46 +{"friction": [[0.0001114534578977028, -4.251891222437449e-05, -4.258466253376924e-05], [-4.251891222437449e-05, 0.00011144864949534345, -4.256506137534343e-05], [-4.258466253376924e-05, -4.256506137534343e-05, 0.00011152238176292117]]} + #*EXTRAS*# Step: 5 Bead: 46 +{"friction": [[0.00011172904665970957, -4.2686830873687415e-05, -4.274205852575965e-05], [-4.2686830873687415e-05, 0.00011170966323768848, -4.2723271124024345e-05], [-4.274205852575965e-05, -4.2723271124024345e-05, 0.00011179464375741968]]} + #*EXTRAS*# Step: 6 Bead: 46 +{"friction": [[0.00011190071030750553, -4.2789330925817436e-05, -4.283624263432756e-05], [-4.2789330925817436e-05, 0.00011187051373963898, -4.281762366778519e-05], [-4.283624263432756e-05, -4.281762366778519e-05, 0.00011196414305280242]]} + #*EXTRAS*# Step: 7 Bead: 46 +{"friction": [[0.00011200864949655341, -4.2852980629950976e-05, -4.2893942750402515e-05], [-4.2852980629950976e-05, 0.00011197094056671673, -4.287527250277649e-05], [-4.2893942750402515e-05, -4.287527250277649e-05, 0.00011207070591016548]]} + #*EXTRAS*# Step: 8 Bead: 46 +{"friction": [[0.00011207814111548145, -4.289363743411503e-05, -4.293046776688013e-05], [-4.289363743411503e-05, 0.00011203529650948634, -4.291169424226401e-05], [-4.293046776688013e-05, -4.291169424226401e-05, 0.00011213931036372298]]} + #*EXTRAS*# Step: 9 Bead: 46 +{"friction": [[0.00011212336752035216, -4.291996410945537e-05, -4.295397673201995e-05], [-4.291996410945537e-05, 0.00011207705258158327, -4.293510483331291e-05], [-4.295397673201995e-05, -4.293510483331291e-05, 0.00011218396031317572]]} + #*EXTRAS*# Step: 10 Bead: 46 +{"friction": [[0.00011215308917756725, -4.293720846251329e-05, -4.29693136108016e-05], [-4.293720846251329e-05, 0.00011210443813053993, -4.2950363245731e-05], [-4.29693136108016e-05, -4.2950363245731e-05, 0.00011221330391794694]]} + #*EXTRAS*# Step: 11 Bead: 46 +{"friction": [[0.00011217273202854153, -4.2948580512310046e-05, -4.2979400615524976e-05], [-4.2948580512310046e-05, 0.00011212251274861597, -4.296039225366435e-05], [-4.2979400615524976e-05, -4.296039225366435e-05, 0.00011223269736382091]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 new file mode 100644 index 000000000..c975cc3e7 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 47 +{"friction": [[0.00010528762108165504, -3.73210662070218e-05, -3.725656530783905e-05], [-3.73210662070218e-05, 0.0001052870117955876, -3.741999059478165e-05], [-3.725656530783905e-05, -3.741999059478165e-05, 0.00010507311718896647]]} + #*EXTRAS*# Step: 1 Bead: 47 +{"friction": [[0.0001078704511116357, -3.9882300210906057e-05, -3.9883198943246924e-05], [-3.9882300210906057e-05, 0.00010787013901492297, -3.988433822695942e-05], [-3.9883198943246924e-05, -3.988433822695942e-05, 0.00010788872237563123]]} + #*EXTRAS*# Step: 2 Bead: 47 +{"friction": [[0.00010994857898437897, -4.152153006976962e-05, -4.159314746922519e-05], [-4.152153006976962e-05, 0.00010997376793619955, -4.156544179976334e-05], [-4.159314746922519e-05, -4.156544179976334e-05, 0.0001100255323165689]]} + #*EXTRAS*# Step: 3 Bead: 47 +{"friction": [[0.0001106927191699658, -4.2032532420192095e-05, -4.2110973217978145e-05], [-4.2032532420192095e-05, 0.00011071225375081056, -4.208709576241603e-05], [-4.2110973217978145e-05, -4.208709576241603e-05, 0.00011076864695074036]]} + #*EXTRAS*# Step: 4 Bead: 47 +{"friction": [[0.00011119602073174465, -4.235817201253699e-05, -4.2430774754559896e-05], [-4.235817201253699e-05, 0.00011120191738594266, -4.24099525204161e-05], [-4.2430774754559896e-05, -4.24099525204161e-05, 0.00011126776433184093]]} + #*EXTRAS*# Step: 5 Bead: 47 +{"friction": [[0.0001114842101255233, -4.253785976719452e-05, -4.260260316119028e-05], [-4.253785976719452e-05, 0.00011147793935938565, -4.258312138168878e-05], [-4.260260316119028e-05, -4.258312138168878e-05, 0.00011155277575944616]]} + #*EXTRAS*# Step: 6 Bead: 47 +{"friction": [[0.00011166358075739829, -4.2647322034618075e-05, -4.270535930470349e-05], [-4.2647322034618075e-05, 0.00011164796412219416, -4.268643446700857e-05], [-4.270535930470349e-05, -4.268643446700857e-05, 0.0001117299887252038]]} + #*EXTRAS*# Step: 7 Bead: 47 +{"friction": [[0.00011177637590557875, -4.2715249086544054e-05, -4.2768322211692875e-05], [-4.2715249086544054e-05, 0.00011175414774983026, -4.2749609955092125e-05], [-4.2768322211692875e-05, -4.2749609955092125e-05, 0.00011184138095541767]]} + #*EXTRAS*# Step: 8 Bead: 47 +{"friction": [[0.00011184898614342392, -4.275861246819041e-05, -4.280817636836665e-05], [-4.275861246819041e-05, 0.00011182219248969327, -4.2789537557981594e-05], [-4.280817636836665e-05, -4.2789537557981594e-05, 0.00011191307541446234]]} + #*EXTRAS*# Step: 9 Bead: 47 +{"friction": [[0.00011189624383936546, -4.2786683932543513e-05, -4.283382970546871e-05], [-4.2786683932543513e-05, 0.00011186634611045422, -4.281521012723448e-05], [-4.283382970546871e-05, -4.281521012723448e-05, 0.00011195973338251051]]} + #*EXTRAS*# Step: 10 Bead: 47 +{"friction": [[0.00011192730030011488, -4.280506732624384e-05, -4.285056575450533e-05], [-4.280506732624384e-05, 0.00011189530502285922, -4.283194602735919e-05], [-4.285056575450533e-05, -4.283194602735919e-05, 0.0001119903945788839]]} + #*EXTRAS*# Step: 11 Bead: 47 +{"friction": [[0.0001119478256290553, -4.281718908956797e-05, -4.2861573268018635e-05], [-4.281718908956797e-05, 0.00011191441879469995, -4.284294772835962e-05], [-4.2861573268018635e-05, -4.284294772835962e-05, 0.00011201065830746748]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 new file mode 100644 index 000000000..a46e8f448 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 48 +{"friction": [[0.00010490062451440705, -3.687350091212312e-05, -3.6805665261342465e-05], [-3.687350091212312e-05, 0.00010490061033065456, -3.69947368229772e-05], [-3.6805665261342465e-05, -3.69947368229772e-05, 0.0001046451982602587]]} + #*EXTRAS*# Step: 1 Bead: 48 +{"friction": [[0.00010751933279627845, -3.9571281514985224e-05, -3.9559630751252144e-05], [-3.9571281514985224e-05, 0.00010751616596963181, -3.9576303756615484e-05], [-3.9559630751252144e-05, -3.9576303756615484e-05, 0.00010751479334275887]]} + #*EXTRAS*# Step: 2 Bead: 48 +{"friction": [[0.00010964966386135679, -4.1305687465597434e-05, -4.137044257821771e-05], [-4.1305687465597434e-05, 0.00010967342652668003, -4.1342269128064986e-05], [-4.137044257821771e-05, -4.1342269128064986e-05, 0.00010972459857508748]]} + #*EXTRAS*# Step: 3 Bead: 48 +{"friction": [[0.00011042916436843229, -4.185571283636858e-05, -4.193363695482147e-05], [-4.185571283636858e-05, 0.00011045245147070559, -4.190814412951436e-05], [-4.193363695482147e-05, -4.190814412951436e-05, 0.00011050629779866348]]} + #*EXTRAS*# Step: 4 Bead: 48 +{"friction": [[0.00011095230853856884, -4.220241398292837e-05, -4.227903046645702e-05], [-4.220241398292837e-05, 0.00011096594502782647, -4.225678842939314e-05], [-4.227903046645702e-05, -4.225678842939314e-05, 0.00011102634066625348]]} + #*EXTRAS*# Step: 5 Bead: 48 +{"friction": [[0.00011125239613991877, -4.2393700223781755e-05, -4.246503840071435e-05], [-4.2393700223781755e-05, 0.00011125617792842779, -4.2444513392334635e-05], [-4.246503840071435e-05, -4.2444513392334635e-05, 0.00011132355306983547]]} + #*EXTRAS*# Step: 6 Bead: 48 +{"friction": [[0.00011143903608994259, -4.251000800497215e-05, -4.257621638820006e-05], [-4.251000800497215e-05, 0.00011143489967095269, -4.255655705572104e-05], [-4.257621638820006e-05, -4.255655705572104e-05, 0.00011150812658752761]]} + #*EXTRAS*# Step: 7 Bead: 48 +{"friction": [[0.00011155640872001583, -4.258213484429366e-05, -4.264435138713613e-05], [-4.258213484429366e-05, 0.00011154654528857232, -4.262512358659337e-05], [-4.264435138713613e-05, -4.262512358659337e-05, 0.00011162411884896791]]} + #*EXTRAS*# Step: 8 Bead: 48 +{"friction": [[0.00011163195799102799, -4.2628153542826036e-05, -4.268747783497091e-05], [-4.2628153542826036e-05, 0.00011161809184408185, -4.266847333013431e-05], [-4.268747783497091e-05, -4.266847333013431e-05, 0.00011169875373965129]]} + #*EXTRAS*# Step: 9 Bead: 48 +{"friction": [[0.00011168112978389636, -4.265793588533556e-05, -4.2715239281155884e-05], [-4.265793588533556e-05, 0.00011166452239525116, -4.2696354982770866e-05], [-4.2715239281155884e-05, -4.2696354982770866e-05, 0.00011174732140402385]]} + #*EXTRAS*# Step: 10 Bead: 48 +{"friction": [[0.00011171344396853811, -4.26774358251897e-05, -4.2733350985311486e-05], [-4.26774358251897e-05, 0.00011169497590957938, -4.2714534285888316e-05], [-4.2733350985311486e-05, -4.2714534285888316e-05, 0.00011177923523292904]]} + #*EXTRAS*# Step: 11 Bead: 48 +{"friction": [[0.00011173480079233538, -4.2690292344457025e-05, -4.274526360999068e-05], [-4.2690292344457025e-05, 0.00011171507699385572, -4.272648645404588e-05], [-4.274526360999068e-05, -4.272648645404588e-05, 0.0001118003261504056]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 new file mode 100644 index 000000000..3bd1a51d7 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 49 +{"friction": [[0.00010454547171753977, -3.6444056165635773e-05, -3.637510960233212e-05], [-3.6444056165635773e-05, 0.00010454494879362924, -3.658517988655125e-05], [-3.637510960233212e-05, -3.658517988655125e-05, 0.00010425342130998133]]} + #*EXTRAS*# Step: 1 Bead: 49 +{"friction": [[0.00010718972227491339, -3.9269616442606175e-05, -3.924711656540057e-05], [-3.9269616442606175e-05, 0.00010718514048158849, -3.928132516899051e-05], [-3.924711656540057e-05, -3.928132516899051e-05, 0.00010716031004237312]]} + #*EXTRAS*# Step: 2 Bead: 49 +{"friction": [[0.00010936813232911244, -4.1096568060181137e-05, -4.115321350227058e-05], [-4.1096568060181137e-05, 0.00010938917643809587, -4.112555334101409e-05], [-4.115321350227058e-05, -4.112555334101409e-05, 0.00010943956856354979]]} + #*EXTRAS*# Step: 3 Bead: 49 +{"friction": [[0.00011018074088021696, -4.168490371317932e-05, -4.1760366755337695e-05], [-4.168490371317932e-05, 0.00011020573518179522, -4.1733560177609555e-05], [-4.1760366755337695e-05, -4.1733560177609555e-05, 0.00011025820775565387]]} + #*EXTRAS*# Step: 4 Bead: 49 +{"friction": [[0.00011072257036036972, -4.2052280995570795e-05, -4.2130634064617134e-05], [-4.2052280995570795e-05, 0.00011074154256000285, -4.210694581061294e-05], [-4.2130634064617134e-05, -4.210694581061294e-05, 0.00011079831308265448]]} + #*EXTRAS*# Step: 5 Bead: 49 +{"friction": [[0.00011103385172111439, -4.225492493035832e-05, -4.233045555750098e-05], [-4.225492493035832e-05, 0.00011104514597036944, -4.230870835427604e-05], [-4.233045555750098e-05, -4.230870835427604e-05, 0.00011110716681259907]]} + #*EXTRAS*# Step: 6 Bead: 49 +{"friction": [[0.00011122732268778896, -4.237792171574066e-05, -4.244983832822908e-05], [-4.237792171574066e-05, 0.00011123206059573108, -4.2429182915318095e-05], [-4.244983832822908e-05, -4.2429182915318095e-05, 0.00011129874291264384]]} + #*EXTRAS*# Step: 7 Bead: 49 +{"friction": [[0.00011134899409147604, -4.245414698653464e-05, -4.252301354335068e-05], [-4.245414698653464e-05, 0.00011134885623864095, -4.2502961331310564e-05], [-4.252301354335068e-05, -4.2502961331310564e-05, 0.00011141910357010713]]} + #*EXTRAS*# Step: 8 Bead: 49 +{"friction": [[0.00011142730268450619, -4.2502754935544865e-05, -4.256932937428298e-05], [-4.2502754935544865e-05, 0.0001114237065088634, -4.2549621707374074e-05], [-4.256932937428298e-05, -4.2549621707374074e-05, 0.00011149652808577145]]} + #*EXTRAS*# Step: 9 Bead: 49 +{"friction": [[0.00011147827129729228, -4.253420480424595e-05, -4.2599145860553944e-05], [-4.253420480424595e-05, 0.00011147228607805608, -4.257964153068416e-05], [-4.2599145860553944e-05, -4.257964153068416e-05, 0.0001115469064139975]]} + #*EXTRAS*# Step: 10 Bead: 49 +{"friction": [[0.00011151176606799609, -4.255479267540448e-05, -4.2618598732686786e-05], [-4.255479267540448e-05, 0.00011150415061784592, -4.259921834855598e-05], [-4.2618598732686786e-05, -4.259921834855598e-05, 0.00011158000748449947]]} + #*EXTRAS*# Step: 11 Bead: 49 +{"friction": [[0.00011153390336263999, -4.256836498331526e-05, -4.263139384856813e-05], [-4.256836498331526e-05, 0.0001115251839797575, -4.2612090970459306e-05], [-4.263139384856813e-05, -4.2612090970459306e-05, 0.00011160188222604244]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 new file mode 100644 index 000000000..252e7bea8 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 50 +{"friction": [[0.00010422157793290393, -3.6035021611147086e-05, -3.5966888494172815e-05], [-3.6035021611147086e-05, 0.00010421927471690661, -3.619295965410192e-05], [-3.5966888494172815e-05, -3.619295965410192e-05, 0.00010389772288898436]]} + #*EXTRAS*# Step: 1 Bead: 50 +{"friction": [[0.00010688226525661363, -3.897942834033022e-05, -3.8947664518042906e-05], [-3.897942834033022e-05, 0.0001068772645223112, -3.900032845297986e-05], [-3.8947664518042906e-05, -3.900032845297986e-05, 0.00010682705015776695]]} + #*EXTRAS*# Step: 2 Bead: 50 +{"friction": [[0.0001091042228457379, -4.0895248920428554e-05, -4.094314518969592e-05], [-4.0895248920428554e-05, 0.00010912183848657076, -4.091703380455052e-05], [-4.094314518969592e-05, -4.091703380455052e-05, 0.0001091707872657307]]} + #*EXTRAS*# Step: 3 Bead: 50 +{"friction": [[0.00010994769659753867, -4.152090209304113e-05, -4.15925022556862e-05], [-4.152090209304113e-05, 0.0001099728839578621, -4.156479395136362e-05], [-4.15925022556862e-05, -4.156479395136362e-05, 0.00011002464631106863]]} + #*EXTRAS*# Step: 4 Bead: 50 +{"friction": [[0.00011050704081943693, -4.1908424699192846e-05, -4.198673626199791e-05], [-4.1908424699192846e-05, 0.0001105294385242952, -4.1961705153029155e-05], [-4.198673626199791e-05, -4.1961705153029155e-05, 0.0001105839025039089]]} + #*EXTRAS*# Step: 5 Bead: 50 +{"friction": [[0.0001108288083312415, -4.212211256295431e-05, -4.219989978294769e-05], [-4.212211256295431e-05, 0.00011084553886792053, -4.217688544393612e-05], [-4.219989978294769e-05, -4.217688544393612e-05, 0.00011090382053479518]]} + #*EXTRAS*# Step: 6 Bead: 50 +{"friction": [[0.00011102867090044044, -4.225160060857412e-05, -4.232720778643653e-05], [-4.225160060857412e-05, 0.00011104012122110064, -4.2305429629705166e-05], [-4.232720778643653e-05, -4.2305429629705166e-05, 0.00011110203309474452]]} + #*EXTRAS*# Step: 7 Bead: 50 +{"friction": [[0.00011115436191735961, -4.2331798356731695e-05, -4.2405252817913006e-05], [-4.2331798356731695e-05, 0.00011116174125842683, -4.2384202105818835e-05], [-4.2405252817913006e-05, -4.2384202105818835e-05, 0.00011122652631873643]]} + #*EXTRAS*# Step: 8 Bead: 50 +{"friction": [[0.00011123524988312174, -4.2382914202604164e-05, -4.2454650720194915e-05], [-4.2382914202604164e-05, 0.00011123968820345596, -4.2434036854054145e-05], [-4.2454650720194915e-05, -4.2434036854054145e-05, 0.00011130658726798664]]} + #*EXTRAS*# Step: 9 Bead: 50 +{"friction": [[0.0001112878978940052, -4.2415978503685e-05, -4.248645342692199e-05], [-4.2415978503685e-05, 0.00011129028297772307, -4.246610784802755e-05], [-4.248645342692199e-05, -4.246610784802755e-05, 0.0001113586757951835]]} + #*EXTRAS*# Step: 10 Bead: 50 +{"friction": [[0.00011132249601873564, -4.24376193784944e-05, -4.2507202691430194e-05], [-4.24376193784944e-05, 0.00011132347105566937, -4.248702573797676e-05], [-4.2507202691430194e-05, -4.248702573797676e-05, 0.0001113928978216412]]} + #*EXTRAS*# Step: 11 Bead: 50 +{"friction": [[0.0001113453626974834, -4.245188437280933e-05, -4.252085090360856e-05], [-4.245188437280933e-05, 0.0001113453790596462, -4.250078182989472e-05], [-4.252085090360856e-05, -4.250078182989472e-05, 0.00011141551245044024]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 new file mode 100644 index 000000000..89e4768b1 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 51 +{"friction": [[0.00010392810737404057, -3.564841585082599e-05, -3.5582711172999606e-05], [-3.564841585082599e-05, 0.0001039227172200635, -3.581976330672245e-05], [-3.5582711172999606e-05, -3.581976330672245e-05, 0.00010357747568088037]]} + #*EXTRAS*# Step: 1 Bead: 51 +{"friction": [[0.00010659738920046837, -3.87026521400088e-05, -3.8663082009413894e-05], [-3.87026521400088e-05, 0.00010659261223789722, -3.87342657679597e-05], [-3.8663082009413894e-05, -3.87342657679597e-05, 0.00010651635869829663]]} + #*EXTRAS*# Step: 2 Bead: 51 +{"friction": [[0.00010885815780103535, -4.070280912408581e-05, -4.074180295934311e-05], [-4.070280912408581e-05, 0.00010887208789185322, -4.071825509031117e-05], [-4.074180295934311e-05, -4.071825509031117e-05, 0.00010891863881567782]]} + #*EXTRAS*# Step: 3 Bead: 51 +{"friction": [[0.00010973026642054414, -4.136450895870238e-05, -4.143130738960599e-05], [-4.136450895870238e-05, 0.00010975457884155222, -4.1403169161820155e-05], [-4.143130738960599e-05, -4.1403169161820155e-05, 0.00010980590779731617]]} + #*EXTRAS*# Step: 4 Bead: 51 +{"friction": [[0.00011030594060479529, -4.1771498043873867e-05, -4.184842767574959e-05], [-4.1771498043873867e-05, 0.00011033028197926537, -4.1822247505509544e-05], [-4.184842767574959e-05, -4.1822247505509544e-05, 0.00011038334545006209]]} + #*EXTRAS*# Step: 5 Bead: 51 +{"friction": [[0.00011063748246108206, -4.199584142658615e-05, -4.2074363990955145e-05], [-4.199584142658615e-05, 0.0001106579816669476, -4.205013812514188e-05], [-4.2074363990955145e-05, -4.205013812514188e-05, 0.00011071372803504835]]} + #*EXTRAS*# Step: 6 Bead: 51 +{"friction": [[0.00011084329564996089, -4.213158094578883e-05, -4.220925977432778e-05], [-4.213158094578883e-05, 0.00011085969083919635, -4.218633696450145e-05], [-4.220925977432778e-05, -4.218633696450145e-05, 0.00011091819990393749]]} + #*EXTRAS*# Step: 7 Bead: 51 +{"friction": [[0.00011097272644766295, -4.22156001792611e-05, -4.229196848509937e-05], [-4.22156001792611e-05, 0.00011098579919729196, -4.2269851770361327e-05], [-4.229196848509937e-05, -4.2269851770361327e-05, 0.00011104658400682763]]} + #*EXTRAS*# Step: 8 Bead: 51 +{"friction": [[0.00011105601348272115, -4.226912702286552e-05, -4.234431848664201e-05], [-4.226912702286552e-05, 0.00011106662885798345, -4.2322702846666086e-05], [-4.234431848664201e-05, -4.2322702846666086e-05, 0.00011112912480202128]]} + #*EXTRAS*# Step: 9 Bead: 51 +{"friction": [[0.00011111022325952321, -4.2303742761092796e-05, -4.237802395733137e-05], [-4.2303742761092796e-05, 0.00011111910041682936, -4.235672381742277e-05], [-4.237802395733137e-05, -4.235672381742277e-05, 0.00011118282099533963]]} + #*EXTRAS*# Step: 10 Bead: 51 +{"friction": [[0.00011114584737309008, -4.232639529769034e-05, -4.240001527243073e-05], [-4.232639529769034e-05, 0.00011115352147461868, -4.237891700912842e-05], [-4.240001527243073e-05, -4.237891700912842e-05, 0.00011121809638953061]]} + #*EXTRAS*# Step: 11 Bead: 51 +{"friction": [[0.00011116939226247045, -4.234132567559808e-05, -4.241448088425314e-05], [-4.234132567559808e-05, 0.00011117624443519128, -4.239351342034503e-05], [-4.241448088425314e-05, -4.239351342034503e-05, 0.00011124140613133703]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 new file mode 100644 index 000000000..36c5dff68 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 52 +{"friction": [[0.00010366394327696455, -3.5285887569447394e-05, -3.522391444163986e-05], [-3.5285887569447394e-05, 0.00010365423205589712, -3.546717661556058e-05], [-3.522391444163986e-05, -3.546717661556058e-05, 0.00010329150520581095]]} + #*EXTRAS*# Step: 1 Bead: 52 +{"friction": [[0.00010633529483262444, -3.84409999687275e-05, -3.839494416313572e-05], [-3.84409999687275e-05, 0.00010633111189352298, -3.848406180840241e-05], [-3.839494416313572e-05, -3.848406180840241e-05, 0.00010622915768290394]]} + #*EXTRAS*# Step: 2 Bead: 52 +{"friction": [[0.00010863014551742617, -4.0520316283984664e-05, -4.0550629116795764e-05], [-4.0520316283984664e-05, 0.0001086404678881989, -4.0530574346712984e-05], [-4.0550629116795764e-05, -4.0530574346712984e-05, 0.00010868353854298102]]} + #*EXTRAS*# Step: 3 Bead: 52 +{"friction": [[0.00010952867169385479, -4.12165188087269e-05, -4.127796428052876e-05], [-4.12165188087269e-05, 0.00010955140750574472, -4.1249882888814735e-05], [-4.127796428052876e-05, -4.1249882888814735e-05, 0.00010960230512537791]]} + #*EXTRAS*# Step: 4 Bead: 52 +{"friction": [[0.0001101194767097989, -4.164214761038742e-05, -4.17167334593018e-05], [-4.164214761038742e-05, 0.00011014464567331005, -4.1689653022112195e-05], [-4.17167334593018e-05, -4.1689653022112195e-05, 0.00011019689026788544]]} + #*EXTRAS*# Step: 5 Bead: 52 +{"friction": [[0.00011046007600826995, -4.1876682935204065e-05, -4.195478368167024e-05], [-4.1876682935204065e-05, 0.00011048303130395, -4.192947198122667e-05], [-4.195478368167024e-05, -4.192947198122667e-05, 0.00011053711054109131]]} + #*EXTRAS*# Step: 6 Bead: 52 +{"friction": [[0.00011067139685442698, -4.2018391919222346e-05, -4.2096876598199625e-05], [-4.2018391919222346e-05, 0.00011069131540531362, -4.2072864328219056e-05], [-4.2096876598199625e-05, -4.2072864328219056e-05, 0.00011074745115197221]]} + #*EXTRAS*# Step: 7 Bead: 52 +{"friction": [[0.00011080428672376668, -4.2106056537063517e-05, -4.218400998219951e-05], [-4.2106056537063517e-05, 0.00011082156847871106, -4.216084038632012e-05], [-4.218400998219951e-05, -4.216084038632012e-05, 0.00011087947719794702]]} + #*EXTRAS*# Step: 8 Bead: 52 +{"friction": [[0.00011088979205998749, -4.2161881902089115e-05, -4.223916124884156e-05], [-4.2161881902089115e-05, 0.0001109050618055459, -4.2216530813007675e-05], [-4.223916124884156e-05, -4.2216530813007675e-05, 0.00011096433700701134]]} + #*EXTRAS*# Step: 9 Bead: 52 +{"friction": [[0.00011094544569655772, -4.2197976164666226e-05, -4.2274672541037186e-05], [-4.2197976164666226e-05, 0.00011095926829410107, -4.225238819477053e-05], [-4.2274672541037186e-05, -4.225238819477053e-05, 0.00011101953573134598]]} + #*EXTRAS*# Step: 10 Bead: 52 +{"friction": [[0.0001109820182623048, -4.222159259809246e-05, -4.229784274604936e-05], [-4.222159259809246e-05, 0.00011099482946544186, -4.227578277250922e-05], [-4.229784274604936e-05, -4.227578277250922e-05, 0.00011105579525902599]]} + #*EXTRAS*# Step: 11 Bead: 52 +{"friction": [[0.00011100619007828505, -4.223715685099646e-05, -4.2313084249124014e-05], [-4.223715685099646e-05, 0.0001110183061482042, -4.2291170960268984e-05], [-4.2313084249124014e-05, -4.2291170960268984e-05, 0.00011107975427839271]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 new file mode 100644 index 000000000..a9e36f273 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 53 +{"friction": [[0.00010342777205096691, -3.4948757364551355e-05, -3.48915119324289e-05], [-3.4948757364551355e-05, 0.00010341266127600232, -3.513667008856002e-05], [-3.48915119324289e-05, -3.513667008856002e-05, 0.0001030382318154365]]} + #*EXTRAS*# Step: 1 Bead: 53 +{"friction": [[0.00010609599691303195, -3.819597322211792e-05, -3.81446102538467e-05], [-3.819597322211792e-05, 0.00010609257661209749, -3.825060395285669e-05], [-3.81446102538467e-05, -3.825060395285669e-05, 0.0001059660103422631]]} + #*EXTRAS*# Step: 2 Bead: 53 +{"friction": [[0.00010842038144812837, -4.034881331496071e-05, -4.037094161657163e-05], [-4.034881331496071e-05, 0.0001084274044080589, -4.035517150651024e-05], [-4.037094161657163e-05, -4.035517150651024e-05, 0.0001084659237797132]]} + #*EXTRAS*# Step: 3 Bead: 53 +{"friction": [[0.00010934311960735249, -4.1077709356246505e-05, -4.1133568542785985e-05], [-4.1077709356246505e-05, 0.00010936387023376427, -4.110600739328421e-05], [-4.1133568542785985e-05, -4.110600739328421e-05, 0.00010941416301194454]]} + #*EXTRAS*# Step: 4 Bead: 53 +{"friction": [[0.00010994784245418986, -4.152100589995588e-05, -4.1592608913119075e-05], [-4.152100589995588e-05, 0.00010997303007873796, -4.1564901043879487e-05], [-4.1592608913119075e-05, -4.1564901043879487e-05, 0.00011002479276678453]]} + #*EXTRAS*# Step: 5 Bead: 53 +{"friction": [[0.0001102967764728108, -4.176519505159984e-05, -4.18420326143446e-05], [-4.176519505159984e-05, 0.00011032117959137537, -4.1815803886408767e-05], [-4.18420326143446e-05, -4.1815803886408767e-05, 0.0001103741933708584]]} + #*EXTRAS*# Step: 6 Bead: 53 +{"friction": [[0.000110513159688305, -4.1912549717315214e-05, -4.199088357709438e-05], [-4.1912549717315214e-05, 0.00011053547993273332, -4.196588945827663e-05], [-4.199088357709438e-05, -4.196588945827663e-05, 0.00011058999688590044]]} + #*EXTRAS*# Step: 7 Bead: 53 +{"friction": [[0.00011064922686583983, -4.200365880606488e-05, -4.208217266214199e-05], [-4.200365880606488e-05, 0.0001106695291467517, -4.205802062855221e-05], [-4.208217266214199e-05, -4.205802062855221e-05, 0.00011072540760139091]]} + #*EXTRAS*# Step: 8 Bead: 53 +{"friction": [[0.00011073676917255757, -4.2061654833051176e-05, -4.2139955321469756e-05], [-4.2061654833051176e-05, 0.00011075546361518265, -4.211635718221711e-05], [-4.2139955321469756e-05, -4.211635718221711e-05, 0.00011081242067964347]]} + #*EXTRAS*# Step: 9 Bead: 53 +{"friction": [[0.00011079374843170799, -4.209914491633419e-05, -4.217716317596078e-05], [-4.209914491633419e-05, 0.0001108112607829503, -4.21539267595911e-05], [-4.217716317596078e-05, -4.21539267595911e-05, 0.00011086901377529946]]} + #*EXTRAS*# Step: 10 Bead: 53 +{"friction": [[0.00011083119170682856, -4.212367114181219e-05, -4.220144105138178e-05], [-4.212367114181219e-05, 0.00011084786757029157, -4.2178441781560744e-05], [-4.220144105138178e-05, -4.2178441781560744e-05, 0.000110906186284153]]} + #*EXTRAS*# Step: 11 Bead: 53 +{"friction": [[0.00011085593903310046, -4.2139833610318514e-05, -4.221741162438055e-05], [-4.2139833610318514e-05, 0.00011087203563670366, -4.219456854556681e-05], [-4.221741162438055e-05, -4.219456854556681e-05, 0.00011093074750693787]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 new file mode 100644 index 000000000..0f156953b --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 54 +{"friction": [[0.00010321820672526034, -3.463813479007007e-05, -3.4586315531130965e-05], [-3.463813479007007e-05, 0.00010319683609987853, -3.482966366715975e-05], [-3.4586315531130965e-05, -3.482966366715975e-05, 0.00010281585060269033]]} + #*EXTRAS*# Step: 1 Bead: 54 +{"friction": [[0.00010587938648071665, -3.796890114537215e-05, -3.7913266677567196e-05], [-3.796890114537215e-05, 0.00010587675610782059, -3.803475647524443e-05], [-3.7913266677567196e-05, -3.803475647524443e-05, 0.00010572721017266073]]} + #*EXTRAS*# Step: 2 Bead: 54 +{"friction": [[0.00010822904871973259, -4.018930566833102e-05, -4.020393438010497e-05], [-4.018930566833102e-05, 0.00010823322132307501, -4.019306154146698e-05], [-4.020393438010497e-05, -4.019306154146698e-05, 0.00010826624387855552]]} + #*EXTRAS*# Step: 3 Bead: 54 +{"friction": [[0.00010917380258737363, -4.094883154395565e-05, -4.099912588563783e-05], [-4.094883154395565e-05, 0.00010919238691573272, -4.09724937013694e-05], [-4.099912588563783e-05, -4.09724937013694e-05, 0.00010924181091614152]]} + #*EXTRAS*# Step: 4 Bead: 54 +{"friction": [[0.00010979121732685517, -4.1408683720930764e-05, -4.147693599058431e-05], [-4.1408683720930764e-05, 0.00010981586808200854, -4.144887146872218e-05], [-4.147693599058431e-05, -4.144887146872218e-05, 0.00010986731143173133]]} + #*EXTRAS*# Step: 5 Bead: 54 +{"friction": [[0.00011014775699662489, -4.1661915801868875e-05, -4.173691926448433e-05], [-4.1661915801868875e-05, 0.00011017285679065683, -4.170996231546591e-05], [-4.173691926448433e-05, -4.170996231546591e-05, 0.00011022520221547483]]} + #*EXTRAS*# Step: 6 Bead: 54 +{"friction": [[0.00011036875470171303, -4.1814551653449256e-05, -4.189204548015638e-05], [-4.1814551653449256e-05, 0.00011039261143666444, -4.1866208158066496e-05], [-4.189204548015638e-05, -4.1866208158066496e-05, 0.00011044604623062921]]} + #*EXTRAS*# Step: 7 Bead: 54 +{"friction": [[0.00011050771622821612, -4.190888014268581e-05, -4.1987194225555015e-05], [-4.190888014268581e-05, 0.00011053010543779985, -4.196216719500818e-05], [-4.1987194225555015e-05, -4.196216719500818e-05, 0.00011058457523180933]]} + #*EXTRAS*# Step: 8 Bead: 54 +{"friction": [[0.00011059711353281078, -4.1968904003692625e-05, -4.204742119105575e-05], [-4.1968904003692625e-05, 0.00011061825643487608, -4.2022942898067e-05], [-4.204742119105575e-05, -4.2022942898067e-05, 0.00011067357044430695]]} + #*EXTRAS*# Step: 9 Bead: 54 +{"friction": [[0.00011065529979946061, -4.2007697679593364e-05, -4.208620520318973e-05], [-4.2007697679593364e-05, 0.00011067549853019927, -4.206209140669799e-05], [-4.208620520318973e-05, -4.206209140669799e-05, 0.00011073144642344597]]} + #*EXTRAS*# Step: 10 Bead: 54 +{"friction": [[0.00011069353580632324, -4.20330734259487e-05, -4.211151223299558e-05], [-4.20330734259487e-05, 0.00011071305538868232, -4.208763994711919e-05], [-4.211151223299558e-05, -4.208763994711919e-05, 0.00011076945864689924]]} + #*EXTRAS*# Step: 11 Bead: 54 +{"friction": [[0.00011071880707627625, -4.204979441374409e-05, -4.212816024232781e-05], [-4.204979441374409e-05, 0.00011073785178045527, -4.21044481141756e-05], [-4.212816024232781e-05, -4.21044481141756e-05, 0.00011079457363198546]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 new file mode 100644 index 000000000..ed70dbf7e --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 55 +{"friction": [[0.0001030336955245592, -3.435497053307799e-05, -3.430893758166685e-05], [-3.435497053307799e-05, 0.00010300555227581691, -3.4547622358950575e-05], [-3.430893758166685e-05, -3.4547622358950575e-05, 0.00010262224478354004]]} + #*EXTRAS*# Step: 1 Bead: 55 +{"friction": [[0.00010568527053064547, -3.7760961772199965e-05, -3.770195122035504e-05], [-3.7760961772199965e-05, 0.00010568336598957213, -3.7837357817431626e-05], [-3.770195122035504e-05, -3.7837357817431626e-05, 0.00010551284542658475]]} + #*EXTRAS*# Step: 2 Bead: 55 +{"friction": [[0.00010805631812484309, -4.004274919114014e-05, -4.005067886697458e-05], [-4.004274919114014e-05, 0.00010805815574732738, -4.004510800760899e-05], [-4.005067886697458e-05, -4.004510800760899e-05, 0.00010808494981191354]]} + #*EXTRAS*# Step: 3 Bead: 55 +{"friction": [[0.00010902089769672644, -4.0830600038885e-05, -4.087554987674827e-05], [-4.0830600038885e-05, 0.0001090373047441396, -4.085017658855083e-05], [-4.087554987674827e-05, -4.085017658855083e-05, 0.00010908557588979122]]} + #*EXTRAS*# Step: 4 Bead: 55 +{"friction": [[0.00010964976668667094, -4.130576279925025e-05, -4.1370520603282006e-05], [-4.130576279925025e-05, 0.00010967353012443889, -4.1342347150740044e-05], [-4.1370520603282006e-05, -4.1342347150740044e-05, 0.00010972470238199631]]} + #*EXTRAS*# Step: 5 Bead: 55 +{"friction": [[0.00011001317627539949, -4.156735697168856e-05, -4.164018398962453e-05], [-4.156735697168856e-05, 0.00011003843560122355, -4.1612688580600166e-05], [-4.164018398962453e-05, -4.1612688580600166e-05, 0.00011009035918223477]]} + #*EXTRAS*# Step: 6 Bead: 55 +{"friction": [[0.00011023833782219693, -4.172487045249428e-05, -4.1801063619613784e-05], [-4.172487045249428e-05, 0.00011026308227496954, -4.1774534901132106e-05], [-4.1801063619613784e-05, -4.1774534901132106e-05, 0.00011031580400185701]]} + #*EXTRAS*# Step: 7 Bead: 55 +{"friction": [[0.0001103799094437924, -4.182217011542601e-05, -4.189975177567129e-05], [-4.182217011542601e-05, 0.00011040366873687404, -4.187397704591758e-05], [-4.189975177567129e-05, -4.187397704591758e-05, 0.00011045717534616317]]} + #*EXTRAS*# Step: 8 Bead: 55 +{"friction": [[0.00011047097907485705, -4.188406464063633e-05, -4.196222055045534e-05], [-4.188406464063633e-05, 0.00011049381071119826, -4.193697343783128e-05], [-4.196222055045534e-05, -4.193697343783128e-05, 0.00011054797588521862]]} + #*EXTRAS*# Step: 9 Bead: 55 +{"friction": [[0.00011053025332210125, -4.192406055722852e-05, -4.200245033017237e-05], [-4.192406055722852e-05, 0.00011055235122620279, -4.197756002786641e-05], [-4.200245033017237e-05, -4.197756002786641e-05, 0.00011060701975019464]]} + #*EXTRAS*# Step: 10 Bead: 55 +{"friction": [[0.00011056920382736851, -4.1950219646933315e-05, -4.202870145763412e-05], [-4.1950219646933315e-05, 0.0001105907620513734, -4.200405013165232e-05], [-4.202870145763412e-05, -4.200405013165232e-05, 0.00011064579618917533]]} + #*EXTRAS*# Step: 11 Bead: 55 +{"friction": [[0.00011059494731092463, -4.196745559126683e-05, -4.2045970954250854e-05], [-4.196745559126683e-05, 0.00011061612331212563, -4.202147918371152e-05], [-4.2045970954250854e-05, -4.202147918371152e-05, 0.00011067141505080317]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 new file mode 100644 index 000000000..6aa8a14ce --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 56 +{"friction": [[0.00010287248283727404, -3.41000175745236e-05, -3.4059743381936934e-05], [-3.41000175745236e-05, 0.00010283753372188608, -3.4291999923335146e-05], [-3.4059743381936934e-05, -3.4291999923335146e-05, 0.00010245497440254835]]} + #*EXTRAS*# Step: 1 Bead: 56 +{"friction": [[0.00010551338152019661, -3.757317297080601e-05, -3.751154664211382e-05], [-3.757317297080601e-05, 0.00010551208747260516, -3.76591904443821e-05], [-3.751154664211382e-05, -3.76591904443821e-05, 0.00010532282944900653]]} + #*EXTRAS*# Step: 2 Bead: 56 +{"friction": [[0.00010790234770645254, -3.991003876806969e-05, -3.9912126560933974e-05], [-3.991003876806969e-05, 0.0001079023730119228, -3.991203723344638e-05], [-3.9912126560933974e-05, -3.991203723344638e-05, 0.0001079224837223884]]} + #*EXTRAS*# Step: 3 Bead: 56 +{"friction": [[0.00010888456606022351, -4.0723684343475974e-05, -4.0763660698731716e-05], [-4.0723684343475974e-05, 0.00010889890629591815, -4.073978057987642e-05], [-4.0763660698731716e-05, -4.073978057987642e-05, 0.00010894577553168974]]} + #*EXTRAS*# Step: 4 Bead: 56 +{"friction": [[0.00010952364135854918, -4.1212788728038696e-05, -4.127409062198184e-05], [-4.1212788728038696e-05, 0.00010954632959185874, -4.1246017068110866e-05], [-4.127409062198184e-05, -4.1246017068110866e-05, 0.0001095972142383212]]} + #*EXTRAS*# Step: 5 Bead: 56 +{"friction": [[0.00010989317837141276, -4.1481998082769866e-05, -4.1552496820752654e-05], [-4.1481998082769866e-05, 0.00010991823539637821, -4.152463878101612e-05], [-4.1552496820752654e-05, -4.152463878101612e-05, 0.0001099698787317994]]} + #*EXTRAS*# Step: 6 Bead: 56 +{"friction": [[0.00011012205026325673, -4.164394878498173e-05, -4.171857352858452e-05], [-4.164394878498173e-05, 0.00011014721373497907, -4.169150411439326e-05], [-4.171857352858452e-05, -4.169150411439326e-05, 0.0001101994672081787]]} + #*EXTRAS*# Step: 7 Bead: 56 +{"friction": [[0.00011026594637922502, -4.174394956478799e-05, -4.1820459432655924e-05], [-4.174394956478799e-05, 0.00011029054077892647, -4.179407030030076e-05], [-4.1820459432655924e-05, -4.179407030030076e-05, 0.00011034339526781115]]} + #*EXTRAS*# Step: 8 Bead: 56 +{"friction": [[0.0001103585049350248, -4.1807544069176005e-05, -4.188495387656098e-05], [-4.1807544069176005e-05, 0.00011038244815289338, -4.185905947427962e-05], [-4.188495387656098e-05, -4.185905947427962e-05, 0.00011043581856480895]]} + #*EXTRAS*# Step: 9 Bead: 56 +{"friction": [[0.00011041874770492986, -4.184863227802106e-05, -4.192649018667254e-05], [-4.184863227802106e-05, 0.00011044214041805985, -4.1900937027270956e-05], [-4.192649018667254e-05, -4.1900937027270956e-05, 0.00011049591174802914]]} + #*EXTRAS*# Step: 10 Bead: 56 +{"friction": [[0.0001104583342076689, -4.1875502969051744e-05, -4.1953594556826755e-05], [-4.1875502969051744e-05, 0.00011048130893671071, -4.192827257107027e-05], [-4.1953594556826755e-05, -4.192827257107027e-05, 0.00011053537463051823]]} + #*EXTRAS*# Step: 11 Bead: 56 +{"friction": [[0.00011048449800378008, -4.1893206664688265e-05, -4.197142576463895e-05], [-4.1893206664688265e-05, 0.00011050717147044749, -4.1946259212570714e-05], [-4.197142576463895e-05, -4.1946259212570714e-05, 0.00011056144601116417]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 new file mode 100644 index 000000000..e467f6e4d --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 57 +{"friction": [[0.00010273307889993032, -3.387387660981356e-05, -3.383904253920663e-05], [-3.387387660981356e-05, 0.00010269165843199864, -3.406401214784578e-05], [-3.383904253920663e-05, -3.406401214784578e-05, 0.00010231189325852699]]} + #*EXTRAS*# Step: 1 Bead: 57 +{"friction": [[0.00010536340689656752, -3.7406405851485144e-05, -3.734279685029382e-05], [-3.7406405851485144e-05, 0.00010536258765219391, -3.750097330746608e-05], [-3.734279685029382e-05, -3.750097330746608e-05, 0.0001051569518497606]]} + #*EXTRAS*# Step: 2 Bead: 57 +{"friction": [[0.0001077672899467541, -3.979200408389626e-05, -3.978911239809217e-05], [-3.979200408389626e-05, 0.00010776597932267155, -3.979444212774247e-05], [-3.978911239809217e-05, -3.979444212774247e-05, 0.00010777928592300358]]} + #*EXTRAS*# Step: 3 Bead: 57 +{"friction": [[0.0001087649523324993, -4.0628700634069755e-05, -4.066418472077692e-05], [-4.0628700634069755e-05, 0.00010877741770462994, -4.064192658711429e-05], [-4.066418472077692e-05, -4.064192658711429e-05, 0.00010882271122082538]]} + #*EXTRAS*# Step: 4 Bead: 57 +{"friction": [[0.00010941297716055378, -4.113026435924637e-05, -4.118829446586204e-05], [-4.113026435924637e-05, 0.0001094345282604382, -4.116048000380276e-05], [-4.118829446586204e-05, -4.116048000380276e-05, 0.00010948508305179779]]} + #*EXTRAS*# Step: 5 Bead: 57 +{"friction": [[0.00010978789245555794, -4.1406280738047924e-05, -4.147445579266751e-05], [-4.1406280738047924e-05, 0.00010981252654353268, -4.144638625364133e-05], [-4.147445579266751e-05, -4.144638625364133e-05, 0.00010986396363720996]]} + #*EXTRAS*# Step: 6 Bead: 57 +{"friction": [[0.00011002001836375603, -4.157219412992952e-05, -4.1645143149069345e-05], [-4.157219412992952e-05, 0.00011004527972096271, -4.161767195391058e-05], [-4.1645143149069345e-05, -4.161767195391058e-05, 0.00011009722155591035]]} + #*EXTRAS*# Step: 7 Bead: 57 +{"friction": [[0.00011016595202276082, -4.167460576822622e-05, -4.174986644005414e-05], [-4.167460576822622e-05, 0.00011019099695999457, -4.172299161834093e-05], [-4.174986644005414e-05, -4.172299161834093e-05, 0.00011024341120308603]]} + #*EXTRAS*# Step: 8 Bead: 57 +{"friction": [[0.00011025981536631939, -4.1739717063769264e-05, -4.181615848851476e-05], [-4.1739717063769264e-05, 0.00011028444480968353, -4.178973801867443e-05], [-4.181615848851476e-05, -4.178973801867443e-05, 0.00011033726902870968]]} + #*EXTRAS*# Step: 9 Bead: 57 +{"friction": [[0.0001103209067663942, -4.1781779664792057e-05, -4.185885435365232e-05], [-4.1781779664792057e-05, 0.00011034514244129577, -4.1832754314504246e-05], [-4.185885435365232e-05, -4.1832754314504246e-05, 0.00011039828945047845]]} + #*EXTRAS*# Step: 10 Bead: 57 +{"friction": [[0.00011036105049583356, -4.1809285068399454e-05, -4.188671603744782e-05], [-4.1809285068399454e-05, 0.00011038497250746309, -4.1860835771759115e-05], [-4.188671603744782e-05, -4.1860835771759115e-05, 0.00011043835876664947]]} + #*EXTRAS*# Step: 11 Bead: 57 +{"friction": [[0.00011038758253108684, -4.1827405941199015e-05, -4.1905045830065985e-05], [-4.1827405941199015e-05, 0.00011041127277516824, -4.187931443464574e-05], [-4.1905045830065985e-05, -4.187931443464574e-05, 0.00011046482985904919]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 new file mode 100644 index 000000000..8a0b14d89 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 58 +{"friction": [[0.00010261428366339391, -3.367703313457375e-05, -3.3647121432587244e-05], [-3.367703313457375e-05, 0.00010256698019056102, -3.3864653594504656e-05], [-3.3647121432587244e-05, -3.3864653594504656e-05, 0.00010219119996151315]]} + #*EXTRAS*# Step: 1 Bead: 58 +{"friction": [[0.0001052350179684757, -3.7261400315599e-05, -3.719632488166249e-05], [-3.7261400315599e-05, 0.00010523453987101449, -3.7363357930734816e-05], [-3.719632488166249e-05, -3.7363357930734816e-05, 0.0001050149275339326]]} + #*EXTRAS*# Step: 2 Bead: 58 +{"friction": [[0.00010765130340315402, -3.9689410025850775e-05, -3.968235868597892e-05], [-3.9689410025850775e-05, 0.00010764903244530955, -3.969277934457391e-05], [-3.968235868597892e-05, -3.969277934457391e-05, 0.00010765581254918402]]} + #*EXTRAS*# Step: 3 Bead: 58 +{"friction": [[0.00010866218424880969, -4.054620443346167e-05, -4.057775472510992e-05], [-4.054620443346167e-05, 0.00010867301667475944, -4.0557138841220643e-05], [-4.057775472510992e-05, -4.0557138841220643e-05, 0.00010871666181012876]]} + #*EXTRAS*# Step: 4 Bead: 58 +{"friction": [[0.00010931789438123606, -4.105864371625966e-05, -4.1113700161084415e-05], [-4.105864371625966e-05, 0.00010933834160357464, -4.1086248483347904e-05], [-4.1113700161084415e-05, -4.1086248483347904e-05, 0.00010938852742091382]]} + #*EXTRAS*# Step: 5 Bead: 58 +{"friction": [[0.00010969743250532752, -4.134060341369331e-05, -4.1406585725889926e-05], [-4.134060341369331e-05, 0.00010972153465585688, -4.137842432157714e-05], [-4.1406585725889926e-05, -4.137842432157714e-05, 0.00010977280108308987]]} + #*EXTRAS*# Step: 6 Bead: 58 +{"friction": [[0.00010993235338128733, -4.150997403822779e-05, -4.15812714544102e-05], [-4.150997403822779e-05, 0.00010995751040483094, -4.155351839302731e-05], [-4.15812714544102e-05, -4.155351839302731e-05, 0.00011000923806253775]]} + #*EXTRAS*# Step: 7 Bead: 58 +{"friction": [[0.00011008003632569763, -4.16144879784933e-05, -4.168845569472884e-05], [-4.16144879784933e-05, 0.0001101052696301386, -4.166121190343459e-05], [-4.168845569472884e-05, -4.166121190343459e-05, 0.0001101573851489705]]} + #*EXTRAS*# Step: 8 Bead: 58 +{"friction": [[0.00011017501960659655, -4.168092155523587e-05, -4.175630702221574e-05], [-4.168092155523587e-05, 0.00011020003414407904, -4.1729473887282815e-05], [-4.175630702221574e-05, -4.1729473887282815e-05, 0.00011025248389147027]]} + #*EXTRAS*# Step: 9 Bead: 58 +{"friction": [[0.00011023683932210806, -4.172383344860166e-05, -4.180000880369074e-05], [-4.172383344860166e-05, 0.00011026159135153239, -4.177347262322645e-05], [-4.180000880369074e-05, -4.177347262322645e-05, 0.00011031430612943409]]} + #*EXTRAS*# Step: 10 Bead: 58 +{"friction": [[0.00011027746124519757, -4.17518920161995e-05, -4.182852750065361e-05], [-4.17518920161995e-05, 0.00011030198715209597, -4.180219773447237e-05], [-4.182852750065361e-05, -4.180219773447237e-05, 0.00011035489973834276]]} + #*EXTRAS*# Step: 11 Bead: 58 +{"friction": [[0.00011030430927864885, -4.177037644188916e-05, -4.184728986434607e-05], [-4.177037644188916e-05, 0.00011032866180931211, -4.182110102163738e-05], [-4.184728986434607e-05, -4.182110102163738e-05, 0.00011038171635405511]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 new file mode 100644 index 000000000..9f2b42a41 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 59 +{"friction": [[0.00010251514085647045, -3.350986950112593e-05, -3.3484233397662335e-05], [-3.350986950112593e-05, 0.0001024627094050115, -3.369472217637789e-05], [-3.3484233397662335e-05, -3.369472217637789e-05, 0.00010209140079979171]]} + #*EXTRAS*# Step: 1 Bead: 59 +{"friction": [[0.00010512788961161465, -3.71387729731769e-05, -3.7072642833027904e-05], [-3.71387729731769e-05, 0.00010512763581882635, -3.724691914570833e-05], [-3.7072642833027904e-05, -3.724691914570833e-05, 0.00010489643388892816]]} + #*EXTRAS*# Step: 2 Bead: 59 +{"friction": [[0.00010755451041822721, -3.960291575373603e-05, -3.9592476967194964e-05], [-3.960291575373603e-05, 0.00010755156267742175, -3.960743732596367e-05], [-3.9592476967194964e-05, -3.960743732596367e-05, 0.00010755243649046094]]} + #*EXTRAS*# Step: 3 Bead: 59 +{"friction": [[0.00010857637231398265, -4.0476684216099065e-05, -4.05049106472146e-05], [-4.0476684216099065e-05, 0.00010858584013436002, -4.0485851819446464e-05], [-4.05049106472146e-05, -4.0485851819446464e-05, 0.00010862787795858954]]} + #*EXTRAS*# Step: 4 Bead: 59 +{"friction": [[0.00010923849721524898, -4.0998326486522296e-05, -4.105079474597055e-05], [-4.0998326486522296e-05, 0.00010925794377160113, -4.1023752723423126e-05], [-4.105079474597055e-05, -4.1023752723423126e-05, 0.00010930774390070632]]} + #*EXTRAS*# Step: 5 Bead: 59 +{"friction": [[0.00010962189698362254, -4.128531676556566e-05, -4.1349337375174327e-05], [-4.128531676556566e-05, 0.00010964544463478689, -4.1321169149820804e-05], [-4.1349337375174327e-05, -4.1321169149820804e-05, 0.0001096965590126182]]} + #*EXTRAS*# Step: 6 Bead: 59 +{"friction": [[0.00010985915126110704, -4.145761185929922e-05, -4.152738743221311e-05], [-4.145761185929922e-05, 0.00010988409571330159, -4.149944945349963e-05], [-4.152738743221311e-05, -4.149944945349963e-05, 0.00010993566987552648]]} + #*EXTRAS*# Step: 7 Bead: 59 +{"friction": [[0.00011000829401724617, -4.156390339529413e-05, -4.1636642632954926e-05], [-4.156390339529413e-05, 0.00011003355124973123, -4.160913016722292e-05], [-4.1636642632954926e-05, -4.160913016722292e-05, 0.00011008546198226062]]} + #*EXTRAS*# Step: 8 Bead: 59 +{"friction": [[0.00011010421171911968, -4.163145475285745e-05, -4.1705806257958496e-05], [-4.163145475285745e-05, 0.00011012940998297533, -4.167866134262013e-05], [-4.1705806257958496e-05, -4.167866134262013e-05, 0.00011018160308948388]]} + #*EXTRAS*# Step: 9 Bead: 59 +{"friction": [[0.00011016663904073194, -4.167508448620823e-05, -4.175035469243272e-05], [-4.167508448620823e-05, 0.00011019168174626674, -4.172348301170962e-05], [-4.175035469243272e-05, -4.172348301170962e-05, 0.00011024409865081321]]} + #*EXTRAS*# Step: 10 Bead: 59 +{"friction": [[0.0001102076598792176, -4.170361055787318e-05, -4.177942641040984e-05], [-4.170361055787318e-05, 0.00011023254792276632, -4.1752747364611484e-05], [-4.177942641040984e-05, -4.1752747364611484e-05, 0.00011028513245299239]]} + #*EXTRAS*# Step: 11 Bead: 59 +{"friction": [[0.00011023477151328872, -4.1722402221112785e-05, -4.179855289230215e-05], [-4.1722402221112785e-05, 0.00011025953390246373, -4.177200643463401e-05], [-4.179855289230215e-05, -4.177200643463401e-05, 0.00011031223913385279]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 new file mode 100644 index 000000000..bbb66c535 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 60 +{"friction": [[0.00010243489413890537, -3.337266793205423e-05, -3.3350583183048474e-05], [-3.337266793205423e-05, 0.00010237819197671717, -3.355483283288116e-05], [-3.3350583183048474e-05, -3.355483283288116e-05, 0.00010201127331709875]]} + #*EXTRAS*# Step: 1 Bead: 60 +{"friction": [[0.00010504171525898483, -3.703902177562985e-05, -3.697215820465263e-05], [-3.703902177562985e-05, 0.00010504159386926141, -3.715214478383926e-05], [-3.697215820465263e-05, -3.715214478383926e-05, 0.00010480114085988345]]} + #*EXTRAS*# Step: 2 Bead: 60 +{"friction": [[0.00010747699575359396, -3.953306711412285e-05, -3.951997134586765e-05], [-3.953306711412285e-05, 0.00010747358365077813, -3.953874851522914e-05], [-3.951997134586765e-05, -3.953874851522914e-05, 0.0001074694386068857]]} + #*EXTRAS*# Step: 3 Bead: 60 +{"friction": [[0.0001085076094704989, -4.042055585190487e-05, -4.044610051763782e-05], [-4.042055585190487e-05, 0.00010851599113750501, -4.0428416722827415e-05], [-4.044610051763782e-05, -4.0428416722827415e-05, 0.00010855657703823011]]} + #*EXTRAS*# Step: 4 Bead: 60 +{"friction": [[0.00010917487325976849, -4.094965321539262e-05, -4.0999983984558606e-05], [-4.094965321539262e-05, 0.00010919347217277586, -4.097334444339943e-05], [-4.0999983984558606e-05, -4.097334444339943e-05, 0.00010924290289239569]]} + #*EXTRAS*# Step: 5 Bead: 60 +{"friction": [[0.00010956136852074872, -4.124071950738956e-05, -4.1303086864651574e-05], [-4.124071950738956e-05, 0.00010958440437717394, -4.1274962534541497e-05], [-4.1303086864651574e-05, -4.1274962534541497e-05, 0.00010963538281766172]]} + #*EXTRAS*# Step: 6 Bead: 60 +{"friction": [[0.0001098004924002042, -4.141538298453672e-05, -4.148384935776913e-05], [-4.141538298453672e-05, 0.00010982518853729445, -4.145579942454147e-05], [-4.148384935776913e-05, -4.145579942454147e-05, 0.0001098766493826682]]} + #*EXTRAS*# Step: 7 Bead: 60 +{"friction": [[0.00010995080441076994, -4.152311362160652e-05, -4.159477440880391e-05], [-4.152311362160652e-05, 0.00010997599730210928, -4.1567075413781526e-05], [-4.159477440880391e-05, -4.1567075413781526e-05, 0.00011002776681098711]]} + #*EXTRAS*# Step: 8 Bead: 60 +{"friction": [[0.00011004747042252092, -4.1591569731421995e-05, -4.166499624115483e-05], [-4.1591569731421995e-05, 0.00011007272924659043, -4.163762577262774e-05], [-4.166499624115483e-05, -4.163762577262774e-05, 0.0001101247473785609]]} + #*EXTRAS*# Step: 9 Bead: 60 +{"friction": [[0.00011011038428813566, -4.1635780429990154e-05, -4.1710227443457736e-05], [-4.1635780429990154e-05, 0.00011013557137722407, -4.1683108412967094e-05], [-4.1710227443457736e-05, -4.1683108412967094e-05, 0.00011018778506388565]]} + #*EXTRAS*# Step: 10 Bead: 60 +{"friction": [[0.0001101517245444789, -4.166468483652233e-05, -4.1739745155579874e-05], [-4.166468483652233e-05, 0.0001101768130724035, -4.171280593949865e-05], [-4.1739745155579874e-05, -4.171280593949865e-05, 0.00011022917323283132]]} + #*EXTRAS*# Step: 11 Bead: 60 +{"friction": [[0.00011017904724149928, -4.168372512500324e-05, -4.175916529714994e-05], [-4.168372512500324e-05, 0.00011020404761867768, -4.1732350837467645e-05], [-4.175916529714994e-05, -4.1732350837467645e-05, 0.00011025651340074062]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 new file mode 100644 index 000000000..c81aa6d8a --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 61 +{"friction": [[0.00010237295826707656, -3.326562672264948e-05, -3.3246327268270765e-05], [-3.326562672264948e-05, 0.00010231289990664679, -3.3445442976744176e-05], [-3.3246327268270765e-05, -3.3445442976744176e-05, 0.0001019498435873969]]} + #*EXTRAS*# Step: 1 Bead: 61 +{"friction": [[0.00010497622350492327, -3.696253465527045e-05, -3.6895184002999406e-05], [-3.696253465527045e-05, 0.0001049761700279079, -3.7079431383619136e-05], [-3.6895184002999406e-05, -3.7079431383619136e-05, 0.00010472874078958076]]} + #*EXTRAS*# Step: 2 Bead: 61 +{"friction": [[0.00010741881640390687, -3.948029896129552e-05, -3.946524193977612e-05], [-3.948029896129552e-05, 0.00010741509919581306, -3.948698521976394e-05], [-3.946524193977612e-05, -3.948698521976394e-05, 0.00010740702430699702]]} + #*EXTRAS*# Step: 3 Bead: 61 +{"friction": [[0.00010845597074566795, -4.0378157902783e-05, -4.040168143887436e-05], [-4.0378157902783e-05, 0.00010846354482416401, -4.038510722770884e-05], [-4.040168143887436e-05, -4.038510722770884e-05, 0.00010850293869586134]]} + #*EXTRAS*# Step: 4 Bead: 61 +{"friction": [[0.00010912709309522245, -4.091290125601393e-05, -4.096159230280928e-05], [-4.091290125601393e-05, 0.00010914503152720644, -4.093530035955948e-05], [-4.096159230280928e-05, -4.093530035955948e-05, 0.00010919414511008921]]} + #*EXTRAS*# Step: 5 Bead: 61 +{"friction": [[0.00010951591361911851, -4.120705490803478e-05, -4.1268135336905526e-05], [-4.120705490803478e-05, 0.0001095385280367727, -4.12400744720793e-05], [-4.1268135336905526e-05, -4.12400744720793e-05, 0.00010958939245441774]]} + #*EXTRAS*# Step: 6 Bead: 61 +{"friction": [[0.00010975644142369795, -4.138351165211073e-05, -4.145094429416002e-05], [-4.138351165211073e-05, 0.00010978090756342167, -4.1422832932032534e-05], [-4.145094429416002e-05, -4.1422832932032534e-05, 0.0001098322856887074]]} + #*EXTRAS*# Step: 7 Bead: 61 +{"friction": [[0.00010990763121726532, -4.149233164767918e-05, -4.156312930641954e-05], [-4.149233164767918e-05, 0.00010993272886860607, -4.15353084149259e-05], [-4.156312930641954e-05, -4.15353084149259e-05, 0.00010998440265835843]]} + #*EXTRAS*# Step: 8 Bead: 61 +{"friction": [[0.00011000485892522482, -4.156147252525685e-05, -4.1634149641135395e-05], [-4.156147252525685e-05, 0.00011003011436462694, -4.1606625285818845e-05], [-4.1634149641135395e-05, -4.1606625285818845e-05, 0.00011008201614364663]]} + #*EXTRAS*# Step: 9 Bead: 61 +{"friction": [[0.00011006813797439846, -4.16061228917534e-05, -4.167989607373449e-05], [-4.16061228917534e-05, 0.00011009338346565017, -4.165260511638784e-05], [-4.167989607373449e-05, -4.165260511638784e-05, 0.00011014546248999789]]} + #*EXTRAS*# Step: 10 Bead: 61 +{"friction": [[0.00011010971796554216, -4.1635313601837346e-05, -4.170975035414365e-05], [-4.1635313601837346e-05, 0.00011013490630485031, -4.1682628517081335e-05], [-4.170975035414365e-05, -4.1682628517081335e-05, 0.00011018711775438423]]} + #*EXTRAS*# Step: 11 Bead: 61 +{"friction": [[0.00011013719906930738, -4.165454202988721e-05, -4.172939211098937e-05], [-4.165454202988721e-05, 0.00011016232696405186, -4.1702388457941515e-05], [-4.172939211098937e-05, -4.1702388457941515e-05, 0.00011021463389413222]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 new file mode 100644 index 000000000..3a8bdd729 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 62 +{"friction": [[0.00010232890466352831, -3.318888996525138e-05, -3.3171590289423344e-05], [-3.318888996525138e-05, 0.00010226643313891227, -3.33668903313071e-05], [-3.3171590289423344e-05, -3.33668903313071e-05, 0.00010190637620575303]]} + #*EXTRAS*# Step: 1 Bead: 62 +{"friction": [[0.00010493119610870736, -3.690960222648608e-05, -3.68419526225159e-05], [-3.690960222648608e-05, 0.00010493117133566126, -3.702908608317043e-05], [-3.68419526225159e-05, -3.702908608317043e-05, 0.00010467897768247295]]} + #*EXTRAS*# Step: 2 Bead: 62 +{"friction": [[0.0001073800096357312, -3.9444937165909055e-05, -3.942858780610902e-05], [-3.9444937165909055e-05, 0.00010737610893022676, -3.945235623979784e-05], [-3.942858780610902e-05, -3.945235623979784e-05, 0.00010736533720958268]]} + #*EXTRAS*# Step: 3 Bead: 62 +{"friction": [[0.00010842151291922681, -4.034974781250241e-05, -4.037192049143732e-05], [-4.034974781250241e-05, 0.0001084285533218993, -4.035612431593316e-05], [-4.037192049143732e-05, -4.035612431593316e-05, 0.00010846710117630905]]} + #*EXTRAS*# Step: 4 Bead: 62 +{"friction": [[0.00010909520995018607, -4.088828150263538e-05, -4.093586285564525e-05], [-4.088828150263538e-05, 0.00010911269726537385, -4.090982519163474e-05], [-4.093586285564525e-05, -4.090982519163474e-05, 0.00010916157868434374]]} + #*EXTRAS*# Step: 5 Bead: 62 +{"friction": [[0.00010948558239711153, -4.118450794598396e-05, -4.124470875251072e-05], [-4.118450794598396e-05, 0.00010950789874685311, -4.121670537621751e-05], [-4.124470875251072e-05, -4.121670537621751e-05, 0.00010955868005340166]]} + #*EXTRAS*# Step: 6 Bead: 62 +{"friction": [[0.00010972704698816182, -4.1362168349263066e-05, -4.142888776319552e-05], [-4.1362168349263066e-05, 0.00010975133964274408, -4.140074673987314e-05], [-4.142888776319552e-05, -4.140074673987314e-05, 0.00010980266252099715]]} + #*EXTRAS*# Step: 7 Bead: 62 +{"friction": [[0.00010987882237959801, -4.1471719397705736e-05, -4.154191633496635e-05], [-4.1471719397705736e-05, 0.00010990383478619501, -4.1514023266728234e-05], [-4.154191633496635e-05, -4.1514023266728234e-05, 0.00010995544853837047]]} + #*EXTRAS*# Step: 8 Bead: 62 +{"friction": [[0.00010997642477719597, -4.154131976356126e-05, -4.161347129972085e-05], [-4.154131976356126e-05, 0.00011000165530307113, -4.1585852117568044e-05], [-4.161347129972085e-05, -4.1585852117568044e-05, 0.00011005348557759603]]} + #*EXTRAS*# Step: 9 Bead: 62 +{"friction": [[0.00011003994741609463, -4.158626513429387e-05, -4.165956271321123e-05], [-4.158626513429387e-05, 0.00011006520864600165, -4.163216407930532e-05], [-4.165956271321123e-05, -4.163216407930532e-05, 0.00011011720536618256]]} + #*EXTRAS*# Step: 10 Bead: 62 +{"friction": [[0.00011008168731381539, -4.161564793801208e-05, -4.1689642354305476e-05], [-4.161564793801208e-05, 0.00011010691866485967, -4.166240518661445e-05], [-4.1689642354305476e-05, -4.166240518661445e-05, 0.00011015903933372153]]} + #*EXTRAS*# Step: 11 Bead: 62 +{"friction": [[0.00011010927407535976, -4.163500259398473e-05, -4.170943250394984e-05], [-4.163500259398473e-05, 0.00011013446324163322, -4.168230879885966e-05], [-4.170943250394984e-05, -4.168230879885966e-05, 0.00011018667320293423]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 new file mode 100644 index 000000000..7a829d3fe --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 @@ -0,0 +1,24 @@ + #*EXTRAS*# Step: 0 Bead: 63 +{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} + #*EXTRAS*# Step: 1 Bead: 63 +{"friction": [[0.00010490646196707843, -3.688040445238592e-05, -3.681260326094125e-05], [-3.688040445238592e-05, 0.00010490644633441923, -3.700130613295973e-05], [-3.681260326094125e-05, -3.700130613295973e-05, 0.00010465164772604607]]} + #*EXTRAS*# Step: 2 Bead: 63 +{"friction": [[0.00010736059912417344, -3.942720019368981e-05, -3.941020921641274e-05], [-3.942720019368981e-05, 0.0001073566125073179, -3.943500429453144e-05], [-3.941020921641274e-05, -3.943500429453144e-05, 0.00010734446961473918]]} + #*EXTRAS*# Step: 3 Bead: 63 +{"friction": [[0.00010840427424357551, -4.033549902001546e-05, -4.035699548366669e-05], [-4.033549902001546e-05, 0.00010841104949806518, -4.0341600028322654e-05], [-4.035699548366669e-05, -4.0341600028322654e-05, 0.00010844915849013377]]} + #*EXTRAS*# Step: 4 Bead: 63 +{"friction": [[0.00010907925945021144, -4.087593592646039e-05, -4.092295764769355e-05], [-4.087593592646039e-05, 0.00010909651816779468, -4.0897054042152546e-05], [-4.092295764769355e-05, -4.0897054042152546e-05, 0.0001091452769495408]]} + #*EXTRAS*# Step: 5 Bead: 63 +{"friction": [[0.00010947040838536123, -4.117320315043954e-05, -4.1232957787394115e-05], [-4.117320315043954e-05, 0.0001094925707286398, -4.120498783657466e-05], [-4.1232957787394115e-05, -4.120498783657466e-05, 0.00010954330807887231]]} + #*EXTRAS*# Step: 6 Bead: 63 +{"friction": [[0.00010971234162371044, -4.135146784021359e-05, -4.1417823540771805e-05], [-4.135146784021359e-05, 0.00010973654162811998, -4.138967118707266e-05], [-4.1417823540771805e-05, -4.138967118707266e-05, 0.00010978783661459619]]} + #*EXTRAS*# Step: 7 Bead: 63 +{"friction": [[0.00010986440993848807, -4.146138586654531e-05, -4.153127496362318e-05], [-4.146138586654531e-05, 0.00010988937332306589, -4.150334863731693e-05], [-4.153127496362318e-05, -4.150334863731693e-05, 0.00010994095797070902]]} + #*EXTRAS*# Step: 8 Bead: 63 +{"friction": [[0.00010996219974949212, -4.153121687394696e-05, -4.1603097929312325e-05], [-4.153121687394696e-05, 0.00010998741113946761, -4.157543376168608e-05], [-4.1603097929312325e-05, -4.157543376168608e-05, 0.00011003920727490534]]} + #*EXTRAS*# Step: 9 Bead: 63 +{"friction": [[0.00011002584422402483, -4.157631031732261e-05, -4.1649362279812446e-05], [-4.157631031732261e-05, 0.00011005110647749188, -4.162191198525026e-05], [-4.1649362279812446e-05, -4.162191198525026e-05, 0.00011010306408844832]]} + #*EXTRAS*# Step: 10 Bead: 63 +{"friction": [[0.00011006766410040153, -4.16057895370744e-05, -4.1679554894746565e-05], [-4.16057895370744e-05, 0.00011009291000845757, -4.165226207976316e-05], [-4.1679554894746565e-05, -4.165226207976316e-05, 0.00011014498760158926]]} + #*EXTRAS*# Step: 11 Bead: 63 +{"friction": [[0.00011009530370704743, -4.162520754867345e-05, -4.1699419434893625e-05], [-4.162520754867345e-05, 0.00011012051649486337, -4.167223761841634e-05], [-4.1699419434893625e-05, -4.167223761841634e-05, 0.00011017268046141867]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat new file mode 100644 index 000000000..f58744441 --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat @@ -0,0 +1,64 @@ +2.3727731017022706 0.13344076815778944 +2.373211152535036 0.13350597554029547 +2.374086336849262 0.13363575948820305 +2.3753968183111454 0.1338288632110306 +2.377139838420972 0.134083413638433 +2.37931171193371 0.13439693597364508 +2.381907821115009 0.13476637311767872 +2.3849226091344726 0.13518810997043584 +2.3883495729623347 0.13565800260347652 +2.3921812561951343 0.13617141228015153 +2.3964092422848546 0.13672324427064092 +2.401024148687287 0.13730799137215854 +2.4060156224757043 0.13791978199771937 +2.411372337984157 0.13855243264065165 +2.4170819970525947 0.13919950445753013 +2.4231313324387553 0.13985436364001252 +2.4295061149433943 0.14051024516837346 +2.4361911647625227 0.1411603194579342 +2.4431703675355485 0.14179775445635487 +2.4504266958110636 0.14241568519506387 +2.4579422413457497 0.14300728328348783 +2.465698258604672 0.14356589508503978 +2.473675216355156 0.1440851172115186 +2.481852857235644 0.14455886944443586 +2.490210265066654 0.14498146573989762 +2.4987259394908965 0.14534768216272217 +2.5073778773600814 0.1456528205872441 +2.5161436601187166 0.1458927670262171 +2.5250005462861926 0.14606404350729021 +2.5339255680037502 0.14616385250803637 +2.542895630503215 0.14619011308405766 +2.5518876132687565 0.1461415902639429 +2.5608784706097456 0.14601937534911896 +2.569845316057347 0.1458265254311242 +2.578765492870325 0.145566805530133 +2.58761664169884 0.14524457610961072 +2.596376765285668 0.14486470916780467 +2.6050242898107223 0.14443250216916687 +2.6135381225336554 0.14395359154023069 +2.6218977054462664 0.1434338673450423 +2.6300830647037903 0.14287939061258836 +2.6380748556678935 0.14229631461851475 +2.6458544034562985 0.14169081123268026 +2.6534037389585743 0.1410690032391952 +2.660705630338084 0.14043690332361008 +2.6677436101028182 0.1398003602086623 +2.674501997880584 0.1391650122122337 +2.6809659190822788 0.13853604243049505 +2.687121320810235 0.13791761692261295 +2.6929549884902007 0.13731369340396973 +2.6984545585902553 0.13672823296400757 +2.7036085265029537 0.13616515878196916 +2.7084062501095665 0.13562831507462428 +2.7128379495945523 0.13512142682802297 +2.716894704112094 0.13464806082706757 +2.720568445925636 0.13421158845277156 +2.7238519526475953 0.13381515066910485 +2.726738838193951 0.13346162557208227 +2.729223543049307 0.13315359882371663 +2.7313013244007887 0.13289333724556276 +2.7329682466547207 0.13268276580079472 +2.734221172794841 0.13252344815140743 +2.735057756976749 0.13241657093852707 +2.735476438682034 0.1323629318989296 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat b/drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/060K/MEP.dat b/drivers/py/pes/friction/frictionH/060K/MEP.dat new file mode 100644 index 000000000..e69de29bb diff --git a/drivers/py/pes/friction/frictionH/060K/RESTART b/drivers/py/pes/friction/frictionH/060K/RESTART new file mode 100644 index 000000000..1c516a07f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/RESTART @@ -0,0 +1,1063 @@ + + + [ step, potential{electronvolt} ] + extras + extras + + 16 + 30 + + + + + + [ friction ] + + + + 1.90008912e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 1.53942804e-03, 1.53982849e-03, 1.54064652e-03, 1.54191721e-03, 1.54369533e-03, + 1.54605802e-03, 1.54910860e-03, 1.55298158e-03, 1.55784924e-03, 1.56392988e-03, + 1.57149821e-03, 1.58089806e-03, 1.59255794e-03, 1.60700960e-03, 1.62491007e-03, + 1.64706700e-03, 1.67446721e-03, 1.70830774e-03, 1.75002760e-03, 1.80133767e-03, + 1.86424405e-03, 1.94105823e-03, 2.03438418e-03, 2.14706908e-03, 2.28210033e-03, + 2.44242787e-03, 2.63068841e-03, 2.84880926e-03, 3.09747653e-03, 3.37546744e-03, + 3.67845832e-03, 3.99748069e-03, 4.31874982e-03, 4.62348251e-03, 4.89031385e-03, + 5.10635288e-03, 5.26305752e-03, 5.35283931e-03, 5.36943053e-03, 5.31335664e-03, + 5.19769209e-03, 5.03816021e-03, 4.84349175e-03, 4.61499986e-03, 4.35543233e-03, + 4.07492841e-03, 3.78764349e-03, 3.50491204e-03, 3.23514178e-03, 2.98354922e-03, + 2.75263267e-03, 2.54360073e-03, 2.35672829e-03, 2.19160155e-03, 2.04732860e-03, + 1.92258846e-03, 1.81578669e-03, 1.72546973e-03, 1.65037070e-03, 1.58941113e-03, + 1.54169962e-03, 1.50652891e-03, 1.48337242e-03, 1.47188112e-03 ] + + + [ -5.01050817e-04, 2.88014170e-06, 2.65947398e-06, -5.05731985e-04, 2.91650062e-06, + 2.69358374e-06, -5.15146470e-04, 2.98978934e-06, 2.76237418e-06, -5.29398865e-04, + 3.10113582e-06, 2.86697659e-06, -5.48646713e-04, 3.25219652e-06, 3.00906014e-06, + -5.73101137e-04, 3.44511160e-06, 3.19079639e-06, -6.03027371e-04, 3.68244157e-06, + 3.41480862e-06, -6.38744923e-04, 3.96708229e-06, 3.68410282e-06, -6.80626989e-04, + 4.30215440e-06, 4.00197624e-06, -7.29098600e-04, 4.69086239e-06, 4.37189854e-06, + -7.84632826e-04, 5.13631759e-06, 4.79735900e-06, -8.47744159e-04, 5.64131920e-06, + 5.28167292e-06, -9.18977959e-04, 6.20808691e-06, 5.82773844e-06, -9.98894519e-04, + 6.83793911e-06, 6.43773514e-06, -1.08804594e-03, 7.53091183e-06, 7.11275481e-06, + -1.18694360e-03, 8.28531529e-06, 7.85235574e-06, -1.29601336e-03, 9.09722864e-06, + 8.65403327e-06, -1.41553531e-03, 9.95993804e-06, 9.51260298e-06, -1.54556398e-03, + 1.08633299e-05, 1.04194986e-05, -1.68582453e-03, 1.17932600e-05, 1.13619957e-05, + -1.83557991e-03, 1.27309331e-05, 1.23223882e-05, -1.99346385e-03, 1.36523538e-05, + 1.32771650e-05, -2.15727482e-03, 1.45278751e-05, 1.41962497e-05, -2.32372773e-03, + 1.53219243e-05, 1.50424064e-05, -2.48816268e-03, 1.59929800e-05, 1.57709454e-05, + -2.64421569e-03, 1.64938647e-05, 1.63299007e-05, -2.78346492e-03, 1.67723718e-05, + 1.66608702e-05, -2.89507907e-03, 1.67722270e-05, 1.67007277e-05, -2.96551390e-03, + 1.64343033e-05, 1.63843859e-05, -2.97834866e-03, 1.56978180e-05, 1.56486992e-05, + -2.91808012e-03, 1.45010850e-05, 1.44374315e-05, -2.77746412e-03, 1.27859597e-05, + 1.27064470e-05, -2.55491091e-03, 1.05118758e-05, 1.04294035e-05, -2.25514834e-03, + 7.67222390e-06, 7.60580392e-06, -1.88843065e-03, 4.30858677e-06, 4.27001613e-06, + -1.46256029e-03, 5.09294924e-07, 4.95322034e-07, -9.86852373e-04, -3.61947376e-06, + -3.61511684e-06, -4.78936857e-04, -7.96380218e-06, -7.93946859e-06, 3.53047744e-05, + -1.23851601e-05, -1.23433534e-05, 5.32585726e-04, -1.67302133e-05, -1.66891421e-05, + 1.00042511e-03, -2.08726378e-05, -2.08513840e-05, 1.42921428e-03, -2.47279207e-05, + -2.47286318e-05, 1.80715244e-03, -2.82396438e-05, -2.82485381e-05, 2.12104464e-03, + -3.13649784e-05, -3.13678016e-05, 2.36248330e-03, -3.40774542e-05, -3.40687399e-05, + 2.53503932e-03, -3.63698507e-05, -3.63525426e-05, 2.65020279e-03, -3.82535981e-05, + -3.82346032e-05, 2.71890103e-03, -3.97549062e-05, -3.97421270e-05, 2.75092380e-03, + -4.09107915e-05, -4.09108151e-05, 2.75455211e-03, -4.17655827e-05, -4.17811242e-05, + 2.73658568e-03, -4.23668145e-05, -4.23948365e-05, 2.70284448e-03, -4.27608264e-05, + -4.27928135e-05, 2.65825963e-03, -4.29901999e-05, -4.30137067e-05, 2.60695308e-03, + -4.30924651e-05, -4.30932789e-05, 2.55232998e-03, -4.30994977e-05, -4.30640780e-05, + 2.49726097e-03, -4.30371606e-05, -4.29552853e-05, 2.44416434e-03, -4.29263162e-05, + -4.27928694e-05, 2.39488132e-03, -4.27851675e-05, -4.25999328e-05, 2.35077787e-03, + -4.26301969e-05, -4.23967768e-05, 2.31285091e-03, -4.24762787e-05, -4.22008548e-05, + 2.28181378e-03, -4.23364577e-05, -4.20267180e-05, 2.25816333e-03, -4.22216340e-05, + -4.18859881e-05, 2.24223050e-03, -4.21402625e-05, -4.17873565e-05, 2.23421661e-03, + -4.20981141e-05, -4.17365999e-05 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] + + True + + [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, + 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, + 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, + 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, + 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, + 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, + 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, + 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, + 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, + 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, + 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, + 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, + 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, + 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, + 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, + 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, + 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, + 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, + 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, + 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, + 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, + 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, + 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, + 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, + 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, + 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, + 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, + 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, + 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, + 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, + 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, + 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, + 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, + 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, + 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, + 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, + 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, + 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, + 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, + 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, + 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, + 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, + 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, + 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, + 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, + 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, + 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, + 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, + 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, + 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, + 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, + 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, + 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, + 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, + 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, + 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, + 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, + 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, + 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, + 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, + 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, + 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, + 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, + 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, + 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, + 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, + 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, + 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, + 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, + 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, + 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, + 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, + 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, + 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, + 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, + 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, + 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, + 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, + 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, + 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, + 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, + 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, + 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, + 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, + 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, + 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, + 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, + 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, + 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, + 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, + 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, + 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, + 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, + 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, + 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, + 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, + 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, + 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, + 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, + 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, + 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, + 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, + 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, + 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, + 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, + 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, + 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, + 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, + 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, + 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, + 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, + 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, + 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, + 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, + 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, + 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, + 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, + 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, + 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, + 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, + 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, + 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, + 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, + 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, + 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, + 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, + 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, + 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, + 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, + 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, + 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, + 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, + 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, + 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, + 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, + 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, + 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, + 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, + 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, + 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, + 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, + 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, + 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, + 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, + 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, + 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, + 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, + 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, + 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, + 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, + 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, + 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, + 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, + 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, + 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, + 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, + 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, + 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, + 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, + 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, + 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, + 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, + 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, + 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, + 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, + 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, + 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, + 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, + 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, + 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, + 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, + 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, + 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, + 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, + 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, + 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, + 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, + 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, + 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, + 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, + 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, + 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, + 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, + 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, + 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, + 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, + 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, + 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, + 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, + 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, + 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, + 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, + 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, + 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, + 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, + 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, + 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, + 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, + 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, + 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, + 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, + 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, + 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, + 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, + 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, + 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, + 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, + 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, + 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, + 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, + 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, + 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, + 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, + 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, + 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, + 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, + 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, + 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, + 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, + 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, + 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, + 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, + 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, + 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, + 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, + 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, + 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, + 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, + 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, + 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, + 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, + 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, + 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, + 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, + 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, + 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, + 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, + 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, + 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, + 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, + 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, + 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, + 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, + 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, + 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, + 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, + 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, + 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, + 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, + 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, + 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, + 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, + 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, + 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, + 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, + 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, + 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, + 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, + 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, + 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, + 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, + 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, + 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, + 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, + 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, + 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, + 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, + 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, + 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, + 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, + 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, + 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, + 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, + 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, + 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, + 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, + 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, + 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, + 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, + 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, + 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, + 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, + 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, + 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, + 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, + 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, + 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, + 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, + 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, + 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, + 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, + 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, + 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, + 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, + 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, + 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, + 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, + 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, + 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, + 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, + 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, + 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, + 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, + 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, + 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, + 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, + 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, + 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, + 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, + 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, + 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, + 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, + 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, + 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, + 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, + 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, + 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, + 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, + 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, + 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, + 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, + 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, + 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, + 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, + 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, + 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, + 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, + 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, + 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, + 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, + 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, + 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, + 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, + 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, + 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, + 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, + 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, + 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, + 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, + 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, + 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, + 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, + 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, + 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, + 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, + 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, + 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, + 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, + 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, + 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, + 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, + 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, + 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, + 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, + 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, + 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, + 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, + 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, + 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, + 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, + 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, + 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, + 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, + 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, + 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, + 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, + 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, + 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, + 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, + 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, + 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, + 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, + 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, + 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, + 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, + 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, + 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, + 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, + 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, + 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, + 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, + 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, + 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, + 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, + 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, + 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, + 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, + 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, + 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, + 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, + 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, + 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, + 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, + 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, + 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, + 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, + 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, + 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, + 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, + 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] + + + [ 1.72738330e-02, 9.87604599e-05, 9.30137216e-05, 1.72596504e-02, 9.90329642e-05, + 9.32978576e-05, 1.72310601e-02, 9.95676147e-05, 9.38571021e-05, 1.71876080e-02, + 1.00343891e-04, 9.46735532e-05, 1.71286019e-02, 1.01331504e-04, 9.57207378e-05, + 1.70530984e-02, 1.02490969e-04, 9.69640571e-05, 1.69598851e-02, 1.03774376e-04, + 9.83613646e-05, 1.68474573e-02, 1.05126315e-04, 9.98636645e-05, 1.67139901e-02, + 1.06484976e-04, 1.01415914e-04, 1.65573040e-02, 1.07783395e-04, 1.02957913e-04, + 1.63748245e-02, 1.08950836e-04, 1.04425267e-04, 1.61635352e-02, 1.09914305e-04, + 1.05750397e-04, 1.59199231e-02, 1.10600175e-04, 1.06863596e-04, 1.56399152e-02, + 1.10935917e-04, 1.07694112e-04, 1.53188080e-02, 1.10851929e-04, 1.08171252e-04, + 1.49511860e-02, 1.10283451e-04, 1.08225524e-04, 1.45308318e-02, 1.09172554e-04, + 1.07789825e-04, 1.40506261e-02, 1.07470200e-04, 1.06800712e-04, 1.35024396e-02, + 1.05138344e-04, 1.05199822e-04, 1.28770171e-02, 1.02152066e-04, 1.02935493e-04, + 1.21638597e-02, 9.85016825e-05, 9.99647001e-05, 1.13511076e-02, 9.41947686e-05, + 9.62554064e-05, 1.04254371e-02, 8.92579942e-05, 9.17894368e-05, 9.37198199e-03, + 8.37386066e-05, 8.65659662e-05, 8.17430412e-03, 7.77053309e-05, 8.06056515e-05, + 6.81444039e-03, 7.12483565e-05, 7.39553374e-05, 5.27306924e-03, 6.44779547e-05, + 6.66930979e-05, 3.52985049e-03, 5.75211266e-05, 5.89331438e-05, 1.56400850e-03, + 5.05154881e-05, 5.08298199e-05, -6.36095804e-04, 4.35754163e-05, 4.25835058e-05, + -2.83031034e-03, 3.61709787e-05, 3.44850237e-05, -4.84421458e-03, 2.81676941e-05, + 2.66524887e-05, -6.59406142e-03, 1.99052840e-05, 1.91865102e-05, -7.99307885e-03, + 1.20398544e-05, 1.23387812e-05, -9.08777482e-03, 6.21904917e-06, 6.80304919e-06, + -1.00074258e-02, 3.11045233e-06, 3.20054222e-06, -1.06993457e-02, 1.27416438e-06, + 1.40808345e-06, -1.09694249e-02, 6.82140844e-07, 1.31457077e-06, -1.07679196e-02, + 3.05190775e-06, 3.12995572e-06, -1.03076140e-02, 7.85374760e-06, 6.73607583e-06, + -9.71063987e-03, 1.31854170e-05, 1.16369865e-05, -8.96664729e-03, 1.79285028e-05, + 1.73236592e-05, -7.93427567e-03, 2.30667278e-05, 2.34314022e-05, -6.61833645e-03, + 2.88255368e-05, 2.95954446e-05, -5.12047906e-03, 3.50576133e-05, 3.55835888e-05, + -3.75312991e-03, 4.13459883e-05, 4.15335955e-05, -2.54820805e-03, 4.74663366e-05, + 4.73143517e-05, -1.49351279e-03, 5.32635812e-05, 5.27714327e-05, -5.74491015e-04, + 5.86033693e-05, 5.77880655e-05, 2.36533668e-04, 6.32216630e-05, 6.23458538e-05, + 9.52898044e-04, 6.71037525e-05, 6.64861707e-05, 1.58292340e-03, 7.03239923e-05, + 7.02519558e-05, 2.13454114e-03, 7.29637456e-05, 7.36814853e-05, 2.61514548e-03, + 7.51035538e-05, 7.68044869e-05, 3.03092873e-03, 7.68398876e-05, 7.96451741e-05, + 3.37777405e-03, 7.86164664e-05, 8.22765951e-05, 3.66123611e-03, 8.04964160e-05, + 8.46865292e-05, 3.89056709e-03, 8.23691705e-05, 8.68388385e-05, 4.07357188e-03, + 8.41400313e-05, 8.87086933e-05, 4.21671284e-03, 8.57299966e-05, 9.02800131e-05, + 4.32520908e-03, 8.70751755e-05, 9.15431483e-05, 4.40312452e-03, 8.81259591e-05, + 9.24928714e-05, 4.45344111e-03, 8.88461271e-05, 9.31267282e-05, 4.47811513e-03, + 8.92120407e-05, 9.34437847e-05, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 2.11758237e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.11758237e-19, + 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, + 4.23516474e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 1.27054942e-18, 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, + 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -8.47032947e-19, 5.51152161e-01, + 0.00000000e+00, -8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, + 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, + -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, -2.11758237e-19, 5.51152161e-01, + 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, -1.69406589e-18, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, + 5.51152161e-01, 0.00000000e+00, 6.77626358e-18, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 6.77626358e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, + 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, + 6.77626358e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 1.01643954e-17, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, + 5.51152161e-01 ] + + + [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] + + True + + + + + [ 1.89462714e+00, -5.22567433e-06, -4.82529901e-06, 1.89489911e+00, -5.29164327e-06, + -4.88718712e-06, 1.89544678e+00, -5.42461692e-06, -5.01199918e-06, 1.89627766e+00, + -5.62664186e-06, -5.20178780e-06, 1.89740320e+00, -5.90072351e-06, -5.45958149e-06, + 1.89883897e+00, -6.25074497e-06, -5.78932029e-06, 1.90060493e+00, -6.68135196e-06, + -6.19576382e-06, 1.90272572e+00, -7.19779866e-06, -6.68436609e-06, 1.90523112e+00, + -7.80574714e-06, -7.26110959e-06, 1.90815645e+00, -8.51101151e-06, -7.93228957e-06, + 1.91154308e+00, -9.31923695e-06, -8.70423695e-06, 1.91543902e+00, -1.02355023e-05, + -9.58296690e-06, 1.91989947e+00, -1.12638348e-05, -1.05737378e-05, 1.92498751e+00, + -1.24066267e-05, -1.16805042e-05, 1.93077470e+00, -1.36639432e-05, -1.29052471e-05, + 1.93734175e+00, -1.50327185e-05, -1.42471649e-05, 1.94477909e+00, -1.65058387e-05, + -1.57017134e-05, 1.95318739e+00, -1.80711222e-05, -1.72594860e-05, 1.96267790e+00, + -1.97102193e-05, -1.89049401e-05, 1.97337263e+00, -2.13974666e-05, -2.06149890e-05, + 1.98540414e+00, -2.30987629e-05, -2.23575069e-05, 1.99891499e+00, -2.47705712e-05, + -2.40898356e-05, 2.01405644e+00, -2.63591004e-05, -2.57574055e-05, 2.03098653e+00, + -2.77998081e-05, -2.72926561e-05, 2.04986708e+00, -2.90173588e-05, -2.86145035e-05, + 2.07085933e+00, -2.99261544e-05, -2.96286612e-05, 2.09411813e+00, -3.04314725e-05, + -3.02291660e-05, 2.11978414e+00, -3.04312097e-05, -3.03014827e-05, 2.14797378e+00, + -2.98180874e-05, -2.97275182e-05, 2.17876671e+00, -2.84818225e-05, -2.83927022e-05, + 2.21219061e+00, -2.63104928e-05, -2.61950012e-05, 2.24820677e+00, -2.31986022e-05, + -2.30543358e-05, 2.28670319e+00, -1.90725475e-05, -1.89229113e-05, 2.32749291e+00, + -1.39203371e-05, -1.37998260e-05, 2.37031812e+00, -7.81741791e-06, -7.74743606e-06, + 2.41485941e+00, -9.24055024e-07, -8.98702879e-07, 2.46074292e+00, 6.56710437e-06, + 6.55919925e-06, 2.50754873e+00, 1.44493712e-05, 1.44052208e-05, 2.55482700e+00, + 2.24713989e-05, 2.23955457e-05, 2.60212169e+00, 3.03549808e-05, 3.02804621e-05, + 2.64899196e+00, 3.78709172e-05, 3.78323546e-05, 2.69502364e+00, 4.48658691e-05, + 4.48671593e-05, 2.73983807e+00, 5.12374727e-05, 5.12536103e-05, 2.78310284e+00, + 5.69080204e-05, 5.69131427e-05, 2.82454395e+00, 6.18294848e-05, 6.18136739e-05, + 2.86395346e+00, 6.59887655e-05, 6.59573619e-05, 2.90118616e+00, 6.94066010e-05, + 6.93721370e-05, 2.93614904e+00, 7.21305458e-05, 7.21073595e-05, 2.96879114e+00, + 7.42277622e-05, 7.42278049e-05, 2.99909461e+00, 7.57786790e-05, 7.58068772e-05, + 3.02706701e+00, 7.68695425e-05, 7.69203851e-05, 3.05273502e+00, 7.75844302e-05, + 7.76424669e-05, 3.07613907e+00, 7.80006012e-05, 7.80432515e-05, 3.09732877e+00, + 7.81861492e-05, 7.81876257e-05, 3.11635910e+00, 7.81989091e-05, 7.81346442e-05, + 3.13328730e+00, 7.80858058e-05, 7.79372529e-05, 3.14817022e+00, 7.78846917e-05, + 7.76425685e-05, 3.16106217e+00, 7.76285942e-05, 7.72925080e-05, 3.17201320e+00, + 7.73474186e-05, 7.69239057e-05, 3.18106789e+00, 7.70681523e-05, 7.65684284e-05, + 3.18826445e+00, 7.68144637e-05, 7.62524779e-05, 3.19363408e+00, 7.66061299e-05, + 7.59971404e-05, 3.19720051e+00, 7.64584910e-05, 7.58181850e-05, 3.19897971e+00, + 7.63820177e-05, 7.57260931e-05 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/frictionH/060K/clean.sh b/drivers/py/pes/friction/frictionH/060K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/frictionH/060K/get1D.sh b/drivers/py/pes/friction/frictionH/060K/get1D.sh new file mode 100755 index 000000000..5cd175503 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/get1D.sh @@ -0,0 +1,6 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 +xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/frictionH/060K/init.xyz b/drivers/py/pes/friction/frictionH/060K/init.xyz new file mode 100644 index 000000000..cf8e637e3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/init.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1448613 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1460477 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1477077 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1498430 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1524556 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1555471 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1591193 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1631742 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1677134 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1727363 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1782411 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1842257 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1906879 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1976222 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2050185 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2128665 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2211559 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2298731 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2389979 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2485087 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2686011 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2791254 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2899215 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3009534 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3121847 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3235746 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3350802 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3466586 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3582672 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3698644 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3814100 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3928638 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4041854 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4153390 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4262942 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4370210 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4474895 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4576725 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4675494 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4771003 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4951464 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5036114 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5116899 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5193718 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5266471 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5335107 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5399597 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5459909 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5516014 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5567903 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5615583 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5659063 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5698349 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5733452 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5764386 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5791165 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5813803 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5832315 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5846716 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5857018 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0000000 0.0000000 diff --git a/drivers/py/pes/friction/frictionH/060K/input.xml b/drivers/py/pes/friction/frictionH/060K/input.xml new file mode 100644 index 000000000..1b68adbe5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/input.xml @@ -0,0 +1,45 @@ + + + [ step, potential{electronvolt}] + extras + extras + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + ['friction'] + + + + 60 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + + z_friction.dat + true + true + none + 0.1 + + + +
diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_00 b/drivers/py/pes/friction/frictionH/060K/inst.fric_00 new file mode 100644 index 000000000..c08d1136a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_00 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 0 + 0.00013194 -0.00003135 -0.00003130 + -0.00003135 0.00013218 -0.00003131 + -0.00003130 -0.00003131 0.00013173 + #*EXTRAS*# Step: 1 Bead: 0 + 0.00013424 -0.00002349 -0.00002325 + -0.00002349 0.00013444 -0.00002337 + -0.00002325 -0.00002337 0.00013439 + #*EXTRAS*# Step: 2 Bead: 0 + 0.00013575 -0.00001519 -0.00001469 + -0.00001519 0.00013585 -0.00001505 + -0.00001469 -0.00001505 0.00013627 + #*EXTRAS*# Step: 3 Bead: 0 + 0.00013715 -0.00000761 -0.00000716 + -0.00000761 0.00013718 -0.00000751 + -0.00000716 -0.00000751 0.00013787 + #*EXTRAS*# Step: 4 Bead: 0 + 0.00013769 -0.00000503 -0.00000467 + -0.00000503 0.00013771 -0.00000495 + -0.00000467 -0.00000495 0.00013846 + #*EXTRAS*# Step: 5 Bead: 0 + 0.00013771 -0.00000496 -0.00000461 + -0.00000496 0.00013772 -0.00000488 + -0.00000461 -0.00000488 0.00013847 + #*EXTRAS*# Step: 6 Bead: 0 + 0.00013784 -0.00000437 -0.00000404 + -0.00000437 0.00013786 -0.00000429 + -0.00000404 -0.00000429 0.00013861 + #*EXTRAS*# Step: 7 Bead: 0 + 0.00013788 -0.00000418 -0.00000387 + -0.00000418 0.00013790 -0.00000411 + -0.00000387 -0.00000411 0.00013866 + #*EXTRAS*# Step: 8 Bead: 0 + 0.00013792 -0.00000402 -0.00000371 + -0.00000402 0.00013793 -0.00000395 + -0.00000371 -0.00000395 0.00013869 + #*EXTRAS*# Step: 9 Bead: 0 + 0.00013794 -0.00000393 -0.00000363 + -0.00000393 0.00013795 -0.00000386 + -0.00000363 -0.00000386 0.00013872 + #*EXTRAS*# Step: 10 Bead: 0 + 0.00013795 -0.00000386 -0.00000357 + -0.00000386 0.00013797 -0.00000380 + -0.00000357 -0.00000380 0.00013873 + #*EXTRAS*# Step: 11 Bead: 0 + 0.00013796 -0.00000383 -0.00000353 + -0.00000383 0.00013798 -0.00000376 + -0.00000353 -0.00000376 0.00013874 + #*EXTRAS*# Step: 12 Bead: 0 + 0.00013797 -0.00000380 -0.00000351 + -0.00000380 0.00013798 -0.00000373 + -0.00000351 -0.00000373 0.00013875 + #*EXTRAS*# Step: 13 Bead: 0 + 0.00013797 -0.00000379 -0.00000350 + -0.00000379 0.00013799 -0.00000372 + -0.00000350 -0.00000372 0.00013875 + #*EXTRAS*# Step: 14 Bead: 0 + 0.00013797 -0.00000378 -0.00000349 + -0.00000378 0.00013799 -0.00000371 + -0.00000349 -0.00000371 0.00013875 + #*EXTRAS*# Step: 15 Bead: 0 + 0.00013797 -0.00000377 -0.00000348 + -0.00000377 0.00013799 -0.00000370 + -0.00000348 -0.00000370 0.00013875 + #*EXTRAS*# Step: 16 Bead: 0 + 0.00013797 -0.00000376 -0.00000348 + -0.00000376 0.00013799 -0.00000370 + -0.00000348 -0.00000370 0.00013875 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_01 b/drivers/py/pes/friction/frictionH/060K/inst.fric_01 new file mode 100644 index 000000000..e9ad4a64a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_01 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 1 + 0.00013190 -0.00003145 -0.00003140 + -0.00003145 0.00013214 -0.00003142 + -0.00003140 -0.00003142 0.00013168 + #*EXTRAS*# Step: 1 Bead: 1 + 0.00013421 -0.00002361 -0.00002337 + -0.00002361 0.00013442 -0.00002349 + -0.00002337 -0.00002349 0.00013436 + #*EXTRAS*# Step: 2 Bead: 1 + 0.00013573 -0.00001531 -0.00001481 + -0.00001531 0.00013583 -0.00001517 + -0.00001481 -0.00001517 0.00013624 + #*EXTRAS*# Step: 3 Bead: 1 + 0.00013713 -0.00000770 -0.00000724 + -0.00000770 0.00013716 -0.00000760 + -0.00000724 -0.00000760 0.00013785 + #*EXTRAS*# Step: 4 Bead: 1 + 0.00013768 -0.00000509 -0.00000473 + -0.00000509 0.00013770 -0.00000500 + -0.00000473 -0.00000500 0.00013844 + #*EXTRAS*# Step: 5 Bead: 1 + 0.00013770 -0.00000501 -0.00000466 + -0.00000501 0.00013771 -0.00000493 + -0.00000466 -0.00000493 0.00013846 + #*EXTRAS*# Step: 6 Bead: 1 + 0.00013783 -0.00000441 -0.00000409 + -0.00000441 0.00013785 -0.00000433 + -0.00000409 -0.00000433 0.00013860 + #*EXTRAS*# Step: 7 Bead: 1 + 0.00013787 -0.00000422 -0.00000391 + -0.00000422 0.00013789 -0.00000415 + -0.00000391 -0.00000415 0.00013865 + #*EXTRAS*# Step: 8 Bead: 1 + 0.00013791 -0.00000406 -0.00000375 + -0.00000406 0.00013793 -0.00000398 + -0.00000375 -0.00000398 0.00013868 + #*EXTRAS*# Step: 9 Bead: 1 + 0.00013793 -0.00000396 -0.00000366 + -0.00000396 0.00013795 -0.00000389 + -0.00000366 -0.00000389 0.00013871 + #*EXTRAS*# Step: 10 Bead: 1 + 0.00013794 -0.00000390 -0.00000361 + -0.00000390 0.00013796 -0.00000383 + -0.00000361 -0.00000383 0.00013872 + #*EXTRAS*# Step: 11 Bead: 1 + 0.00013795 -0.00000386 -0.00000357 + -0.00000386 0.00013797 -0.00000379 + -0.00000357 -0.00000379 0.00013873 + #*EXTRAS*# Step: 12 Bead: 1 + 0.00013796 -0.00000384 -0.00000355 + -0.00000384 0.00013797 -0.00000377 + -0.00000355 -0.00000377 0.00013874 + #*EXTRAS*# Step: 13 Bead: 1 + 0.00013796 -0.00000382 -0.00000353 + -0.00000382 0.00013798 -0.00000375 + -0.00000353 -0.00000375 0.00013874 + #*EXTRAS*# Step: 14 Bead: 1 + 0.00013796 -0.00000381 -0.00000352 + -0.00000381 0.00013798 -0.00000374 + -0.00000352 -0.00000374 0.00013874 + #*EXTRAS*# Step: 15 Bead: 1 + 0.00013797 -0.00000380 -0.00000351 + -0.00000380 0.00013798 -0.00000374 + -0.00000351 -0.00000374 0.00013874 + #*EXTRAS*# Step: 16 Bead: 1 + 0.00013797 -0.00000380 -0.00000351 + -0.00000380 0.00013798 -0.00000373 + -0.00000351 -0.00000373 0.00013875 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_02 b/drivers/py/pes/friction/frictionH/060K/inst.fric_02 new file mode 100644 index 000000000..86a73b0d5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_02 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 2 + 0.00013182 -0.00003163 -0.00003158 + -0.00003163 0.00013207 -0.00003160 + -0.00003158 -0.00003160 0.00013160 + #*EXTRAS*# Step: 1 Bead: 2 + 0.00013417 -0.00002381 -0.00002358 + -0.00002381 0.00013437 -0.00002370 + -0.00002358 -0.00002370 0.00013431 + #*EXTRAS*# Step: 2 Bead: 2 + 0.00013570 -0.00001552 -0.00001502 + -0.00001552 0.00013580 -0.00001538 + -0.00001502 -0.00001538 0.00013620 + #*EXTRAS*# Step: 3 Bead: 2 + 0.00013710 -0.00000787 -0.00000740 + -0.00000787 0.00013713 -0.00000776 + -0.00000740 -0.00000776 0.00013782 + #*EXTRAS*# Step: 4 Bead: 2 + 0.00013765 -0.00000520 -0.00000484 + -0.00000520 0.00013767 -0.00000512 + -0.00000484 -0.00000512 0.00013842 + #*EXTRAS*# Step: 5 Bead: 2 + 0.00013767 -0.00000511 -0.00000475 + -0.00000511 0.00013769 -0.00000503 + -0.00000475 -0.00000503 0.00013844 + #*EXTRAS*# Step: 6 Bead: 2 + 0.00013781 -0.00000450 -0.00000417 + -0.00000450 0.00013783 -0.00000442 + -0.00000417 -0.00000442 0.00013858 + #*EXTRAS*# Step: 7 Bead: 2 + 0.00013785 -0.00000430 -0.00000399 + -0.00000430 0.00013787 -0.00000423 + -0.00000399 -0.00000423 0.00013863 + #*EXTRAS*# Step: 8 Bead: 2 + 0.00013789 -0.00000413 -0.00000382 + -0.00000413 0.00013791 -0.00000406 + -0.00000382 -0.00000406 0.00013867 + #*EXTRAS*# Step: 9 Bead: 2 + 0.00013791 -0.00000404 -0.00000374 + -0.00000404 0.00013793 -0.00000397 + -0.00000374 -0.00000397 0.00013869 + #*EXTRAS*# Step: 10 Bead: 2 + 0.00013793 -0.00000398 -0.00000368 + -0.00000398 0.00013794 -0.00000391 + -0.00000368 -0.00000391 0.00013870 + #*EXTRAS*# Step: 11 Bead: 2 + 0.00013794 -0.00000394 -0.00000364 + -0.00000394 0.00013795 -0.00000387 + -0.00000364 -0.00000387 0.00013871 + #*EXTRAS*# Step: 12 Bead: 2 + 0.00013794 -0.00000391 -0.00000361 + -0.00000391 0.00013796 -0.00000384 + -0.00000361 -0.00000384 0.00013872 + #*EXTRAS*# Step: 13 Bead: 2 + 0.00013795 -0.00000389 -0.00000360 + -0.00000389 0.00013796 -0.00000382 + -0.00000360 -0.00000382 0.00013872 + #*EXTRAS*# Step: 14 Bead: 2 + 0.00013795 -0.00000388 -0.00000359 + -0.00000388 0.00013796 -0.00000381 + -0.00000359 -0.00000381 0.00013873 + #*EXTRAS*# Step: 15 Bead: 2 + 0.00013795 -0.00000388 -0.00000358 + -0.00000388 0.00013797 -0.00000381 + -0.00000358 -0.00000381 0.00013873 + #*EXTRAS*# Step: 16 Bead: 2 + 0.00013795 -0.00000387 -0.00000358 + -0.00000387 0.00013797 -0.00000380 + -0.00000358 -0.00000380 0.00013873 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_03 b/drivers/py/pes/friction/frictionH/060K/inst.fric_03 new file mode 100644 index 000000000..b8fce7c34 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_03 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 3 + 0.00013172 -0.00003187 -0.00003181 + -0.00003187 0.00013196 -0.00003184 + -0.00003181 -0.00003184 0.00013149 + #*EXTRAS*# Step: 1 Bead: 3 + 0.00013411 -0.00002409 -0.00002388 + -0.00002409 0.00013432 -0.00002398 + -0.00002388 -0.00002398 0.00013423 + #*EXTRAS*# Step: 2 Bead: 3 + 0.00013565 -0.00001581 -0.00001532 + -0.00001581 0.00013575 -0.00001567 + -0.00001532 -0.00001567 0.00013614 + #*EXTRAS*# Step: 3 Bead: 3 + 0.00013705 -0.00000810 -0.00000763 + -0.00000810 0.00013708 -0.00000799 + -0.00000763 -0.00000799 0.00013777 + #*EXTRAS*# Step: 4 Bead: 3 + 0.00013762 -0.00000537 -0.00000500 + -0.00000537 0.00013764 -0.00000529 + -0.00000500 -0.00000529 0.00013838 + #*EXTRAS*# Step: 5 Bead: 3 + 0.00013764 -0.00000526 -0.00000489 + -0.00000526 0.00013766 -0.00000518 + -0.00000489 -0.00000518 0.00013840 + #*EXTRAS*# Step: 6 Bead: 3 + 0.00013778 -0.00000463 -0.00000429 + -0.00000463 0.00013780 -0.00000455 + -0.00000429 -0.00000455 0.00013855 + #*EXTRAS*# Step: 7 Bead: 3 + 0.00013782 -0.00000443 -0.00000410 + -0.00000443 0.00013784 -0.00000435 + -0.00000410 -0.00000435 0.00013860 + #*EXTRAS*# Step: 8 Bead: 3 + 0.00013786 -0.00000425 -0.00000394 + -0.00000425 0.00013788 -0.00000418 + -0.00000394 -0.00000418 0.00013864 + #*EXTRAS*# Step: 9 Bead: 3 + 0.00013789 -0.00000415 -0.00000384 + -0.00000415 0.00013790 -0.00000408 + -0.00000384 -0.00000408 0.00013866 + #*EXTRAS*# Step: 10 Bead: 3 + 0.00013790 -0.00000409 -0.00000378 + -0.00000409 0.00013792 -0.00000402 + -0.00000378 -0.00000402 0.00013868 + #*EXTRAS*# Step: 11 Bead: 3 + 0.00013791 -0.00000405 -0.00000374 + -0.00000405 0.00013793 -0.00000398 + -0.00000374 -0.00000398 0.00013869 + #*EXTRAS*# Step: 12 Bead: 3 + 0.00013792 -0.00000402 -0.00000372 + -0.00000402 0.00013793 -0.00000395 + -0.00000372 -0.00000395 0.00013869 + #*EXTRAS*# Step: 13 Bead: 3 + 0.00013792 -0.00000400 -0.00000370 + -0.00000400 0.00013794 -0.00000393 + -0.00000370 -0.00000393 0.00013870 + #*EXTRAS*# Step: 14 Bead: 3 + 0.00013792 -0.00000399 -0.00000369 + -0.00000399 0.00013794 -0.00000392 + -0.00000369 -0.00000392 0.00013870 + #*EXTRAS*# Step: 15 Bead: 3 + 0.00013792 -0.00000398 -0.00000368 + -0.00000398 0.00013794 -0.00000391 + -0.00000368 -0.00000391 0.00013870 + #*EXTRAS*# Step: 16 Bead: 3 + 0.00013793 -0.00000398 -0.00000368 + -0.00000398 0.00013794 -0.00000391 + -0.00000368 -0.00000391 0.00013870 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_04 b/drivers/py/pes/friction/frictionH/060K/inst.fric_04 new file mode 100644 index 000000000..032511633 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_04 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 4 + 0.00013158 -0.00003218 -0.00003211 + -0.00003218 0.00013182 -0.00003215 + -0.00003211 -0.00003215 0.00013134 + #*EXTRAS*# Step: 1 Bead: 4 + 0.00013403 -0.00002446 -0.00002426 + -0.00002446 0.00013424 -0.00002435 + -0.00002426 -0.00002435 0.00013413 + #*EXTRAS*# Step: 2 Bead: 4 + 0.00013558 -0.00001619 -0.00001571 + -0.00001619 0.00013569 -0.00001605 + -0.00001571 -0.00001605 0.00013606 + #*EXTRAS*# Step: 3 Bead: 4 + 0.00013699 -0.00000841 -0.00000793 + -0.00000841 0.00013702 -0.00000830 + -0.00000793 -0.00000830 0.00013770 + #*EXTRAS*# Step: 4 Bead: 4 + 0.00013757 -0.00000560 -0.00000522 + -0.00000560 0.00013759 -0.00000551 + -0.00000522 -0.00000551 0.00013833 + #*EXTRAS*# Step: 5 Bead: 4 + 0.00013760 -0.00000546 -0.00000509 + -0.00000546 0.00013762 -0.00000538 + -0.00000509 -0.00000538 0.00013836 + #*EXTRAS*# Step: 6 Bead: 4 + 0.00013774 -0.00000481 -0.00000446 + -0.00000481 0.00013776 -0.00000473 + -0.00000446 -0.00000473 0.00013851 + #*EXTRAS*# Step: 7 Bead: 4 + 0.00013779 -0.00000460 -0.00000426 + -0.00000460 0.00013780 -0.00000452 + -0.00000426 -0.00000452 0.00013856 + #*EXTRAS*# Step: 8 Bead: 4 + 0.00013783 -0.00000441 -0.00000409 + -0.00000441 0.00013785 -0.00000434 + -0.00000409 -0.00000434 0.00013860 + #*EXTRAS*# Step: 9 Bead: 4 + 0.00013785 -0.00000431 -0.00000399 + -0.00000431 0.00013787 -0.00000423 + -0.00000399 -0.00000423 0.00013863 + #*EXTRAS*# Step: 10 Bead: 4 + 0.00013787 -0.00000424 -0.00000392 + -0.00000424 0.00013788 -0.00000417 + -0.00000392 -0.00000417 0.00013864 + #*EXTRAS*# Step: 11 Bead: 4 + 0.00013788 -0.00000420 -0.00000388 + -0.00000420 0.00013789 -0.00000412 + -0.00000388 -0.00000412 0.00013865 + #*EXTRAS*# Step: 12 Bead: 4 + 0.00013788 -0.00000417 -0.00000386 + -0.00000417 0.00013790 -0.00000410 + -0.00000386 -0.00000410 0.00013866 + #*EXTRAS*# Step: 13 Bead: 4 + 0.00013789 -0.00000415 -0.00000384 + -0.00000415 0.00013790 -0.00000408 + -0.00000384 -0.00000408 0.00013866 + #*EXTRAS*# Step: 14 Bead: 4 + 0.00013789 -0.00000414 -0.00000383 + -0.00000414 0.00013791 -0.00000407 + -0.00000383 -0.00000407 0.00013867 + #*EXTRAS*# Step: 15 Bead: 4 + 0.00013789 -0.00000413 -0.00000382 + -0.00000413 0.00013791 -0.00000406 + -0.00000382 -0.00000406 0.00013867 + #*EXTRAS*# Step: 16 Bead: 4 + 0.00013789 -0.00000413 -0.00000382 + -0.00000413 0.00013791 -0.00000406 + -0.00000382 -0.00000406 0.00013867 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_05 b/drivers/py/pes/friction/frictionH/060K/inst.fric_05 new file mode 100644 index 000000000..fbcf08c6d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_05 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 5 + 0.00013141 -0.00003255 -0.00003248 + -0.00003255 0.00013164 -0.00003253 + -0.00003248 -0.00003253 0.00013115 + #*EXTRAS*# Step: 1 Bead: 5 + 0.00013392 -0.00002491 -0.00002473 + -0.00002491 0.00013414 -0.00002481 + -0.00002473 -0.00002481 0.00013401 + #*EXTRAS*# Step: 2 Bead: 5 + 0.00013550 -0.00001667 -0.00001619 + -0.00001667 0.00013561 -0.00001653 + -0.00001619 -0.00001653 0.00013596 + #*EXTRAS*# Step: 3 Bead: 5 + 0.00013691 -0.00000880 -0.00000831 + -0.00000880 0.00013695 -0.00000869 + -0.00000831 -0.00000869 0.00013761 + #*EXTRAS*# Step: 4 Bead: 5 + 0.00013750 -0.00000589 -0.00000550 + -0.00000589 0.00013752 -0.00000581 + -0.00000550 -0.00000581 0.00013826 + #*EXTRAS*# Step: 5 Bead: 5 + 0.00013754 -0.00000572 -0.00000533 + -0.00000572 0.00013756 -0.00000563 + -0.00000533 -0.00000563 0.00013830 + #*EXTRAS*# Step: 6 Bead: 5 + 0.00013769 -0.00000504 -0.00000468 + -0.00000504 0.00013771 -0.00000495 + -0.00000468 -0.00000495 0.00013846 + #*EXTRAS*# Step: 7 Bead: 5 + 0.00013774 -0.00000481 -0.00000446 + -0.00000481 0.00013776 -0.00000473 + -0.00000446 -0.00000473 0.00013851 + #*EXTRAS*# Step: 8 Bead: 5 + 0.00013778 -0.00000461 -0.00000428 + -0.00000461 0.00013780 -0.00000454 + -0.00000428 -0.00000454 0.00013855 + #*EXTRAS*# Step: 9 Bead: 5 + 0.00013781 -0.00000451 -0.00000418 + -0.00000451 0.00013782 -0.00000443 + -0.00000418 -0.00000443 0.00013858 + #*EXTRAS*# Step: 10 Bead: 5 + 0.00013782 -0.00000443 -0.00000411 + -0.00000443 0.00013784 -0.00000436 + -0.00000411 -0.00000436 0.00013860 + #*EXTRAS*# Step: 11 Bead: 5 + 0.00013783 -0.00000439 -0.00000406 + -0.00000439 0.00013785 -0.00000431 + -0.00000406 -0.00000431 0.00013861 + #*EXTRAS*# Step: 12 Bead: 5 + 0.00013784 -0.00000436 -0.00000404 + -0.00000436 0.00013786 -0.00000428 + -0.00000404 -0.00000428 0.00013861 + #*EXTRAS*# Step: 13 Bead: 5 + 0.00013784 -0.00000434 -0.00000402 + -0.00000434 0.00013786 -0.00000426 + -0.00000402 -0.00000426 0.00013862 + #*EXTRAS*# Step: 14 Bead: 5 + 0.00013785 -0.00000433 -0.00000401 + -0.00000433 0.00013786 -0.00000425 + -0.00000401 -0.00000425 0.00013862 + #*EXTRAS*# Step: 15 Bead: 5 + 0.00013785 -0.00000432 -0.00000400 + -0.00000432 0.00013787 -0.00000425 + -0.00000400 -0.00000425 0.00013862 + #*EXTRAS*# Step: 16 Bead: 5 + 0.00013785 -0.00000431 -0.00000400 + -0.00000431 0.00013787 -0.00000424 + -0.00000400 -0.00000424 0.00013862 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_06 b/drivers/py/pes/friction/frictionH/060K/inst.fric_06 new file mode 100644 index 000000000..d49232d63 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_06 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 6 + 0.00013120 -0.00003298 -0.00003290 + -0.00003298 0.00013143 -0.00003297 + -0.00003290 -0.00003297 0.00013093 + #*EXTRAS*# Step: 1 Bead: 6 + 0.00013380 -0.00002544 -0.00002528 + -0.00002544 0.00013402 -0.00002534 + -0.00002528 -0.00002534 0.00013385 + #*EXTRAS*# Step: 2 Bead: 6 + 0.00013540 -0.00001724 -0.00001678 + -0.00001724 0.00013552 -0.00001710 + -0.00001678 -0.00001710 0.00013584 + #*EXTRAS*# Step: 3 Bead: 6 + 0.00013682 -0.00000928 -0.00000878 + -0.00000928 0.00013686 -0.00000917 + -0.00000878 -0.00000917 0.00013751 + #*EXTRAS*# Step: 4 Bead: 6 + 0.00013743 -0.00000626 -0.00000585 + -0.00000626 0.00013745 -0.00000616 + -0.00000585 -0.00000616 0.00013818 + #*EXTRAS*# Step: 5 Bead: 6 + 0.00013747 -0.00000604 -0.00000563 + -0.00000604 0.00013750 -0.00000595 + -0.00000563 -0.00000595 0.00013823 + #*EXTRAS*# Step: 6 Bead: 6 + 0.00013763 -0.00000531 -0.00000494 + -0.00000531 0.00013765 -0.00000523 + -0.00000494 -0.00000523 0.00013839 + #*EXTRAS*# Step: 7 Bead: 6 + 0.00013768 -0.00000507 -0.00000471 + -0.00000507 0.00013770 -0.00000499 + -0.00000471 -0.00000499 0.00013845 + #*EXTRAS*# Step: 8 Bead: 6 + 0.00013773 -0.00000486 -0.00000452 + -0.00000486 0.00013775 -0.00000478 + -0.00000452 -0.00000478 0.00013850 + #*EXTRAS*# Step: 9 Bead: 6 + 0.00013775 -0.00000475 -0.00000441 + -0.00000475 0.00013777 -0.00000467 + -0.00000441 -0.00000467 0.00013852 + #*EXTRAS*# Step: 10 Bead: 6 + 0.00013777 -0.00000467 -0.00000433 + -0.00000467 0.00013779 -0.00000459 + -0.00000433 -0.00000459 0.00013854 + #*EXTRAS*# Step: 11 Bead: 6 + 0.00013778 -0.00000462 -0.00000429 + -0.00000462 0.00013780 -0.00000454 + -0.00000429 -0.00000454 0.00013855 + #*EXTRAS*# Step: 12 Bead: 6 + 0.00013779 -0.00000459 -0.00000426 + -0.00000459 0.00013781 -0.00000451 + -0.00000426 -0.00000451 0.00013856 + #*EXTRAS*# Step: 13 Bead: 6 + 0.00013779 -0.00000457 -0.00000424 + -0.00000457 0.00013781 -0.00000449 + -0.00000424 -0.00000449 0.00013856 + #*EXTRAS*# Step: 14 Bead: 6 + 0.00013780 -0.00000456 -0.00000423 + -0.00000456 0.00013781 -0.00000448 + -0.00000423 -0.00000448 0.00013857 + #*EXTRAS*# Step: 15 Bead: 6 + 0.00013780 -0.00000455 -0.00000422 + -0.00000455 0.00013782 -0.00000447 + -0.00000422 -0.00000447 0.00013857 + #*EXTRAS*# Step: 16 Bead: 6 + 0.00013780 -0.00000454 -0.00000421 + -0.00000454 0.00013782 -0.00000447 + -0.00000421 -0.00000447 0.00013857 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_07 b/drivers/py/pes/friction/frictionH/060K/inst.fric_07 new file mode 100644 index 000000000..f5cd051a9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_07 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 7 + 0.00013094 -0.00003348 -0.00003337 + -0.00003348 0.00013117 -0.00003348 + -0.00003337 -0.00003348 0.00013066 + #*EXTRAS*# Step: 1 Bead: 7 + 0.00013365 -0.00002606 -0.00002592 + -0.00002606 0.00013387 -0.00002597 + -0.00002592 -0.00002597 0.00013367 + #*EXTRAS*# Step: 2 Bead: 7 + 0.00013528 -0.00001791 -0.00001747 + -0.00001791 0.00013541 -0.00001777 + -0.00001747 -0.00001777 0.00013569 + #*EXTRAS*# Step: 3 Bead: 7 + 0.00013671 -0.00000986 -0.00000935 + -0.00000986 0.00013675 -0.00000974 + -0.00000935 -0.00000974 0.00013739 + #*EXTRAS*# Step: 4 Bead: 7 + 0.00013734 -0.00000669 -0.00000626 + -0.00000669 0.00013736 -0.00000659 + -0.00000626 -0.00000659 0.00013808 + #*EXTRAS*# Step: 5 Bead: 7 + 0.00013739 -0.00000641 -0.00000600 + -0.00000641 0.00013742 -0.00000632 + -0.00000600 -0.00000632 0.00013814 + #*EXTRAS*# Step: 6 Bead: 7 + 0.00013756 -0.00000565 -0.00000526 + -0.00000565 0.00013758 -0.00000556 + -0.00000526 -0.00000556 0.00013832 + #*EXTRAS*# Step: 7 Bead: 7 + 0.00013761 -0.00000538 -0.00000501 + -0.00000538 0.00013763 -0.00000530 + -0.00000501 -0.00000530 0.00013838 + #*EXTRAS*# Step: 8 Bead: 7 + 0.00013766 -0.00000516 -0.00000480 + -0.00000516 0.00013768 -0.00000508 + -0.00000480 -0.00000508 0.00013843 + #*EXTRAS*# Step: 9 Bead: 7 + 0.00013769 -0.00000504 -0.00000468 + -0.00000504 0.00013771 -0.00000496 + -0.00000468 -0.00000496 0.00013846 + #*EXTRAS*# Step: 10 Bead: 7 + 0.00013771 -0.00000495 -0.00000460 + -0.00000495 0.00013773 -0.00000487 + -0.00000460 -0.00000487 0.00013847 + #*EXTRAS*# Step: 11 Bead: 7 + 0.00013772 -0.00000490 -0.00000455 + -0.00000490 0.00013774 -0.00000482 + -0.00000455 -0.00000482 0.00013849 + #*EXTRAS*# Step: 12 Bead: 7 + 0.00013773 -0.00000487 -0.00000452 + -0.00000487 0.00013774 -0.00000479 + -0.00000452 -0.00000479 0.00013849 + #*EXTRAS*# Step: 13 Bead: 7 + 0.00013773 -0.00000485 -0.00000450 + -0.00000485 0.00013775 -0.00000477 + -0.00000450 -0.00000477 0.00013850 + #*EXTRAS*# Step: 14 Bead: 7 + 0.00013773 -0.00000483 -0.00000449 + -0.00000483 0.00013775 -0.00000475 + -0.00000449 -0.00000475 0.00013850 + #*EXTRAS*# Step: 15 Bead: 7 + 0.00013774 -0.00000482 -0.00000448 + -0.00000482 0.00013775 -0.00000474 + -0.00000448 -0.00000474 0.00013851 + #*EXTRAS*# Step: 16 Bead: 7 + 0.00013774 -0.00000482 -0.00000447 + -0.00000482 0.00013776 -0.00000474 + -0.00000447 -0.00000474 0.00013851 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_08 b/drivers/py/pes/friction/frictionH/060K/inst.fric_08 new file mode 100644 index 000000000..7989a9c5b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_08 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 8 + 0.00013065 -0.00003403 -0.00003390 + -0.00003403 0.00013086 -0.00003404 + -0.00003390 -0.00003404 0.00013035 + #*EXTRAS*# Step: 1 Bead: 8 + 0.00013346 -0.00002676 -0.00002665 + -0.00002676 0.00013370 -0.00002668 + -0.00002665 -0.00002668 0.00013346 + #*EXTRAS*# Step: 2 Bead: 8 + 0.00013515 -0.00001868 -0.00001827 + -0.00001868 0.00013529 -0.00001855 + -0.00001827 -0.00001855 0.00013552 + #*EXTRAS*# Step: 3 Bead: 8 + 0.00013658 -0.00001053 -0.00001001 + -0.00001053 0.00013663 -0.00001041 + -0.00001001 -0.00001041 0.00013724 + #*EXTRAS*# Step: 4 Bead: 8 + 0.00013723 -0.00000720 -0.00000676 + -0.00000720 0.00013726 -0.00000710 + -0.00000676 -0.00000710 0.00013796 + #*EXTRAS*# Step: 5 Bead: 8 + 0.00013730 -0.00000686 -0.00000643 + -0.00000686 0.00013733 -0.00000676 + -0.00000643 -0.00000676 0.00013804 + #*EXTRAS*# Step: 6 Bead: 8 + 0.00013747 -0.00000604 -0.00000564 + -0.00000604 0.00013749 -0.00000595 + -0.00000564 -0.00000595 0.00013823 + #*EXTRAS*# Step: 7 Bead: 8 + 0.00013753 -0.00000575 -0.00000536 + -0.00000575 0.00013755 -0.00000566 + -0.00000536 -0.00000566 0.00013829 + #*EXTRAS*# Step: 8 Bead: 8 + 0.00013759 -0.00000551 -0.00000514 + -0.00000551 0.00013761 -0.00000543 + -0.00000514 -0.00000543 0.00013835 + #*EXTRAS*# Step: 9 Bead: 8 + 0.00013761 -0.00000538 -0.00000501 + -0.00000538 0.00013763 -0.00000529 + -0.00000501 -0.00000529 0.00013838 + #*EXTRAS*# Step: 10 Bead: 8 + 0.00013763 -0.00000529 -0.00000492 + -0.00000529 0.00013765 -0.00000520 + -0.00000492 -0.00000520 0.00013840 + #*EXTRAS*# Step: 11 Bead: 8 + 0.00013765 -0.00000523 -0.00000487 + -0.00000523 0.00013767 -0.00000515 + -0.00000487 -0.00000515 0.00013841 + #*EXTRAS*# Step: 12 Bead: 8 + 0.00013765 -0.00000519 -0.00000483 + -0.00000519 0.00013767 -0.00000511 + -0.00000483 -0.00000511 0.00013842 + #*EXTRAS*# Step: 13 Bead: 8 + 0.00013766 -0.00000517 -0.00000481 + -0.00000517 0.00013768 -0.00000509 + -0.00000481 -0.00000509 0.00013842 + #*EXTRAS*# Step: 14 Bead: 8 + 0.00013766 -0.00000516 -0.00000479 + -0.00000516 0.00013768 -0.00000507 + -0.00000479 -0.00000507 0.00013843 + #*EXTRAS*# Step: 15 Bead: 8 + 0.00013767 -0.00000515 -0.00000479 + -0.00000515 0.00013768 -0.00000506 + -0.00000479 -0.00000506 0.00013843 + #*EXTRAS*# Step: 16 Bead: 8 + 0.00013767 -0.00000514 -0.00000478 + -0.00000514 0.00013769 -0.00000506 + -0.00000478 -0.00000506 0.00013843 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_09 b/drivers/py/pes/friction/frictionH/060K/inst.fric_09 new file mode 100644 index 000000000..6176a97e0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_09 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 9 + 0.00013031 -0.00003464 -0.00003447 + -0.00003464 0.00013051 -0.00003465 + -0.00003447 -0.00003465 0.00012999 + #*EXTRAS*# Step: 1 Bead: 9 + 0.00013325 -0.00002755 -0.00002746 + -0.00002755 0.00013349 -0.00002747 + -0.00002746 -0.00002747 0.00013320 + #*EXTRAS*# Step: 2 Bead: 9 + 0.00013499 -0.00001956 -0.00001918 + -0.00001956 0.00013514 -0.00001943 + -0.00001918 -0.00001943 0.00013533 + #*EXTRAS*# Step: 3 Bead: 9 + 0.00013644 -0.00001132 -0.00001079 + -0.00001132 0.00013649 -0.00001119 + -0.00001079 -0.00001119 0.00013708 + #*EXTRAS*# Step: 4 Bead: 9 + 0.00013711 -0.00000780 -0.00000734 + -0.00000780 0.00013714 -0.00000770 + -0.00000734 -0.00000770 0.00013783 + #*EXTRAS*# Step: 5 Bead: 9 + 0.00013719 -0.00000738 -0.00000693 + -0.00000738 0.00013722 -0.00000727 + -0.00000693 -0.00000727 0.00013793 + #*EXTRAS*# Step: 6 Bead: 9 + 0.00013738 -0.00000650 -0.00000608 + -0.00000650 0.00013740 -0.00000640 + -0.00000608 -0.00000640 0.00013812 + #*EXTRAS*# Step: 7 Bead: 9 + 0.00013744 -0.00000618 -0.00000577 + -0.00000618 0.00013747 -0.00000609 + -0.00000577 -0.00000609 0.00013819 + #*EXTRAS*# Step: 8 Bead: 9 + 0.00013750 -0.00000592 -0.00000553 + -0.00000592 0.00013752 -0.00000583 + -0.00000553 -0.00000583 0.00013825 + #*EXTRAS*# Step: 9 Bead: 9 + 0.00013753 -0.00000577 -0.00000538 + -0.00000577 0.00013755 -0.00000569 + -0.00000538 -0.00000569 0.00013829 + #*EXTRAS*# Step: 10 Bead: 9 + 0.00013755 -0.00000568 -0.00000529 + -0.00000568 0.00013757 -0.00000559 + -0.00000529 -0.00000559 0.00013831 + #*EXTRAS*# Step: 11 Bead: 9 + 0.00013756 -0.00000561 -0.00000523 + -0.00000561 0.00013758 -0.00000553 + -0.00000523 -0.00000553 0.00013832 + #*EXTRAS*# Step: 12 Bead: 9 + 0.00013757 -0.00000557 -0.00000519 + -0.00000557 0.00013759 -0.00000549 + -0.00000519 -0.00000549 0.00013833 + #*EXTRAS*# Step: 13 Bead: 9 + 0.00013758 -0.00000555 -0.00000517 + -0.00000555 0.00013760 -0.00000546 + -0.00000517 -0.00000546 0.00013834 + #*EXTRAS*# Step: 14 Bead: 9 + 0.00013758 -0.00000553 -0.00000515 + -0.00000553 0.00013760 -0.00000545 + -0.00000515 -0.00000545 0.00013834 + #*EXTRAS*# Step: 15 Bead: 9 + 0.00013758 -0.00000552 -0.00000514 + -0.00000552 0.00013760 -0.00000544 + -0.00000514 -0.00000544 0.00013834 + #*EXTRAS*# Step: 16 Bead: 9 + 0.00013758 -0.00000552 -0.00000514 + -0.00000552 0.00013761 -0.00000543 + -0.00000514 -0.00000543 0.00013835 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_10 b/drivers/py/pes/friction/frictionH/060K/inst.fric_10 new file mode 100644 index 000000000..167c2ba31 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_10 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 10 + 0.00012992 -0.00003529 -0.00003508 + -0.00003529 0.00013011 -0.00003531 + -0.00003508 -0.00003531 0.00012959 + #*EXTRAS*# Step: 1 Bead: 10 + 0.00013299 -0.00002841 -0.00002834 + -0.00002841 0.00013324 -0.00002834 + -0.00002834 -0.00002834 0.00013290 + #*EXTRAS*# Step: 2 Bead: 10 + 0.00013481 -0.00002056 -0.00002021 + -0.00002056 0.00013498 -0.00002043 + -0.00002021 -0.00002043 0.00013510 + #*EXTRAS*# Step: 3 Bead: 10 + 0.00013627 -0.00001222 -0.00001169 + -0.00001222 0.00013634 -0.00001209 + -0.00001169 -0.00001209 0.00013689 + #*EXTRAS*# Step: 4 Bead: 10 + 0.00013697 -0.00000850 -0.00000801 + -0.00000850 0.00013700 -0.00000838 + -0.00000801 -0.00000838 0.00013768 + #*EXTRAS*# Step: 5 Bead: 10 + 0.00013707 -0.00000797 -0.00000750 + -0.00000797 0.00013711 -0.00000786 + -0.00000750 -0.00000786 0.00013780 + #*EXTRAS*# Step: 6 Bead: 10 + 0.00013727 -0.00000702 -0.00000658 + -0.00000702 0.00013729 -0.00000692 + -0.00000658 -0.00000692 0.00013800 + #*EXTRAS*# Step: 7 Bead: 10 + 0.00013734 -0.00000667 -0.00000625 + -0.00000667 0.00013736 -0.00000658 + -0.00000625 -0.00000658 0.00013808 + #*EXTRAS*# Step: 8 Bead: 10 + 0.00013740 -0.00000639 -0.00000598 + -0.00000639 0.00013742 -0.00000630 + -0.00000598 -0.00000630 0.00013815 + #*EXTRAS*# Step: 9 Bead: 10 + 0.00013743 -0.00000623 -0.00000582 + -0.00000623 0.00013746 -0.00000614 + -0.00000582 -0.00000614 0.00013818 + #*EXTRAS*# Step: 10 Bead: 10 + 0.00013745 -0.00000612 -0.00000572 + -0.00000612 0.00013748 -0.00000603 + -0.00000572 -0.00000603 0.00013821 + #*EXTRAS*# Step: 11 Bead: 10 + 0.00013747 -0.00000606 -0.00000565 + -0.00000606 0.00013749 -0.00000596 + -0.00000565 -0.00000596 0.00013822 + #*EXTRAS*# Step: 12 Bead: 10 + 0.00013748 -0.00000601 -0.00000561 + -0.00000601 0.00013750 -0.00000592 + -0.00000561 -0.00000592 0.00013823 + #*EXTRAS*# Step: 13 Bead: 10 + 0.00013748 -0.00000598 -0.00000558 + -0.00000598 0.00013751 -0.00000589 + -0.00000558 -0.00000589 0.00013824 + #*EXTRAS*# Step: 14 Bead: 10 + 0.00013749 -0.00000597 -0.00000557 + -0.00000597 0.00013751 -0.00000588 + -0.00000557 -0.00000588 0.00013824 + #*EXTRAS*# Step: 15 Bead: 10 + 0.00013749 -0.00000596 -0.00000556 + -0.00000596 0.00013751 -0.00000586 + -0.00000556 -0.00000586 0.00013825 + #*EXTRAS*# Step: 16 Bead: 10 + 0.00013749 -0.00000595 -0.00000555 + -0.00000595 0.00013751 -0.00000586 + -0.00000555 -0.00000586 0.00013825 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_11 b/drivers/py/pes/friction/frictionH/060K/inst.fric_11 new file mode 100644 index 000000000..ed5581bb1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_11 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 11 + 0.00012948 -0.00003598 -0.00003572 + -0.00003598 0.00012966 -0.00003601 + -0.00003572 -0.00003601 0.00012914 + #*EXTRAS*# Step: 1 Bead: 11 + 0.00013269 -0.00002936 -0.00002931 + -0.00002936 0.00013293 -0.00002930 + -0.00002931 -0.00002930 0.00013256 + #*EXTRAS*# Step: 2 Bead: 11 + 0.00013460 -0.00002166 -0.00002136 + -0.00002166 0.00013478 -0.00002154 + -0.00002136 -0.00002154 0.00013484 + #*EXTRAS*# Step: 3 Bead: 11 + 0.00013609 -0.00001325 -0.00001273 + -0.00001325 0.00013616 -0.00001312 + -0.00001273 -0.00001312 0.00013667 + #*EXTRAS*# Step: 4 Bead: 11 + 0.00013682 -0.00000929 -0.00000879 + -0.00000929 0.00013686 -0.00000917 + -0.00000879 -0.00000917 0.00013751 + #*EXTRAS*# Step: 5 Bead: 11 + 0.00013694 -0.00000865 -0.00000816 + -0.00000865 0.00013698 -0.00000854 + -0.00000816 -0.00000854 0.00013765 + #*EXTRAS*# Step: 6 Bead: 11 + 0.00013714 -0.00000762 -0.00000717 + -0.00000762 0.00013717 -0.00000752 + -0.00000717 -0.00000752 0.00013787 + #*EXTRAS*# Step: 7 Bead: 11 + 0.00013722 -0.00000724 -0.00000679 + -0.00000724 0.00013725 -0.00000714 + -0.00000679 -0.00000714 0.00013796 + #*EXTRAS*# Step: 8 Bead: 11 + 0.00013729 -0.00000693 -0.00000649 + -0.00000693 0.00013731 -0.00000683 + -0.00000649 -0.00000683 0.00013803 + #*EXTRAS*# Step: 9 Bead: 11 + 0.00013732 -0.00000675 -0.00000632 + -0.00000675 0.00013735 -0.00000665 + -0.00000632 -0.00000665 0.00013807 + #*EXTRAS*# Step: 10 Bead: 11 + 0.00013735 -0.00000663 -0.00000621 + -0.00000663 0.00013737 -0.00000654 + -0.00000621 -0.00000654 0.00013809 + #*EXTRAS*# Step: 11 Bead: 11 + 0.00013736 -0.00000656 -0.00000614 + -0.00000656 0.00013739 -0.00000646 + -0.00000614 -0.00000646 0.00013811 + #*EXTRAS*# Step: 12 Bead: 11 + 0.00013737 -0.00000651 -0.00000609 + -0.00000651 0.00013740 -0.00000642 + -0.00000609 -0.00000642 0.00013812 + #*EXTRAS*# Step: 13 Bead: 11 + 0.00013738 -0.00000648 -0.00000606 + -0.00000648 0.00013740 -0.00000639 + -0.00000606 -0.00000639 0.00013813 + #*EXTRAS*# Step: 14 Bead: 11 + 0.00013738 -0.00000646 -0.00000604 + -0.00000646 0.00013741 -0.00000637 + -0.00000604 -0.00000637 0.00013813 + #*EXTRAS*# Step: 15 Bead: 11 + 0.00013739 -0.00000645 -0.00000603 + -0.00000645 0.00013741 -0.00000635 + -0.00000603 -0.00000635 0.00013813 + #*EXTRAS*# Step: 16 Bead: 11 + 0.00013739 -0.00000644 -0.00000602 + -0.00000644 0.00013741 -0.00000635 + -0.00000602 -0.00000635 0.00013814 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_12 b/drivers/py/pes/friction/frictionH/060K/inst.fric_12 new file mode 100644 index 000000000..b4f3a7a94 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_12 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 12 + 0.00012899 -0.00003670 -0.00003639 + -0.00003670 0.00012915 -0.00003675 + -0.00003639 -0.00003675 0.00012865 + #*EXTRAS*# Step: 1 Bead: 12 + 0.00013232 -0.00003038 -0.00003033 + -0.00003038 0.00013257 -0.00003033 + -0.00003033 -0.00003033 0.00013215 + #*EXTRAS*# Step: 2 Bead: 12 + 0.00013436 -0.00002288 -0.00002262 + -0.00002288 0.00013456 -0.00002277 + -0.00002262 -0.00002277 0.00013454 + #*EXTRAS*# Step: 3 Bead: 12 + 0.00013589 -0.00001442 -0.00001391 + -0.00001442 0.00013597 -0.00001428 + -0.00001391 -0.00001428 0.00013643 + #*EXTRAS*# Step: 4 Bead: 12 + 0.00013664 -0.00001020 -0.00000968 + -0.00001020 0.00013669 -0.00001007 + -0.00000968 -0.00001007 0.00013731 + #*EXTRAS*# Step: 5 Bead: 12 + 0.00013679 -0.00000942 -0.00000891 + -0.00000942 0.00013683 -0.00000930 + -0.00000891 -0.00000930 0.00013748 + #*EXTRAS*# Step: 6 Bead: 12 + 0.00013701 -0.00000831 -0.00000783 + -0.00000831 0.00013704 -0.00000820 + -0.00000783 -0.00000820 0.00013772 + #*EXTRAS*# Step: 7 Bead: 12 + 0.00013709 -0.00000788 -0.00000741 + -0.00000788 0.00013712 -0.00000777 + -0.00000741 -0.00000777 0.00013782 + #*EXTRAS*# Step: 8 Bead: 12 + 0.00013716 -0.00000754 -0.00000708 + -0.00000754 0.00013719 -0.00000744 + -0.00000708 -0.00000744 0.00013789 + #*EXTRAS*# Step: 9 Bead: 12 + 0.00013720 -0.00000734 -0.00000689 + -0.00000734 0.00013723 -0.00000724 + -0.00000689 -0.00000724 0.00013793 + #*EXTRAS*# Step: 10 Bead: 12 + 0.00013723 -0.00000721 -0.00000677 + -0.00000721 0.00013725 -0.00000711 + -0.00000677 -0.00000711 0.00013796 + #*EXTRAS*# Step: 11 Bead: 12 + 0.00013724 -0.00000713 -0.00000669 + -0.00000713 0.00013727 -0.00000703 + -0.00000669 -0.00000703 0.00013798 + #*EXTRAS*# Step: 12 Bead: 12 + 0.00013726 -0.00000708 -0.00000664 + -0.00000708 0.00013728 -0.00000698 + -0.00000664 -0.00000698 0.00013799 + #*EXTRAS*# Step: 13 Bead: 12 + 0.00013726 -0.00000705 -0.00000661 + -0.00000705 0.00013729 -0.00000695 + -0.00000661 -0.00000695 0.00013800 + #*EXTRAS*# Step: 14 Bead: 12 + 0.00013727 -0.00000703 -0.00000659 + -0.00000703 0.00013729 -0.00000693 + -0.00000659 -0.00000693 0.00013800 + #*EXTRAS*# Step: 15 Bead: 12 + 0.00013727 -0.00000701 -0.00000657 + -0.00000701 0.00013730 -0.00000691 + -0.00000657 -0.00000691 0.00013801 + #*EXTRAS*# Step: 16 Bead: 12 + 0.00013727 -0.00000700 -0.00000656 + -0.00000700 0.00013730 -0.00000690 + -0.00000656 -0.00000690 0.00013801 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_13 b/drivers/py/pes/friction/frictionH/060K/inst.fric_13 new file mode 100644 index 000000000..372da34cb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_13 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 13 + 0.00012846 -0.00003745 -0.00003707 + -0.00003745 0.00012860 -0.00003750 + -0.00003707 -0.00003750 0.00012811 + #*EXTRAS*# Step: 1 Bead: 13 + 0.00013189 -0.00003147 -0.00003142 + -0.00003147 0.00013213 -0.00003144 + -0.00003142 -0.00003144 0.00013167 + #*EXTRAS*# Step: 2 Bead: 13 + 0.00013408 -0.00002422 -0.00002401 + -0.00002422 0.00013429 -0.00002411 + -0.00002401 -0.00002411 0.00013420 + #*EXTRAS*# Step: 3 Bead: 13 + 0.00013566 -0.00001573 -0.00001524 + -0.00001573 0.00013576 -0.00001559 + -0.00001524 -0.00001559 0.00013616 + #*EXTRAS*# Step: 4 Bead: 13 + 0.00013645 -0.00001122 -0.00001070 + -0.00001122 0.00013651 -0.00001110 + -0.00001070 -0.00001110 0.00013710 + #*EXTRAS*# Step: 5 Bead: 13 + 0.00013663 -0.00001028 -0.00000977 + -0.00001028 0.00013667 -0.00001016 + -0.00000977 -0.00001016 0.00013730 + #*EXTRAS*# Step: 6 Bead: 13 + 0.00013686 -0.00000908 -0.00000858 + -0.00000908 0.00013690 -0.00000896 + -0.00000858 -0.00000896 0.00013755 + #*EXTRAS*# Step: 7 Bead: 13 + 0.00013695 -0.00000860 -0.00000811 + -0.00000860 0.00013699 -0.00000849 + -0.00000811 -0.00000849 0.00013766 + #*EXTRAS*# Step: 8 Bead: 13 + 0.00013702 -0.00000823 -0.00000775 + -0.00000823 0.00013706 -0.00000812 + -0.00000775 -0.00000812 0.00013774 + #*EXTRAS*# Step: 9 Bead: 13 + 0.00013707 -0.00000801 -0.00000754 + -0.00000801 0.00013710 -0.00000790 + -0.00000754 -0.00000790 0.00013779 + #*EXTRAS*# Step: 10 Bead: 13 + 0.00013709 -0.00000787 -0.00000740 + -0.00000787 0.00013713 -0.00000776 + -0.00000740 -0.00000776 0.00013782 + #*EXTRAS*# Step: 11 Bead: 13 + 0.00013711 -0.00000778 -0.00000732 + -0.00000778 0.00013714 -0.00000767 + -0.00000732 -0.00000767 0.00013784 + #*EXTRAS*# Step: 12 Bead: 13 + 0.00013712 -0.00000772 -0.00000726 + -0.00000772 0.00013715 -0.00000762 + -0.00000726 -0.00000762 0.00013785 + #*EXTRAS*# Step: 13 Bead: 13 + 0.00013713 -0.00000769 -0.00000722 + -0.00000769 0.00013716 -0.00000758 + -0.00000722 -0.00000758 0.00013786 + #*EXTRAS*# Step: 14 Bead: 13 + 0.00013714 -0.00000766 -0.00000720 + -0.00000766 0.00013717 -0.00000756 + -0.00000720 -0.00000756 0.00013786 + #*EXTRAS*# Step: 15 Bead: 13 + 0.00013714 -0.00000765 -0.00000719 + -0.00000765 0.00013717 -0.00000754 + -0.00000719 -0.00000754 0.00013787 + #*EXTRAS*# Step: 16 Bead: 13 + 0.00013714 -0.00000764 -0.00000718 + -0.00000764 0.00013717 -0.00000753 + -0.00000718 -0.00000753 0.00013787 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_14 b/drivers/py/pes/friction/frictionH/060K/inst.fric_14 new file mode 100644 index 000000000..c2717e151 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_14 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 14 + 0.00012788 -0.00003821 -0.00003777 + -0.00003821 0.00012800 -0.00003827 + -0.00003777 -0.00003827 0.00012753 + #*EXTRAS*# Step: 1 Bead: 14 + 0.00013137 -0.00003262 -0.00003255 + -0.00003262 0.00013161 -0.00003261 + -0.00003255 -0.00003261 0.00013111 + #*EXTRAS*# Step: 2 Bead: 14 + 0.00013374 -0.00002566 -0.00002551 + -0.00002566 0.00013397 -0.00002556 + -0.00002551 -0.00002556 0.00013379 + #*EXTRAS*# Step: 3 Bead: 14 + 0.00013541 -0.00001719 -0.00001673 + -0.00001719 0.00013553 -0.00001705 + -0.00001673 -0.00001705 0.00013585 + #*EXTRAS*# Step: 4 Bead: 14 + 0.00013624 -0.00001238 -0.00001185 + -0.00001238 0.00013631 -0.00001225 + -0.00001185 -0.00001225 0.00013685 + #*EXTRAS*# Step: 5 Bead: 14 + 0.00013645 -0.00001126 -0.00001073 + -0.00001126 0.00013650 -0.00001113 + -0.00001073 -0.00001113 0.00013709 + #*EXTRAS*# Step: 6 Bead: 14 + 0.00013669 -0.00000994 -0.00000943 + -0.00000994 0.00013674 -0.00000982 + -0.00000943 -0.00000982 0.00013737 + #*EXTRAS*# Step: 7 Bead: 14 + 0.00013679 -0.00000941 -0.00000891 + -0.00000941 0.00013683 -0.00000929 + -0.00000891 -0.00000929 0.00013748 + #*EXTRAS*# Step: 8 Bead: 14 + 0.00013687 -0.00000900 -0.00000851 + -0.00000900 0.00013691 -0.00000889 + -0.00000851 -0.00000889 0.00013757 + #*EXTRAS*# Step: 9 Bead: 14 + 0.00013692 -0.00000877 -0.00000828 + -0.00000877 0.00013695 -0.00000865 + -0.00000828 -0.00000865 0.00013762 + #*EXTRAS*# Step: 10 Bead: 14 + 0.00013695 -0.00000861 -0.00000812 + -0.00000861 0.00013698 -0.00000850 + -0.00000812 -0.00000850 0.00013766 + #*EXTRAS*# Step: 11 Bead: 14 + 0.00013697 -0.00000851 -0.00000803 + -0.00000851 0.00013700 -0.00000840 + -0.00000803 -0.00000840 0.00013768 + #*EXTRAS*# Step: 12 Bead: 14 + 0.00013698 -0.00000845 -0.00000796 + -0.00000845 0.00013701 -0.00000834 + -0.00000796 -0.00000834 0.00013769 + #*EXTRAS*# Step: 13 Bead: 14 + 0.00013699 -0.00000841 -0.00000792 + -0.00000841 0.00013702 -0.00000830 + -0.00000792 -0.00000830 0.00013770 + #*EXTRAS*# Step: 14 Bead: 14 + 0.00013699 -0.00000838 -0.00000790 + -0.00000838 0.00013703 -0.00000827 + -0.00000790 -0.00000827 0.00013771 + #*EXTRAS*# Step: 15 Bead: 14 + 0.00013700 -0.00000836 -0.00000788 + -0.00000836 0.00013703 -0.00000825 + -0.00000788 -0.00000825 0.00013771 + #*EXTRAS*# Step: 16 Bead: 14 + 0.00013700 -0.00000835 -0.00000787 + -0.00000835 0.00013703 -0.00000824 + -0.00000787 -0.00000824 0.00013771 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_15 b/drivers/py/pes/friction/frictionH/060K/inst.fric_15 new file mode 100644 index 000000000..15af13159 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_15 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 15 + 0.00012726 -0.00003897 -0.00003848 + -0.00003897 0.00012736 -0.00003904 + -0.00003848 -0.00003904 0.00012691 + #*EXTRAS*# Step: 1 Bead: 15 + 0.00013076 -0.00003384 -0.00003371 + -0.00003384 0.00013097 -0.00003383 + -0.00003371 -0.00003383 0.00013046 + #*EXTRAS*# Step: 2 Bead: 15 + 0.00013334 -0.00002721 -0.00002711 + -0.00002721 0.00013358 -0.00002712 + -0.00002711 -0.00002712 0.00013331 + #*EXTRAS*# Step: 3 Bead: 15 + 0.00013513 -0.00001880 -0.00001839 + -0.00001880 0.00013527 -0.00001867 + -0.00001839 -0.00001867 0.00013550 + #*EXTRAS*# Step: 4 Bead: 15 + 0.00013601 -0.00001368 -0.00001316 + -0.00001368 0.00013609 -0.00001354 + -0.00001316 -0.00001354 0.00013658 + #*EXTRAS*# Step: 5 Bead: 15 + 0.00013625 -0.00001234 -0.00001181 + -0.00001234 0.00013632 -0.00001221 + -0.00001181 -0.00001221 0.00013686 + #*EXTRAS*# Step: 6 Bead: 15 + 0.00013651 -0.00001091 -0.00001039 + -0.00001091 0.00013656 -0.00001079 + -0.00001039 -0.00001079 0.00013716 + #*EXTRAS*# Step: 7 Bead: 15 + 0.00013662 -0.00001032 -0.00000980 + -0.00001032 0.00013667 -0.00001020 + -0.00000980 -0.00001020 0.00013729 + #*EXTRAS*# Step: 8 Bead: 15 + 0.00013670 -0.00000987 -0.00000936 + -0.00000987 0.00013675 -0.00000975 + -0.00000936 -0.00000975 0.00013738 + #*EXTRAS*# Step: 9 Bead: 15 + 0.00013675 -0.00000961 -0.00000911 + -0.00000961 0.00013680 -0.00000949 + -0.00000911 -0.00000949 0.00013744 + #*EXTRAS*# Step: 10 Bead: 15 + 0.00013679 -0.00000944 -0.00000893 + -0.00000944 0.00013683 -0.00000932 + -0.00000893 -0.00000932 0.00013748 + #*EXTRAS*# Step: 11 Bead: 15 + 0.00013681 -0.00000933 -0.00000883 + -0.00000933 0.00013685 -0.00000921 + -0.00000883 -0.00000921 0.00013750 + #*EXTRAS*# Step: 12 Bead: 15 + 0.00013682 -0.00000926 -0.00000876 + -0.00000926 0.00013686 -0.00000914 + -0.00000876 -0.00000914 0.00013752 + #*EXTRAS*# Step: 13 Bead: 15 + 0.00013683 -0.00000921 -0.00000871 + -0.00000921 0.00013687 -0.00000910 + -0.00000871 -0.00000910 0.00013753 + #*EXTRAS*# Step: 14 Bead: 15 + 0.00013684 -0.00000918 -0.00000869 + -0.00000918 0.00013688 -0.00000907 + -0.00000869 -0.00000907 0.00013753 + #*EXTRAS*# Step: 15 Bead: 15 + 0.00013684 -0.00000917 -0.00000867 + -0.00000917 0.00013688 -0.00000905 + -0.00000867 -0.00000905 0.00013754 + #*EXTRAS*# Step: 16 Bead: 15 + 0.00013684 -0.00000915 -0.00000866 + -0.00000915 0.00013688 -0.00000904 + -0.00000866 -0.00000904 0.00013754 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_16 b/drivers/py/pes/friction/frictionH/060K/inst.fric_16 new file mode 100644 index 000000000..0f2a9344b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_16 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 16 + 0.00012661 -0.00003971 -0.00003918 + -0.00003971 0.00012670 -0.00003980 + -0.00003918 -0.00003980 0.00012627 + #*EXTRAS*# Step: 1 Bead: 16 + 0.00013004 -0.00003508 -0.00003488 + -0.00003508 0.00013024 -0.00003510 + -0.00003488 -0.00003510 0.00012972 + #*EXTRAS*# Step: 2 Bead: 16 + 0.00013285 -0.00002885 -0.00002879 + -0.00002885 0.00013310 -0.00002878 + -0.00002879 -0.00002878 0.00013275 + #*EXTRAS*# Step: 3 Bead: 16 + 0.00013481 -0.00002057 -0.00002022 + -0.00002057 0.00013497 -0.00002044 + -0.00002022 -0.00002044 0.00013510 + #*EXTRAS*# Step: 4 Bead: 16 + 0.00013576 -0.00001513 -0.00001462 + -0.00001513 0.00013586 -0.00001499 + -0.00001462 -0.00001499 0.00013628 + #*EXTRAS*# Step: 5 Bead: 16 + 0.00013604 -0.00001355 -0.00001303 + -0.00001355 0.00013612 -0.00001342 + -0.00001303 -0.00001342 0.00013661 + #*EXTRAS*# Step: 6 Bead: 16 + 0.00013631 -0.00001200 -0.00001147 + -0.00001200 0.00013638 -0.00001186 + -0.00001147 -0.00001186 0.00013694 + #*EXTRAS*# Step: 7 Bead: 16 + 0.00013643 -0.00001134 -0.00001081 + -0.00001134 0.00013649 -0.00001121 + -0.00001081 -0.00001121 0.00013707 + #*EXTRAS*# Step: 8 Bead: 16 + 0.00013652 -0.00001085 -0.00001032 + -0.00001085 0.00013657 -0.00001072 + -0.00001032 -0.00001072 0.00013718 + #*EXTRAS*# Step: 9 Bead: 16 + 0.00013658 -0.00001056 -0.00001004 + -0.00001056 0.00013663 -0.00001043 + -0.00001004 -0.00001043 0.00013724 + #*EXTRAS*# Step: 10 Bead: 16 + 0.00013661 -0.00001036 -0.00000985 + -0.00001036 0.00013666 -0.00001024 + -0.00000985 -0.00001024 0.00013728 + #*EXTRAS*# Step: 11 Bead: 16 + 0.00013663 -0.00001024 -0.00000973 + -0.00001024 0.00013668 -0.00001012 + -0.00000973 -0.00001012 0.00013730 + #*EXTRAS*# Step: 12 Bead: 16 + 0.00013665 -0.00001017 -0.00000965 + -0.00001017 0.00013670 -0.00001004 + -0.00000965 -0.00001004 0.00013732 + #*EXTRAS*# Step: 13 Bead: 16 + 0.00013666 -0.00001012 -0.00000960 + -0.00001012 0.00013670 -0.00001000 + -0.00000960 -0.00001000 0.00013733 + #*EXTRAS*# Step: 14 Bead: 16 + 0.00013666 -0.00001009 -0.00000957 + -0.00001009 0.00013671 -0.00000996 + -0.00000957 -0.00000996 0.00013734 + #*EXTRAS*# Step: 15 Bead: 16 + 0.00013667 -0.00001007 -0.00000955 + -0.00001007 0.00013671 -0.00000994 + -0.00000955 -0.00000994 0.00013734 + #*EXTRAS*# Step: 16 Bead: 16 + 0.00013667 -0.00001005 -0.00000954 + -0.00001005 0.00013672 -0.00000993 + -0.00000954 -0.00000993 0.00013735 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_17 b/drivers/py/pes/friction/frictionH/060K/inst.fric_17 new file mode 100644 index 000000000..72a93a760 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_17 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 17 + 0.00012594 -0.00004043 -0.00003988 + -0.00004043 0.00012601 -0.00004052 + -0.00003988 -0.00004052 0.00012562 + #*EXTRAS*# Step: 1 Bead: 17 + 0.00012923 -0.00003635 -0.00003606 + -0.00003635 0.00012940 -0.00003639 + -0.00003606 -0.00003639 0.00012889 + #*EXTRAS*# Step: 2 Bead: 17 + 0.00013225 -0.00003057 -0.00003053 + -0.00003057 0.00013250 -0.00003052 + -0.00003053 -0.00003052 0.00013207 + #*EXTRAS*# Step: 3 Bead: 17 + 0.00013444 -0.00002249 -0.00002221 + -0.00002249 0.00013463 -0.00002237 + -0.00002221 -0.00002237 0.00013464 + #*EXTRAS*# Step: 4 Bead: 17 + 0.00013549 -0.00001673 -0.00001626 + -0.00001673 0.00013560 -0.00001659 + -0.00001626 -0.00001659 0.00013594 + #*EXTRAS*# Step: 5 Bead: 17 + 0.00013580 -0.00001489 -0.00001438 + -0.00001489 0.00013590 -0.00001475 + -0.00001438 -0.00001475 0.00013633 + #*EXTRAS*# Step: 6 Bead: 17 + 0.00013610 -0.00001320 -0.00001267 + -0.00001320 0.00013617 -0.00001306 + -0.00001267 -0.00001306 0.00013668 + #*EXTRAS*# Step: 7 Bead: 17 + 0.00013623 -0.00001247 -0.00001194 + -0.00001247 0.00013630 -0.00001233 + -0.00001194 -0.00001233 0.00013684 + #*EXTRAS*# Step: 8 Bead: 17 + 0.00013632 -0.00001193 -0.00001140 + -0.00001193 0.00013639 -0.00001180 + -0.00001140 -0.00001180 0.00013695 + #*EXTRAS*# Step: 9 Bead: 17 + 0.00013638 -0.00001161 -0.00001108 + -0.00001161 0.00013644 -0.00001148 + -0.00001108 -0.00001148 0.00013702 + #*EXTRAS*# Step: 10 Bead: 17 + 0.00013642 -0.00001140 -0.00001087 + -0.00001140 0.00013648 -0.00001127 + -0.00001087 -0.00001127 0.00013706 + #*EXTRAS*# Step: 11 Bead: 17 + 0.00013645 -0.00001126 -0.00001074 + -0.00001126 0.00013650 -0.00001114 + -0.00001074 -0.00001114 0.00013709 + #*EXTRAS*# Step: 12 Bead: 17 + 0.00013646 -0.00001118 -0.00001065 + -0.00001118 0.00013652 -0.00001105 + -0.00001065 -0.00001105 0.00013711 + #*EXTRAS*# Step: 13 Bead: 17 + 0.00013647 -0.00001112 -0.00001060 + -0.00001112 0.00013653 -0.00001100 + -0.00001060 -0.00001100 0.00013712 + #*EXTRAS*# Step: 14 Bead: 17 + 0.00013648 -0.00001109 -0.00001057 + -0.00001109 0.00013653 -0.00001096 + -0.00001057 -0.00001096 0.00013713 + #*EXTRAS*# Step: 15 Bead: 17 + 0.00013648 -0.00001107 -0.00001054 + -0.00001107 0.00013654 -0.00001094 + -0.00001054 -0.00001094 0.00013713 + #*EXTRAS*# Step: 16 Bead: 17 + 0.00013648 -0.00001105 -0.00001053 + -0.00001105 0.00013654 -0.00001093 + -0.00001053 -0.00001093 0.00013713 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_18 b/drivers/py/pes/friction/frictionH/060K/inst.fric_18 new file mode 100644 index 000000000..a3f684fc7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_18 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 18 + 0.00012526 -0.00004110 -0.00004055 + -0.00004110 0.00012533 -0.00004120 + -0.00004055 -0.00004120 0.00012496 + #*EXTRAS*# Step: 1 Bead: 18 + 0.00012834 -0.00003761 -0.00003722 + -0.00003761 0.00012848 -0.00003767 + -0.00003722 -0.00003767 0.00012799 + #*EXTRAS*# Step: 2 Bead: 18 + 0.00013150 -0.00003236 -0.00003229 + -0.00003236 0.00013173 -0.00003234 + -0.00003229 -0.00003234 0.00013125 + #*EXTRAS*# Step: 3 Bead: 18 + 0.00013401 -0.00002455 -0.00002435 + -0.00002455 0.00013422 -0.00002444 + -0.00002435 -0.00002444 0.00013411 + #*EXTRAS*# Step: 4 Bead: 18 + 0.00013518 -0.00001850 -0.00001808 + -0.00001850 0.00013532 -0.00001837 + -0.00001808 -0.00001837 0.00013556 + #*EXTRAS*# Step: 5 Bead: 18 + 0.00013555 -0.00001636 -0.00001588 + -0.00001636 0.00013566 -0.00001623 + -0.00001588 -0.00001623 0.00013602 + #*EXTRAS*# Step: 6 Bead: 18 + 0.00013587 -0.00001453 -0.00001401 + -0.00001453 0.00013596 -0.00001439 + -0.00001401 -0.00001439 0.00013641 + #*EXTRAS*# Step: 7 Bead: 18 + 0.00013601 -0.00001372 -0.00001320 + -0.00001372 0.00013609 -0.00001358 + -0.00001320 -0.00001358 0.00013658 + #*EXTRAS*# Step: 8 Bead: 18 + 0.00013611 -0.00001313 -0.00001260 + -0.00001313 0.00013619 -0.00001299 + -0.00001260 -0.00001299 0.00013670 + #*EXTRAS*# Step: 9 Bead: 18 + 0.00013617 -0.00001277 -0.00001225 + -0.00001277 0.00013624 -0.00001264 + -0.00001225 -0.00001264 0.00013677 + #*EXTRAS*# Step: 10 Bead: 18 + 0.00013622 -0.00001254 -0.00001201 + -0.00001254 0.00013628 -0.00001241 + -0.00001201 -0.00001241 0.00013682 + #*EXTRAS*# Step: 11 Bead: 18 + 0.00013624 -0.00001240 -0.00001187 + -0.00001240 0.00013631 -0.00001226 + -0.00001187 -0.00001226 0.00013685 + #*EXTRAS*# Step: 12 Bead: 18 + 0.00013626 -0.00001230 -0.00001177 + -0.00001230 0.00013632 -0.00001217 + -0.00001177 -0.00001217 0.00013687 + #*EXTRAS*# Step: 13 Bead: 18 + 0.00013627 -0.00001224 -0.00001171 + -0.00001224 0.00013633 -0.00001211 + -0.00001171 -0.00001211 0.00013688 + #*EXTRAS*# Step: 14 Bead: 18 + 0.00013628 -0.00001220 -0.00001168 + -0.00001220 0.00013634 -0.00001207 + -0.00001168 -0.00001207 0.00013689 + #*EXTRAS*# Step: 15 Bead: 18 + 0.00013628 -0.00001218 -0.00001165 + -0.00001218 0.00013634 -0.00001205 + -0.00001165 -0.00001205 0.00013690 + #*EXTRAS*# Step: 16 Bead: 18 + 0.00013628 -0.00001216 -0.00001163 + -0.00001216 0.00013635 -0.00001203 + -0.00001163 -0.00001203 0.00013690 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_19 b/drivers/py/pes/friction/frictionH/060K/inst.fric_19 new file mode 100644 index 000000000..8c8abd912 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_19 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 19 + 0.00012460 -0.00004170 -0.00004120 + -0.00004170 0.00012466 -0.00004181 + -0.00004120 -0.00004181 0.00012432 + #*EXTRAS*# Step: 1 Bead: 19 + 0.00012738 -0.00003883 -0.00003835 + -0.00003883 0.00012748 -0.00003890 + -0.00003835 -0.00003890 0.00012703 + #*EXTRAS*# Step: 2 Bead: 19 + 0.00013056 -0.00003419 -0.00003404 + -0.00003419 0.00013078 -0.00003419 + -0.00003404 -0.00003419 0.00013026 + #*EXTRAS*# Step: 3 Bead: 19 + 0.00013347 -0.00002673 -0.00002662 + -0.00002673 0.00013371 -0.00002664 + -0.00002662 -0.00002664 0.00013347 + #*EXTRAS*# Step: 4 Bead: 19 + 0.00013483 -0.00002044 -0.00002008 + -0.00002044 0.00013500 -0.00002031 + -0.00002008 -0.00002031 0.00013513 + #*EXTRAS*# Step: 5 Bead: 19 + 0.00013527 -0.00001798 -0.00001754 + -0.00001798 0.00013540 -0.00001784 + -0.00001754 -0.00001784 0.00013568 + #*EXTRAS*# Step: 6 Bead: 19 + 0.00013562 -0.00001599 -0.00001550 + -0.00001599 0.00013572 -0.00001585 + -0.00001550 -0.00001585 0.00013610 + #*EXTRAS*# Step: 7 Bead: 19 + 0.00013577 -0.00001509 -0.00001459 + -0.00001509 0.00013586 -0.00001496 + -0.00001459 -0.00001496 0.00013629 + #*EXTRAS*# Step: 8 Bead: 19 + 0.00013588 -0.00001445 -0.00001394 + -0.00001445 0.00013597 -0.00001431 + -0.00001394 -0.00001431 0.00013642 + #*EXTRAS*# Step: 9 Bead: 19 + 0.00013595 -0.00001406 -0.00001354 + -0.00001406 0.00013603 -0.00001392 + -0.00001354 -0.00001392 0.00013650 + #*EXTRAS*# Step: 10 Bead: 19 + 0.00013599 -0.00001381 -0.00001329 + -0.00001381 0.00013607 -0.00001367 + -0.00001329 -0.00001367 0.00013656 + #*EXTRAS*# Step: 11 Bead: 19 + 0.00013602 -0.00001365 -0.00001312 + -0.00001365 0.00013610 -0.00001351 + -0.00001312 -0.00001351 0.00013659 + #*EXTRAS*# Step: 12 Bead: 19 + 0.00013604 -0.00001354 -0.00001302 + -0.00001354 0.00013612 -0.00001341 + -0.00001302 -0.00001341 0.00013661 + #*EXTRAS*# Step: 13 Bead: 19 + 0.00013605 -0.00001348 -0.00001295 + -0.00001348 0.00013613 -0.00001334 + -0.00001295 -0.00001334 0.00013663 + #*EXTRAS*# Step: 14 Bead: 19 + 0.00013606 -0.00001344 -0.00001291 + -0.00001344 0.00013613 -0.00001330 + -0.00001291 -0.00001330 0.00013663 + #*EXTRAS*# Step: 15 Bead: 19 + 0.00013606 -0.00001341 -0.00001288 + -0.00001341 0.00013614 -0.00001327 + -0.00001288 -0.00001327 0.00013664 + #*EXTRAS*# Step: 16 Bead: 19 + 0.00013606 -0.00001339 -0.00001287 + -0.00001339 0.00013614 -0.00001326 + -0.00001287 -0.00001326 0.00013664 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_20 b/drivers/py/pes/friction/frictionH/060K/inst.fric_20 new file mode 100644 index 000000000..648f45995 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_20 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 20 + 0.00012394 -0.00004224 -0.00004182 + -0.00004224 0.00012400 -0.00004234 + -0.00004182 -0.00004234 0.00012371 + #*EXTRAS*# Step: 1 Bead: 20 + 0.00012637 -0.00003998 -0.00003944 + -0.00003998 0.00012645 -0.00004007 + -0.00003944 -0.00004007 0.00012604 + #*EXTRAS*# Step: 2 Bead: 20 + 0.00012946 -0.00003601 -0.00003575 + -0.00003601 0.00012964 -0.00003604 + -0.00003575 -0.00003604 0.00012912 + #*EXTRAS*# Step: 3 Bead: 20 + 0.00013280 -0.00002902 -0.00002896 + -0.00002902 0.00013304 -0.00002896 + -0.00002896 -0.00002896 0.00013268 + #*EXTRAS*# Step: 4 Bead: 20 + 0.00013443 -0.00002254 -0.00002226 + -0.00002254 0.00013462 -0.00002242 + -0.00002226 -0.00002242 0.00013463 + #*EXTRAS*# Step: 5 Bead: 20 + 0.00013496 -0.00001974 -0.00001936 + -0.00001974 0.00013511 -0.00001961 + -0.00001936 -0.00001961 0.00013529 + #*EXTRAS*# Step: 6 Bead: 20 + 0.00013534 -0.00001759 -0.00001714 + -0.00001759 0.00013547 -0.00001745 + -0.00001714 -0.00001745 0.00013576 + #*EXTRAS*# Step: 7 Bead: 20 + 0.00013551 -0.00001661 -0.00001613 + -0.00001661 0.00013562 -0.00001647 + -0.00001613 -0.00001647 0.00013597 + #*EXTRAS*# Step: 8 Bead: 20 + 0.00013563 -0.00001590 -0.00001541 + -0.00001590 0.00013574 -0.00001576 + -0.00001541 -0.00001576 0.00013612 + #*EXTRAS*# Step: 9 Bead: 20 + 0.00013570 -0.00001548 -0.00001498 + -0.00001548 0.00013580 -0.00001534 + -0.00001498 -0.00001534 0.00013621 + #*EXTRAS*# Step: 10 Bead: 20 + 0.00013575 -0.00001520 -0.00001470 + -0.00001520 0.00013585 -0.00001506 + -0.00001470 -0.00001506 0.00013627 + #*EXTRAS*# Step: 11 Bead: 20 + 0.00013578 -0.00001502 -0.00001452 + -0.00001502 0.00013588 -0.00001489 + -0.00001452 -0.00001489 0.00013630 + #*EXTRAS*# Step: 12 Bead: 20 + 0.00013580 -0.00001491 -0.00001440 + -0.00001491 0.00013589 -0.00001477 + -0.00001440 -0.00001477 0.00013633 + #*EXTRAS*# Step: 13 Bead: 20 + 0.00013581 -0.00001484 -0.00001433 + -0.00001484 0.00013591 -0.00001470 + -0.00001433 -0.00001470 0.00013634 + #*EXTRAS*# Step: 14 Bead: 20 + 0.00013582 -0.00001479 -0.00001428 + -0.00001479 0.00013591 -0.00001466 + -0.00001428 -0.00001466 0.00013635 + #*EXTRAS*# Step: 15 Bead: 20 + 0.00013583 -0.00001476 -0.00001425 + -0.00001476 0.00013592 -0.00001463 + -0.00001425 -0.00001463 0.00013636 + #*EXTRAS*# Step: 16 Bead: 20 + 0.00013583 -0.00001474 -0.00001424 + -0.00001474 0.00013592 -0.00001461 + -0.00001424 -0.00001461 0.00013636 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_21 b/drivers/py/pes/friction/frictionH/060K/inst.fric_21 new file mode 100644 index 000000000..47e1d1937 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_21 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 21 + 0.00012329 -0.00004270 -0.00004239 + -0.00004270 0.00012336 -0.00004279 + -0.00004239 -0.00004279 0.00012310 + #*EXTRAS*# Step: 1 Bead: 21 + 0.00012536 -0.00004101 -0.00004046 + -0.00004101 0.00012542 -0.00004111 + -0.00004046 -0.00004111 0.00012505 + #*EXTRAS*# Step: 2 Bead: 21 + 0.00012821 -0.00003778 -0.00003738 + -0.00003778 0.00012834 -0.00003784 + -0.00003738 -0.00003784 0.00012786 + #*EXTRAS*# Step: 3 Bead: 21 + 0.00013192 -0.00003139 -0.00003134 + -0.00003139 0.00013217 -0.00003135 + -0.00003134 -0.00003135 0.00013171 + #*EXTRAS*# Step: 4 Bead: 21 + 0.00013395 -0.00002479 -0.00002461 + -0.00002479 0.00013417 -0.00002469 + -0.00002461 -0.00002469 0.00013404 + #*EXTRAS*# Step: 5 Bead: 21 + 0.00013461 -0.00002165 -0.00002134 + -0.00002165 0.00013479 -0.00002153 + -0.00002134 -0.00002153 0.00013485 + #*EXTRAS*# Step: 6 Bead: 21 + 0.00013503 -0.00001933 -0.00001893 + -0.00001933 0.00013518 -0.00001920 + -0.00001893 -0.00001920 0.00013538 + #*EXTRAS*# Step: 7 Bead: 21 + 0.00013522 -0.00001825 -0.00001782 + -0.00001825 0.00013536 -0.00001812 + -0.00001782 -0.00001812 0.00013562 + #*EXTRAS*# Step: 8 Bead: 21 + 0.00013536 -0.00001749 -0.00001704 + -0.00001749 0.00013548 -0.00001735 + -0.00001704 -0.00001735 0.00013578 + #*EXTRAS*# Step: 9 Bead: 21 + 0.00013544 -0.00001703 -0.00001656 + -0.00001703 0.00013556 -0.00001689 + -0.00001656 -0.00001689 0.00013588 + #*EXTRAS*# Step: 10 Bead: 21 + 0.00013549 -0.00001673 -0.00001625 + -0.00001673 0.00013560 -0.00001659 + -0.00001625 -0.00001659 0.00013595 + #*EXTRAS*# Step: 11 Bead: 21 + 0.00013552 -0.00001653 -0.00001606 + -0.00001653 0.00013563 -0.00001639 + -0.00001606 -0.00001639 0.00013599 + #*EXTRAS*# Step: 12 Bead: 21 + 0.00013554 -0.00001641 -0.00001593 + -0.00001641 0.00013565 -0.00001627 + -0.00001593 -0.00001627 0.00013601 + #*EXTRAS*# Step: 13 Bead: 21 + 0.00013556 -0.00001633 -0.00001585 + -0.00001633 0.00013567 -0.00001619 + -0.00001585 -0.00001619 0.00013603 + #*EXTRAS*# Step: 14 Bead: 21 + 0.00013556 -0.00001628 -0.00001580 + -0.00001628 0.00013567 -0.00001614 + -0.00001580 -0.00001614 0.00013604 + #*EXTRAS*# Step: 15 Bead: 21 + 0.00013557 -0.00001625 -0.00001577 + -0.00001625 0.00013568 -0.00001611 + -0.00001577 -0.00001611 0.00013605 + #*EXTRAS*# Step: 16 Bead: 21 + 0.00013557 -0.00001623 -0.00001575 + -0.00001623 0.00013568 -0.00001609 + -0.00001575 -0.00001609 0.00013605 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_22 b/drivers/py/pes/friction/frictionH/060K/inst.fric_22 new file mode 100644 index 000000000..d263221c5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_22 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 22 + 0.00012263 -0.00004310 -0.00004291 + -0.00004310 0.00012270 -0.00004316 + -0.00004291 -0.00004316 0.00012248 + #*EXTRAS*# Step: 1 Bead: 22 + 0.00012438 -0.00004189 -0.00004141 + -0.00004189 0.00012444 -0.00004199 + -0.00004141 -0.00004199 0.00012412 + #*EXTRAS*# Step: 2 Bead: 22 + 0.00012687 -0.00003943 -0.00003891 + -0.00003943 0.00012696 -0.00003951 + -0.00003891 -0.00003951 0.00012653 + #*EXTRAS*# Step: 3 Bead: 22 + 0.00013078 -0.00003379 -0.00003367 + -0.00003379 0.00013100 -0.00003379 + -0.00003367 -0.00003379 0.00013049 + #*EXTRAS*# Step: 4 Bead: 22 + 0.00013335 -0.00002719 -0.00002708 + -0.00002719 0.00013359 -0.00002710 + -0.00002708 -0.00002710 0.00013332 + #*EXTRAS*# Step: 5 Bead: 22 + 0.00013419 -0.00002370 -0.00002347 + -0.00002370 0.00013440 -0.00002359 + -0.00002347 -0.00002359 0.00013433 + #*EXTRAS*# Step: 6 Bead: 22 + 0.00013469 -0.00002121 -0.00002089 + -0.00002121 0.00013486 -0.00002109 + -0.00002089 -0.00002109 0.00013495 + #*EXTRAS*# Step: 7 Bead: 22 + 0.00013491 -0.00002004 -0.00001967 + -0.00002004 0.00013507 -0.00001991 + -0.00001967 -0.00001991 0.00013522 + #*EXTRAS*# Step: 8 Bead: 22 + 0.00013505 -0.00001922 -0.00001882 + -0.00001922 0.00013520 -0.00001908 + -0.00001882 -0.00001908 0.00013541 + #*EXTRAS*# Step: 9 Bead: 22 + 0.00013514 -0.00001871 -0.00001830 + -0.00001871 0.00013528 -0.00001858 + -0.00001830 -0.00001858 0.00013552 + #*EXTRAS*# Step: 10 Bead: 22 + 0.00013520 -0.00001839 -0.00001796 + -0.00001839 0.00013534 -0.00001825 + -0.00001796 -0.00001825 0.00013559 + #*EXTRAS*# Step: 11 Bead: 22 + 0.00013524 -0.00001818 -0.00001775 + -0.00001818 0.00013537 -0.00001804 + -0.00001775 -0.00001804 0.00013563 + #*EXTRAS*# Step: 12 Bead: 22 + 0.00013526 -0.00001804 -0.00001761 + -0.00001804 0.00013539 -0.00001791 + -0.00001761 -0.00001791 0.00013566 + #*EXTRAS*# Step: 13 Bead: 22 + 0.00013528 -0.00001796 -0.00001752 + -0.00001796 0.00013541 -0.00001782 + -0.00001752 -0.00001782 0.00013568 + #*EXTRAS*# Step: 14 Bead: 22 + 0.00013528 -0.00001790 -0.00001746 + -0.00001790 0.00013542 -0.00001777 + -0.00001746 -0.00001777 0.00013569 + #*EXTRAS*# Step: 15 Bead: 22 + 0.00013529 -0.00001787 -0.00001743 + -0.00001787 0.00013542 -0.00001773 + -0.00001743 -0.00001773 0.00013570 + #*EXTRAS*# Step: 16 Bead: 22 + 0.00013529 -0.00001785 -0.00001741 + -0.00001785 0.00013542 -0.00001771 + -0.00001741 -0.00001771 0.00013571 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_23 b/drivers/py/pes/friction/frictionH/060K/inst.fric_23 new file mode 100644 index 000000000..220de4dcd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_23 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 23 + 0.00012195 -0.00004344 -0.00004336 + -0.00004344 0.00012200 -0.00004347 + -0.00004336 -0.00004347 0.00012184 + #*EXTRAS*# Step: 1 Bead: 23 + 0.00012344 -0.00004260 -0.00004226 + -0.00004260 0.00012351 -0.00004269 + -0.00004226 -0.00004269 0.00012324 + #*EXTRAS*# Step: 2 Bead: 23 + 0.00012551 -0.00004086 -0.00004031 + -0.00004086 0.00012557 -0.00004096 + -0.00004031 -0.00004096 0.00012520 + #*EXTRAS*# Step: 3 Bead: 23 + 0.00012936 -0.00003616 -0.00003588 + -0.00003616 0.00012953 -0.00003619 + -0.00003588 -0.00003619 0.00012902 + #*EXTRAS*# Step: 4 Bead: 23 + 0.00013257 -0.00002969 -0.00002964 + -0.00002969 0.00013282 -0.00002964 + -0.00002964 -0.00002964 0.00013243 + #*EXTRAS*# Step: 5 Bead: 23 + 0.00013369 -0.00002589 -0.00002574 + -0.00002589 0.00013392 -0.00002579 + -0.00002574 -0.00002579 0.00013372 + #*EXTRAS*# Step: 6 Bead: 23 + 0.00013429 -0.00002324 -0.00002299 + -0.00002324 0.00013449 -0.00002312 + -0.00002299 -0.00002312 0.00013445 + #*EXTRAS*# Step: 7 Bead: 23 + 0.00013455 -0.00002196 -0.00002167 + -0.00002196 0.00013473 -0.00002184 + -0.00002167 -0.00002184 0.00013477 + #*EXTRAS*# Step: 8 Bead: 23 + 0.00013472 -0.00002108 -0.00002075 + -0.00002108 0.00013489 -0.00002095 + -0.00002075 -0.00002095 0.00013498 + #*EXTRAS*# Step: 9 Bead: 23 + 0.00013482 -0.00002054 -0.00002018 + -0.00002054 0.00013498 -0.00002041 + -0.00002018 -0.00002041 0.00013511 + #*EXTRAS*# Step: 10 Bead: 23 + 0.00013488 -0.00002018 -0.00001982 + -0.00002018 0.00013504 -0.00002005 + -0.00001982 -0.00002005 0.00013519 + #*EXTRAS*# Step: 11 Bead: 23 + 0.00013492 -0.00001996 -0.00001959 + -0.00001996 0.00013508 -0.00001983 + -0.00001959 -0.00001983 0.00013524 + #*EXTRAS*# Step: 12 Bead: 23 + 0.00013495 -0.00001982 -0.00001944 + -0.00001982 0.00013510 -0.00001968 + -0.00001944 -0.00001968 0.00013527 + #*EXTRAS*# Step: 13 Bead: 23 + 0.00013496 -0.00001972 -0.00001934 + -0.00001972 0.00013512 -0.00001959 + -0.00001934 -0.00001959 0.00013529 + #*EXTRAS*# Step: 14 Bead: 23 + 0.00013497 -0.00001966 -0.00001928 + -0.00001966 0.00013513 -0.00001953 + -0.00001928 -0.00001953 0.00013531 + #*EXTRAS*# Step: 15 Bead: 23 + 0.00013498 -0.00001963 -0.00001924 + -0.00001963 0.00013513 -0.00001949 + -0.00001924 -0.00001949 0.00013532 + #*EXTRAS*# Step: 16 Bead: 23 + 0.00013499 -0.00001960 -0.00001922 + -0.00001960 0.00013514 -0.00001947 + -0.00001922 -0.00001947 0.00013532 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_24 b/drivers/py/pes/friction/frictionH/060K/inst.fric_24 new file mode 100644 index 000000000..80b168f64 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_24 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 24 + 0.00012123 -0.00004375 -0.00004374 + -0.00004375 0.00012123 -0.00004372 + -0.00004374 -0.00004372 0.00012116 + #*EXTRAS*# Step: 1 Bead: 24 + 0.00012251 -0.00004316 -0.00004300 + -0.00004316 0.00012257 -0.00004322 + -0.00004300 -0.00004322 0.00012237 + #*EXTRAS*# Step: 2 Bead: 24 + 0.00012422 -0.00004202 -0.00004156 + -0.00004202 0.00012428 -0.00004212 + -0.00004156 -0.00004212 0.00012397 + #*EXTRAS*# Step: 3 Bead: 24 + 0.00012774 -0.00003839 -0.00003794 + -0.00003839 0.00012786 -0.00003845 + -0.00003794 -0.00003845 0.00012738 + #*EXTRAS*# Step: 4 Bead: 24 + 0.00013154 -0.00003227 -0.00003221 + -0.00003227 0.00013177 -0.00003225 + -0.00003221 -0.00003225 0.00013129 + #*EXTRAS*# Step: 5 Bead: 24 + 0.00013306 -0.00002819 -0.00002812 + -0.00002819 0.00013330 -0.00002812 + -0.00002812 -0.00002812 0.00013298 + #*EXTRAS*# Step: 6 Bead: 24 + 0.00013381 -0.00002539 -0.00002523 + -0.00002539 0.00013403 -0.00002529 + -0.00002523 -0.00002529 0.00013387 + #*EXTRAS*# Step: 7 Bead: 24 + 0.00013412 -0.00002402 -0.00002380 + -0.00002402 0.00013433 -0.00002391 + -0.00002380 -0.00002391 0.00013425 + #*EXTRAS*# Step: 8 Bead: 24 + 0.00013432 -0.00002307 -0.00002282 + -0.00002307 0.00013452 -0.00002296 + -0.00002282 -0.00002296 0.00013450 + #*EXTRAS*# Step: 9 Bead: 24 + 0.00013444 -0.00002249 -0.00002222 + -0.00002249 0.00013463 -0.00002237 + -0.00002222 -0.00002237 0.00013464 + #*EXTRAS*# Step: 10 Bead: 24 + 0.00013452 -0.00002212 -0.00002182 + -0.00002212 0.00013470 -0.00002199 + -0.00002182 -0.00002199 0.00013473 + #*EXTRAS*# Step: 11 Bead: 24 + 0.00013456 -0.00002188 -0.00002158 + -0.00002188 0.00013474 -0.00002175 + -0.00002158 -0.00002175 0.00013479 + #*EXTRAS*# Step: 12 Bead: 24 + 0.00013459 -0.00002172 -0.00002141 + -0.00002172 0.00013477 -0.00002160 + -0.00002141 -0.00002160 0.00013483 + #*EXTRAS*# Step: 13 Bead: 24 + 0.00013461 -0.00002162 -0.00002131 + -0.00002162 0.00013479 -0.00002150 + -0.00002131 -0.00002150 0.00013485 + #*EXTRAS*# Step: 14 Bead: 24 + 0.00013462 -0.00002156 -0.00002125 + -0.00002156 0.00013480 -0.00002143 + -0.00002125 -0.00002143 0.00013487 + #*EXTRAS*# Step: 15 Bead: 24 + 0.00013463 -0.00002152 -0.00002120 + -0.00002152 0.00013481 -0.00002139 + -0.00002120 -0.00002139 0.00013488 + #*EXTRAS*# Step: 16 Bead: 24 + 0.00013464 -0.00002149 -0.00002118 + -0.00002149 0.00013481 -0.00002137 + -0.00002118 -0.00002137 0.00013488 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_25 b/drivers/py/pes/friction/frictionH/060K/inst.fric_25 new file mode 100644 index 000000000..02a98e002 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_25 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 25 + 0.00012045 -0.00004404 -0.00004402 + -0.00004404 0.00012038 -0.00004393 + -0.00004402 -0.00004393 0.00012041 + #*EXTRAS*# Step: 1 Bead: 25 + 0.00012154 -0.00004362 -0.00004359 + -0.00004362 0.00012156 -0.00004362 + -0.00004359 -0.00004362 0.00012145 + #*EXTRAS*# Step: 2 Bead: 25 + 0.00012300 -0.00004288 -0.00004263 + -0.00004288 0.00012307 -0.00004296 + -0.00004263 -0.00004296 0.00012283 + #*EXTRAS*# Step: 3 Bead: 25 + 0.00012602 -0.00004035 -0.00003979 + -0.00004035 0.00012610 -0.00004044 + -0.00003979 -0.00004044 0.00012570 + #*EXTRAS*# Step: 4 Bead: 25 + 0.00013017 -0.00003488 -0.00003469 + -0.00003488 0.00013037 -0.00003489 + -0.00003469 -0.00003489 0.00012985 + #*EXTRAS*# Step: 5 Bead: 25 + 0.00013224 -0.00003060 -0.00003056 + -0.00003060 0.00013249 -0.00003055 + -0.00003056 -0.00003055 0.00013206 + #*EXTRAS*# Step: 6 Bead: 25 + 0.00013322 -0.00002766 -0.00002757 + -0.00002766 0.00013346 -0.00002758 + -0.00002757 -0.00002758 0.00013316 + #*EXTRAS*# Step: 7 Bead: 25 + 0.00013361 -0.00002619 -0.00002606 + -0.00002619 0.00013384 -0.00002610 + -0.00002606 -0.00002610 0.00013363 + #*EXTRAS*# Step: 8 Bead: 25 + 0.00013386 -0.00002519 -0.00002502 + -0.00002519 0.00013408 -0.00002509 + -0.00002502 -0.00002509 0.00013393 + #*EXTRAS*# Step: 9 Bead: 25 + 0.00013400 -0.00002458 -0.00002438 + -0.00002458 0.00013421 -0.00002447 + -0.00002438 -0.00002447 0.00013410 + #*EXTRAS*# Step: 10 Bead: 25 + 0.00013409 -0.00002418 -0.00002397 + -0.00002418 0.00013430 -0.00002407 + -0.00002397 -0.00002407 0.00013421 + #*EXTRAS*# Step: 11 Bead: 25 + 0.00013414 -0.00002392 -0.00002370 + -0.00002392 0.00013435 -0.00002381 + -0.00002370 -0.00002381 0.00013428 + #*EXTRAS*# Step: 12 Bead: 25 + 0.00013418 -0.00002376 -0.00002353 + -0.00002376 0.00013438 -0.00002364 + -0.00002353 -0.00002364 0.00013432 + #*EXTRAS*# Step: 13 Bead: 25 + 0.00013420 -0.00002365 -0.00002342 + -0.00002365 0.00013441 -0.00002354 + -0.00002342 -0.00002354 0.00013435 + #*EXTRAS*# Step: 14 Bead: 25 + 0.00013422 -0.00002358 -0.00002335 + -0.00002358 0.00013442 -0.00002347 + -0.00002335 -0.00002347 0.00013436 + #*EXTRAS*# Step: 15 Bead: 25 + 0.00013423 -0.00002354 -0.00002331 + -0.00002354 0.00013443 -0.00002343 + -0.00002331 -0.00002343 0.00013438 + #*EXTRAS*# Step: 16 Bead: 25 + 0.00013423 -0.00002351 -0.00002328 + -0.00002351 0.00013443 -0.00002340 + -0.00002328 -0.00002340 0.00013438 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_26 b/drivers/py/pes/friction/frictionH/060K/inst.fric_26 new file mode 100644 index 000000000..f99d1947e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_26 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 26 + 0.00011962 -0.00004429 -0.00004422 + -0.00004429 0.00011945 -0.00004408 + -0.00004422 -0.00004408 0.00011960 + #*EXTRAS*# Step: 1 Bead: 26 + 0.00012048 -0.00004403 -0.00004402 + -0.00004403 0.00012041 -0.00004392 + -0.00004402 -0.00004392 0.00012043 + #*EXTRAS*# Step: 2 Bead: 26 + 0.00012177 -0.00004352 -0.00004347 + -0.00004352 0.00012181 -0.00004354 + -0.00004347 -0.00004354 0.00012167 + #*EXTRAS*# Step: 3 Bead: 26 + 0.00012438 -0.00004188 -0.00004141 + -0.00004188 0.00012444 -0.00004199 + -0.00004141 -0.00004199 0.00012412 + #*EXTRAS*# Step: 4 Bead: 26 + 0.00012851 -0.00003738 -0.00003701 + -0.00003738 0.00012865 -0.00003744 + -0.00003701 -0.00003744 0.00012815 + #*EXTRAS*# Step: 5 Bead: 26 + 0.00013115 -0.00003307 -0.00003298 + -0.00003307 0.00013138 -0.00003306 + -0.00003298 -0.00003306 0.00013088 + #*EXTRAS*# Step: 6 Bead: 26 + 0.00013245 -0.00003002 -0.00002998 + -0.00003002 0.00013270 -0.00002997 + -0.00002998 -0.00002997 0.00013230 + #*EXTRAS*# Step: 7 Bead: 26 + 0.00013297 -0.00002847 -0.00002840 + -0.00002847 0.00013322 -0.00002840 + -0.00002840 -0.00002840 0.00013288 + #*EXTRAS*# Step: 8 Bead: 26 + 0.00013328 -0.00002742 -0.00002733 + -0.00002742 0.00013352 -0.00002734 + -0.00002733 -0.00002734 0.00013324 + #*EXTRAS*# Step: 9 Bead: 26 + 0.00013346 -0.00002678 -0.00002666 + -0.00002678 0.00013369 -0.00002669 + -0.00002666 -0.00002669 0.00013345 + #*EXTRAS*# Step: 10 Bead: 26 + 0.00013357 -0.00002635 -0.00002623 + -0.00002635 0.00013380 -0.00002626 + -0.00002623 -0.00002626 0.00013358 + #*EXTRAS*# Step: 11 Bead: 26 + 0.00013364 -0.00002608 -0.00002595 + -0.00002608 0.00013387 -0.00002599 + -0.00002595 -0.00002599 0.00013366 + #*EXTRAS*# Step: 12 Bead: 26 + 0.00013368 -0.00002591 -0.00002577 + -0.00002591 0.00013391 -0.00002581 + -0.00002577 -0.00002581 0.00013372 + #*EXTRAS*# Step: 13 Bead: 26 + 0.00013371 -0.00002580 -0.00002565 + -0.00002580 0.00013394 -0.00002570 + -0.00002565 -0.00002570 0.00013375 + #*EXTRAS*# Step: 14 Bead: 26 + 0.00013373 -0.00002573 -0.00002558 + -0.00002573 0.00013395 -0.00002563 + -0.00002558 -0.00002563 0.00013377 + #*EXTRAS*# Step: 15 Bead: 26 + 0.00013374 -0.00002568 -0.00002553 + -0.00002568 0.00013396 -0.00002559 + -0.00002553 -0.00002559 0.00013378 + #*EXTRAS*# Step: 16 Bead: 26 + 0.00013375 -0.00002565 -0.00002550 + -0.00002565 0.00013397 -0.00002556 + -0.00002550 -0.00002556 0.00013379 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_27 b/drivers/py/pes/friction/frictionH/060K/inst.fric_27 new file mode 100644 index 000000000..20de3802f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_27 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 27 + 0.00011876 -0.00004448 -0.00004434 + -0.00004448 0.00011848 -0.00004419 + -0.00004434 -0.00004419 0.00011875 + #*EXTRAS*# Step: 1 Bead: 27 + 0.00011933 -0.00004436 -0.00004427 + -0.00004436 0.00011912 -0.00004412 + -0.00004427 -0.00004412 0.00011931 + #*EXTRAS*# Step: 2 Bead: 27 + 0.00012042 -0.00004405 -0.00004403 + -0.00004405 0.00012035 -0.00004393 + -0.00004403 -0.00004393 0.00012038 + #*EXTRAS*# Step: 3 Bead: 27 + 0.00012287 -0.00004296 -0.00004273 + -0.00004296 0.00012294 -0.00004304 + -0.00004273 -0.00004304 0.00012271 + #*EXTRAS*# Step: 4 Bead: 27 + 0.00012667 -0.00003965 -0.00003912 + -0.00003965 0.00012676 -0.00003973 + -0.00003912 -0.00003973 0.00012633 + #*EXTRAS*# Step: 5 Bead: 27 + 0.00012975 -0.00003555 -0.00003532 + -0.00003555 0.00012994 -0.00003558 + -0.00003532 -0.00003558 0.00012942 + #*EXTRAS*# Step: 6 Bead: 27 + 0.00013145 -0.00003246 -0.00003239 + -0.00003246 0.00013169 -0.00003244 + -0.00003239 -0.00003244 0.00013120 + #*EXTRAS*# Step: 7 Bead: 27 + 0.00013215 -0.00003083 -0.00003079 + -0.00003083 0.00013239 -0.00003079 + -0.00003079 -0.00003079 0.00013196 + #*EXTRAS*# Step: 8 Bead: 27 + 0.00013255 -0.00002975 -0.00002970 + -0.00002975 0.00013280 -0.00002969 + -0.00002970 -0.00002969 0.00013240 + #*EXTRAS*# Step: 9 Bead: 27 + 0.00013278 -0.00002907 -0.00002902 + -0.00002907 0.00013303 -0.00002901 + -0.00002902 -0.00002901 0.00013266 + #*EXTRAS*# Step: 10 Bead: 27 + 0.00013292 -0.00002863 -0.00002857 + -0.00002863 0.00013317 -0.00002856 + -0.00002857 -0.00002856 0.00013283 + #*EXTRAS*# Step: 11 Bead: 27 + 0.00013301 -0.00002835 -0.00002828 + -0.00002835 0.00013325 -0.00002828 + -0.00002828 -0.00002828 0.00013293 + #*EXTRAS*# Step: 12 Bead: 27 + 0.00013307 -0.00002817 -0.00002809 + -0.00002817 0.00013331 -0.00002810 + -0.00002809 -0.00002810 0.00013299 + #*EXTRAS*# Step: 13 Bead: 27 + 0.00013310 -0.00002805 -0.00002798 + -0.00002805 0.00013334 -0.00002798 + -0.00002798 -0.00002798 0.00013303 + #*EXTRAS*# Step: 14 Bead: 27 + 0.00013312 -0.00002798 -0.00002790 + -0.00002798 0.00013336 -0.00002790 + -0.00002790 -0.00002790 0.00013306 + #*EXTRAS*# Step: 15 Bead: 27 + 0.00013314 -0.00002793 -0.00002785 + -0.00002793 0.00013338 -0.00002785 + -0.00002785 -0.00002785 0.00013307 + #*EXTRAS*# Step: 16 Bead: 27 + 0.00013315 -0.00002790 -0.00002782 + -0.00002790 0.00013339 -0.00002782 + -0.00002782 -0.00002782 0.00013308 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_28 b/drivers/py/pes/friction/frictionH/060K/inst.fric_28 new file mode 100644 index 000000000..78161dbe4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_28 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 28 + 0.00011788 -0.00004460 -0.00004438 + -0.00004460 0.00011751 -0.00004424 + -0.00004438 -0.00004424 0.00011788 + #*EXTRAS*# Step: 1 Bead: 28 + 0.00011813 -0.00004458 -0.00004438 + -0.00004458 0.00011779 -0.00004423 + -0.00004438 -0.00004423 0.00011813 + #*EXTRAS*# Step: 2 Bead: 28 + 0.00011894 -0.00004445 -0.00004432 + -0.00004445 0.00011869 -0.00004417 + -0.00004432 -0.00004417 0.00011893 + #*EXTRAS*# Step: 3 Bead: 28 + 0.00012133 -0.00004371 -0.00004369 + -0.00004371 0.00012134 -0.00004369 + -0.00004369 -0.00004369 0.00012125 + #*EXTRAS*# Step: 4 Bead: 28 + 0.00012485 -0.00004149 -0.00004096 + -0.00004149 0.00012491 -0.00004159 + -0.00004096 -0.00004159 0.00012456 + #*EXTRAS*# Step: 5 Bead: 28 + 0.00012810 -0.00003792 -0.00003751 + -0.00003792 0.00012823 -0.00003798 + -0.00003751 -0.00003798 0.00012775 + #*EXTRAS*# Step: 6 Bead: 28 + 0.00013014 -0.00003491 -0.00003472 + -0.00003491 0.00013035 -0.00003493 + -0.00003472 -0.00003493 0.00012983 + #*EXTRAS*# Step: 7 Bead: 28 + 0.00013106 -0.00003325 -0.00003315 + -0.00003325 0.00013129 -0.00003324 + -0.00003315 -0.00003324 0.00013079 + #*EXTRAS*# Step: 8 Bead: 28 + 0.00013160 -0.00003213 -0.00003207 + -0.00003213 0.00013184 -0.00003211 + -0.00003207 -0.00003211 0.00013136 + #*EXTRAS*# Step: 9 Bead: 28 + 0.00013190 -0.00003144 -0.00003139 + -0.00003144 0.00013215 -0.00003141 + -0.00003139 -0.00003141 0.00013169 + #*EXTRAS*# Step: 10 Bead: 28 + 0.00013209 -0.00003099 -0.00003094 + -0.00003099 0.00013233 -0.00003095 + -0.00003094 -0.00003095 0.00013189 + #*EXTRAS*# Step: 11 Bead: 28 + 0.00013220 -0.00003070 -0.00003065 + -0.00003070 0.00013245 -0.00003065 + -0.00003065 -0.00003065 0.00013201 + #*EXTRAS*# Step: 12 Bead: 28 + 0.00013227 -0.00003051 -0.00003047 + -0.00003051 0.00013252 -0.00003046 + -0.00003047 -0.00003046 0.00013209 + #*EXTRAS*# Step: 13 Bead: 28 + 0.00013232 -0.00003039 -0.00003035 + -0.00003039 0.00013257 -0.00003034 + -0.00003035 -0.00003034 0.00013214 + #*EXTRAS*# Step: 14 Bead: 28 + 0.00013235 -0.00003031 -0.00003027 + -0.00003031 0.00013260 -0.00003026 + -0.00003027 -0.00003026 0.00013218 + #*EXTRAS*# Step: 15 Bead: 28 + 0.00013237 -0.00003026 -0.00003022 + -0.00003026 0.00013261 -0.00003021 + -0.00003022 -0.00003021 0.00013220 + #*EXTRAS*# Step: 16 Bead: 28 + 0.00013238 -0.00003023 -0.00003019 + -0.00003023 0.00013263 -0.00003018 + -0.00003019 -0.00003018 0.00013221 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_29 b/drivers/py/pes/friction/frictionH/060K/inst.fric_29 new file mode 100644 index 000000000..9429b69e8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_29 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 29 + 0.00011700 -0.00004463 -0.00004435 + -0.00004463 0.00011658 -0.00004423 + -0.00004435 -0.00004423 0.00011701 + #*EXTRAS*# Step: 1 Bead: 29 + 0.00011693 -0.00004463 -0.00004434 + -0.00004463 0.00011651 -0.00004422 + -0.00004434 -0.00004422 0.00011694 + #*EXTRAS*# Step: 2 Bead: 29 + 0.00011741 -0.00004463 -0.00004437 + -0.00004463 0.00011701 -0.00004424 + -0.00004437 -0.00004424 0.00011742 + #*EXTRAS*# Step: 3 Bead: 29 + 0.00011959 -0.00004430 -0.00004423 + -0.00004430 0.00011941 -0.00004409 + -0.00004423 -0.00004409 0.00011957 + #*EXTRAS*# Step: 4 Bead: 29 + 0.00012318 -0.00004277 -0.00004248 + -0.00004277 0.00012325 -0.00004286 + -0.00004248 -0.00004286 0.00012299 + #*EXTRAS*# Step: 5 Bead: 29 + 0.00012631 -0.00004004 -0.00003950 + -0.00004004 0.00012639 -0.00004013 + -0.00003950 -0.00004013 0.00012598 + #*EXTRAS*# Step: 6 Bead: 29 + 0.00012857 -0.00003729 -0.00003693 + -0.00003729 0.00012872 -0.00003735 + -0.00003693 -0.00003735 0.00012822 + #*EXTRAS*# Step: 7 Bead: 29 + 0.00012969 -0.00003566 -0.00003542 + -0.00003566 0.00012987 -0.00003568 + -0.00003542 -0.00003568 0.00012935 + #*EXTRAS*# Step: 8 Bead: 29 + 0.00013036 -0.00003455 -0.00003438 + -0.00003455 0.00013057 -0.00003456 + -0.00003438 -0.00003456 0.00013005 + #*EXTRAS*# Step: 9 Bead: 29 + 0.00013075 -0.00003385 -0.00003372 + -0.00003385 0.00013097 -0.00003385 + -0.00003372 -0.00003385 0.00013046 + #*EXTRAS*# Step: 10 Bead: 29 + 0.00013099 -0.00003339 -0.00003328 + -0.00003339 0.00013122 -0.00003338 + -0.00003328 -0.00003338 0.00013071 + #*EXTRAS*# Step: 11 Bead: 29 + 0.00013114 -0.00003309 -0.00003300 + -0.00003309 0.00013137 -0.00003308 + -0.00003300 -0.00003308 0.00013087 + #*EXTRAS*# Step: 12 Bead: 29 + 0.00013124 -0.00003290 -0.00003282 + -0.00003290 0.00013147 -0.00003289 + -0.00003282 -0.00003289 0.00013097 + #*EXTRAS*# Step: 13 Bead: 29 + 0.00013130 -0.00003278 -0.00003270 + -0.00003278 0.00013153 -0.00003277 + -0.00003270 -0.00003277 0.00013103 + #*EXTRAS*# Step: 14 Bead: 29 + 0.00013133 -0.00003270 -0.00003262 + -0.00003270 0.00013157 -0.00003269 + -0.00003262 -0.00003269 0.00013107 + #*EXTRAS*# Step: 15 Bead: 29 + 0.00013136 -0.00003265 -0.00003258 + -0.00003265 0.00013159 -0.00003263 + -0.00003258 -0.00003263 0.00013110 + #*EXTRAS*# Step: 16 Bead: 29 + 0.00013137 -0.00003262 -0.00003254 + -0.00003262 0.00013161 -0.00003260 + -0.00003254 -0.00003260 0.00013112 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_30 b/drivers/py/pes/friction/frictionH/060K/inst.fric_30 new file mode 100644 index 000000000..8fded9a4f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_30 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 30 + 0.00011614 -0.00004454 -0.00004426 + -0.00004454 0.00011572 -0.00004416 + -0.00004426 -0.00004416 0.00011615 + #*EXTRAS*# Step: 1 Bead: 30 + 0.00011576 -0.00004447 -0.00004420 + -0.00004447 0.00011536 -0.00004411 + -0.00004420 -0.00004411 0.00011578 + #*EXTRAS*# Step: 2 Bead: 30 + 0.00011591 -0.00004450 -0.00004422 + -0.00004450 0.00011550 -0.00004413 + -0.00004422 -0.00004413 0.00011593 + #*EXTRAS*# Step: 3 Bead: 30 + 0.00011772 -0.00004462 -0.00004438 + -0.00004462 0.00011734 -0.00004424 + -0.00004438 -0.00004424 0.00011772 + #*EXTRAS*# Step: 4 Bead: 30 + 0.00012152 -0.00004363 -0.00004360 + -0.00004363 0.00012155 -0.00004363 + -0.00004360 -0.00004363 0.00012144 + #*EXTRAS*# Step: 5 Bead: 30 + 0.00012456 -0.00004173 -0.00004123 + -0.00004173 0.00012462 -0.00004184 + -0.00004123 -0.00004184 0.00012429 + #*EXTRAS*# Step: 6 Bead: 30 + 0.00012683 -0.00003947 -0.00003895 + -0.00003947 0.00012692 -0.00003955 + -0.00003895 -0.00003955 0.00012648 + #*EXTRAS*# Step: 7 Bead: 30 + 0.00012808 -0.00003796 -0.00003754 + -0.00003796 0.00012821 -0.00003802 + -0.00003754 -0.00003802 0.00012772 + #*EXTRAS*# Step: 8 Bead: 30 + 0.00012885 -0.00003690 -0.00003657 + -0.00003690 0.00012901 -0.00003695 + -0.00003657 -0.00003695 0.00012850 + #*EXTRAS*# Step: 9 Bead: 30 + 0.00012932 -0.00003623 -0.00003594 + -0.00003623 0.00012949 -0.00003626 + -0.00003594 -0.00003626 0.00012898 + #*EXTRAS*# Step: 10 Bead: 30 + 0.00012961 -0.00003578 -0.00003553 + -0.00003578 0.00012979 -0.00003580 + -0.00003553 -0.00003580 0.00012928 + #*EXTRAS*# Step: 11 Bead: 30 + 0.00012979 -0.00003549 -0.00003526 + -0.00003549 0.00012998 -0.00003551 + -0.00003526 -0.00003551 0.00012946 + #*EXTRAS*# Step: 12 Bead: 30 + 0.00012991 -0.00003530 -0.00003509 + -0.00003530 0.00013010 -0.00003532 + -0.00003509 -0.00003532 0.00012958 + #*EXTRAS*# Step: 13 Bead: 30 + 0.00012998 -0.00003518 -0.00003497 + -0.00003518 0.00013018 -0.00003520 + -0.00003497 -0.00003520 0.00012966 + #*EXTRAS*# Step: 14 Bead: 30 + 0.00013003 -0.00003510 -0.00003490 + -0.00003510 0.00013023 -0.00003512 + -0.00003490 -0.00003512 0.00012971 + #*EXTRAS*# Step: 15 Bead: 30 + 0.00013006 -0.00003505 -0.00003485 + -0.00003505 0.00013026 -0.00003507 + -0.00003485 -0.00003507 0.00012974 + #*EXTRAS*# Step: 16 Bead: 30 + 0.00013008 -0.00003502 -0.00003482 + -0.00003502 0.00013028 -0.00003504 + -0.00003482 -0.00003504 0.00012976 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_31 b/drivers/py/pes/friction/frictionH/060K/inst.fric_31 new file mode 100644 index 000000000..0f5a66aa2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_31 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 31 + 0.00011529 -0.00004435 -0.00004411 + -0.00004435 0.00011492 -0.00004403 + -0.00004411 -0.00004403 0.00011532 + #*EXTRAS*# Step: 1 Bead: 31 + 0.00011463 -0.00004414 -0.00004394 + -0.00004414 0.00011432 -0.00004389 + -0.00004394 -0.00004389 0.00011466 + #*EXTRAS*# Step: 2 Bead: 31 + 0.00011447 -0.00004408 -0.00004390 + -0.00004408 0.00011418 -0.00004385 + -0.00004390 -0.00004385 0.00011451 + #*EXTRAS*# Step: 3 Bead: 31 + 0.00011588 -0.00004449 -0.00004422 + -0.00004449 0.00011547 -0.00004413 + -0.00004422 -0.00004413 0.00011589 + #*EXTRAS*# Step: 4 Bead: 31 + 0.00011966 -0.00004428 -0.00004422 + -0.00004428 0.00011949 -0.00004408 + -0.00004422 -0.00004408 0.00011963 + #*EXTRAS*# Step: 5 Bead: 31 + 0.00012296 -0.00004291 -0.00004267 + -0.00004291 0.00012302 -0.00004299 + -0.00004267 -0.00004299 0.00012278 + #*EXTRAS*# Step: 6 Bead: 31 + 0.00012507 -0.00004128 -0.00004074 + -0.00004128 0.00012513 -0.00004138 + -0.00004074 -0.00004138 0.00012478 + #*EXTRAS*# Step: 7 Bead: 31 + 0.00012634 -0.00004001 -0.00003947 + -0.00004001 0.00012642 -0.00004010 + -0.00003947 -0.00004010 0.00012601 + #*EXTRAS*# Step: 8 Bead: 31 + 0.00012717 -0.00003908 -0.00003859 + -0.00003908 0.00012727 -0.00003916 + -0.00003859 -0.00003916 0.00012682 + #*EXTRAS*# Step: 9 Bead: 31 + 0.00012768 -0.00003846 -0.00003801 + -0.00003846 0.00012779 -0.00003853 + -0.00003801 -0.00003853 0.00012732 + #*EXTRAS*# Step: 10 Bead: 31 + 0.00012800 -0.00003805 -0.00003763 + -0.00003805 0.00012813 -0.00003811 + -0.00003763 -0.00003811 0.00012765 + #*EXTRAS*# Step: 11 Bead: 31 + 0.00012821 -0.00003778 -0.00003738 + -0.00003778 0.00012835 -0.00003784 + -0.00003738 -0.00003784 0.00012786 + #*EXTRAS*# Step: 12 Bead: 31 + 0.00012834 -0.00003760 -0.00003721 + -0.00003760 0.00012848 -0.00003766 + -0.00003721 -0.00003766 0.00012799 + #*EXTRAS*# Step: 13 Bead: 31 + 0.00012843 -0.00003749 -0.00003711 + -0.00003749 0.00012857 -0.00003754 + -0.00003711 -0.00003754 0.00012808 + #*EXTRAS*# Step: 14 Bead: 31 + 0.00012848 -0.00003742 -0.00003704 + -0.00003742 0.00012863 -0.00003747 + -0.00003704 -0.00003747 0.00012813 + #*EXTRAS*# Step: 15 Bead: 31 + 0.00012852 -0.00003737 -0.00003700 + -0.00003737 0.00012866 -0.00003742 + -0.00003700 -0.00003742 0.00012817 + #*EXTRAS*# Step: 16 Bead: 31 + 0.00012854 -0.00003734 -0.00003697 + -0.00003734 0.00012868 -0.00003739 + -0.00003697 -0.00003739 0.00012819 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_32 b/drivers/py/pes/friction/frictionH/060K/inst.fric_32 new file mode 100644 index 000000000..283e398a1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_32 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 32 + 0.00011447 -0.00004408 -0.00004390 + -0.00004408 0.00011418 -0.00004385 + -0.00004390 -0.00004385 0.00011451 + #*EXTRAS*# Step: 1 Bead: 32 + 0.00011355 -0.00004368 -0.00004359 + -0.00004368 0.00011336 -0.00004356 + -0.00004359 -0.00004356 0.00011359 + #*EXTRAS*# Step: 2 Bead: 32 + 0.00011311 -0.00004346 -0.00004341 + -0.00004346 0.00011296 -0.00004339 + -0.00004341 -0.00004339 0.00011316 + #*EXTRAS*# Step: 3 Bead: 32 + 0.00011412 -0.00004394 -0.00004379 + -0.00004394 0.00011386 -0.00004375 + -0.00004379 -0.00004375 0.00011416 + #*EXTRAS*# Step: 4 Bead: 32 + 0.00011763 -0.00004462 -0.00004438 + -0.00004462 0.00011725 -0.00004424 + -0.00004438 -0.00004424 0.00011764 + #*EXTRAS*# Step: 5 Bead: 32 + 0.00012132 -0.00004371 -0.00004370 + -0.00004371 0.00012133 -0.00004369 + -0.00004370 -0.00004369 0.00012124 + #*EXTRAS*# Step: 6 Bead: 32 + 0.00012345 -0.00004259 -0.00004225 + -0.00004259 0.00012352 -0.00004268 + -0.00004225 -0.00004268 0.00012325 + #*EXTRAS*# Step: 7 Bead: 32 + 0.00012464 -0.00004167 -0.00004116 + -0.00004167 0.00012470 -0.00004177 + -0.00004116 -0.00004177 0.00012437 + #*EXTRAS*# Step: 8 Bead: 32 + 0.00012543 -0.00004094 -0.00004038 + -0.00004094 0.00012550 -0.00004104 + -0.00004038 -0.00004104 0.00012513 + #*EXTRAS*# Step: 9 Bead: 32 + 0.00012595 -0.00004043 -0.00003987 + -0.00004043 0.00012602 -0.00004052 + -0.00003987 -0.00004052 0.00012562 + #*EXTRAS*# Step: 10 Bead: 32 + 0.00012628 -0.00004007 -0.00003953 + -0.00004007 0.00012636 -0.00004016 + -0.00003953 -0.00004016 0.00012595 + #*EXTRAS*# Step: 11 Bead: 32 + 0.00012650 -0.00003984 -0.00003930 + -0.00003984 0.00012658 -0.00003993 + -0.00003930 -0.00003993 0.00012616 + #*EXTRAS*# Step: 12 Bead: 32 + 0.00012664 -0.00003969 -0.00003916 + -0.00003969 0.00012672 -0.00003977 + -0.00003916 -0.00003977 0.00012630 + #*EXTRAS*# Step: 13 Bead: 32 + 0.00012672 -0.00003959 -0.00003906 + -0.00003959 0.00012681 -0.00003967 + -0.00003906 -0.00003967 0.00012638 + #*EXTRAS*# Step: 14 Bead: 32 + 0.00012678 -0.00003952 -0.00003900 + -0.00003952 0.00012687 -0.00003961 + -0.00003900 -0.00003961 0.00012644 + #*EXTRAS*# Step: 15 Bead: 32 + 0.00012682 -0.00003948 -0.00003896 + -0.00003948 0.00012691 -0.00003956 + -0.00003896 -0.00003956 0.00012647 + #*EXTRAS*# Step: 16 Bead: 32 + 0.00012684 -0.00003946 -0.00003894 + -0.00003946 0.00012693 -0.00003954 + -0.00003894 -0.00003954 0.00012650 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_33 b/drivers/py/pes/friction/frictionH/060K/inst.fric_33 new file mode 100644 index 000000000..2e2015433 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_33 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 33 + 0.00011368 -0.00004374 -0.00004364 + -0.00004374 0.00011347 -0.00004360 + -0.00004364 -0.00004360 0.00011372 + #*EXTRAS*# Step: 1 Bead: 33 + 0.00011251 -0.00004314 -0.00004315 + -0.00004314 0.00011243 -0.00004313 + -0.00004315 -0.00004313 0.00011257 + #*EXTRAS*# Step: 2 Bead: 33 + 0.00011181 -0.00004273 -0.00004279 + -0.00004273 0.00011178 -0.00004277 + -0.00004279 -0.00004277 0.00011187 + #*EXTRAS*# Step: 3 Bead: 33 + 0.00011247 -0.00004312 -0.00004313 + -0.00004312 0.00011239 -0.00004311 + -0.00004313 -0.00004311 0.00011252 + #*EXTRAS*# Step: 4 Bead: 33 + 0.00011564 -0.00004444 -0.00004417 + -0.00004444 0.00011524 -0.00004409 + -0.00004417 -0.00004409 0.00011566 + #*EXTRAS*# Step: 5 Bead: 33 + 0.00011947 -0.00004433 -0.00004425 + -0.00004433 0.00011927 -0.00004411 + -0.00004425 -0.00004411 0.00011945 + #*EXTRAS*# Step: 6 Bead: 33 + 0.00012188 -0.00004348 -0.00004341 + -0.00004348 0.00012192 -0.00004350 + -0.00004341 -0.00004350 0.00012177 + #*EXTRAS*# Step: 7 Bead: 33 + 0.00012308 -0.00004283 -0.00004257 + -0.00004283 0.00012315 -0.00004292 + -0.00004257 -0.00004292 0.00012290 + #*EXTRAS*# Step: 8 Bead: 33 + 0.00012382 -0.00004233 -0.00004193 + -0.00004233 0.00012389 -0.00004242 + -0.00004193 -0.00004242 0.00012359 + #*EXTRAS*# Step: 9 Bead: 33 + 0.00012429 -0.00004196 -0.00004149 + -0.00004196 0.00012435 -0.00004206 + -0.00004149 -0.00004206 0.00012404 + #*EXTRAS*# Step: 10 Bead: 33 + 0.00012460 -0.00004170 -0.00004120 + -0.00004170 0.00012466 -0.00004180 + -0.00004120 -0.00004180 0.00012433 + #*EXTRAS*# Step: 11 Bead: 33 + 0.00012480 -0.00004152 -0.00004100 + -0.00004152 0.00012486 -0.00004162 + -0.00004100 -0.00004162 0.00012452 + #*EXTRAS*# Step: 12 Bead: 33 + 0.00012493 -0.00004141 -0.00004087 + -0.00004141 0.00012499 -0.00004151 + -0.00004087 -0.00004151 0.00012465 + #*EXTRAS*# Step: 13 Bead: 33 + 0.00012502 -0.00004133 -0.00004079 + -0.00004133 0.00012508 -0.00004143 + -0.00004079 -0.00004143 0.00012473 + #*EXTRAS*# Step: 14 Bead: 33 + 0.00012507 -0.00004128 -0.00004074 + -0.00004128 0.00012513 -0.00004138 + -0.00004074 -0.00004138 0.00012478 + #*EXTRAS*# Step: 15 Bead: 33 + 0.00012511 -0.00004125 -0.00004070 + -0.00004125 0.00012517 -0.00004135 + -0.00004070 -0.00004135 0.00012481 + #*EXTRAS*# Step: 16 Bead: 33 + 0.00012513 -0.00004123 -0.00004068 + -0.00004123 0.00012519 -0.00004133 + -0.00004068 -0.00004133 0.00012483 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_34 b/drivers/py/pes/friction/frictionH/060K/inst.fric_34 new file mode 100644 index 000000000..da57776c1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_34 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 34 + 0.00011291 -0.00004336 -0.00004333 + -0.00004336 0.00011279 -0.00004331 + -0.00004333 -0.00004331 0.00011296 + #*EXTRAS*# Step: 1 Bead: 34 + 0.00011152 -0.00004256 -0.00004262 + -0.00004256 0.00011151 -0.00004260 + -0.00004262 -0.00004260 0.00011159 + #*EXTRAS*# Step: 2 Bead: 34 + 0.00011057 -0.00004195 -0.00004203 + -0.00004195 0.00011060 -0.00004201 + -0.00004203 -0.00004201 0.00011065 + #*EXTRAS*# Step: 3 Bead: 34 + 0.00011091 -0.00004217 -0.00004225 + -0.00004217 0.00011092 -0.00004223 + -0.00004225 -0.00004223 0.00011098 + #*EXTRAS*# Step: 4 Bead: 34 + 0.00011376 -0.00004378 -0.00004367 + -0.00004378 0.00011354 -0.00004363 + -0.00004367 -0.00004363 0.00011380 + #*EXTRAS*# Step: 5 Bead: 34 + 0.00011748 -0.00004463 -0.00004437 + -0.00004463 0.00011708 -0.00004424 + -0.00004437 -0.00004424 0.00011748 + #*EXTRAS*# Step: 6 Bead: 34 + 0.00012013 -0.00004414 -0.00004411 + -0.00004414 0.00012002 -0.00004399 + -0.00004411 -0.00004399 0.00012009 + #*EXTRAS*# Step: 7 Bead: 34 + 0.00012151 -0.00004364 -0.00004360 + -0.00004364 0.00012154 -0.00004363 + -0.00004360 -0.00004363 0.00012143 + #*EXTRAS*# Step: 8 Bead: 34 + 0.00012229 -0.00004328 -0.00004315 + -0.00004328 0.00012235 -0.00004333 + -0.00004315 -0.00004333 0.00012216 + #*EXTRAS*# Step: 9 Bead: 34 + 0.00012276 -0.00004302 -0.00004282 + -0.00004302 0.00012283 -0.00004310 + -0.00004282 -0.00004310 0.00012260 + #*EXTRAS*# Step: 10 Bead: 34 + 0.00012306 -0.00004284 -0.00004258 + -0.00004284 0.00012313 -0.00004293 + -0.00004258 -0.00004293 0.00012288 + #*EXTRAS*# Step: 11 Bead: 34 + 0.00012325 -0.00004272 -0.00004243 + -0.00004272 0.00012332 -0.00004281 + -0.00004243 -0.00004281 0.00012306 + #*EXTRAS*# Step: 12 Bead: 34 + 0.00012337 -0.00004264 -0.00004232 + -0.00004264 0.00012344 -0.00004273 + -0.00004232 -0.00004273 0.00012317 + #*EXTRAS*# Step: 13 Bead: 34 + 0.00012345 -0.00004259 -0.00004226 + -0.00004259 0.00012352 -0.00004268 + -0.00004226 -0.00004268 0.00012325 + #*EXTRAS*# Step: 14 Bead: 34 + 0.00012350 -0.00004255 -0.00004221 + -0.00004255 0.00012357 -0.00004265 + -0.00004221 -0.00004265 0.00012329 + #*EXTRAS*# Step: 15 Bead: 34 + 0.00012353 -0.00004253 -0.00004218 + -0.00004253 0.00012360 -0.00004263 + -0.00004218 -0.00004263 0.00012332 + #*EXTRAS*# Step: 16 Bead: 34 + 0.00012355 -0.00004252 -0.00004217 + -0.00004252 0.00012362 -0.00004261 + -0.00004217 -0.00004261 0.00012334 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_35 b/drivers/py/pes/friction/frictionH/060K/inst.fric_35 new file mode 100644 index 000000000..3c7ab39c0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_35 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 35 + 0.00011217 -0.00004295 -0.00004298 + -0.00004295 0.00011212 -0.00004296 + -0.00004298 -0.00004296 0.00011223 + #*EXTRAS*# Step: 1 Bead: 35 + 0.00011057 -0.00004195 -0.00004203 + -0.00004195 0.00011059 -0.00004200 + -0.00004203 -0.00004200 0.00011065 + #*EXTRAS*# Step: 2 Bead: 35 + 0.00010940 -0.00004112 -0.00004118 + -0.00004112 0.00010942 -0.00004115 + -0.00004118 -0.00004115 0.00010947 + #*EXTRAS*# Step: 3 Bead: 35 + 0.00010943 -0.00004114 -0.00004120 + -0.00004114 0.00010945 -0.00004118 + -0.00004120 -0.00004118 0.00010950 + #*EXTRAS*# Step: 4 Bead: 35 + 0.00011199 -0.00004284 -0.00004288 + -0.00004284 0.00011195 -0.00004287 + -0.00004288 -0.00004287 0.00011205 + #*EXTRAS*# Step: 5 Bead: 35 + 0.00011553 -0.00004442 -0.00004415 + -0.00004442 0.00011514 -0.00004407 + -0.00004415 -0.00004407 0.00011555 + #*EXTRAS*# Step: 6 Bead: 35 + 0.00011819 -0.00004457 -0.00004437 + -0.00004457 0.00011785 -0.00004422 + -0.00004437 -0.00004422 0.00011819 + #*EXTRAS*# Step: 7 Bead: 35 + 0.00011974 -0.00004425 -0.00004420 + -0.00004425 0.00011959 -0.00004406 + -0.00004420 -0.00004406 0.00011972 + #*EXTRAS*# Step: 8 Bead: 35 + 0.00012065 -0.00004397 -0.00004396 + -0.00004397 0.00012059 -0.00004388 + -0.00004396 -0.00004388 0.00012060 + #*EXTRAS*# Step: 9 Bead: 35 + 0.00012118 -0.00004377 -0.00004376 + -0.00004377 0.00012118 -0.00004374 + -0.00004376 -0.00004374 0.00012111 + #*EXTRAS*# Step: 10 Bead: 35 + 0.00012151 -0.00004364 -0.00004361 + -0.00004364 0.00012153 -0.00004363 + -0.00004361 -0.00004363 0.00012142 + #*EXTRAS*# Step: 11 Bead: 35 + 0.00012171 -0.00004355 -0.00004350 + -0.00004355 0.00012175 -0.00004356 + -0.00004350 -0.00004356 0.00012161 + #*EXTRAS*# Step: 12 Bead: 35 + 0.00012184 -0.00004349 -0.00004343 + -0.00004349 0.00012188 -0.00004351 + -0.00004343 -0.00004351 0.00012174 + #*EXTRAS*# Step: 13 Bead: 35 + 0.00012192 -0.00004345 -0.00004338 + -0.00004345 0.00012197 -0.00004348 + -0.00004338 -0.00004348 0.00012181 + #*EXTRAS*# Step: 14 Bead: 35 + 0.00012198 -0.00004343 -0.00004335 + -0.00004343 0.00012202 -0.00004346 + -0.00004335 -0.00004346 0.00012186 + #*EXTRAS*# Step: 15 Bead: 35 + 0.00012201 -0.00004341 -0.00004333 + -0.00004341 0.00012206 -0.00004345 + -0.00004333 -0.00004345 0.00012190 + #*EXTRAS*# Step: 16 Bead: 35 + 0.00012203 -0.00004340 -0.00004332 + -0.00004340 0.00012208 -0.00004344 + -0.00004332 -0.00004344 0.00012192 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_36 b/drivers/py/pes/friction/frictionH/060K/inst.fric_36 new file mode 100644 index 000000000..a055dde38 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_36 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 36 + 0.00011145 -0.00004252 -0.00004258 + -0.00004252 0.00011145 -0.00004256 + -0.00004258 -0.00004256 0.00011152 + #*EXTRAS*# Step: 1 Bead: 36 + 0.00010967 -0.00004132 -0.00004138 + -0.00004132 0.00010969 -0.00004135 + -0.00004138 -0.00004135 0.00010974 + #*EXTRAS*# Step: 2 Bead: 36 + 0.00010829 -0.00004024 -0.00004025 + -0.00004024 0.00010829 -0.00004024 + -0.00004025 -0.00004024 0.00010833 + #*EXTRAS*# Step: 3 Bead: 36 + 0.00010803 -0.00004002 -0.00004003 + -0.00004002 0.00010804 -0.00004003 + -0.00004003 -0.00004003 0.00010806 + #*EXTRAS*# Step: 4 Bead: 36 + 0.00011033 -0.00004179 -0.00004187 + -0.00004179 0.00011035 -0.00004184 + -0.00004187 -0.00004184 0.00011041 + #*EXTRAS*# Step: 5 Bead: 36 + 0.00011369 -0.00004375 -0.00004364 + -0.00004375 0.00011348 -0.00004361 + -0.00004364 -0.00004361 0.00011373 + #*EXTRAS*# Step: 6 Bead: 36 + 0.00011624 -0.00004456 -0.00004427 + -0.00004456 0.00011582 -0.00004417 + -0.00004427 -0.00004417 0.00011625 + #*EXTRAS*# Step: 7 Bead: 36 + 0.00011782 -0.00004461 -0.00004438 + -0.00004461 0.00011745 -0.00004424 + -0.00004438 -0.00004424 0.00011782 + #*EXTRAS*# Step: 8 Bead: 36 + 0.00011879 -0.00004448 -0.00004434 + -0.00004448 0.00011852 -0.00004418 + -0.00004434 -0.00004418 0.00011878 + #*EXTRAS*# Step: 9 Bead: 36 + 0.00011939 -0.00004435 -0.00004426 + -0.00004435 0.00011918 -0.00004412 + -0.00004426 -0.00004412 0.00011937 + #*EXTRAS*# Step: 10 Bead: 36 + 0.00011976 -0.00004425 -0.00004420 + -0.00004425 0.00011960 -0.00004406 + -0.00004420 -0.00004406 0.00011973 + #*EXTRAS*# Step: 11 Bead: 36 + 0.00011999 -0.00004418 -0.00004415 + -0.00004418 0.00011987 -0.00004402 + -0.00004415 -0.00004402 0.00011996 + #*EXTRAS*# Step: 12 Bead: 36 + 0.00012014 -0.00004414 -0.00004411 + -0.00004414 0.00012003 -0.00004399 + -0.00004411 -0.00004399 0.00012011 + #*EXTRAS*# Step: 13 Bead: 36 + 0.00012024 -0.00004411 -0.00004409 + -0.00004411 0.00012014 -0.00004397 + -0.00004409 -0.00004397 0.00012020 + #*EXTRAS*# Step: 14 Bead: 36 + 0.00012030 -0.00004409 -0.00004407 + -0.00004409 0.00012021 -0.00004396 + -0.00004407 -0.00004396 0.00012026 + #*EXTRAS*# Step: 15 Bead: 36 + 0.00012034 -0.00004407 -0.00004406 + -0.00004407 0.00012025 -0.00004395 + -0.00004406 -0.00004395 0.00012030 + #*EXTRAS*# Step: 16 Bead: 36 + 0.00012036 -0.00004407 -0.00004405 + -0.00004407 0.00012028 -0.00004395 + -0.00004405 -0.00004395 0.00012032 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_37 b/drivers/py/pes/friction/frictionH/060K/inst.fric_37 new file mode 100644 index 000000000..b2372b603 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_37 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 37 + 0.00011076 -0.00004208 -0.00004216 + -0.00004208 0.00011078 -0.00004213 + -0.00004216 -0.00004213 0.00011084 + #*EXTRAS*# Step: 1 Bead: 37 + 0.00010880 -0.00004066 -0.00004070 + -0.00004066 0.00010882 -0.00004067 + -0.00004070 -0.00004067 0.00010886 + #*EXTRAS*# Step: 2 Bead: 37 + 0.00010723 -0.00003930 -0.00003928 + -0.00003930 0.00010722 -0.00003931 + -0.00003928 -0.00003931 0.00010720 + #*EXTRAS*# Step: 3 Bead: 37 + 0.00010671 -0.00003881 -0.00003878 + -0.00003881 0.00010670 -0.00003884 + -0.00003878 -0.00003884 0.00010664 + #*EXTRAS*# Step: 4 Bead: 37 + 0.00010877 -0.00004063 -0.00004067 + -0.00004063 0.00010878 -0.00004064 + -0.00004067 -0.00004064 0.00010882 + #*EXTRAS*# Step: 5 Bead: 37 + 0.00011196 -0.00004282 -0.00004287 + -0.00004282 0.00011193 -0.00004285 + -0.00004287 -0.00004285 0.00011202 + #*EXTRAS*# Step: 6 Bead: 37 + 0.00011438 -0.00004405 -0.00004387 + -0.00004405 0.00011409 -0.00004382 + -0.00004387 -0.00004382 0.00011441 + #*EXTRAS*# Step: 7 Bead: 37 + 0.00011592 -0.00004450 -0.00004422 + -0.00004450 0.00011551 -0.00004413 + -0.00004422 -0.00004413 0.00011593 + #*EXTRAS*# Step: 8 Bead: 37 + 0.00011687 -0.00004462 -0.00004434 + -0.00004462 0.00011645 -0.00004422 + -0.00004434 -0.00004422 0.00011688 + #*EXTRAS*# Step: 9 Bead: 37 + 0.00011748 -0.00004463 -0.00004437 + -0.00004463 0.00011708 -0.00004424 + -0.00004437 -0.00004424 0.00011748 + #*EXTRAS*# Step: 10 Bead: 37 + 0.00011786 -0.00004461 -0.00004438 + -0.00004461 0.00011750 -0.00004424 + -0.00004438 -0.00004424 0.00011786 + #*EXTRAS*# Step: 11 Bead: 37 + 0.00011811 -0.00004458 -0.00004438 + -0.00004458 0.00011776 -0.00004423 + -0.00004438 -0.00004423 0.00011811 + #*EXTRAS*# Step: 12 Bead: 37 + 0.00011827 -0.00004456 -0.00004437 + -0.00004456 0.00011794 -0.00004422 + -0.00004437 -0.00004422 0.00011827 + #*EXTRAS*# Step: 13 Bead: 37 + 0.00011837 -0.00004455 -0.00004437 + -0.00004455 0.00011805 -0.00004422 + -0.00004437 -0.00004422 0.00011837 + #*EXTRAS*# Step: 14 Bead: 37 + 0.00011843 -0.00004454 -0.00004436 + -0.00004454 0.00011812 -0.00004421 + -0.00004436 -0.00004421 0.00011843 + #*EXTRAS*# Step: 15 Bead: 37 + 0.00011848 -0.00004453 -0.00004436 + -0.00004453 0.00011817 -0.00004421 + -0.00004436 -0.00004421 0.00011847 + #*EXTRAS*# Step: 16 Bead: 37 + 0.00011850 -0.00004453 -0.00004436 + -0.00004453 0.00011820 -0.00004421 + -0.00004436 -0.00004421 0.00011850 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_38 b/drivers/py/pes/friction/frictionH/060K/inst.fric_38 new file mode 100644 index 000000000..358673c0d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_38 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 38 + 0.00011010 -0.00004163 -0.00004170 + -0.00004163 0.00011012 -0.00004168 + -0.00004170 -0.00004168 0.00011018 + #*EXTRAS*# Step: 1 Bead: 38 + 0.00010798 -0.00003998 -0.00003998 + -0.00003998 0.00010798 -0.00003998 + -0.00003998 -0.00003998 0.00010800 + #*EXTRAS*# Step: 2 Bead: 38 + 0.00010623 -0.00003833 -0.00003828 + -0.00003833 0.00010622 -0.00003838 + -0.00003828 -0.00003838 0.00010611 + #*EXTRAS*# Step: 3 Bead: 38 + 0.00010548 -0.00003754 -0.00003748 + -0.00003754 0.00010548 -0.00003763 + -0.00003748 -0.00003763 0.00010529 + #*EXTRAS*# Step: 4 Bead: 38 + 0.00010729 -0.00003936 -0.00003934 + -0.00003936 0.00010728 -0.00003937 + -0.00003934 -0.00003937 0.00010727 + #*EXTRAS*# Step: 5 Bead: 38 + 0.00011034 -0.00004180 -0.00004187 + -0.00004180 0.00011037 -0.00004185 + -0.00004187 -0.00004185 0.00011042 + #*EXTRAS*# Step: 6 Bead: 38 + 0.00011263 -0.00004321 -0.00004320 + -0.00004321 0.00011254 -0.00004318 + -0.00004320 -0.00004318 0.00011268 + #*EXTRAS*# Step: 7 Bead: 38 + 0.00011411 -0.00004393 -0.00004379 + -0.00004393 0.00011385 -0.00004374 + -0.00004379 -0.00004374 0.00011415 + #*EXTRAS*# Step: 8 Bead: 38 + 0.00011502 -0.00004427 -0.00004404 + -0.00004427 0.00011468 -0.00004398 + -0.00004404 -0.00004398 0.00011505 + #*EXTRAS*# Step: 9 Bead: 38 + 0.00011560 -0.00004444 -0.00004417 + -0.00004444 0.00011521 -0.00004409 + -0.00004417 -0.00004409 0.00011563 + #*EXTRAS*# Step: 10 Bead: 38 + 0.00011598 -0.00004451 -0.00004423 + -0.00004451 0.00011557 -0.00004414 + -0.00004423 -0.00004414 0.00011600 + #*EXTRAS*# Step: 11 Bead: 38 + 0.00011622 -0.00004456 -0.00004427 + -0.00004456 0.00011580 -0.00004417 + -0.00004427 -0.00004417 0.00011623 + #*EXTRAS*# Step: 12 Bead: 38 + 0.00011637 -0.00004458 -0.00004429 + -0.00004458 0.00011595 -0.00004418 + -0.00004429 -0.00004418 0.00011639 + #*EXTRAS*# Step: 13 Bead: 38 + 0.00011647 -0.00004459 -0.00004430 + -0.00004459 0.00011605 -0.00004419 + -0.00004430 -0.00004419 0.00011649 + #*EXTRAS*# Step: 14 Bead: 38 + 0.00011654 -0.00004460 -0.00004431 + -0.00004460 0.00011611 -0.00004420 + -0.00004431 -0.00004420 0.00011655 + #*EXTRAS*# Step: 15 Bead: 38 + 0.00011658 -0.00004460 -0.00004431 + -0.00004460 0.00011615 -0.00004420 + -0.00004431 -0.00004420 0.00011659 + #*EXTRAS*# Step: 16 Bead: 38 + 0.00011660 -0.00004460 -0.00004431 + -0.00004460 0.00011618 -0.00004420 + -0.00004431 -0.00004420 0.00011661 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_39 b/drivers/py/pes/friction/frictionH/060K/inst.fric_39 new file mode 100644 index 000000000..afd657b0a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_39 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 39 + 0.00010946 -0.00004117 -0.00004123 + -0.00004117 0.00010948 -0.00004120 + -0.00004123 -0.00004120 0.00010953 + #*EXTRAS*# Step: 1 Bead: 39 + 0.00010719 -0.00003927 -0.00003925 + -0.00003927 0.00010719 -0.00003928 + -0.00003925 -0.00003928 0.00010716 + #*EXTRAS*# Step: 2 Bead: 39 + 0.00010531 -0.00003735 -0.00003728 + -0.00003735 0.00010531 -0.00003744 + -0.00003728 -0.00003744 0.00010510 + #*EXTRAS*# Step: 3 Bead: 39 + 0.00010438 -0.00003624 -0.00003617 + -0.00003624 0.00010438 -0.00003639 + -0.00003617 -0.00003639 0.00010407 + #*EXTRAS*# Step: 4 Bead: 39 + 0.00010591 -0.00003800 -0.00003794 + -0.00003800 0.00010590 -0.00003806 + -0.00003794 -0.00003806 0.00010576 + #*EXTRAS*# Step: 5 Bead: 39 + 0.00010882 -0.00004067 -0.00004071 + -0.00004067 0.00010883 -0.00004069 + -0.00004071 -0.00004069 0.00010888 + #*EXTRAS*# Step: 6 Bead: 39 + 0.00011099 -0.00004223 -0.00004230 + -0.00004223 0.00011100 -0.00004228 + -0.00004230 -0.00004228 0.00011106 + #*EXTRAS*# Step: 7 Bead: 39 + 0.00011241 -0.00004308 -0.00004310 + -0.00004308 0.00011234 -0.00004308 + -0.00004310 -0.00004308 0.00011246 + #*EXTRAS*# Step: 8 Bead: 39 + 0.00011328 -0.00004355 -0.00004349 + -0.00004355 0.00011312 -0.00004346 + -0.00004349 -0.00004346 0.00011333 + #*EXTRAS*# Step: 9 Bead: 39 + 0.00011383 -0.00004381 -0.00004369 + -0.00004381 0.00011361 -0.00004365 + -0.00004369 -0.00004365 0.00011387 + #*EXTRAS*# Step: 10 Bead: 39 + 0.00011419 -0.00004397 -0.00004381 + -0.00004397 0.00011392 -0.00004377 + -0.00004381 -0.00004377 0.00011423 + #*EXTRAS*# Step: 11 Bead: 39 + 0.00011442 -0.00004406 -0.00004388 + -0.00004406 0.00011413 -0.00004383 + -0.00004388 -0.00004383 0.00011445 + #*EXTRAS*# Step: 12 Bead: 39 + 0.00011457 -0.00004412 -0.00004392 + -0.00004412 0.00011426 -0.00004387 + -0.00004392 -0.00004387 0.00011460 + #*EXTRAS*# Step: 13 Bead: 39 + 0.00011466 -0.00004415 -0.00004395 + -0.00004415 0.00011435 -0.00004389 + -0.00004395 -0.00004389 0.00011469 + #*EXTRAS*# Step: 14 Bead: 39 + 0.00011472 -0.00004417 -0.00004397 + -0.00004417 0.00011440 -0.00004391 + -0.00004397 -0.00004391 0.00011475 + #*EXTRAS*# Step: 15 Bead: 39 + 0.00011476 -0.00004419 -0.00004398 + -0.00004419 0.00011444 -0.00004392 + -0.00004398 -0.00004392 0.00011479 + #*EXTRAS*# Step: 16 Bead: 39 + 0.00011479 -0.00004420 -0.00004398 + -0.00004420 0.00011446 -0.00004392 + -0.00004398 -0.00004392 0.00011482 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_40 b/drivers/py/pes/friction/frictionH/060K/inst.fric_40 new file mode 100644 index 000000000..226fc8748 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_40 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 40 + 0.00010885 -0.00004069 -0.00004073 + -0.00004069 0.00010886 -0.00004071 + -0.00004073 -0.00004071 0.00010891 + #*EXTRAS*# Step: 1 Bead: 40 + 0.00010645 -0.00003856 -0.00003852 + -0.00003856 0.00010645 -0.00003860 + -0.00003852 -0.00003860 0.00010636 + #*EXTRAS*# Step: 2 Bead: 40 + 0.00010448 -0.00003636 -0.00003629 + -0.00003636 0.00010448 -0.00003650 + -0.00003629 -0.00003650 0.00010418 + #*EXTRAS*# Step: 3 Bead: 40 + 0.00010342 -0.00003494 -0.00003488 + -0.00003494 0.00010341 -0.00003513 + -0.00003488 -0.00003513 0.00010303 + #*EXTRAS*# Step: 4 Bead: 40 + 0.00010466 -0.00003658 -0.00003651 + -0.00003658 0.00010466 -0.00003672 + -0.00003651 -0.00003672 0.00010438 + #*EXTRAS*# Step: 5 Bead: 40 + 0.00010738 -0.00003945 -0.00003943 + -0.00003945 0.00010738 -0.00003945 + -0.00003943 -0.00003945 0.00010737 + #*EXTRAS*# Step: 6 Bead: 40 + 0.00010945 -0.00004116 -0.00004121 + -0.00004116 0.00010947 -0.00004119 + -0.00004121 -0.00004119 0.00010952 + #*EXTRAS*# Step: 7 Bead: 40 + 0.00011081 -0.00004211 -0.00004218 + -0.00004211 0.00011082 -0.00004216 + -0.00004218 -0.00004216 0.00011088 + #*EXTRAS*# Step: 8 Bead: 40 + 0.00011164 -0.00004263 -0.00004269 + -0.00004263 0.00011163 -0.00004267 + -0.00004269 -0.00004267 0.00011171 + #*EXTRAS*# Step: 9 Bead: 40 + 0.00011217 -0.00004295 -0.00004298 + -0.00004295 0.00011212 -0.00004296 + -0.00004298 -0.00004296 0.00011223 + #*EXTRAS*# Step: 10 Bead: 40 + 0.00011251 -0.00004314 -0.00004314 + -0.00004314 0.00011243 -0.00004312 + -0.00004314 -0.00004312 0.00011256 + #*EXTRAS*# Step: 11 Bead: 40 + 0.00011272 -0.00004326 -0.00004325 + -0.00004326 0.00011262 -0.00004322 + -0.00004325 -0.00004322 0.00011278 + #*EXTRAS*# Step: 12 Bead: 40 + 0.00011286 -0.00004333 -0.00004331 + -0.00004333 0.00011275 -0.00004329 + -0.00004331 -0.00004329 0.00011292 + #*EXTRAS*# Step: 13 Bead: 40 + 0.00011295 -0.00004338 -0.00004335 + -0.00004338 0.00011283 -0.00004332 + -0.00004335 -0.00004332 0.00011301 + #*EXTRAS*# Step: 14 Bead: 40 + 0.00011301 -0.00004341 -0.00004337 + -0.00004341 0.00011288 -0.00004335 + -0.00004337 -0.00004335 0.00011306 + #*EXTRAS*# Step: 15 Bead: 40 + 0.00011305 -0.00004343 -0.00004339 + -0.00004343 0.00011291 -0.00004336 + -0.00004339 -0.00004336 0.00011310 + #*EXTRAS*# Step: 16 Bead: 40 + 0.00011307 -0.00004344 -0.00004340 + -0.00004344 0.00011293 -0.00004337 + -0.00004340 -0.00004337 0.00011312 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_41 b/drivers/py/pes/friction/frictionH/060K/inst.fric_41 new file mode 100644 index 000000000..9ae4df75c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_41 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 41 + 0.00010826 -0.00004021 -0.00004023 + -0.00004021 0.00010826 -0.00004022 + -0.00004023 -0.00004022 0.00010830 + #*EXTRAS*# Step: 1 Bead: 41 + 0.00010576 -0.00003784 -0.00003779 + -0.00003784 0.00010576 -0.00003792 + -0.00003779 -0.00003792 0.00010560 + #*EXTRAS*# Step: 2 Bead: 41 + 0.00010374 -0.00003539 -0.00003532 + -0.00003539 0.00010373 -0.00003557 + -0.00003532 -0.00003557 0.00010337 + #*EXTRAS*# Step: 3 Bead: 41 + 0.00010261 -0.00003366 -0.00003364 + -0.00003366 0.00010256 -0.00003385 + -0.00003364 -0.00003385 0.00010218 + #*EXTRAS*# Step: 4 Bead: 41 + 0.00010357 -0.00003516 -0.00003510 + -0.00003516 0.00010356 -0.00003534 + -0.00003510 -0.00003534 0.00010319 + #*EXTRAS*# Step: 5 Bead: 41 + 0.00010604 -0.00003814 -0.00003809 + -0.00003814 0.00010604 -0.00003820 + -0.00003809 -0.00003820 0.00010590 + #*EXTRAS*# Step: 6 Bead: 41 + 0.00010799 -0.00003999 -0.00003999 + -0.00003999 0.00010799 -0.00003999 + -0.00003999 -0.00003999 0.00010802 + #*EXTRAS*# Step: 7 Bead: 41 + 0.00010930 -0.00004105 -0.00004110 + -0.00004105 0.00010932 -0.00004107 + -0.00004110 -0.00004107 0.00010937 + #*EXTRAS*# Step: 8 Bead: 41 + 0.00011010 -0.00004163 -0.00004170 + -0.00004163 0.00011012 -0.00004167 + -0.00004170 -0.00004167 0.00011017 + #*EXTRAS*# Step: 9 Bead: 41 + 0.00011060 -0.00004197 -0.00004205 + -0.00004197 0.00011062 -0.00004203 + -0.00004205 -0.00004203 0.00011068 + #*EXTRAS*# Step: 10 Bead: 41 + 0.00011092 -0.00004218 -0.00004226 + -0.00004218 0.00011094 -0.00004224 + -0.00004226 -0.00004224 0.00011100 + #*EXTRAS*# Step: 11 Bead: 41 + 0.00011113 -0.00004232 -0.00004239 + -0.00004232 0.00011114 -0.00004237 + -0.00004239 -0.00004237 0.00011120 + #*EXTRAS*# Step: 12 Bead: 41 + 0.00011127 -0.00004240 -0.00004247 + -0.00004240 0.00011127 -0.00004245 + -0.00004247 -0.00004245 0.00011134 + #*EXTRAS*# Step: 13 Bead: 41 + 0.00011135 -0.00004246 -0.00004252 + -0.00004246 0.00011135 -0.00004250 + -0.00004252 -0.00004250 0.00011142 + #*EXTRAS*# Step: 14 Bead: 41 + 0.00011141 -0.00004249 -0.00004256 + -0.00004249 0.00011140 -0.00004254 + -0.00004256 -0.00004254 0.00011147 + #*EXTRAS*# Step: 15 Bead: 41 + 0.00011144 -0.00004251 -0.00004258 + -0.00004251 0.00011144 -0.00004256 + -0.00004258 -0.00004256 0.00011151 + #*EXTRAS*# Step: 16 Bead: 41 + 0.00011146 -0.00004252 -0.00004259 + -0.00004252 0.00011146 -0.00004257 + -0.00004259 -0.00004257 0.00011153 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_42 b/drivers/py/pes/friction/frictionH/060K/inst.fric_42 new file mode 100644 index 000000000..9532cafc9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_42 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 42 + 0.00010769 -0.00003973 -0.00003972 + -0.00003973 0.00010769 -0.00003973 + -0.00003972 -0.00003973 0.00010770 + #*EXTRAS*# Step: 1 Bead: 42 + 0.00010513 -0.00003714 -0.00003707 + -0.00003714 0.00010513 -0.00003724 + -0.00003707 -0.00003724 0.00010489 + #*EXTRAS*# Step: 2 Bead: 42 + 0.00010309 -0.00003444 -0.00003439 + -0.00003444 0.00010306 -0.00003463 + -0.00003439 -0.00003463 0.00010268 + #*EXTRAS*# Step: 3 Bead: 42 + 0.00010191 -0.00003243 -0.00003243 + -0.00003243 0.00010182 -0.00003258 + -0.00003243 -0.00003258 0.00010150 + #*EXTRAS*# Step: 4 Bead: 42 + 0.00010266 -0.00003375 -0.00003371 + -0.00003375 0.00010261 -0.00003393 + -0.00003371 -0.00003393 0.00010223 + #*EXTRAS*# Step: 5 Bead: 42 + 0.00010483 -0.00003679 -0.00003672 + -0.00003679 0.00010483 -0.00003691 + -0.00003672 -0.00003691 0.00010456 + #*EXTRAS*# Step: 6 Bead: 42 + 0.00010662 -0.00003873 -0.00003869 + -0.00003873 0.00010662 -0.00003876 + -0.00003869 -0.00003876 0.00010655 + #*EXTRAS*# Step: 7 Bead: 42 + 0.00010788 -0.00003989 -0.00003989 + -0.00003989 0.00010788 -0.00003989 + -0.00003989 -0.00003989 0.00010790 + #*EXTRAS*# Step: 8 Bead: 42 + 0.00010864 -0.00004053 -0.00004056 + -0.00004053 0.00010866 -0.00004054 + -0.00004056 -0.00004054 0.00010870 + #*EXTRAS*# Step: 9 Bead: 42 + 0.00010913 -0.00004091 -0.00004096 + -0.00004091 0.00010915 -0.00004094 + -0.00004096 -0.00004094 0.00010920 + #*EXTRAS*# Step: 10 Bead: 42 + 0.00010944 -0.00004115 -0.00004121 + -0.00004115 0.00010946 -0.00004118 + -0.00004121 -0.00004118 0.00010951 + #*EXTRAS*# Step: 11 Bead: 42 + 0.00010963 -0.00004129 -0.00004136 + -0.00004129 0.00010966 -0.00004133 + -0.00004136 -0.00004133 0.00010971 + #*EXTRAS*# Step: 12 Bead: 42 + 0.00010976 -0.00004139 -0.00004145 + -0.00004139 0.00010979 -0.00004143 + -0.00004145 -0.00004143 0.00010984 + #*EXTRAS*# Step: 13 Bead: 42 + 0.00010984 -0.00004145 -0.00004152 + -0.00004145 0.00010987 -0.00004149 + -0.00004152 -0.00004149 0.00010992 + #*EXTRAS*# Step: 14 Bead: 42 + 0.00010990 -0.00004148 -0.00004155 + -0.00004148 0.00010992 -0.00004153 + -0.00004155 -0.00004153 0.00010997 + #*EXTRAS*# Step: 15 Bead: 42 + 0.00010993 -0.00004151 -0.00004158 + -0.00004151 0.00010995 -0.00004155 + -0.00004158 -0.00004155 0.00011001 + #*EXTRAS*# Step: 16 Bead: 42 + 0.00010995 -0.00004152 -0.00004159 + -0.00004152 0.00010998 -0.00004157 + -0.00004159 -0.00004157 0.00011003 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_43 b/drivers/py/pes/friction/frictionH/060K/inst.fric_43 new file mode 100644 index 000000000..71cfadacc --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_43 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 43 + 0.00010715 -0.00003923 -0.00003921 + -0.00003923 0.00010715 -0.00003925 + -0.00003921 -0.00003925 0.00010712 + #*EXTRAS*# Step: 1 Bead: 43 + 0.00010454 -0.00003644 -0.00003637 + -0.00003644 0.00010454 -0.00003658 + -0.00003637 -0.00003658 0.00010425 + #*EXTRAS*# Step: 2 Bead: 43 + 0.00010253 -0.00003353 -0.00003350 + -0.00003353 0.00010248 -0.00003372 + -0.00003350 -0.00003372 0.00010210 + #*EXTRAS*# Step: 3 Bead: 43 + 0.00010129 -0.00003125 -0.00003127 + -0.00003125 0.00010117 -0.00003135 + -0.00003127 -0.00003135 0.00010094 + #*EXTRAS*# Step: 4 Bead: 43 + 0.00010188 -0.00003237 -0.00003238 + -0.00003237 0.00010179 -0.00003253 + -0.00003238 -0.00003253 0.00010147 + #*EXTRAS*# Step: 5 Bead: 43 + 0.00010377 -0.00003543 -0.00003536 + -0.00003543 0.00010376 -0.00003560 + -0.00003536 -0.00003560 0.00010340 + #*EXTRAS*# Step: 6 Bead: 43 + 0.00010537 -0.00003741 -0.00003735 + -0.00003741 0.00010537 -0.00003751 + -0.00003735 -0.00003751 0.00010516 + #*EXTRAS*# Step: 7 Bead: 43 + 0.00010654 -0.00003865 -0.00003861 + -0.00003865 0.00010654 -0.00003868 + -0.00003861 -0.00003868 0.00010646 + #*EXTRAS*# Step: 8 Bead: 43 + 0.00010727 -0.00003935 -0.00003933 + -0.00003935 0.00010727 -0.00003936 + -0.00003933 -0.00003936 0.00010725 + #*EXTRAS*# Step: 9 Bead: 43 + 0.00010774 -0.00003977 -0.00003976 + -0.00003977 0.00010774 -0.00003977 + -0.00003976 -0.00003977 0.00010775 + #*EXTRAS*# Step: 10 Bead: 43 + 0.00010803 -0.00004002 -0.00004003 + -0.00004002 0.00010803 -0.00004003 + -0.00004003 -0.00004003 0.00010806 + #*EXTRAS*# Step: 11 Bead: 43 + 0.00010822 -0.00004018 -0.00004020 + -0.00004018 0.00010823 -0.00004019 + -0.00004020 -0.00004019 0.00010826 + #*EXTRAS*# Step: 12 Bead: 43 + 0.00010834 -0.00004029 -0.00004031 + -0.00004029 0.00010835 -0.00004029 + -0.00004031 -0.00004029 0.00010839 + #*EXTRAS*# Step: 13 Bead: 43 + 0.00010842 -0.00004035 -0.00004037 + -0.00004035 0.00010843 -0.00004036 + -0.00004037 -0.00004036 0.00010847 + #*EXTRAS*# Step: 14 Bead: 43 + 0.00010847 -0.00004039 -0.00004042 + -0.00004039 0.00010848 -0.00004040 + -0.00004042 -0.00004040 0.00010852 + #*EXTRAS*# Step: 15 Bead: 43 + 0.00010850 -0.00004042 -0.00004044 + -0.00004042 0.00010851 -0.00004043 + -0.00004044 -0.00004043 0.00010855 + #*EXTRAS*# Step: 16 Bead: 43 + 0.00010853 -0.00004043 -0.00004046 + -0.00004043 0.00010853 -0.00004044 + -0.00004046 -0.00004044 0.00010857 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_44 b/drivers/py/pes/friction/frictionH/060K/inst.fric_44 new file mode 100644 index 000000000..0e28a7e9d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_44 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 44 + 0.00010664 -0.00003874 -0.00003871 + -0.00003874 0.00010664 -0.00003877 + -0.00003871 -0.00003877 0.00010656 + #*EXTRAS*# Step: 1 Bead: 44 + 0.00010402 -0.00003577 -0.00003570 + -0.00003577 0.00010401 -0.00003593 + -0.00003570 -0.00003593 0.00010367 + #*EXTRAS*# Step: 2 Bead: 44 + 0.00010203 -0.00003266 -0.00003266 + -0.00003266 0.00010195 -0.00003282 + -0.00003266 -0.00003282 0.00010162 + #*EXTRAS*# Step: 3 Bead: 44 + 0.00010072 -0.00003012 -0.00003016 + -0.00003012 0.00010059 -0.00003016 + -0.00003016 -0.00003016 0.00010048 + #*EXTRAS*# Step: 4 Bead: 44 + 0.00010119 -0.00003106 -0.00003109 + -0.00003106 0.00010107 -0.00003115 + -0.00003109 -0.00003115 0.00010086 + #*EXTRAS*# Step: 5 Bead: 44 + 0.00010286 -0.00003409 -0.00003405 + -0.00003409 0.00010283 -0.00003428 + -0.00003405 -0.00003428 0.00010245 + #*EXTRAS*# Step: 6 Bead: 44 + 0.00010425 -0.00003608 -0.00003601 + -0.00003608 0.00010425 -0.00003623 + -0.00003601 -0.00003623 0.00010393 + #*EXTRAS*# Step: 7 Bead: 44 + 0.00010532 -0.00003736 -0.00003729 + -0.00003736 0.00010532 -0.00003746 + -0.00003729 -0.00003746 0.00010511 + #*EXTRAS*# Step: 8 Bead: 44 + 0.00010599 -0.00003809 -0.00003804 + -0.00003809 0.00010599 -0.00003815 + -0.00003804 -0.00003815 0.00010585 + #*EXTRAS*# Step: 9 Bead: 44 + 0.00010643 -0.00003854 -0.00003849 + -0.00003854 0.00010643 -0.00003858 + -0.00003849 -0.00003858 0.00010633 + #*EXTRAS*# Step: 10 Bead: 44 + 0.00010671 -0.00003881 -0.00003878 + -0.00003881 0.00010671 -0.00003884 + -0.00003878 -0.00003884 0.00010664 + #*EXTRAS*# Step: 11 Bead: 44 + 0.00010689 -0.00003899 -0.00003896 + -0.00003899 0.00010689 -0.00003901 + -0.00003896 -0.00003901 0.00010684 + #*EXTRAS*# Step: 12 Bead: 44 + 0.00010701 -0.00003910 -0.00003907 + -0.00003910 0.00010700 -0.00003912 + -0.00003907 -0.00003912 0.00010696 + #*EXTRAS*# Step: 13 Bead: 44 + 0.00010708 -0.00003917 -0.00003914 + -0.00003917 0.00010708 -0.00003918 + -0.00003914 -0.00003918 0.00010704 + #*EXTRAS*# Step: 14 Bead: 44 + 0.00010713 -0.00003921 -0.00003919 + -0.00003921 0.00010713 -0.00003923 + -0.00003919 -0.00003923 0.00010710 + #*EXTRAS*# Step: 15 Bead: 44 + 0.00010716 -0.00003924 -0.00003922 + -0.00003924 0.00010716 -0.00003926 + -0.00003922 -0.00003926 0.00010713 + #*EXTRAS*# Step: 16 Bead: 44 + 0.00010718 -0.00003926 -0.00003924 + -0.00003926 0.00010718 -0.00003927 + -0.00003924 -0.00003927 0.00010715 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_45 b/drivers/py/pes/friction/frictionH/060K/inst.fric_45 new file mode 100644 index 000000000..f63352d2b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_45 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 45 + 0.00010616 -0.00003826 -0.00003821 + -0.00003826 0.00010615 -0.00003831 + -0.00003821 -0.00003831 0.00010603 + #*EXTRAS*# Step: 1 Bead: 45 + 0.00010354 -0.00003511 -0.00003505 + -0.00003511 0.00010353 -0.00003530 + -0.00003505 -0.00003530 0.00010316 + #*EXTRAS*# Step: 2 Bead: 45 + 0.00010159 -0.00003183 -0.00003185 + -0.00003183 0.00010149 -0.00003196 + -0.00003185 -0.00003196 0.00010121 + #*EXTRAS*# Step: 3 Bead: 45 + 0.00010019 -0.00002906 -0.00002909 + -0.00002906 0.00010007 -0.00002903 + -0.00002909 -0.00002903 0.00010008 + #*EXTRAS*# Step: 4 Bead: 45 + 0.00010056 -0.00002981 -0.00002984 + -0.00002981 0.00010044 -0.00002983 + -0.00002984 -0.00002983 0.00010036 + #*EXTRAS*# Step: 5 Bead: 45 + 0.00010210 -0.00003279 -0.00003278 + -0.00003279 0.00010203 -0.00003296 + -0.00003278 -0.00003296 0.00010169 + #*EXTRAS*# Step: 6 Bead: 45 + 0.00010329 -0.00003475 -0.00003470 + -0.00003475 0.00010327 -0.00003494 + -0.00003470 -0.00003494 0.00010289 + #*EXTRAS*# Step: 7 Bead: 45 + 0.00010423 -0.00003605 -0.00003598 + -0.00003605 0.00010423 -0.00003621 + -0.00003598 -0.00003621 0.00010391 + #*EXTRAS*# Step: 8 Bead: 45 + 0.00010484 -0.00003680 -0.00003673 + -0.00003680 0.00010484 -0.00003693 + -0.00003673 -0.00003693 0.00010458 + #*EXTRAS*# Step: 9 Bead: 45 + 0.00010524 -0.00003726 -0.00003720 + -0.00003726 0.00010524 -0.00003737 + -0.00003720 -0.00003737 0.00010502 + #*EXTRAS*# Step: 10 Bead: 45 + 0.00010550 -0.00003755 -0.00003749 + -0.00003755 0.00010549 -0.00003764 + -0.00003749 -0.00003764 0.00010530 + #*EXTRAS*# Step: 11 Bead: 45 + 0.00010566 -0.00003774 -0.00003768 + -0.00003774 0.00010566 -0.00003781 + -0.00003768 -0.00003781 0.00010549 + #*EXTRAS*# Step: 12 Bead: 45 + 0.00010577 -0.00003785 -0.00003780 + -0.00003785 0.00010577 -0.00003792 + -0.00003780 -0.00003792 0.00010561 + #*EXTRAS*# Step: 13 Bead: 45 + 0.00010584 -0.00003793 -0.00003787 + -0.00003793 0.00010584 -0.00003799 + -0.00003787 -0.00003799 0.00010568 + #*EXTRAS*# Step: 14 Bead: 45 + 0.00010588 -0.00003797 -0.00003792 + -0.00003797 0.00010588 -0.00003804 + -0.00003792 -0.00003804 0.00010573 + #*EXTRAS*# Step: 15 Bead: 45 + 0.00010591 -0.00003800 -0.00003795 + -0.00003800 0.00010591 -0.00003807 + -0.00003795 -0.00003807 0.00010576 + #*EXTRAS*# Step: 16 Bead: 45 + 0.00010593 -0.00003802 -0.00003797 + -0.00003802 0.00010593 -0.00003809 + -0.00003797 -0.00003809 0.00010578 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_46 b/drivers/py/pes/friction/frictionH/060K/inst.fric_46 new file mode 100644 index 000000000..ce5fab2ce --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_46 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 46 + 0.00010571 -0.00003778 -0.00003773 + -0.00003778 0.00010570 -0.00003786 + -0.00003773 -0.00003786 0.00010554 + #*EXTRAS*# Step: 1 Bead: 46 + 0.00010312 -0.00003449 -0.00003444 + -0.00003449 0.00010310 -0.00003468 + -0.00003444 -0.00003468 0.00010271 + #*EXTRAS*# Step: 2 Bead: 46 + 0.00010119 -0.00003105 -0.00003108 + -0.00003105 0.00010107 -0.00003115 + -0.00003108 -0.00003115 0.00010086 + #*EXTRAS*# Step: 3 Bead: 46 + 0.00009968 -0.00002808 -0.00002807 + -0.00002808 0.00009961 -0.00002798 + -0.00002807 -0.00002798 0.00009974 + #*EXTRAS*# Step: 4 Bead: 46 + 0.00009997 -0.00002864 -0.00002865 + -0.00002864 0.00009987 -0.00002857 + -0.00002865 -0.00002857 0.00009993 + #*EXTRAS*# Step: 5 Bead: 46 + 0.00010144 -0.00003155 -0.00003157 + -0.00003155 0.00010133 -0.00003166 + -0.00003157 -0.00003166 0.00010108 + #*EXTRAS*# Step: 6 Bead: 46 + 0.00010248 -0.00003346 -0.00003343 + -0.00003346 0.00010243 -0.00003364 + -0.00003343 -0.00003364 0.00010206 + #*EXTRAS*# Step: 7 Bead: 46 + 0.00010330 -0.00003476 -0.00003470 + -0.00003476 0.00010328 -0.00003495 + -0.00003470 -0.00003495 0.00010290 + #*EXTRAS*# Step: 8 Bead: 46 + 0.00010383 -0.00003551 -0.00003545 + -0.00003551 0.00010382 -0.00003569 + -0.00003545 -0.00003569 0.00010347 + #*EXTRAS*# Step: 9 Bead: 46 + 0.00010418 -0.00003598 -0.00003591 + -0.00003598 0.00010418 -0.00003614 + -0.00003591 -0.00003614 0.00010385 + #*EXTRAS*# Step: 10 Bead: 46 + 0.00010441 -0.00003628 -0.00003621 + -0.00003628 0.00010441 -0.00003643 + -0.00003621 -0.00003643 0.00010411 + #*EXTRAS*# Step: 11 Bead: 46 + 0.00010456 -0.00003646 -0.00003640 + -0.00003646 0.00010456 -0.00003660 + -0.00003640 -0.00003660 0.00010427 + #*EXTRAS*# Step: 12 Bead: 46 + 0.00010466 -0.00003658 -0.00003652 + -0.00003658 0.00010466 -0.00003672 + -0.00003652 -0.00003672 0.00010438 + #*EXTRAS*# Step: 13 Bead: 46 + 0.00010472 -0.00003666 -0.00003659 + -0.00003666 0.00010472 -0.00003679 + -0.00003659 -0.00003679 0.00010445 + #*EXTRAS*# Step: 14 Bead: 46 + 0.00010476 -0.00003671 -0.00003664 + -0.00003671 0.00010476 -0.00003684 + -0.00003664 -0.00003684 0.00010449 + #*EXTRAS*# Step: 15 Bead: 46 + 0.00010479 -0.00003674 -0.00003667 + -0.00003674 0.00010479 -0.00003687 + -0.00003667 -0.00003687 0.00010452 + #*EXTRAS*# Step: 16 Bead: 46 + 0.00010480 -0.00003676 -0.00003669 + -0.00003676 0.00010480 -0.00003689 + -0.00003669 -0.00003689 0.00010454 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_47 b/drivers/py/pes/friction/frictionH/060K/inst.fric_47 new file mode 100644 index 000000000..46dfc1590 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_47 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 47 + 0.00010529 -0.00003732 -0.00003726 + -0.00003732 0.00010529 -0.00003742 + -0.00003726 -0.00003742 0.00010507 + #*EXTRAS*# Step: 1 Bead: 47 + 0.00010275 -0.00003390 -0.00003386 + -0.00003390 0.00010271 -0.00003409 + -0.00003386 -0.00003409 0.00010233 + #*EXTRAS*# Step: 2 Bead: 47 + 0.00010082 -0.00003032 -0.00003036 + -0.00003032 0.00010069 -0.00003037 + -0.00003036 -0.00003037 0.00010056 + #*EXTRAS*# Step: 3 Bead: 47 + 0.00009921 -0.00002716 -0.00002710 + -0.00002716 0.00009919 -0.00002699 + -0.00002710 -0.00002699 0.00009945 + #*EXTRAS*# Step: 4 Bead: 47 + 0.00009940 -0.00002754 -0.00002750 + -0.00002754 0.00009936 -0.00002740 + -0.00002750 -0.00002740 0.00009957 + #*EXTRAS*# Step: 5 Bead: 47 + 0.00010084 -0.00003037 -0.00003041 + -0.00003037 0.00010072 -0.00003042 + -0.00003041 -0.00003042 0.00010058 + #*EXTRAS*# Step: 6 Bead: 47 + 0.00010179 -0.00003222 -0.00003222 + -0.00003222 0.00010170 -0.00003236 + -0.00003222 -0.00003236 0.00010139 + #*EXTRAS*# Step: 7 Bead: 47 + 0.00010251 -0.00003350 -0.00003347 + -0.00003350 0.00010246 -0.00003368 + -0.00003347 -0.00003368 0.00010209 + #*EXTRAS*# Step: 8 Bead: 47 + 0.00010296 -0.00003425 -0.00003420 + -0.00003425 0.00010293 -0.00003444 + -0.00003420 -0.00003444 0.00010255 + #*EXTRAS*# Step: 9 Bead: 47 + 0.00010327 -0.00003472 -0.00003466 + -0.00003472 0.00010325 -0.00003491 + -0.00003466 -0.00003491 0.00010287 + #*EXTRAS*# Step: 10 Bead: 47 + 0.00010347 -0.00003501 -0.00003496 + -0.00003501 0.00010346 -0.00003520 + -0.00003496 -0.00003520 0.00010309 + #*EXTRAS*# Step: 11 Bead: 47 + 0.00010360 -0.00003520 -0.00003514 + -0.00003520 0.00010359 -0.00003539 + -0.00003514 -0.00003539 0.00010323 + #*EXTRAS*# Step: 12 Bead: 47 + 0.00010369 -0.00003532 -0.00003526 + -0.00003532 0.00010368 -0.00003550 + -0.00003526 -0.00003550 0.00010332 + #*EXTRAS*# Step: 13 Bead: 47 + 0.00010375 -0.00003540 -0.00003534 + -0.00003540 0.00010374 -0.00003558 + -0.00003534 -0.00003558 0.00010338 + #*EXTRAS*# Step: 14 Bead: 47 + 0.00010378 -0.00003545 -0.00003538 + -0.00003545 0.00010377 -0.00003563 + -0.00003538 -0.00003563 0.00010342 + #*EXTRAS*# Step: 15 Bead: 47 + 0.00010380 -0.00003548 -0.00003542 + -0.00003548 0.00010380 -0.00003566 + -0.00003542 -0.00003566 0.00010344 + #*EXTRAS*# Step: 16 Bead: 47 + 0.00010382 -0.00003550 -0.00003544 + -0.00003550 0.00010381 -0.00003568 + -0.00003544 -0.00003568 0.00010346 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_48 b/drivers/py/pes/friction/frictionH/060K/inst.fric_48 new file mode 100644 index 000000000..c44ace386 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_48 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 48 + 0.00010490 -0.00003687 -0.00003681 + -0.00003687 0.00010490 -0.00003699 + -0.00003681 -0.00003699 0.00010465 + #*EXTRAS*# Step: 1 Bead: 48 + 0.00010241 -0.00003333 -0.00003331 + -0.00003333 0.00010235 -0.00003351 + -0.00003331 -0.00003351 0.00010199 + #*EXTRAS*# Step: 2 Bead: 48 + 0.00010048 -0.00002964 -0.00002968 + -0.00002964 0.00010036 -0.00002965 + -0.00002968 -0.00002965 0.00010030 + #*EXTRAS*# Step: 3 Bead: 48 + 0.00009877 -0.00002630 -0.00002619 + -0.00002630 0.00009882 -0.00002608 + -0.00002619 -0.00002608 0.00009919 + #*EXTRAS*# Step: 4 Bead: 48 + 0.00009888 -0.00002651 -0.00002642 + -0.00002651 0.00009891 -0.00002631 + -0.00002642 -0.00002631 0.00009925 + #*EXTRAS*# Step: 5 Bead: 48 + 0.00010029 -0.00002927 -0.00002930 + -0.00002927 0.00010017 -0.00002925 + -0.00002930 -0.00002925 0.00010016 + #*EXTRAS*# Step: 6 Bead: 48 + 0.00010118 -0.00003104 -0.00003107 + -0.00003104 0.00010106 -0.00003113 + -0.00003107 -0.00003113 0.00010085 + #*EXTRAS*# Step: 7 Bead: 48 + 0.00010183 -0.00003230 -0.00003230 + -0.00003230 0.00010174 -0.00003245 + -0.00003230 -0.00003245 0.00010143 + #*EXTRAS*# Step: 8 Bead: 48 + 0.00010224 -0.00003303 -0.00003301 + -0.00003303 0.00010217 -0.00003320 + -0.00003301 -0.00003320 0.00010182 + #*EXTRAS*# Step: 9 Bead: 48 + 0.00010251 -0.00003349 -0.00003347 + -0.00003349 0.00010245 -0.00003368 + -0.00003347 -0.00003368 0.00010208 + #*EXTRAS*# Step: 10 Bead: 48 + 0.00010268 -0.00003379 -0.00003375 + -0.00003379 0.00010264 -0.00003398 + -0.00003375 -0.00003398 0.00010226 + #*EXTRAS*# Step: 11 Bead: 48 + 0.00010279 -0.00003397 -0.00003394 + -0.00003397 0.00010276 -0.00003417 + -0.00003394 -0.00003417 0.00010237 + #*EXTRAS*# Step: 12 Bead: 48 + 0.00010287 -0.00003409 -0.00003405 + -0.00003409 0.00010283 -0.00003429 + -0.00003405 -0.00003429 0.00010245 + #*EXTRAS*# Step: 13 Bead: 48 + 0.00010292 -0.00003417 -0.00003413 + -0.00003417 0.00010288 -0.00003436 + -0.00003413 -0.00003436 0.00010250 + #*EXTRAS*# Step: 14 Bead: 48 + 0.00010295 -0.00003422 -0.00003418 + -0.00003422 0.00010292 -0.00003441 + -0.00003418 -0.00003441 0.00010253 + #*EXTRAS*# Step: 15 Bead: 48 + 0.00010297 -0.00003425 -0.00003421 + -0.00003425 0.00010294 -0.00003444 + -0.00003421 -0.00003444 0.00010255 + #*EXTRAS*# Step: 16 Bead: 48 + 0.00010298 -0.00003427 -0.00003423 + -0.00003427 0.00010295 -0.00003446 + -0.00003423 -0.00003446 0.00010257 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_49 b/drivers/py/pes/friction/frictionH/060K/inst.fric_49 new file mode 100644 index 000000000..c89bfdbd6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_49 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 49 + 0.00010455 -0.00003644 -0.00003638 + -0.00003644 0.00010454 -0.00003659 + -0.00003638 -0.00003659 0.00010425 + #*EXTRAS*# Step: 1 Bead: 49 + 0.00010211 -0.00003281 -0.00003280 + -0.00003281 0.00010204 -0.00003297 + -0.00003280 -0.00003297 0.00010170 + #*EXTRAS*# Step: 2 Bead: 49 + 0.00010016 -0.00002901 -0.00002903 + -0.00002901 0.00010005 -0.00002898 + -0.00002903 -0.00002898 0.00010007 + #*EXTRAS*# Step: 3 Bead: 49 + 0.00009840 -0.00002549 -0.00002533 + -0.00002549 0.00009851 -0.00002523 + -0.00002533 -0.00002523 0.00009897 + #*EXTRAS*# Step: 4 Bead: 49 + 0.00009842 -0.00002555 -0.00002539 + -0.00002555 0.00009853 -0.00002529 + -0.00002539 -0.00002529 0.00009898 + #*EXTRAS*# Step: 5 Bead: 49 + 0.00009977 -0.00002825 -0.00002825 + -0.00002825 0.00009969 -0.00002816 + -0.00002825 -0.00002816 0.00009980 + #*EXTRAS*# Step: 6 Bead: 49 + 0.00010063 -0.00002994 -0.00002997 + -0.00002994 0.00010050 -0.00002996 + -0.00002997 -0.00002996 0.00010041 + #*EXTRAS*# Step: 7 Bead: 49 + 0.00010124 -0.00003116 -0.00003118 + -0.00003116 0.00010112 -0.00003125 + -0.00003118 -0.00003125 0.00010090 + #*EXTRAS*# Step: 8 Bead: 49 + 0.00010161 -0.00003187 -0.00003188 + -0.00003187 0.00010151 -0.00003200 + -0.00003188 -0.00003200 0.00010123 + #*EXTRAS*# Step: 9 Bead: 49 + 0.00010185 -0.00003233 -0.00003233 + -0.00003233 0.00010176 -0.00003248 + -0.00003233 -0.00003248 0.00010145 + #*EXTRAS*# Step: 10 Bead: 49 + 0.00010201 -0.00003261 -0.00003261 + -0.00003261 0.00010193 -0.00003277 + -0.00003261 -0.00003277 0.00010159 + #*EXTRAS*# Step: 11 Bead: 49 + 0.00010211 -0.00003280 -0.00003279 + -0.00003280 0.00010203 -0.00003296 + -0.00003279 -0.00003296 0.00010169 + #*EXTRAS*# Step: 12 Bead: 49 + 0.00010217 -0.00003291 -0.00003290 + -0.00003291 0.00010210 -0.00003309 + -0.00003290 -0.00003309 0.00010175 + #*EXTRAS*# Step: 13 Bead: 49 + 0.00010222 -0.00003299 -0.00003298 + -0.00003299 0.00010215 -0.00003316 + -0.00003298 -0.00003316 0.00010180 + #*EXTRAS*# Step: 14 Bead: 49 + 0.00010224 -0.00003304 -0.00003302 + -0.00003304 0.00010218 -0.00003321 + -0.00003302 -0.00003321 0.00010182 + #*EXTRAS*# Step: 15 Bead: 49 + 0.00010226 -0.00003307 -0.00003305 + -0.00003307 0.00010219 -0.00003324 + -0.00003305 -0.00003324 0.00010184 + #*EXTRAS*# Step: 16 Bead: 49 + 0.00010227 -0.00003309 -0.00003307 + -0.00003309 0.00010221 -0.00003326 + -0.00003307 -0.00003326 0.00010185 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_50 b/drivers/py/pes/friction/frictionH/060K/inst.fric_50 new file mode 100644 index 000000000..944a43a6c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_50 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 50 + 0.00010422 -0.00003604 -0.00003597 + -0.00003604 0.00010422 -0.00003619 + -0.00003597 -0.00003619 0.00010390 + #*EXTRAS*# Step: 1 Bead: 50 + 0.00010184 -0.00003231 -0.00003232 + -0.00003231 0.00010175 -0.00003246 + -0.00003232 -0.00003246 0.00010144 + #*EXTRAS*# Step: 2 Bead: 50 + 0.00009987 -0.00002843 -0.00002844 + -0.00002843 0.00009977 -0.00002836 + -0.00002844 -0.00002836 0.00009986 + #*EXTRAS*# Step: 3 Bead: 50 + 0.00009808 -0.00002474 -0.00002453 + -0.00002474 0.00009825 -0.00002444 + -0.00002453 -0.00002444 0.00009878 + #*EXTRAS*# Step: 4 Bead: 50 + 0.00009804 -0.00002465 -0.00002443 + -0.00002465 0.00009822 -0.00002434 + -0.00002443 -0.00002434 0.00009876 + #*EXTRAS*# Step: 5 Bead: 50 + 0.00009928 -0.00002730 -0.00002725 + -0.00002730 0.00009925 -0.00002715 + -0.00002725 -0.00002715 0.00009949 + #*EXTRAS*# Step: 6 Bead: 50 + 0.00010011 -0.00002891 -0.00002893 + -0.00002891 0.00010000 -0.00002887 + -0.00002893 -0.00002887 0.00010003 + #*EXTRAS*# Step: 7 Bead: 50 + 0.00010070 -0.00003009 -0.00003013 + -0.00003009 0.00010058 -0.00003013 + -0.00003013 -0.00003013 0.00010047 + #*EXTRAS*# Step: 8 Bead: 50 + 0.00010105 -0.00003078 -0.00003081 + -0.00003078 0.00010093 -0.00003086 + -0.00003081 -0.00003086 0.00010074 + #*EXTRAS*# Step: 9 Bead: 50 + 0.00010128 -0.00003123 -0.00003125 + -0.00003123 0.00010116 -0.00003133 + -0.00003125 -0.00003133 0.00010093 + #*EXTRAS*# Step: 10 Bead: 50 + 0.00010142 -0.00003151 -0.00003153 + -0.00003151 0.00010131 -0.00003162 + -0.00003153 -0.00003162 0.00010106 + #*EXTRAS*# Step: 11 Bead: 50 + 0.00010151 -0.00003169 -0.00003170 + -0.00003169 0.00010141 -0.00003181 + -0.00003170 -0.00003181 0.00010114 + #*EXTRAS*# Step: 12 Bead: 50 + 0.00010157 -0.00003180 -0.00003182 + -0.00003180 0.00010147 -0.00003193 + -0.00003182 -0.00003193 0.00010119 + #*EXTRAS*# Step: 13 Bead: 50 + 0.00010161 -0.00003187 -0.00003189 + -0.00003187 0.00010151 -0.00003200 + -0.00003189 -0.00003200 0.00010123 + #*EXTRAS*# Step: 14 Bead: 50 + 0.00010164 -0.00003192 -0.00003193 + -0.00003192 0.00010154 -0.00003205 + -0.00003193 -0.00003205 0.00010125 + #*EXTRAS*# Step: 15 Bead: 50 + 0.00010165 -0.00003195 -0.00003196 + -0.00003195 0.00010155 -0.00003209 + -0.00003196 -0.00003209 0.00010126 + #*EXTRAS*# Step: 16 Bead: 50 + 0.00010166 -0.00003197 -0.00003198 + -0.00003197 0.00010156 -0.00003211 + -0.00003198 -0.00003211 0.00010127 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_51 b/drivers/py/pes/friction/frictionH/060K/inst.fric_51 new file mode 100644 index 000000000..6b18adf50 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_51 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 51 + 0.00010393 -0.00003565 -0.00003558 + -0.00003565 0.00010392 -0.00003582 + -0.00003558 -0.00003582 0.00010358 + #*EXTRAS*# Step: 1 Bead: 51 + 0.00010160 -0.00003185 -0.00003187 + -0.00003185 0.00010150 -0.00003198 + -0.00003187 -0.00003198 0.00010122 + #*EXTRAS*# Step: 2 Bead: 51 + 0.00009959 -0.00002790 -0.00002788 + -0.00002790 0.00009952 -0.00002779 + -0.00002788 -0.00002779 0.00009968 + #*EXTRAS*# Step: 3 Bead: 51 + 0.00009782 -0.00002404 -0.00002380 + -0.00002404 0.00009805 -0.00002372 + -0.00002380 -0.00002372 0.00009863 + #*EXTRAS*# Step: 4 Bead: 51 + 0.00009774 -0.00002380 -0.00002354 + -0.00002380 0.00009798 -0.00002347 + -0.00002354 -0.00002347 0.00009858 + #*EXTRAS*# Step: 5 Bead: 51 + 0.00009884 -0.00002643 -0.00002633 + -0.00002643 0.00009888 -0.00002622 + -0.00002633 -0.00002622 0.00009923 + #*EXTRAS*# Step: 6 Bead: 51 + 0.00009963 -0.00002797 -0.00002796 + -0.00002797 0.00009956 -0.00002786 + -0.00002796 -0.00002786 0.00009971 + #*EXTRAS*# Step: 7 Bead: 51 + 0.00010021 -0.00002911 -0.00002913 + -0.00002911 0.00010010 -0.00002908 + -0.00002913 -0.00002908 0.00010010 + #*EXTRAS*# Step: 8 Bead: 51 + 0.00010054 -0.00002977 -0.00002980 + -0.00002977 0.00010042 -0.00002978 + -0.00002980 -0.00002978 0.00010034 + #*EXTRAS*# Step: 9 Bead: 51 + 0.00010076 -0.00003020 -0.00003023 + -0.00003020 0.00010063 -0.00003024 + -0.00003023 -0.00003024 0.00010051 + #*EXTRAS*# Step: 10 Bead: 51 + 0.00010089 -0.00003047 -0.00003051 + -0.00003047 0.00010077 -0.00003053 + -0.00003051 -0.00003053 0.00010062 + #*EXTRAS*# Step: 11 Bead: 51 + 0.00010098 -0.00003065 -0.00003068 + -0.00003065 0.00010086 -0.00003071 + -0.00003068 -0.00003071 0.00010069 + #*EXTRAS*# Step: 12 Bead: 51 + 0.00010104 -0.00003076 -0.00003079 + -0.00003076 0.00010092 -0.00003083 + -0.00003079 -0.00003083 0.00010073 + #*EXTRAS*# Step: 13 Bead: 51 + 0.00010107 -0.00003083 -0.00003086 + -0.00003083 0.00010095 -0.00003091 + -0.00003086 -0.00003091 0.00010076 + #*EXTRAS*# Step: 14 Bead: 51 + 0.00010110 -0.00003087 -0.00003090 + -0.00003087 0.00010098 -0.00003096 + -0.00003090 -0.00003096 0.00010078 + #*EXTRAS*# Step: 15 Bead: 51 + 0.00010111 -0.00003090 -0.00003093 + -0.00003090 0.00010099 -0.00003099 + -0.00003093 -0.00003099 0.00010079 + #*EXTRAS*# Step: 16 Bead: 51 + 0.00010112 -0.00003092 -0.00003095 + -0.00003092 0.00010100 -0.00003101 + -0.00003095 -0.00003101 0.00010080 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_52 b/drivers/py/pes/friction/frictionH/060K/inst.fric_52 new file mode 100644 index 000000000..f80f077bb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_52 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 52 + 0.00010366 -0.00003529 -0.00003522 + -0.00003529 0.00010365 -0.00003547 + -0.00003522 -0.00003547 0.00010329 + #*EXTRAS*# Step: 1 Bead: 52 + 0.00010138 -0.00003143 -0.00003145 + -0.00003143 0.00010127 -0.00003154 + -0.00003145 -0.00003154 0.00010102 + #*EXTRAS*# Step: 2 Bead: 52 + 0.00009934 -0.00002741 -0.00002737 + -0.00002741 0.00009930 -0.00002726 + -0.00002737 -0.00002726 0.00009953 + #*EXTRAS*# Step: 3 Bead: 52 + 0.00009762 -0.00002340 -0.00002312 + -0.00002340 0.00009788 -0.00002306 + -0.00002312 -0.00002306 0.00009850 + #*EXTRAS*# Step: 4 Bead: 52 + 0.00009751 -0.00002301 -0.00002272 + -0.00002301 0.00009780 -0.00002266 + -0.00002272 -0.00002266 0.00009843 + #*EXTRAS*# Step: 5 Bead: 52 + 0.00009846 -0.00002562 -0.00002547 + -0.00002562 0.00009856 -0.00002536 + -0.00002547 -0.00002536 0.00009900 + #*EXTRAS*# Step: 6 Bead: 52 + 0.00009918 -0.00002711 -0.00002705 + -0.00002711 0.00009916 -0.00002694 + -0.00002705 -0.00002694 0.00009943 + #*EXTRAS*# Step: 7 Bead: 52 + 0.00009975 -0.00002820 -0.00002820 + -0.00002820 0.00009967 -0.00002811 + -0.00002820 -0.00002811 0.00009979 + #*EXTRAS*# Step: 8 Bead: 52 + 0.00010007 -0.00002884 -0.00002886 + -0.00002884 0.00009997 -0.00002879 + -0.00002886 -0.00002879 0.00010000 + #*EXTRAS*# Step: 9 Bead: 52 + 0.00010029 -0.00002926 -0.00002928 + -0.00002926 0.00010017 -0.00002924 + -0.00002928 -0.00002924 0.00010015 + #*EXTRAS*# Step: 10 Bead: 52 + 0.00010042 -0.00002952 -0.00002955 + -0.00002952 0.00010029 -0.00002952 + -0.00002955 -0.00002952 0.00010025 + #*EXTRAS*# Step: 11 Bead: 52 + 0.00010050 -0.00002969 -0.00002972 + -0.00002969 0.00010038 -0.00002970 + -0.00002972 -0.00002970 0.00010031 + #*EXTRAS*# Step: 12 Bead: 52 + 0.00010056 -0.00002979 -0.00002983 + -0.00002979 0.00010043 -0.00002981 + -0.00002983 -0.00002981 0.00010035 + #*EXTRAS*# Step: 13 Bead: 52 + 0.00010059 -0.00002986 -0.00002990 + -0.00002986 0.00010046 -0.00002988 + -0.00002990 -0.00002988 0.00010038 + #*EXTRAS*# Step: 14 Bead: 52 + 0.00010061 -0.00002991 -0.00002994 + -0.00002991 0.00010049 -0.00002993 + -0.00002994 -0.00002993 0.00010040 + #*EXTRAS*# Step: 15 Bead: 52 + 0.00010063 -0.00002994 -0.00002997 + -0.00002994 0.00010050 -0.00002996 + -0.00002997 -0.00002996 0.00010041 + #*EXTRAS*# Step: 16 Bead: 52 + 0.00010064 -0.00002995 -0.00002999 + -0.00002995 0.00010051 -0.00002998 + -0.00002999 -0.00002998 0.00010041 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_53 b/drivers/py/pes/friction/frictionH/060K/inst.fric_53 new file mode 100644 index 000000000..7da0f7c45 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_53 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 53 + 0.00010343 -0.00003495 -0.00003489 + -0.00003495 0.00010341 -0.00003514 + -0.00003489 -0.00003514 0.00010304 + #*EXTRAS*# Step: 1 Bead: 53 + 0.00010118 -0.00003104 -0.00003107 + -0.00003104 0.00010106 -0.00003113 + -0.00003107 -0.00003113 0.00010085 + #*EXTRAS*# Step: 2 Bead: 53 + 0.00009911 -0.00002697 -0.00002690 + -0.00002697 0.00009910 -0.00002679 + -0.00002690 -0.00002679 0.00009939 + #*EXTRAS*# Step: 3 Bead: 53 + 0.00009746 -0.00002280 -0.00002250 + -0.00002280 0.00009776 -0.00002245 + -0.00002250 -0.00002245 0.00009840 + #*EXTRAS*# Step: 4 Bead: 53 + 0.00009735 -0.00002228 -0.00002197 + -0.00002228 0.00009767 -0.00002193 + -0.00002197 -0.00002193 0.00009831 + #*EXTRAS*# Step: 5 Bead: 53 + 0.00009813 -0.00002488 -0.00002468 + -0.00002488 0.00009830 -0.00002458 + -0.00002468 -0.00002458 0.00009882 + #*EXTRAS*# Step: 6 Bead: 53 + 0.00009878 -0.00002631 -0.00002620 + -0.00002631 0.00009883 -0.00002610 + -0.00002620 -0.00002610 0.00009919 + #*EXTRAS*# Step: 7 Bead: 53 + 0.00009932 -0.00002738 -0.00002734 + -0.00002738 0.00009929 -0.00002723 + -0.00002734 -0.00002723 0.00009952 + #*EXTRAS*# Step: 8 Bead: 53 + 0.00009964 -0.00002799 -0.00002798 + -0.00002799 0.00009957 -0.00002789 + -0.00002798 -0.00002789 0.00009972 + #*EXTRAS*# Step: 9 Bead: 53 + 0.00009985 -0.00002839 -0.00002840 + -0.00002839 0.00009976 -0.00002832 + -0.00002840 -0.00002832 0.00009985 + #*EXTRAS*# Step: 10 Bead: 53 + 0.00009998 -0.00002865 -0.00002866 + -0.00002865 0.00009987 -0.00002859 + -0.00002866 -0.00002859 0.00009994 + #*EXTRAS*# Step: 11 Bead: 53 + 0.00010006 -0.00002881 -0.00002883 + -0.00002881 0.00009995 -0.00002876 + -0.00002883 -0.00002876 0.00009999 + #*EXTRAS*# Step: 12 Bead: 53 + 0.00010011 -0.00002891 -0.00002893 + -0.00002891 0.00010000 -0.00002887 + -0.00002893 -0.00002887 0.00010003 + #*EXTRAS*# Step: 13 Bead: 53 + 0.00010015 -0.00002898 -0.00002900 + -0.00002898 0.00010003 -0.00002894 + -0.00002900 -0.00002894 0.00010005 + #*EXTRAS*# Step: 14 Bead: 53 + 0.00010017 -0.00002902 -0.00002904 + -0.00002902 0.00010005 -0.00002899 + -0.00002904 -0.00002899 0.00010007 + #*EXTRAS*# Step: 15 Bead: 53 + 0.00010018 -0.00002905 -0.00002907 + -0.00002905 0.00010007 -0.00002902 + -0.00002907 -0.00002902 0.00010008 + #*EXTRAS*# Step: 16 Bead: 53 + 0.00010019 -0.00002907 -0.00002909 + -0.00002907 0.00010008 -0.00002904 + -0.00002909 -0.00002904 0.00010009 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_54 b/drivers/py/pes/friction/frictionH/060K/inst.fric_54 new file mode 100644 index 000000000..4f3e1d596 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_54 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 54 + 0.00010322 -0.00003464 -0.00003459 + -0.00003464 0.00010320 -0.00003483 + -0.00003459 -0.00003483 0.00010282 + #*EXTRAS*# Step: 1 Bead: 54 + 0.00010100 -0.00003069 -0.00003072 + -0.00003069 0.00010088 -0.00003076 + -0.00003072 -0.00003076 0.00010070 + #*EXTRAS*# Step: 2 Bead: 54 + 0.00009891 -0.00002656 -0.00002647 + -0.00002656 0.00009893 -0.00002636 + -0.00002647 -0.00002636 0.00009927 + #*EXTRAS*# Step: 3 Bead: 54 + 0.00009735 -0.00002226 -0.00002195 + -0.00002226 0.00009767 -0.00002191 + -0.00002195 -0.00002191 0.00009831 + #*EXTRAS*# Step: 4 Bead: 54 + 0.00009725 -0.00002160 -0.00002129 + -0.00002160 0.00009759 -0.00002126 + -0.00002129 -0.00002126 0.00009822 + #*EXTRAS*# Step: 5 Bead: 54 + 0.00009788 -0.00002420 -0.00002396 + -0.00002420 0.00009809 -0.00002388 + -0.00002396 -0.00002388 0.00009866 + #*EXTRAS*# Step: 6 Bead: 54 + 0.00009844 -0.00002559 -0.00002544 + -0.00002559 0.00009855 -0.00002533 + -0.00002544 -0.00002533 0.00009899 + #*EXTRAS*# Step: 7 Bead: 54 + 0.00009894 -0.00002663 -0.00002654 + -0.00002663 0.00009896 -0.00002644 + -0.00002654 -0.00002644 0.00009929 + #*EXTRAS*# Step: 8 Bead: 54 + 0.00009924 -0.00002723 -0.00002717 + -0.00002723 0.00009922 -0.00002707 + -0.00002717 -0.00002707 0.00009947 + #*EXTRAS*# Step: 9 Bead: 54 + 0.00009944 -0.00002761 -0.00002758 + -0.00002761 0.00009939 -0.00002748 + -0.00002758 -0.00002748 0.00009959 + #*EXTRAS*# Step: 10 Bead: 54 + 0.00009957 -0.00002786 -0.00002784 + -0.00002786 0.00009951 -0.00002774 + -0.00002784 -0.00002774 0.00009967 + #*EXTRAS*# Step: 11 Bead: 54 + 0.00009965 -0.00002802 -0.00002800 + -0.00002802 0.00009958 -0.00002791 + -0.00002800 -0.00002791 0.00009972 + #*EXTRAS*# Step: 12 Bead: 54 + 0.00009970 -0.00002812 -0.00002811 + -0.00002812 0.00009963 -0.00002802 + -0.00002811 -0.00002802 0.00009976 + #*EXTRAS*# Step: 13 Bead: 54 + 0.00009974 -0.00002818 -0.00002818 + -0.00002818 0.00009966 -0.00002809 + -0.00002818 -0.00002809 0.00009978 + #*EXTRAS*# Step: 14 Bead: 54 + 0.00009976 -0.00002822 -0.00002822 + -0.00002822 0.00009967 -0.00002813 + -0.00002822 -0.00002813 0.00009979 + #*EXTRAS*# Step: 15 Bead: 54 + 0.00009977 -0.00002825 -0.00002825 + -0.00002825 0.00009969 -0.00002816 + -0.00002825 -0.00002816 0.00009980 + #*EXTRAS*# Step: 16 Bead: 54 + 0.00009978 -0.00002827 -0.00002826 + -0.00002827 0.00009970 -0.00002818 + -0.00002826 -0.00002818 0.00009981 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_55 b/drivers/py/pes/friction/frictionH/060K/inst.fric_55 new file mode 100644 index 000000000..69a83d0b4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_55 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 55 + 0.00010303 -0.00003435 -0.00003431 + -0.00003435 0.00010301 -0.00003455 + -0.00003431 -0.00003455 0.00010262 + #*EXTRAS*# Step: 1 Bead: 55 + 0.00010084 -0.00003037 -0.00003040 + -0.00003037 0.00010072 -0.00003042 + -0.00003040 -0.00003042 0.00010058 + #*EXTRAS*# Step: 2 Bead: 55 + 0.00009873 -0.00002620 -0.00002609 + -0.00002620 0.00009878 -0.00002598 + -0.00002609 -0.00002598 0.00009916 + #*EXTRAS*# Step: 3 Bead: 55 + 0.00009727 -0.00002176 -0.00002145 + -0.00002176 0.00009761 -0.00002142 + -0.00002145 -0.00002142 0.00009824 + #*EXTRAS*# Step: 4 Bead: 55 + 0.00009720 -0.00002099 -0.00002068 + -0.00002099 0.00009755 -0.00002066 + -0.00002068 -0.00002066 0.00009815 + #*EXTRAS*# Step: 5 Bead: 55 + 0.00009767 -0.00002358 -0.00002331 + -0.00002358 0.00009793 -0.00002324 + -0.00002331 -0.00002324 0.00009853 + #*EXTRAS*# Step: 6 Bead: 55 + 0.00009816 -0.00002494 -0.00002474 + -0.00002494 0.00009832 -0.00002465 + -0.00002474 -0.00002465 0.00009883 + #*EXTRAS*# Step: 7 Bead: 55 + 0.00009861 -0.00002596 -0.00002583 + -0.00002596 0.00009869 -0.00002572 + -0.00002583 -0.00002572 0.00009909 + #*EXTRAS*# Step: 8 Bead: 55 + 0.00009889 -0.00002654 -0.00002644 + -0.00002654 0.00009892 -0.00002633 + -0.00002644 -0.00002633 0.00009926 + #*EXTRAS*# Step: 9 Bead: 55 + 0.00009908 -0.00002692 -0.00002684 + -0.00002692 0.00009908 -0.00002674 + -0.00002684 -0.00002674 0.00009937 + #*EXTRAS*# Step: 10 Bead: 55 + 0.00009920 -0.00002715 -0.00002710 + -0.00002715 0.00009919 -0.00002699 + -0.00002710 -0.00002699 0.00009944 + #*EXTRAS*# Step: 11 Bead: 55 + 0.00009928 -0.00002731 -0.00002726 + -0.00002731 0.00009925 -0.00002715 + -0.00002726 -0.00002715 0.00009949 + #*EXTRAS*# Step: 12 Bead: 55 + 0.00009933 -0.00002740 -0.00002736 + -0.00002740 0.00009930 -0.00002726 + -0.00002736 -0.00002726 0.00009952 + #*EXTRAS*# Step: 13 Bead: 55 + 0.00009936 -0.00002747 -0.00002743 + -0.00002747 0.00009933 -0.00002732 + -0.00002743 -0.00002732 0.00009954 + #*EXTRAS*# Step: 14 Bead: 55 + 0.00009939 -0.00002751 -0.00002747 + -0.00002751 0.00009934 -0.00002737 + -0.00002747 -0.00002737 0.00009956 + #*EXTRAS*# Step: 15 Bead: 55 + 0.00009940 -0.00002753 -0.00002750 + -0.00002753 0.00009936 -0.00002739 + -0.00002750 -0.00002739 0.00009956 + #*EXTRAS*# Step: 16 Bead: 55 + 0.00009941 -0.00002755 -0.00002751 + -0.00002755 0.00009936 -0.00002741 + -0.00002751 -0.00002741 0.00009957 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_56 b/drivers/py/pes/friction/frictionH/060K/inst.fric_56 new file mode 100644 index 000000000..4372cbffd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_56 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 56 + 0.00010287 -0.00003410 -0.00003406 + -0.00003410 0.00010284 -0.00003429 + -0.00003406 -0.00003429 0.00010245 + #*EXTRAS*# Step: 1 Bead: 56 + 0.00010070 -0.00003009 -0.00003012 + -0.00003009 0.00010058 -0.00003012 + -0.00003012 -0.00003012 0.00010046 + #*EXTRAS*# Step: 2 Bead: 56 + 0.00009858 -0.00002588 -0.00002575 + -0.00002588 0.00009866 -0.00002564 + -0.00002575 -0.00002564 0.00009907 + #*EXTRAS*# Step: 3 Bead: 56 + 0.00009722 -0.00002132 -0.00002101 + -0.00002132 0.00009757 -0.00002099 + -0.00002101 -0.00002099 0.00009819 + #*EXTRAS*# Step: 4 Bead: 56 + 0.00009718 -0.00002044 -0.00002014 + -0.00002044 0.00009753 -0.00002013 + -0.00002014 -0.00002013 0.00009810 + #*EXTRAS*# Step: 5 Bead: 56 + 0.00009752 -0.00002303 -0.00002274 + -0.00002303 0.00009780 -0.00002268 + -0.00002274 -0.00002268 0.00009843 + #*EXTRAS*# Step: 6 Bead: 56 + 0.00009793 -0.00002436 -0.00002412 + -0.00002436 0.00009813 -0.00002404 + -0.00002412 -0.00002404 0.00009870 + #*EXTRAS*# Step: 7 Bead: 56 + 0.00009834 -0.00002536 -0.00002519 + -0.00002536 0.00009846 -0.00002509 + -0.00002519 -0.00002509 0.00009893 + #*EXTRAS*# Step: 8 Bead: 56 + 0.00009859 -0.00002592 -0.00002579 + -0.00002592 0.00009867 -0.00002568 + -0.00002579 -0.00002568 0.00009908 + #*EXTRAS*# Step: 9 Bead: 56 + 0.00009877 -0.00002629 -0.00002618 + -0.00002629 0.00009882 -0.00002607 + -0.00002618 -0.00002607 0.00009919 + #*EXTRAS*# Step: 10 Bead: 56 + 0.00009889 -0.00002653 -0.00002643 + -0.00002653 0.00009892 -0.00002632 + -0.00002643 -0.00002632 0.00009925 + #*EXTRAS*# Step: 11 Bead: 56 + 0.00009896 -0.00002667 -0.00002659 + -0.00002667 0.00009898 -0.00002648 + -0.00002659 -0.00002648 0.00009930 + #*EXTRAS*# Step: 12 Bead: 56 + 0.00009901 -0.00002677 -0.00002669 + -0.00002677 0.00009902 -0.00002658 + -0.00002669 -0.00002658 0.00009933 + #*EXTRAS*# Step: 13 Bead: 56 + 0.00009904 -0.00002683 -0.00002675 + -0.00002683 0.00009904 -0.00002665 + -0.00002675 -0.00002665 0.00009935 + #*EXTRAS*# Step: 14 Bead: 56 + 0.00009906 -0.00002687 -0.00002680 + -0.00002687 0.00009906 -0.00002669 + -0.00002680 -0.00002669 0.00009936 + #*EXTRAS*# Step: 15 Bead: 56 + 0.00009907 -0.00002690 -0.00002682 + -0.00002690 0.00009907 -0.00002671 + -0.00002682 -0.00002671 0.00009937 + #*EXTRAS*# Step: 16 Bead: 56 + 0.00009908 -0.00002691 -0.00002684 + -0.00002691 0.00009908 -0.00002673 + -0.00002684 -0.00002673 0.00009937 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_57 b/drivers/py/pes/friction/frictionH/060K/inst.fric_57 new file mode 100644 index 000000000..65e442dfc --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_57 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 57 + 0.00010273 -0.00003387 -0.00003384 + -0.00003387 0.00010269 -0.00003406 + -0.00003384 -0.00003406 0.00010231 + #*EXTRAS*# Step: 1 Bead: 57 + 0.00010058 -0.00002984 -0.00002987 + -0.00002984 0.00010045 -0.00002986 + -0.00002987 -0.00002986 0.00010037 + #*EXTRAS*# Step: 2 Bead: 57 + 0.00009845 -0.00002560 -0.00002545 + -0.00002560 0.00009855 -0.00002534 + -0.00002545 -0.00002534 0.00009900 + #*EXTRAS*# Step: 3 Bead: 57 + 0.00009720 -0.00002094 -0.00002063 + -0.00002094 0.00009755 -0.00002061 + -0.00002063 -0.00002061 0.00009815 + #*EXTRAS*# Step: 4 Bead: 57 + 0.00009718 -0.00001996 -0.00001967 + -0.00001996 0.00009753 -0.00001966 + -0.00001967 -0.00001966 0.00009807 + #*EXTRAS*# Step: 5 Bead: 57 + 0.00009740 -0.00002254 -0.00002224 + -0.00002254 0.00009772 -0.00002219 + -0.00002224 -0.00002219 0.00009835 + #*EXTRAS*# Step: 6 Bead: 57 + 0.00009775 -0.00002384 -0.00002358 + -0.00002384 0.00009799 -0.00002351 + -0.00002358 -0.00002351 0.00009859 + #*EXTRAS*# Step: 7 Bead: 57 + 0.00009812 -0.00002483 -0.00002463 + -0.00002483 0.00009828 -0.00002454 + -0.00002463 -0.00002454 0.00009880 + #*EXTRAS*# Step: 8 Bead: 57 + 0.00009835 -0.00002538 -0.00002521 + -0.00002538 0.00009847 -0.00002511 + -0.00002521 -0.00002511 0.00009894 + #*EXTRAS*# Step: 9 Bead: 57 + 0.00009851 -0.00002575 -0.00002560 + -0.00002575 0.00009860 -0.00002550 + -0.00002560 -0.00002550 0.00009904 + #*EXTRAS*# Step: 10 Bead: 57 + 0.00009862 -0.00002597 -0.00002584 + -0.00002597 0.00009869 -0.00002574 + -0.00002584 -0.00002574 0.00009910 + #*EXTRAS*# Step: 11 Bead: 57 + 0.00009869 -0.00002612 -0.00002600 + -0.00002612 0.00009875 -0.00002589 + -0.00002600 -0.00002589 0.00009914 + #*EXTRAS*# Step: 12 Bead: 57 + 0.00009873 -0.00002622 -0.00002610 + -0.00002622 0.00009879 -0.00002599 + -0.00002610 -0.00002599 0.00009917 + #*EXTRAS*# Step: 13 Bead: 57 + 0.00009876 -0.00002627 -0.00002616 + -0.00002627 0.00009881 -0.00002605 + -0.00002616 -0.00002605 0.00009918 + #*EXTRAS*# Step: 14 Bead: 57 + 0.00009878 -0.00002631 -0.00002620 + -0.00002631 0.00009883 -0.00002610 + -0.00002620 -0.00002610 0.00009919 + #*EXTRAS*# Step: 15 Bead: 57 + 0.00009879 -0.00002634 -0.00002623 + -0.00002634 0.00009884 -0.00002612 + -0.00002623 -0.00002612 0.00009920 + #*EXTRAS*# Step: 16 Bead: 57 + 0.00009880 -0.00002635 -0.00002625 + -0.00002635 0.00009884 -0.00002614 + -0.00002625 -0.00002614 0.00009920 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_58 b/drivers/py/pes/friction/frictionH/060K/inst.fric_58 new file mode 100644 index 000000000..3271af054 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_58 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 58 + 0.00010261 -0.00003368 -0.00003365 + -0.00003368 0.00010257 -0.00003386 + -0.00003365 -0.00003386 0.00010219 + #*EXTRAS*# Step: 1 Bead: 58 + 0.00010047 -0.00002962 -0.00002966 + -0.00002962 0.00010035 -0.00002963 + -0.00002966 -0.00002963 0.00010029 + #*EXTRAS*# Step: 2 Bead: 58 + 0.00009834 -0.00002536 -0.00002519 + -0.00002536 0.00009846 -0.00002509 + -0.00002519 -0.00002509 0.00009893 + #*EXTRAS*# Step: 3 Bead: 58 + 0.00009718 -0.00002060 -0.00002030 + -0.00002060 0.00009753 -0.00002028 + -0.00002030 -0.00002028 0.00009812 + #*EXTRAS*# Step: 4 Bead: 58 + 0.00009720 -0.00001954 -0.00001927 + -0.00001954 0.00009754 -0.00001927 + -0.00001927 -0.00001927 0.00009804 + #*EXTRAS*# Step: 5 Bead: 58 + 0.00009733 -0.00002212 -0.00002181 + -0.00002212 0.00009765 -0.00002177 + -0.00002181 -0.00002177 0.00009829 + #*EXTRAS*# Step: 6 Bead: 58 + 0.00009762 -0.00002340 -0.00002312 + -0.00002340 0.00009788 -0.00002306 + -0.00002312 -0.00002306 0.00009850 + #*EXTRAS*# Step: 7 Bead: 58 + 0.00009794 -0.00002438 -0.00002415 + -0.00002438 0.00009814 -0.00002406 + -0.00002415 -0.00002406 0.00009870 + #*EXTRAS*# Step: 8 Bead: 58 + 0.00009815 -0.00002492 -0.00002472 + -0.00002492 0.00009831 -0.00002463 + -0.00002472 -0.00002463 0.00009882 + #*EXTRAS*# Step: 9 Bead: 58 + 0.00009830 -0.00002528 -0.00002510 + -0.00002528 0.00009843 -0.00002500 + -0.00002510 -0.00002500 0.00009891 + #*EXTRAS*# Step: 10 Bead: 58 + 0.00009840 -0.00002550 -0.00002534 + -0.00002550 0.00009851 -0.00002524 + -0.00002534 -0.00002524 0.00009897 + #*EXTRAS*# Step: 11 Bead: 58 + 0.00009847 -0.00002565 -0.00002549 + -0.00002565 0.00009857 -0.00002539 + -0.00002549 -0.00002539 0.00009901 + #*EXTRAS*# Step: 12 Bead: 58 + 0.00009851 -0.00002574 -0.00002559 + -0.00002574 0.00009860 -0.00002549 + -0.00002559 -0.00002549 0.00009903 + #*EXTRAS*# Step: 13 Bead: 58 + 0.00009854 -0.00002580 -0.00002565 + -0.00002580 0.00009862 -0.00002555 + -0.00002565 -0.00002555 0.00009905 + #*EXTRAS*# Step: 14 Bead: 58 + 0.00009855 -0.00002583 -0.00002569 + -0.00002583 0.00009864 -0.00002559 + -0.00002569 -0.00002559 0.00009906 + #*EXTRAS*# Step: 15 Bead: 58 + 0.00009856 -0.00002586 -0.00002572 + -0.00002586 0.00009865 -0.00002561 + -0.00002572 -0.00002561 0.00009907 + #*EXTRAS*# Step: 16 Bead: 58 + 0.00009857 -0.00002587 -0.00002573 + -0.00002587 0.00009865 -0.00002563 + -0.00002573 -0.00002563 0.00009907 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_59 b/drivers/py/pes/friction/frictionH/060K/inst.fric_59 new file mode 100644 index 000000000..2c4520e12 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_59 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 59 + 0.00010252 -0.00003351 -0.00003348 + -0.00003351 0.00010246 -0.00003369 + -0.00003348 -0.00003369 0.00010209 + #*EXTRAS*# Step: 1 Bead: 59 + 0.00010038 -0.00002944 -0.00002947 + -0.00002944 0.00010026 -0.00002944 + -0.00002947 -0.00002944 0.00010022 + #*EXTRAS*# Step: 2 Bead: 59 + 0.00009825 -0.00002516 -0.00002497 + -0.00002516 0.00009839 -0.00002488 + -0.00002497 -0.00002488 0.00009888 + #*EXTRAS*# Step: 3 Bead: 59 + 0.00009718 -0.00002032 -0.00002003 + -0.00002032 0.00009753 -0.00002002 + -0.00002003 -0.00002002 0.00009809 + #*EXTRAS*# Step: 4 Bead: 59 + 0.00009722 -0.00001919 -0.00001893 + -0.00001919 0.00009755 -0.00001894 + -0.00001893 -0.00001894 0.00009802 + #*EXTRAS*# Step: 5 Bead: 59 + 0.00009727 -0.00002177 -0.00002145 + -0.00002177 0.00009761 -0.00002142 + -0.00002145 -0.00002142 0.00009824 + #*EXTRAS*# Step: 6 Bead: 59 + 0.00009752 -0.00002303 -0.00002274 + -0.00002303 0.00009780 -0.00002268 + -0.00002274 -0.00002268 0.00009843 + #*EXTRAS*# Step: 7 Bead: 59 + 0.00009780 -0.00002399 -0.00002374 + -0.00002399 0.00009803 -0.00002367 + -0.00002374 -0.00002367 0.00009862 + #*EXTRAS*# Step: 8 Bead: 59 + 0.00009800 -0.00002453 -0.00002431 + -0.00002453 0.00009819 -0.00002422 + -0.00002431 -0.00002422 0.00009873 + #*EXTRAS*# Step: 9 Bead: 59 + 0.00009814 -0.00002488 -0.00002468 + -0.00002488 0.00009830 -0.00002459 + -0.00002468 -0.00002459 0.00009882 + #*EXTRAS*# Step: 10 Bead: 59 + 0.00009823 -0.00002511 -0.00002492 + -0.00002511 0.00009837 -0.00002482 + -0.00002492 -0.00002482 0.00009887 + #*EXTRAS*# Step: 11 Bead: 59 + 0.00009829 -0.00002525 -0.00002507 + -0.00002525 0.00009842 -0.00002497 + -0.00002507 -0.00002497 0.00009891 + #*EXTRAS*# Step: 12 Bead: 59 + 0.00009833 -0.00002534 -0.00002517 + -0.00002534 0.00009845 -0.00002507 + -0.00002517 -0.00002507 0.00009893 + #*EXTRAS*# Step: 13 Bead: 59 + 0.00009835 -0.00002540 -0.00002523 + -0.00002540 0.00009848 -0.00002513 + -0.00002523 -0.00002513 0.00009894 + #*EXTRAS*# Step: 14 Bead: 59 + 0.00009837 -0.00002543 -0.00002527 + -0.00002543 0.00009849 -0.00002517 + -0.00002527 -0.00002517 0.00009895 + #*EXTRAS*# Step: 15 Bead: 59 + 0.00009838 -0.00002546 -0.00002529 + -0.00002546 0.00009850 -0.00002519 + -0.00002529 -0.00002519 0.00009896 + #*EXTRAS*# Step: 16 Bead: 59 + 0.00009839 -0.00002547 -0.00002531 + -0.00002547 0.00009850 -0.00002521 + -0.00002531 -0.00002521 0.00009896 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_60 b/drivers/py/pes/friction/frictionH/060K/inst.fric_60 new file mode 100644 index 000000000..a5af0b500 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_60 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 60 + 0.00010243 -0.00003337 -0.00003335 + -0.00003337 0.00010238 -0.00003355 + -0.00003335 -0.00003355 0.00010201 + #*EXTRAS*# Step: 1 Bead: 60 + 0.00010031 -0.00002930 -0.00002932 + -0.00002930 0.00010019 -0.00002928 + -0.00002932 -0.00002928 0.00010017 + #*EXTRAS*# Step: 2 Bead: 60 + 0.00009818 -0.00002499 -0.00002480 + -0.00002499 0.00009834 -0.00002470 + -0.00002480 -0.00002470 0.00009884 + #*EXTRAS*# Step: 3 Bead: 60 + 0.00009718 -0.00002010 -0.00001981 + -0.00002010 0.00009753 -0.00001980 + -0.00001981 -0.00001980 0.00009808 + #*EXTRAS*# Step: 4 Bead: 60 + 0.00009724 -0.00001892 -0.00001867 + -0.00001892 0.00009756 -0.00001867 + -0.00001867 -0.00001867 0.00009801 + #*EXTRAS*# Step: 5 Bead: 60 + 0.00009724 -0.00002148 -0.00002117 + -0.00002148 0.00009758 -0.00002114 + -0.00002117 -0.00002114 0.00009821 + #*EXTRAS*# Step: 6 Bead: 60 + 0.00009745 -0.00002273 -0.00002243 + -0.00002273 0.00009775 -0.00002238 + -0.00002243 -0.00002238 0.00009838 + #*EXTRAS*# Step: 7 Bead: 60 + 0.00009770 -0.00002369 -0.00002342 + -0.00002369 0.00009795 -0.00002335 + -0.00002342 -0.00002335 0.00009856 + #*EXTRAS*# Step: 8 Bead: 60 + 0.00009788 -0.00002422 -0.00002398 + -0.00002422 0.00009809 -0.00002390 + -0.00002398 -0.00002390 0.00009866 + #*EXTRAS*# Step: 9 Bead: 60 + 0.00009801 -0.00002457 -0.00002435 + -0.00002457 0.00009820 -0.00002426 + -0.00002435 -0.00002426 0.00009874 + #*EXTRAS*# Step: 10 Bead: 60 + 0.00009810 -0.00002479 -0.00002458 + -0.00002479 0.00009827 -0.00002449 + -0.00002458 -0.00002449 0.00009879 + #*EXTRAS*# Step: 11 Bead: 60 + 0.00009816 -0.00002493 -0.00002473 + -0.00002493 0.00009831 -0.00002464 + -0.00002473 -0.00002464 0.00009883 + #*EXTRAS*# Step: 12 Bead: 60 + 0.00009819 -0.00002502 -0.00002482 + -0.00002502 0.00009834 -0.00002473 + -0.00002482 -0.00002473 0.00009885 + #*EXTRAS*# Step: 13 Bead: 60 + 0.00009822 -0.00002508 -0.00002489 + -0.00002508 0.00009836 -0.00002479 + -0.00002489 -0.00002479 0.00009886 + #*EXTRAS*# Step: 14 Bead: 60 + 0.00009823 -0.00002511 -0.00002492 + -0.00002511 0.00009838 -0.00002483 + -0.00002492 -0.00002483 0.00009887 + #*EXTRAS*# Step: 15 Bead: 60 + 0.00009824 -0.00002514 -0.00002495 + -0.00002514 0.00009838 -0.00002485 + -0.00002495 -0.00002485 0.00009888 + #*EXTRAS*# Step: 16 Bead: 60 + 0.00009825 -0.00002515 -0.00002497 + -0.00002515 0.00009839 -0.00002487 + -0.00002497 -0.00002487 0.00009888 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_61 b/drivers/py/pes/friction/frictionH/060K/inst.fric_61 new file mode 100644 index 000000000..6e5e2c419 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_61 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 61 + 0.00010237 -0.00003327 -0.00003325 + -0.00003327 0.00010231 -0.00003345 + -0.00003325 -0.00003345 0.00010195 + #*EXTRAS*# Step: 1 Bead: 61 + 0.00010025 -0.00002918 -0.00002921 + -0.00002918 0.00010013 -0.00002916 + -0.00002921 -0.00002916 0.00010013 + #*EXTRAS*# Step: 2 Bead: 61 + 0.00009813 -0.00002487 -0.00002466 + -0.00002487 0.00009829 -0.00002457 + -0.00002466 -0.00002457 0.00009881 + #*EXTRAS*# Step: 3 Bead: 61 + 0.00009718 -0.00001993 -0.00001964 + -0.00001993 0.00009753 -0.00001964 + -0.00001964 -0.00001964 0.00009806 + #*EXTRAS*# Step: 4 Bead: 61 + 0.00009726 -0.00001871 -0.00001847 + -0.00001871 0.00009758 -0.00001847 + -0.00001847 -0.00001847 0.00009800 + #*EXTRAS*# Step: 5 Bead: 61 + 0.00009722 -0.00002127 -0.00002095 + -0.00002127 0.00009757 -0.00002093 + -0.00002095 -0.00002093 0.00009818 + #*EXTRAS*# Step: 6 Bead: 61 + 0.00009740 -0.00002250 -0.00002220 + -0.00002250 0.00009771 -0.00002215 + -0.00002220 -0.00002215 0.00009835 + #*EXTRAS*# Step: 7 Bead: 61 + 0.00009763 -0.00002346 -0.00002318 + -0.00002346 0.00009790 -0.00002312 + -0.00002318 -0.00002312 0.00009851 + #*EXTRAS*# Step: 8 Bead: 61 + 0.00009780 -0.00002398 -0.00002373 + -0.00002398 0.00009803 -0.00002365 + -0.00002373 -0.00002365 0.00009861 + #*EXTRAS*# Step: 9 Bead: 61 + 0.00009792 -0.00002433 -0.00002410 + -0.00002433 0.00009813 -0.00002401 + -0.00002410 -0.00002401 0.00009869 + #*EXTRAS*# Step: 10 Bead: 61 + 0.00009800 -0.00002455 -0.00002433 + -0.00002455 0.00009819 -0.00002424 + -0.00002433 -0.00002424 0.00009874 + #*EXTRAS*# Step: 11 Bead: 61 + 0.00009806 -0.00002469 -0.00002447 + -0.00002469 0.00009824 -0.00002439 + -0.00002447 -0.00002439 0.00009877 + #*EXTRAS*# Step: 12 Bead: 61 + 0.00009809 -0.00002478 -0.00002457 + -0.00002478 0.00009826 -0.00002448 + -0.00002457 -0.00002448 0.00009879 + #*EXTRAS*# Step: 13 Bead: 61 + 0.00009812 -0.00002483 -0.00002463 + -0.00002483 0.00009828 -0.00002454 + -0.00002463 -0.00002454 0.00009880 + #*EXTRAS*# Step: 14 Bead: 61 + 0.00009813 -0.00002487 -0.00002467 + -0.00002487 0.00009829 -0.00002458 + -0.00002467 -0.00002458 0.00009881 + #*EXTRAS*# Step: 15 Bead: 61 + 0.00009814 -0.00002489 -0.00002469 + -0.00002489 0.00009830 -0.00002460 + -0.00002469 -0.00002460 0.00009882 + #*EXTRAS*# Step: 16 Bead: 61 + 0.00009815 -0.00002491 -0.00002471 + -0.00002491 0.00009831 -0.00002462 + -0.00002471 -0.00002462 0.00009882 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_62 b/drivers/py/pes/friction/frictionH/060K/inst.fric_62 new file mode 100644 index 000000000..ad22e7a79 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_62 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 62 + 0.00010233 -0.00003319 -0.00003317 + -0.00003319 0.00010227 -0.00003337 + -0.00003317 -0.00003337 0.00010191 + #*EXTRAS*# Step: 1 Bead: 62 + 0.00010021 -0.00002910 -0.00002913 + -0.00002910 0.00010009 -0.00002907 + -0.00002913 -0.00002907 0.00010010 + #*EXTRAS*# Step: 2 Bead: 62 + 0.00009809 -0.00002478 -0.00002457 + -0.00002478 0.00009826 -0.00002448 + -0.00002457 -0.00002448 0.00009879 + #*EXTRAS*# Step: 3 Bead: 62 + 0.00009719 -0.00001981 -0.00001953 + -0.00001981 0.00009753 -0.00001952 + -0.00001953 -0.00001952 0.00009806 + #*EXTRAS*# Step: 4 Bead: 62 + 0.00009728 -0.00001857 -0.00001834 + -0.00001857 0.00009759 -0.00001834 + -0.00001834 -0.00001834 0.00009800 + #*EXTRAS*# Step: 5 Bead: 62 + 0.00009721 -0.00002112 -0.00002081 + -0.00002112 0.00009756 -0.00002079 + -0.00002081 -0.00002079 0.00009817 + #*EXTRAS*# Step: 6 Bead: 62 + 0.00009737 -0.00002235 -0.00002204 + -0.00002235 0.00009769 -0.00002200 + -0.00002204 -0.00002200 0.00009832 + #*EXTRAS*# Step: 7 Bead: 62 + 0.00009759 -0.00002330 -0.00002302 + -0.00002330 0.00009786 -0.00002296 + -0.00002302 -0.00002296 0.00009848 + #*EXTRAS*# Step: 8 Bead: 62 + 0.00009775 -0.00002382 -0.00002356 + -0.00002382 0.00009799 -0.00002349 + -0.00002356 -0.00002349 0.00009858 + #*EXTRAS*# Step: 9 Bead: 62 + 0.00009787 -0.00002417 -0.00002393 + -0.00002417 0.00009808 -0.00002385 + -0.00002393 -0.00002385 0.00009866 + #*EXTRAS*# Step: 10 Bead: 62 + 0.00009794 -0.00002439 -0.00002416 + -0.00002439 0.00009814 -0.00002407 + -0.00002416 -0.00002407 0.00009870 + #*EXTRAS*# Step: 11 Bead: 62 + 0.00009800 -0.00002453 -0.00002430 + -0.00002453 0.00009819 -0.00002422 + -0.00002430 -0.00002422 0.00009873 + #*EXTRAS*# Step: 12 Bead: 62 + 0.00009803 -0.00002462 -0.00002440 + -0.00002462 0.00009821 -0.00002431 + -0.00002440 -0.00002431 0.00009875 + #*EXTRAS*# Step: 13 Bead: 62 + 0.00009805 -0.00002467 -0.00002446 + -0.00002467 0.00009823 -0.00002437 + -0.00002446 -0.00002437 0.00009877 + #*EXTRAS*# Step: 14 Bead: 62 + 0.00009807 -0.00002471 -0.00002450 + -0.00002471 0.00009824 -0.00002441 + -0.00002450 -0.00002441 0.00009878 + #*EXTRAS*# Step: 15 Bead: 62 + 0.00009808 -0.00002473 -0.00002452 + -0.00002473 0.00009825 -0.00002443 + -0.00002452 -0.00002443 0.00009878 + #*EXTRAS*# Step: 16 Bead: 62 + 0.00009808 -0.00002475 -0.00002454 + -0.00002475 0.00009825 -0.00002445 + -0.00002454 -0.00002445 0.00009878 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_63 b/drivers/py/pes/friction/frictionH/060K/inst.fric_63 new file mode 100644 index 000000000..f7bdcb1c6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.fric_63 @@ -0,0 +1,68 @@ + #*EXTRAS*# Step: 0 Bead: 63 + 0.00010230 -0.00003314 -0.00003313 + -0.00003314 0.00010224 -0.00003332 + -0.00003313 -0.00003332 0.00010188 + #*EXTRAS*# Step: 1 Bead: 63 + 0.00010018 -0.00002905 -0.00002908 + -0.00002905 0.00010007 -0.00002902 + -0.00002908 -0.00002902 0.00010008 + #*EXTRAS*# Step: 2 Bead: 63 + 0.00009807 -0.00002473 -0.00002452 + -0.00002473 0.00009825 -0.00002443 + -0.00002452 -0.00002443 0.00009878 + #*EXTRAS*# Step: 3 Bead: 63 + 0.00009719 -0.00001975 -0.00001947 + -0.00001975 0.00009753 -0.00001946 + -0.00001947 -0.00001946 0.00009805 + #*EXTRAS*# Step: 4 Bead: 63 + 0.00009728 -0.00001850 -0.00001827 + -0.00001850 0.00009759 -0.00001828 + -0.00001827 -0.00001828 0.00009800 + #*EXTRAS*# Step: 5 Bead: 63 + 0.00009720 -0.00002105 -0.00002074 + -0.00002105 0.00009755 -0.00002072 + -0.00002074 -0.00002072 0.00009816 + #*EXTRAS*# Step: 6 Bead: 63 + 0.00009735 -0.00002227 -0.00002196 + -0.00002227 0.00009767 -0.00002192 + -0.00002196 -0.00002192 0.00009831 + #*EXTRAS*# Step: 7 Bead: 63 + 0.00009757 -0.00002322 -0.00002294 + -0.00002322 0.00009785 -0.00002288 + -0.00002294 -0.00002288 0.00009847 + #*EXTRAS*# Step: 8 Bead: 63 + 0.00009772 -0.00002374 -0.00002348 + -0.00002374 0.00009797 -0.00002341 + -0.00002348 -0.00002341 0.00009857 + #*EXTRAS*# Step: 9 Bead: 63 + 0.00009784 -0.00002409 -0.00002385 + -0.00002409 0.00009806 -0.00002377 + -0.00002385 -0.00002377 0.00009864 + #*EXTRAS*# Step: 10 Bead: 63 + 0.00009791 -0.00002431 -0.00002407 + -0.00002431 0.00009812 -0.00002399 + -0.00002407 -0.00002399 0.00009868 + #*EXTRAS*# Step: 11 Bead: 63 + 0.00009797 -0.00002445 -0.00002422 + -0.00002445 0.00009816 -0.00002413 + -0.00002422 -0.00002413 0.00009872 + #*EXTRAS*# Step: 12 Bead: 63 + 0.00009800 -0.00002453 -0.00002431 + -0.00002453 0.00009819 -0.00002423 + -0.00002431 -0.00002423 0.00009874 + #*EXTRAS*# Step: 13 Bead: 63 + 0.00009802 -0.00002459 -0.00002437 + -0.00002459 0.00009821 -0.00002429 + -0.00002437 -0.00002429 0.00009875 + #*EXTRAS*# Step: 14 Bead: 63 + 0.00009804 -0.00002463 -0.00002441 + -0.00002463 0.00009822 -0.00002432 + -0.00002441 -0.00002432 0.00009876 + #*EXTRAS*# Step: 15 Bead: 63 + 0.00009804 -0.00002465 -0.00002444 + -0.00002465 0.00009822 -0.00002435 + -0.00002444 -0.00002435 0.00009876 + #*EXTRAS*# Step: 16 Bead: 63 + 0.00009805 -0.00002467 -0.00002445 + -0.00002467 0.00009823 -0.00002436 + -0.00002445 -0.00002436 0.00009877 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 new file mode 100644 index 000000000..27460fb49 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 @@ -0,0 +1 @@ +3.687051698286220730e-03 6.712672122199119407e-05 6.670489072127725708e-05 3.597103919094801067e-03 6.688353855426881094e-05 6.637432355016311401e-05 3.446380541554903542e-03 6.642988968271351126e-05 6.577450647052704099e-05 3.233794819632444285e-03 6.577054042733922071e-05 6.490807272544913960e-05 2.957929087122570209e-03 6.491116763040295562e-05 6.377948466901779700e-05 2.617100172870378844e-03 6.383725057939182294e-05 6.239852517102376919e-05 2.209817986040916657e-03 6.253454902204098626e-05 6.077594699559518189e-05 1.734890920274673089e-03 6.099384955601493672e-05 5.892223834795439272e-05 1.191713364145808619e-03 5.920485472984547866e-05 5.684839035742755668e-05 5.807302485874060900e-04 5.715646574297206126e-05 5.456558587034316906e-05 -9.583373646323547698e-05 5.483741080720607998e-05 5.208513874986009194e-05 -8.334336371683538462e-04 5.223662326176469389e-05 4.941784204856275155e-05 -1.624412779297941273e-03 4.934374824443024020e-05 4.657347105755226132e-05 -2.456767071165043802e-03 4.614997513664092431e-05 4.356063294874185668e-05 -3.312264498972893913e-03 4.265007699147176453e-05 4.038763604702730092e-05 -4.171955007478755223e-03 3.884484766268979210e-05 3.706341835737469043e-05 -5.021208332479681034e-03 3.474270766629070670e-05 3.359790397837897233e-05 -5.844570605133197344e-03 3.036295808641363613e-05 3.000406666772550819e-05 -6.625262159391994213e-03 2.574125236313446524e-05 2.630179817570448000e-05 -7.345737084648504972e-03 2.107281317731112612e-05 2.256006944115106897e-05 -7.996581183419889521e-03 1.700339321139999750e-05 1.899385535701655537e-05 -8.581919687979049083e-03 1.364408711491314641e-05 1.569715570056485668e-05 -9.119846779993261848e-03 1.100554512546160503e-05 1.273640074960215298e-05 -9.618205574438298475e-03 9.058542434013535743e-06 1.016265520293274001e-05 -1.006953860409344481e-02 7.729031766260979598e-06 8.005806112683246220e-06 -1.046227975324630875e-02 6.611123482606055839e-06 6.212737789760365811e-06 -1.075498312543026087e-02 5.361067485013917503e-06 4.714317308709317685e-06 -1.091448607726847563e-02 4.113517334544000208e-06 3.527307720055954718e-06 -1.093365237087965021e-02 3.027279127259768908e-06 2.673317802858884083e-06 -1.080852581671578987e-02 2.278755168214131729e-06 2.177551986360540227e-06 -1.058610477844376847e-02 2.068376842829107218e-06 2.067826896375531711e-06 -1.032149855623353679e-02 2.423463171366299489e-06 2.344498367174619087e-06 -1.001658513728016786e-02 3.227461798890613779e-06 2.978654107807571406e-06 -9.673862962391878081e-03 4.351809101365188379e-06 3.929788473729555465e-06 -9.293576645292915897e-03 5.663792845375619380e-06 5.149443811296981596e-06 -8.850179563279660447e-03 7.033938319953675549e-06 6.585301668762582057e-06 -8.323984071424943634e-03 8.451557743365051959e-06 8.191676061713374689e-06 -7.720099426882075927e-03 9.979659884623571354e-06 9.927826188797614262e-06 -7.048479129469204310e-03 1.160475364162369928e-05 1.174986676453138874e-05 -6.325205329894943371e-03 1.331208589211437322e-05 1.361714004026895923e-05 -5.590370455630477679e-03 1.508653716930309882e-05 1.549352288616760091e-05 -4.877878488176916848e-03 1.691271420505579030e-05 1.734757131791209584e-05 -4.209175003122370314e-03 1.877255302750453393e-05 1.915609080720812157e-05 -3.592482823959020077e-03 2.062211040169201006e-05 2.093283454958367050e-05 -3.025621890646428610e-03 2.243522943541333354e-05 2.266975808486205865e-05 -2.505776739150898831e-03 2.419485354316840448e-05 2.435138896146921516e-05 -2.030228049916816147e-03 2.588628420425477110e-05 2.596430979690243665e-05 -1.596049016924913286e-03 2.749721947780918175e-05 2.749725108402574402e-05 -1.199909672781787184e-03 2.901819301162580531e-05 2.894153045697316648e-05 -8.388471405732045392e-04 3.044221906136097421e-05 3.029077744283365477e-05 -5.103592734777898359e-04 3.176438837619366190e-05 3.154060100440498834e-05 -2.123015750098865197e-04 3.298171429531471124e-05 3.268846548383386066e-05 5.724683057222812801e-05 3.409304221179517618e-05 3.373360860153026657e-05 3.000009321055775377e-04 3.509873838555792590e-05 3.467675291752791663e-05 5.174372267731147581e-04 3.599998792473017362e-05 3.551976649211241905e-05 7.107745281670547512e-04 3.679196173016733998e-05 3.626638779259347569e-05 8.810316192170097004e-04 3.747691184278350868e-05 3.692057963552922292e-05 1.029113537900126036e-03 3.806125610085348281e-05 3.748585628435021331e-05 1.155813179166867433e-03 3.855107887547841840e-05 3.796552347387085156e-05 1.261815702870578695e-03 3.895194583877019368e-05 3.836258129766081395e-05 1.347706890221104462e-03 3.926876328570906284e-05 3.867965686323870819e-05 1.413972233150879781e-03 3.950565694881715928e-05 3.891894207394869281e-05 1.460987031222276029e-03 3.966586896449487694e-05 3.908213406009789843e-05 1.489049428411310001e-03 3.975174206213562901e-05 3.917045491972642062e-05 6.214209113239468646e-14 5.511521609455126702e-01 -1.440461788627384835e-10 6.331713199828990170e-14 5.511521609436190738e-01 -1.459721370424086715e-10 6.568875180584725120e-14 5.511521609398757349e-01 -1.497759379378698888e-10 6.927410859922842119e-14 5.511521609343169592e-01 -1.554202856507819117e-10 7.410775429293318489e-14 5.511521609269821598e-01 -1.628606955975279655e-10 8.010534227013608141e-14 5.511521609181956327e-01 -1.717616851374863036e-10 8.713747750575614579e-14 5.511521609083643858e-01 -1.817002004970280558e-10 9.503508775222376797e-14 5.511521608979391695e-01 -1.922074808801443090e-10 1.035338248661194884e-13 5.511521608875008527e-01 -2.026824021046269175e-10 1.122577710929522599e-13 5.511521608777599779e-01 -2.123946745851595849e-10 1.207173668336919303e-13 5.511521608695313379e-01 -2.205136838167573965e-10 1.283285449201366031e-13 5.511521608636760217e-01 -2.261699359770594329e-10 1.344680192224075975e-13 5.511521608609963874e-01 -2.285650833451976212e-10 1.385891092937863876e-13 5.511521608620525425e-01 -2.271570400857380375e-10 1.404279169742880858e-13 5.511521608668762395e-01 -2.219456903886431852e-10 1.398111648604193786e-13 5.511521608753515711e-01 -2.130871832821229697e-10 1.363311193391863769e-13 5.511521608877174572e-01 -2.003907086937662677e-10 1.296332279462241204e-13 5.511521609040913594e-01 -1.837891677527814647e-10 1.194814607441080576e-13 5.511521609243902331e-01 -1.634116578762896029e-10 1.067201906503765902e-13 5.511521609470668714e-01 -1.408239914331950504e-10 9.559626567381097086e-14 5.511521609663658783e-01 -1.217204848136540275e-10 8.675384355202638819e-14 5.511521609818084144e-01 -1.065232692331022409e-10 7.826018714004599400e-14 5.511521609961206325e-01 -9.247984378541648959e-11 6.865327774983465594e-14 5.511521610111320690e-01 -7.772592566641969480e-11 5.845239372775131977e-14 5.511521610262076765e-01 -6.285324408698775428e-11 4.459613189849634237e-14 5.511521610444052310e-01 -4.480067316967160117e-11 2.676115642486135634e-14 5.511521610649975367e-01 -2.430378012351983758e-11 9.364768478166032892e-15 5.511521610822469608e-01 -7.116455060910917107e-12 -1.586357099130291161e-14 5.511521610971128471e-01 7.691071487743581985e-12 -1.555801750953922711e-13 5.511521610493128609e-01 -3.988431500101186017e-11 -8.436026159030876454e-18 5.511521610892911038e-01 -9.746677626237533906e-14 6.763954804758626228e-16 5.511521610870893095e-01 -2.297252063625242817e-12 3.591251604890730770e-15 5.511521610811930261e-01 -8.183055272277690210e-12 8.268742835797673090e-15 5.511521610732805776e-01 -1.608783843325309575e-11 1.434592662600943016e-14 5.511521610637003521e-01 -2.566324457434849331e-11 2.298967289762069510e-14 5.511521610502575497e-01 -3.909493309481234838e-11 3.441252110610368102e-14 5.511521610326676202e-01 -5.665689329196240353e-11 4.721385074639117364e-14 5.511521610131441262e-01 -7.612960189599252253e-11 6.075750805272908347e-14 5.511521609924774356e-01 -9.672061468428386489e-11 7.402449115615789610e-14 5.511521609720498871e-01 -1.170532187493449933e-10 8.447714691322213181e-14 5.511521609556545576e-01 -1.333544322496923096e-10 9.009821829674368123e-14 5.511521609463335691e-01 -1.426065120650560898e-10 9.026586366509137767e-14 5.511521609450843462e-01 -1.438270907742335793e-10 8.801600169474791288e-14 5.511521609471893290e-01 -1.417180839858029265e-10 8.442512943189696533e-14 5.511521609510482422e-01 -1.378715929674737266e-10 7.976304953128347428e-14 5.511521609563609925e-01 -1.325845919040982410e-10 7.430737309625810828e-14 5.511521609628218243e-01 -1.261602247636665643e-10 6.834633733987281064e-14 5.511521609701016677e-01 -1.189252586792375370e-10 6.215863819747300337e-14 5.511521609778677888e-01 -1.112095457792338626e-10 5.597415964171980122e-14 5.511521609858432980e-01 -1.032876807044603081e-10 4.997475692334316975e-14 5.511521609938024868e-01 -9.538319687208626512e-11 4.429830358644298412e-14 5.511521610015637229e-01 -8.767569085822535484e-11 3.904346343482311428e-14 5.511521610089836765e-01 -8.030683330288472383e-11 3.427455191017545334e-14 5.511521610159516582e-01 -7.338601972844311365e-11 3.002599166778990511e-14 5.511521610223859557e-01 -6.699369006055789614e-11 2.629294900226683282e-14 5.511521610282641426e-01 -6.115105752093845831e-11 2.307091134815450859e-14 5.511521610335439192e-01 -5.590006740079363682e-11 2.034833358377567131e-14 5.511521610381819869e-01 -5.128450764645520049e-11 1.810094353643771280e-14 5.511521610421544759e-01 -4.732884702281752487e-11 1.629736078766880961e-14 5.511521610454530595e-01 -4.404256259996911319e-11 1.490408802447140001e-14 5.511521610480795141e-01 -4.142468940535541621e-11 1.388974164039281374e-14 5.511521610500415003e-01 -3.946839838051796434e-11 1.322851160710758841e-14 5.511521610513478997e-01 -3.816542134986832716e-11 1.290301829491247340e-14 5.511521610520045966e-01 -3.751025659229732100e-11 6.221501606188175836e-14 -1.440461788627384835e-10 5.511521609451746073e-01 6.340457957774758025e-14 -1.459721370424086715e-10 5.511521609432161739e-01 6.580376380814082238e-14 -1.497759379378698888e-10 5.511521609393517096e-01 6.942925353255286829e-14 -1.554202856507819117e-10 5.511521609336215155e-01 7.431444783674093954e-14 -1.628606955975279655e-10 5.511521609260749965e-01 8.037083459709717845e-14 -1.717616851374863036e-10 5.511521609170589864e-01 8.746225093946231463e-14 -1.817002004970280558e-10 5.511521609070124672e-01 9.541070542232824708e-14 -1.922074808801443090e-10 5.511521608964227159e-01 1.039406478252956770e-13 -2.026824021046269175e-10 5.511521608859111243e-01 1.126634471502650911e-13 -2.123946745851595849e-10 5.511521608762276481e-01 1.210770634005833960e-13 -2.205136838167573965e-10 5.511521608682191653e-01 1.285878473126325697e-13 -2.261699359770594329e-10 5.511521608627629742e-01 1.345690291161829474e-13 -2.285650833451976212e-10 5.511521608606532174e-01 1.384792286492893424e-13 -2.271570400857380375e-10 5.511521608624130319e-01 1.400695205470633384e-13 -2.219456903886431852e-10 5.511521608680107764e-01 1.391899063616154696e-13 -2.130871832821229697e-10 5.511521608772496084e-01 1.354646178765349879e-13 -2.003907086937662677e-10 5.511521608902728575e-01 1.285773269130440025e-13 -1.837891677527814647e-10 5.511521609070978434e-01 1.183315219454823936e-13 -1.634116578762896029e-10 5.511521609275510380e-01 1.055961105715284313e-13 -1.408239914331950504e-10 5.511521609500492636e-01 9.458330667887414129e-14 -1.217204848136540275e-10 5.511521609689592482e-01 8.590050478830427501e-14 -1.065232692331022409e-10 5.511521609839143965e-01 7.759775424726430374e-14 -9.247984378541648959e-11 5.511521609976928193e-01 6.818665710775702395e-14 -7.772592566641969480e-11 5.511521610121922210e-01 5.814802621308568053e-14 -6.285324408698775428e-11 5.511521610268639293e-01 4.441374752916432729e-14 -4.480067316967160117e-11 5.511521610447724928e-01 2.666398557013434343e-14 -2.430378012351983758e-11 5.511521610651743952e-01 9.329980235126581564e-15 -7.116455060910917107e-12 5.511521610822999184e-01 -1.579811414559805822e-14 7.691071487743581985e-12 5.511521610970492313e-01 -1.548322791642892399e-13 -3.988431500101186017e-11 5.511521610496974422e-01 -8.327495957707805058e-18 -9.746677626237533906e-14 5.511521610892937684e-01 6.754095284624679407e-16 -2.297252063625242817e-12 5.511521610870959709e-01 3.585164576980993844e-15 -8.183055272277690210e-12 5.511521610812206706e-01 8.257705556558323566e-15 -1.608783843325309575e-11 5.511521610733235432e-01 1.433124460641865560e-14 -2.566324457434849331e-11 5.511521610637529767e-01 2.296771337868236920e-14 -3.909493309481234838e-11 5.511521610503323787e-01 3.437277857951945537e-14 -5.665689329196240353e-11 5.511521610327984044e-01 4.714190397379072709e-14 -7.612960189599252253e-11 5.511521610133762739e-01 6.063718909172944234e-14 -9.672061468428386489e-11 5.511521609928607957e-01 7.384355870175640574e-14 -1.170532187493449933e-10 5.511521609726227622e-01 8.423650413834834384e-14 -1.333544322496923096e-10 5.511521609564152824e-01 8.981490276082814499e-14 -1.426065120650560898e-10 5.511521609472318506e-01 8.996653806297438653e-14 -1.438270907742335793e-10 5.511521609460398041e-01 8.771738226373245305e-14 -1.417180839858029265e-10 5.511521609481526696e-01 8.413826988509091466e-14 -1.378715929674737266e-10 5.511521609519868248e-01 7.949660054714757082e-14 -1.325845919040982410e-10 5.511521609572481717e-01 7.406795583899619877e-14 -1.261602247636665643e-10 5.511521609636361729e-01 6.813833594429864220e-14 -1.189252586792375370e-10 5.511521609708265323e-01 6.198440583191026940e-14 -1.112095457792338626e-10 5.511521609784920672e-01 5.583419927319790652e-14 -1.032876807044603081e-10 5.511521609863605509e-01 4.986796014519937379e-14 -9.538319687208626512e-11 5.511521609942106048e-01 4.422238229824093181e-14 -8.767569085822535484e-11 5.511521610018644823e-01 3.899521353195092224e-14 -8.030683330288472383e-11 5.511521610091822954e-01 3.425020122894599590e-14 -7.338601972844311365e-11 5.511521610160560192e-01 3.002138666792455657e-14 -6.699369006055789614e-11 5.511521610224064949e-01 2.630382285608616306e-14 -6.115105752093845831e-11 5.511521610282135164e-01 2.309325132027370087e-14 -5.590006740079363682e-11 5.511521610334356724e-01 2.037874463509782215e-14 -5.128450764645520049e-11 5.511521610380287761e-01 1.813676761837926348e-14 -4.732884702281752487e-11 5.511521610419674033e-01 1.633657968809540752e-14 -4.404256259996911319e-11 5.511521610452413400e-01 1.494533046131497762e-14 -4.142468940535541621e-11 5.511521610478505862e-01 1.393211229359675951e-14 -3.946839838051796434e-11 5.511521610498011370e-01 1.327141565082228396e-14 -3.816542134986832716e-11 5.511521610511007641e-01 1.294614403278912762e-14 -3.751025659229732100e-11 5.511521610517542413e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 new file mode 100644 index 000000000..0dc6b77d9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 @@ -0,0 +1 @@ +9.347872524786728088e-03 6.712672121485080119e-05 6.670489071390793491e-05 9.273652010035143139e-03 6.688353854799178181e-05 6.637432354365810426e-05 9.147439059930326591e-03 6.642988967825920216e-05 6.577450646584850533e-05 8.967550030165352334e-03 6.577054042582616237e-05 6.490807272372299487e-05 8.731679345861848712e-03 6.491116763319106282e-05 6.377948467161795776e-05 8.436818919606750566e-03 6.383725058819620865e-05 6.239852517968745257e-05 8.079311126273643062e-03 6.253454903897949035e-05 6.077594701247035502e-05 7.654775224920751242e-03 6.099384958361360118e-05 5.892223837560380461e-05 7.158085368802608039e-03 5.920485477101308238e-05 5.684839039879855673e-05 6.583413002619447826e-03 5.715646580091360073e-05 5.456558592867350344e-05 5.924402936314914978e-03 5.483741088525629005e-05 5.208513882850013510e-05 5.174094060325141325e-03 5.223662336311550640e-05 4.941784215068799612e-05 4.324868705021276544e-03 4.934374837171123844e-05 4.657347118572838365e-05 3.368498572081508186e-03 4.614997529128937411e-05 4.356063310428201534e-05 2.296834707283683212e-03 4.265007717281242479e-05 4.038763622907154063e-05 1.110036318947718939e-03 3.884484786732501037e-05 3.706341856230916206e-05 -1.765748375132571851e-04 3.474270788818305575e-05 3.359790419997435841e-05 -1.533594500273186695e-03 3.036295831714007465e-05 3.000406689745727592e-05 -2.911238960852235037e-03 2.574125259305255311e-05 2.630179840397482114e-05 -4.247577498639968502e-03 2.107281339700607520e-05 2.256006965875746858e-05 -5.504010641549026729e-03 1.700339341150782128e-05 1.899385555495306779e-05 -6.645490929733577877e-03 1.364408728889496230e-05 1.569715587263991163e-05 -7.637720015178880474e-03 1.100554527319888263e-05 1.273640089588996238e-05 -8.477721568372037497e-03 9.058542559613998594e-06 1.016265532756807150e-05 -9.209759562505514044e-03 7.729031870706388015e-06 8.005806216592377750e-06 -9.857964535778172138e-03 6.611123564161272148e-06 6.212737871081395297e-06 -1.040654539469148057e-02 5.361067538215793493e-06 4.714317361833893448e-06 -1.078932749179973595e-02 4.113517357060190001e-06 3.527307742552240507e-06 -1.093904248106147316e-02 3.027279133827050823e-06 2.673317809394812226e-06 -1.084366516591260717e-02 2.278755356609236858e-06 2.177552173789767334e-06 -1.055879087568206871e-02 2.068376917043852573e-06 2.067826970577884974e-06 -1.019819934887559489e-02 2.423463162189680064e-06 2.344498357969593988e-06 -9.769008853034567494e-03 3.227461799056207873e-06 2.978654107968644461e-06 -9.275229006621111064e-03 4.351809110869257189e-06 3.929788483219183211e-06 -8.667067413090130332e-03 5.663792870489289916e-06 5.149443836393115162e-06 -7.906019926576425202e-03 7.033938367551210560e-06 6.585301716329986412e-06 -7.008958869276481554e-03 8.451557818283191685e-06 8.191676136557873370e-06 -6.002358246765870931e-03 9.979659989402961474e-06 9.927826293416461146e-06 -4.984361528731690028e-03 1.160475377209505728e-05 1.174986689472591265e-05 -4.041998419404741610e-03 1.331208603830926650e-05 1.361714018607810524e-05 -3.187049009814481217e-03 1.508653732246899364e-05 1.549352303887193053e-05 -2.414101523419299317e-03 1.691271435906881632e-05 1.734757147142987186e-05 -1.717435792738181751e-03 1.877255317835829307e-05 1.915609095757313593e-05 -1.089894289363924854e-03 2.062211054676838448e-05 2.093283469420741423e-05 -5.228726115102345570e-04 2.243522957289094489e-05 2.266975822194380747e-05 -9.310244238998604399e-06 2.419485367184713923e-05 2.435138908982203534e-05 4.564787107415859899e-04 2.588628432342921680e-05 2.596430991582709572e-05 8.787853513530703188e-04 2.749721958713398614e-05 2.749725119317721498e-05 1.260966964334271807e-03 2.901819311102030375e-05 2.894153055626572958e-05 1.606116592628792058e-03 3.044221915098372448e-05 3.029077753241669614e-05 1.917029588481467114e-03 3.176438845641105658e-05 3.154060108463396366e-05 2.196002988252739908e-03 3.298171436665678629e-05 3.268846555522723202e-05 2.444599191705051997e-03 3.409304227490378604e-05 3.373360866471891765e-05 2.664523987393838372e-03 3.509873844116302325e-05 3.467675297323190677e-05 2.857624002502601006e-03 3.599998797362178948e-05 3.551976654111375616e-05 3.025753747743678557e-03 3.679196177316481947e-05 3.626638783570483029e-05 3.170723494128616354e-03 3.747691188070570906e-05 3.692057967356459367e-05 3.294237382566954017e-03 3.806125613449315236e-05 3.748585631809927209e-05 3.397846675615148401e-03 3.855107890558526261e-05 3.796552350408187405e-05 3.482925391316058980e-03 3.895194586604209993e-05 3.836258132503130128e-05 3.550657324290998600e-03 3.926876331079054867e-05 3.867965688841336764e-05 3.602023025285141372e-03 3.950565697230362108e-05 3.891894209752405918e-05 3.637785447419281462e-03 3.966586898694258496e-05 3.908213408263133974e-05 3.658506621611041457e-03 3.975174208407528668e-05 3.917045494175014461e-05 5.500170130961106367e-14 5.511521608618044077e-01 -2.269367215611519420e-10 5.704010405680159122e-14 5.511521608570782993e-01 -2.317362767773443392e-10 6.123444823139493053e-14 5.511521608476025458e-01 -2.413536953067251556e-10 6.776105207804547376e-14 5.511521608333026512e-01 -2.558664561342967407e-10 7.689585728624195383e-14 5.511521608140450557e-01 -2.754106509860798716e-10 8.890973096313529400e-14 5.511521607899544373e-01 -2.998549047359752558e-10 1.040759819469711551e-13 5.511521607612612783e-01 -3.289526414877505685e-10 1.226337524599377747e-13 5.511521607283141888e-01 -3.623311495451533198e-10 1.447014306328535884e-13 5.511521606917225702e-01 -3.993443660086038554e-10 1.701993082746672764e-13 5.511521606524262262e-01 -4.390032419569410939e-10 1.987675795768921959e-13 5.511521606117559813e-01 -4.799149044340733022e-10 2.296793565297596309e-13 5.511521605714931882e-01 -5.202265506892610749e-10 2.617490190012740940e-13 5.511521605339282370e-01 -5.575739399247616611e-10 2.932375573982282435e-13 5.511521605019192860e-01 -5.890346685256392748e-10 3.217685785067831703e-13 5.511521604789284545e-01 -6.111141618977726598e-10 3.444463817369242727e-13 5.511521604686906439e-01 -6.201169080482014932e-10 3.582234670765768616e-13 5.511521604745401870e-01 -6.128511540889425333e-10 3.603596670871516937e-13 5.511521604987587031e-01 -5.872695420361836577e-10 3.493995487374566699e-13 5.511521605412714742e-01 -5.437292526115152920e-10 3.264151408783095308e-13 5.511521605982492300e-01 -4.863068470355491671e-10 2.957040910534828700e-13 5.511521606618147162e-01 -4.229709143602422606e-10 2.607356590862606278e-13 5.511521607264855405e-01 -3.590626450275898279e-10 2.259974641062407812e-13 5.511521607862335248e-01 -3.003233659248520835e-10 1.942537412121955884e-13 5.511521608381325654e-01 -2.494054215157579504e-10 1.628978021176088081e-13 5.511521608863796384e-01 -2.019626567431730040e-10 1.261513479003100771e-13 5.511521609383505105e-01 -1.505406117350627827e-10 7.996303220468412749e-14 5.511521609980216674e-01 -9.116888943393377171e-11 3.188095834293928939e-14 5.511521610551078920e-01 -3.422315248731928876e-11 -9.296289073384724078e-15 5.511521610985175013e-01 9.094033836845564799e-12 3.281493015015344775e-14 5.511521610623719702e-01 -2.683856761770778641e-11 7.420630944540709436e-14 5.511521610558518525e-01 -3.353246191300290660e-11 -8.500223773163973587e-15 5.511521610755510947e-01 -1.388659913882601427e-11 3.756845763226421650e-15 5.511521610761623835e-01 -1.318997035335856249e-11 1.777281144469328842e-14 5.511521610514020786e-01 -3.793332779958233218e-11 3.945959737144810069e-14 5.511521610170397878e-01 -7.229120377322205053e-11 7.058720800872842703e-14 5.511521609690009926e-01 -1.203001083636300692e-10 1.093306610888626572e-13 5.511521609101300845e-01 -1.790739621343282196e-10 1.519932413329798365e-13 5.511521608456462218e-01 -2.433708032556352443e-10 1.912288658957538855e-13 5.511521607862555072e-01 -3.025047705045312566e-10 2.202193851458069641e-13 5.511521607417712021e-01 -3.467241630760958326e-10 2.376430418966924725e-13 5.511521607137482848e-01 -3.745315357392448112e-10 2.441112450969531294e-13 5.511521607011982127e-01 -3.869536108421099773e-10 2.411196235811953898e-13 5.511521607020792857e-01 -3.860447958878503824e-10 2.330923764380363062e-13 5.511521607097878972e-01 -3.783786029292043944e-10 2.219027391085381845e-13 5.511521607217442220e-01 -3.665145828269007459e-10 2.084417840767979949e-13 5.511521607369174180e-01 -3.514706216677918965e-10 1.934818202136176766e-13 5.511521607544316304e-01 -3.341111683290526537e-10 1.776711421000719895e-13 5.511521607735626604e-01 -3.151493185577620701e-10 1.615531372226940075e-13 5.511521607937052147e-01 -2.951789552288140352e-10 1.455969088200653213e-13 5.511521608143116202e-01 -2.747387221769127349e-10 1.301921513319508982e-13 5.511521608348926016e-01 -2.543111195491895119e-10 1.156403792696721269e-13 5.511521608550358220e-01 -2.343040348822992210e-10 1.021520744844273061e-13 5.511521608744203160e-01 -2.150361807756164801e-10 8.987965209893590931e-14 5.511521608927590909e-01 -1.967937971244044624e-10 7.891760698612248658e-14 5.511521609098056773e-01 -1.798232240202545052e-10 6.929043158152828411e-14 5.511521609253983156e-01 -1.642865844865648274e-10 6.099310907722853854e-14 5.511521609393893462e-01 -1.503336567212892964e-10 5.398800226901884680e-14 5.511521609516677467e-01 -1.380788264589358924e-10 4.820778899950885297e-14 5.511521609621747864e-01 -1.275844739591722243e-10 4.356926858947028141e-14 5.511521609708920355e-01 -1.188723894583655169e-10 3.998557073728686211e-14 5.511521609778287090e-01 -1.119363627536379070e-10 3.737620064418005726e-14 5.511521609830084545e-01 -1.067549918003414308e-10 3.567621843539242597e-14 5.511521609864570292e-01 -1.033040583407027288e-10 3.484267669223983703e-14 5.511521609881911976e-01 -1.015683107208767997e-10 5.484569735903678767e-14 -2.269367215611519420e-10 5.511521608630938207e-01 5.689956438115197238e-14 -2.317362767773443392e-10 5.511521608582217180e-01 6.112522932875903936e-14 -2.413536953067251556e-10 5.511521608484640788e-01 6.770310835292480759e-14 -2.558664561342967407e-10 5.511521608337403011e-01 7.691460349050310399e-14 -2.754106509860798716e-10 5.511521608139109407e-01 8.903451680338196149e-14 -2.998549047359752558e-10 5.511521607891136654e-01 1.043374246262881176e-13 -3.289526414877505685e-10 5.511521607596104877e-01 1.230601158771644737e-13 -3.623311495451533198e-10 5.511521607257989785e-01 1.453116501588892657e-13 -3.993443660086038554e-10 5.511521606883614810e-01 1.709937794599435649e-13 -4.390032419569410939e-10 5.511521606483370528e-01 1.997171077420623475e-13 -4.799149044340733022e-10 5.511521606071818624e-01 2.307130942010404764e-13 -5.202265506892610749e-10 5.511521605668205925e-01 2.627451539706799892e-13 -5.575739399247616611e-10 5.511521605296921811e-01 2.940193862356416535e-13 -5.890346685256392748e-10 5.511521604987825729e-01 3.221137577456277951e-13 -6.111141618977726598e-10 5.511521604776177252e-01 3.441243780622976041e-13 -6.201169080482014932e-10 5.511521604698507160e-01 3.570600073032966720e-13 -6.128511540889425333e-10 5.511521604785279971e-01 3.583090959165139554e-13 -5.872695420361836577e-10 5.511521605054613415e-01 3.466018614587919294e-13 -5.437292526115152920e-10 5.511521605500140364e-01 3.232025105669221885e-13 -4.863068470355491671e-10 5.511521606078693125e-01 2.925198200484150132e-13 -4.229709143602422606e-10 5.511521606709737231e-01 2.579755585755990434e-13 -3.590626450275898279e-10 5.511521607341280937e-01 2.238855639817954220e-13 -3.003233659248520835e-10 5.511521607918730137e-01 1.928219878260944152e-13 -2.494054215157579504e-10 5.511521608418227247e-01 1.620571578183509935e-13 -2.019626567431730040e-10 5.511521608884694112e-01 1.257347772449709999e-13 -1.505406117350627827e-10 5.511521609393463805e-01 7.978856161479742788e-14 -9.116888943393377171e-11 5.511521609984199044e-01 3.182626615443842201e-14 -3.422315248731928876e-11 5.511521610552254646e-01 -9.262186143060733612e-15 9.094033836845564799e-12 5.511521610984505548e-01 3.259694806454417176e-14 -2.683856761770778641e-11 5.511521610627297951e-01 7.419402562524563625e-14 -3.353246191300290660e-11 5.511521610558629547e-01 -8.529615668494333471e-15 -1.388659913882601427e-11 5.511521610754552825e-01 3.746237448928597887e-15 -1.318997035335856249e-11 5.511521610762374346e-01 1.774733344000654180e-14 -3.793332779958233218e-11 5.511521610515109915e-01 3.942737828290470028e-14 -7.229120377322205053e-11 5.511521610171576935e-01 7.053511746577062509e-14 -1.203001083636300692e-10 5.511521609691785173e-01 1.092172776647833765e-13 -1.790739621343282196e-10 5.511521609105016761e-01 1.517607512165544595e-13 -2.433708032556352443e-10 5.511521608463914035e-01 1.908317136348679551e-13 -3.025047705045312566e-10 5.511521607875135009e-01 2.196527043125509275e-13 -3.467241630760958326e-10 5.511521607435579950e-01 2.369408321949009480e-13 -3.745315357392448112e-10 5.511521607159651781e-01 2.433326785363629824e-13 -3.869536108421099773e-10 5.511521607036704573e-01 2.403315507435164059e-13 -3.860447958878503824e-10 5.511521607046069304e-01 2.323411252070865553e-13 -3.783786029292043944e-10 5.511521607122307209e-01 2.212200179458255766e-13 -3.665145828269007459e-10 5.511521607240029708e-01 2.078494213746609823e-13 -3.514706216677918965e-10 5.511521607389182620e-01 1.929926134048971817e-13 -3.341111683290526537e-10 5.511521607561234992e-01 1.772898062555484150e-13 -3.151493185577620701e-10 5.511521607749169105e-01 1.612769683316878247e-13 -2.951789552288140352e-10 5.511521607947156287e-01 1.454172422976312415e-13 -2.747387221769127349e-10 5.511521608149900775e-01 1.300969345175872961e-13 -2.543111195491895119e-10 5.511521608352646373e-01 1.156157567587759443e-13 -2.343040348822992210e-10 5.511521608551356310e-01 1.021838612525916262e-13 -2.150361807756164801e-10 5.511521608742867562e-01 8.995419410381289617e-14 -1.967937971244044624e-10 5.511521608924326854e-01 7.902272234025676427e-14 -1.798232240202545052e-10 5.511521609093271712e-01 6.941518066050684223e-14 -1.642865844865648274e-10 5.511521609248075659e-01 6.112862272680905213e-14 -1.503336567212892964e-10 5.511521609387222131e-01 5.412780127476468698e-14 -1.380788264589358924e-10 5.511521609509534292e-01 4.834778960576956214e-14 -1.275844739591722243e-10 5.511521609614349337e-01 4.370706634788092745e-14 -1.188723894583655169e-10 5.511521609701417468e-01 4.011998965623010534e-14 -1.119363627536379070e-10 5.511521609770770880e-01 3.750747766709494463e-14 -1.067549918003414308e-10 5.511521609822600531e-01 3.580485461594750435e-14 -1.033040583407027288e-10 5.511521609857134019e-01 3.496986638899174293e-14 -1.015683107208767997e-10 5.511521609874505678e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 new file mode 100644 index 000000000..23e54a7a2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 @@ -0,0 +1 @@ +1.718649038085777805e-02 6.712673350968875979e-05 6.670490211180121135e-05 1.717152271981815456e-02 6.688355018160550478e-05 6.637433441549917001e-05 1.714136533978458110e-02 6.642990078332517920e-05 6.577451696810926885e-05 1.709556944098532608e-02 6.577055102175352326e-05 6.490808287167219403e-05 1.703344990836843514e-02 6.491117764001188780e-05 6.377949436601691431e-05 1.695407084041845869e-02 6.383725986420809271e-05 6.239853425371964118e-05 1.685622594127209398e-02 6.253455742088067477e-05 6.077595527726007975e-05 1.673841352207428024e-02 6.099385691904179839e-05 5.892224565531780663e-05 1.659880576603799465e-02 5.920486094259596688e-05 5.684839655569798956e-05 1.643521183533349500e-02 5.715647074174614743e-05 5.456559087893971357e-05 1.624503433046633680e-02 5.483741458612324804e-05 5.208514254959551381e-05 1.602521855068727435e-02 5.223662587203868358e-05 4.941784468091968977e-05 1.577219395912450930e-02 4.934374978769076825e-05 4.657347261787486540e-05 1.548180724505664879e-02 4.614997575391981669e-05 4.356063357494128672e-05 1.514924641993832186e-02 4.265007684957736764e-05 4.038763590547730085e-05 1.476895551507436365e-02 3.884484694014535841e-05 3.706341762820870883e-05 1.433453971750956769e-02 3.474270654066619041e-05 3.359790284203400726e-05 1.383866125752012712e-02 3.036295672362671492e-05 3.000406529337867095e-05 1.327292714619731501e-02 2.574125090955234430e-05 2.630179671257354659e-05 1.262777111708131110e-02 2.107281175380013171e-05 2.256006801182466483e-05 1.189233398003354016e-02 1.700339190571159437e-05 1.899385404950824436e-05 1.105434895207347244e-02 1.364408598254182127e-05 1.569715456960075651e-05 1.010004329271503749e-02 1.100554419290826763e-05 1.273639982041361500e-05 9.014072176196511951e-03 9.058541709641076213e-06 1.016265448236260291e-05 7.779508321436202391e-03 7.729031239679686719e-06 8.005805589054532318e-06 6.377920350501146800e-03 6.611123128998134460e-06 6.212737437952199709e-06 4.789585020561031026e-03 5.361067272144208292e-06 4.714317096972481159e-06 2.993892167246103419e-03 4.113517228851885501e-06 3.527307615199016190e-06 9.700164962100439516e-04 3.027279106167515614e-06 2.673317782227691151e-06 -1.260341055936776153e-03 2.278755306621517172e-06 2.177552124292042232e-06 -3.411026705626204764e-03 2.068376837255995072e-06 2.067826890849922867e-06 -5.357861613478405449e-03 2.423463170701058871e-06 2.344498366501071616e-06 -7.015941295327934348e-03 3.227461795458749255e-06 2.978654104380976698e-06 -8.303987546223296282e-03 4.351809093319252907e-06 3.929788465693123702e-06 -9.346242831455884442e-03 5.663792833419075091e-06 5.149443799346557120e-06 -1.020726021651514881e-02 7.033938489488615903e-06 6.585301840373609482e-06 -1.079682672561817561e-02 8.451557753625038382e-06 8.191676072134224527e-06 -1.093268725011149224e-02 9.979659883637110007e-06 9.927826187915930891e-06 -1.062235684197441500e-02 1.160475362923520715e-05 1.174986675224913317e-05 -1.011820308331466689e-02 1.331208586327828003e-05 1.361714001157214536e-05 -9.480098797369673064e-03 1.508653712085247542e-05 1.549352283790977577e-05 -8.662648630561011615e-03 1.691271413683766763e-05 1.734757124994206913e-05 -7.539323685016627308e-03 1.877255294150497386e-05 1.915609072150049649e-05 -6.142300187258327611e-03 2.062211029844177021e-05 2.093283444666223529e-05 -4.650710411453953981e-03 2.243522931512811593e-05 2.266975796493277446e-05 -3.324814081397755444e-03 2.419485340553063614e-05 2.435138882417971288e-05 -2.159611776123351867e-03 2.588628404608247111e-05 2.596430963887947873e-05 -1.142418920720949214e-03 2.749721928608520537e-05 2.749725089138852383e-05 -2.545479397900224285e-04 2.901819272011386337e-05 2.894153015836983760e-05 5.317726441482336849e-04 3.044221719937450113e-05 3.029077543144773746e-05 1.226363099134622449e-03 3.176438780505855627e-05 3.154060037169464643e-05 1.837422008428230783e-03 3.298171413060911399e-05 3.268846531128606647e-05 2.372693865194080813e-03 3.409304208628318253e-05 3.373360847471220910e-05 2.839350936860106454e-03 3.509873827285769861e-05 3.467675280561023936e-05 3.239603671107406813e-03 3.599998781941199431e-05 3.551976638840558101e-05 3.568873745170826704e-03 3.679196163053191149e-05 3.626638769486128280e-05 3.836796367068300625e-03 3.747691174800784025e-05 3.692057954268409842e-05 4.052581357246333622e-03 3.806125601034471235e-05 3.748585619566350560e-05 4.224004308410815069e-03 3.855107878869319801e-05 3.796552338874671021e-05 4.357508708301497703e-03 3.895194575515516011e-05 3.836258121553909269e-05 4.458302495483191727e-03 3.926876320467657852e-05 3.867965678355192205e-05 4.530443664137338323e-03 3.950565686974258822e-05 3.891894199611096604e-05 4.576911485286328830e-03 3.966586888673283426e-05 3.908213398349785620e-05 4.599661241046252083e-03 3.975174198499402780e-05 3.917045484371238289e-05 1.234983965041218072e-11 5.511521402005423731e-01 -1.935670941407772322e-08 1.169065383505894343e-11 5.511521413306121886e-01 -1.845862271845763925e-08 1.116630043105868726e-11 5.511521421824431277e-01 -1.787674267369684525e-08 1.066368839876500325e-11 5.511521428806802625e-01 -1.743705538664831927e-08 1.008371668903970571e-11 5.511521435371573574e-01 -1.700383611441586909e-08 9.364921619852337690e-12 5.511521442227608203e-01 -1.649981983698858644e-08 8.485977151923647820e-12 5.511521449697928121e-01 -1.589525296729221546e-08 7.458061954026639435e-12 5.511521457863468587e-01 -1.518779969299638823e-08 6.316284317020576669e-12 5.511521466671016611e-01 -1.438874614272897486e-08 5.111031848983411325e-12 5.511521476001219888e-01 -1.351514183465043154e-08 3.899634540605136872e-12 5.511521485705529466e-01 -1.258592955595114187e-08 2.738602530694810055e-12 5.511521495633795453e-01 -1.161933353431432390e-08 1.677728545737958490e-12 5.511521505642107410e-01 -1.063230357177421490e-08 7.558680056482992596e-13 5.511521515595533272e-01 -9.640466126281265452e-09 -1.466479734817472739e-15 5.511521525370669528e-01 -8.658070844883580952e-09 -5.827332731605856423e-13 5.511521534861399951e-01 -7.697579076654907082e-09 -9.892934002582803427e-13 5.511521543983062266e-01 -6.769336171183832162e-09 -1.233153693266008831e-12 5.511521552674258917e-01 -5.881419719165168109e-09 -1.334100660583720515e-12 5.511521560897966188e-01 -5.039584811366905008e-09 -1.316790799849569798e-12 5.511521568638416690e-01 -4.247695244985257096e-09 -1.210092141544493111e-12 5.511521575843766341e-01 -3.513087733780920503e-09 -1.045617483122716815e-12 5.511521582423005716e-01 -2.845442278870368109e-09 -8.542931534360541311e-13 5.511521588272930705e-01 -2.254803503898192850e-09 -6.557191818445007130e-13 5.511521593495096738e-01 -1.730891886948700653e-09 -4.681288982663520356e-13 5.511521598094056840e-01 -1.272633535033911209e-09 -3.090117889105796127e-13 5.511521601940259085e-01 -8.906145787165356227e-10 -1.861085542284147604e-13 5.511521605002654978e-01 -5.858073862103532133e-10 -9.632734683215291286e-14 5.511521607442989579e-01 -3.421984630932781749e-10 -3.695582417616926491e-14 5.511521609328942084e-01 -1.542490542968040559e-10 -1.717278975398314368e-14 5.511521609985814418e-01 -8.935461883491857421e-11 -5.581547939297903266e-15 5.511521610492944312e-01 -3.974413862269620217e-11 1.115568625318191289e-17 5.511521610895709911e-01 7.830030384215564803e-14 1.593867109705366448e-16 5.511521610938311388e-01 4.421617584926850854e-12 2.228082490798406273e-16 5.511521610684850803e-01 -2.080243566886737330e-11 2.389382971041424628e-15 5.511521610403125049e-01 -4.889941676177840064e-11 1.925246135813930800e-13 5.511521586057550603e-01 -2.510126570106235756e-09 4.467250563626549206e-14 5.511521606235184612e-01 -4.671344797901058354e-10 4.622738812621250593e-14 5.511521606437768117e-01 -4.459272570267462048e-10 4.836901590489915790e-14 5.511521606056530853e-01 -4.835956239729760836e-10 4.518840040445150929e-14 5.511521605655852474e-01 -5.233247326547379343e-10 3.602652290910030275e-14 5.511521605366749288e-01 -5.519781904761559653e-10 2.188010084690603363e-14 5.511521605231078924e-01 -5.653624521651853253e-10 4.266306501014683715e-15 5.511521605226834541e-01 -5.656729357314659067e-10 -1.523423745806230447e-14 5.511521605270097712e-01 -5.612823349495807664e-10 -3.586008803396624399e-14 5.511521605301911153e-01 -5.581168396521348987e-10 -5.787471542064953887e-14 5.511521605245897071e-01 -5.640197427954718336e-10 -8.386492397406668888e-14 5.511521604946716391e-01 -5.953512154369803387e-10 -1.233776367478026988e-13 5.511521604002502794e-01 -6.953636386873678149e-10 -2.293533009893482647e-13 5.511521600307198732e-01 -1.091886788810446255e-09 -1.806012315458012833e-12 5.511521540203067060e-01 -7.653112702650894129e-09 -5.211603507625244851e-13 5.511521592921732049e-01 -2.007184840231797248e-09 -1.204072919116495948e-13 5.511521606982753285e-01 -4.144165494804633031e-10 -8.646853929081415418e-14 5.511521608207085032e-01 -2.713747632321659252e-10 -7.842568554717587380e-14 5.511521608558297425e-01 -2.303981829709894755e-10 -7.529218273890837601e-14 5.511521608735718836e-01 -2.106633012932393127e-10 -7.334247064275786074e-14 5.511521608860444621e-01 -1.976903031360392270e-10 -7.170475893522882235e-14 5.511521608961096330e-01 -1.877946065877193359e-10 -7.016044501422173872e-14 5.511521609045965109e-01 -1.797644576673492743e-10 -6.868427561656979367e-14 5.511521609117649989e-01 -1.731327611824736505e-10 -6.731767427396906962e-14 5.511521609176960323e-01 -1.677071377206786822e-10 -6.612840467768450532e-14 5.511521609224147022e-01 -1.634092478412721441e-10 -6.518482762213818366e-14 5.511521609259235621e-01 -1.602145998470972676e-10 -6.453353348970856029e-14 5.511521609282148404e-01 -1.581266520562955671e-10 -6.423856585897039339e-14 5.511521609292620028e-01 -1.571730047983383117e-10 1.145273897543323599e-11 -1.935670941407772322e-08 5.511521431250109293e-01 1.092874061580428695e-11 -1.845862271845763925e-08 5.511521438221935743e-01 1.056338600789975741e-11 -1.787674267369684525e-08 5.511521441691823453e-01 1.021565228967897721e-11 -1.743705538664831927e-08 5.511521443787971153e-01 9.771313574744727879e-12 -1.700383611441586909e-08 5.511521446080671627e-01 9.163066699613016965e-12 -1.649981983698858644e-08 5.511521449421891150e-01 8.369127150609678433e-12 -1.589525296729221546e-08 5.511521454108135876e-01 7.402774126374717156e-12 -1.518779969299638823e-08 5.511521460125273775e-01 6.302211080805049613e-12 -1.438874614272897486e-08 5.511521467314317579e-01 5.121259987691963178e-12 -1.351514183465043154e-08 5.511521475462048958e-01 3.920812492673879379e-12 -1.258592955595114187e-08 5.511521484343242516e-01 2.760944796086644561e-12 -1.161933353431432390e-08 5.511521493746556200e-01 1.694891635525106688e-12 -1.063230357177421490e-08 5.511521503478613582e-01 7.646786486854869770e-13 -9.640466126281265452e-09 5.511521513362668268e-01 -1.480476333379472051e-15 -8.658070844883580952e-09 5.511521523237394860e-01 -5.899760723049388673e-13 -7.697579076654907082e-09 5.511521532959501313e-01 -1.000880341541505180e-12 -6.769336171183832162e-09 5.511521542406263574e-01 -1.245769504726223219e-12 -5.881419719165168109e-09 5.511521551476923353e-01 -1.344799412740105277e-12 -5.039584811366905008e-09 5.511521560092784711e-01 -1.323730294883332378e-12 -4.247695244985257096e-09 5.511521568191922738e-01 -1.212925004417184158e-12 -3.513087733780920503e-09 5.511521575679462215e-01 -1.045063597117934573e-12 -2.845442278870368109e-09 5.511521582453231538e-01 -8.515907818204200507e-13 -2.254803503898192850e-09 5.511521588415833062e-01 -6.523834797775612403e-13 -1.730891886948700653e-09 5.511521593671668828e-01 -4.654806875965434933e-13 -1.272633535033911209e-09 5.511521598238412478e-01 -3.073944181920002782e-13 -8.906145787165356227e-10 5.511521602033718770e-01 -1.850728504501117564e-13 -5.858073862103532133e-10 5.511521605068158136e-01 -9.552695804515585252e-14 -3.421984630932781749e-10 5.511521607500111664e-01 -3.642930707893929214e-14 -1.542490542968040559e-10 5.511521609373267738e-01 -1.690077756974858660e-14 -8.935461883491857421e-11 5.511521610014468164e-01 -5.533935559848325871e-15 -3.974413862269620217e-11 5.511521610499758861e-01 1.861467951235656317e-18 7.830030384215564803e-14 5.511521610893566070e-01 1.585693189421717974e-16 4.421617584926850854e-12 5.511521610937862858e-01 2.212739548769210066e-16 -2.080243566886737330e-11 5.511521610686861417e-01 2.380819449332062007e-15 -4.889941676177840064e-11 5.511521610406658889e-01 1.945787407739943124e-13 -2.510126570106235756e-09 5.511521585524743472e-01 4.479362730834713702e-14 -4.671344797901058354e-10 5.511521606209855983e-01 4.626021990967083335e-14 -4.459272570267462048e-10 5.511521606431466491e-01 4.835493406044413685e-14 -4.835956239729760836e-10 5.511521606059347489e-01 4.514674088497332810e-14 -5.233247326547379343e-10 5.511521605665448131e-01 3.597867492904659419e-14 -5.519781904761559653e-10 5.511521605381461963e-01 2.184487494377527788e-14 -5.653624521651853253e-10 5.511521605249426470e-01 4.258911642423805223e-15 -5.656729357314659067e-10 5.511521605247438060e-01 -1.520405252018804566e-14 -5.612823349495807664e-10 5.511521605291955783e-01 -3.579101604758702897e-14 -5.581168396521348987e-10 5.511521605323441708e-01 -5.779290319582549347e-14 -5.640197427954718336e-10 5.511521605261469059e-01 -8.395500175098229133e-14 -5.953512154369803387e-10 5.511521604934045415e-01 -1.244988868892402730e-13 -6.953636386873678149e-10 5.511521603876532449e-01 -2.366189200938784342e-13 -1.091886788810446255e-09 5.511521599625942569e-01 -1.955551713497116410e-12 -7.653112702650894129e-09 5.511521528012759408e-01 -5.828423913563023169e-13 -2.007184840231797248e-09 5.511521588419169282e-01 -1.283254014494917657e-13 -4.144165494804633031e-10 5.511521606453266831e-01 -8.782284775860520874e-14 -2.713747632321659252e-10 5.511521608122911253e-01 -7.766748075899960238e-14 -2.303981829709894755e-10 5.511521608603434652e-01 -7.368545440224478010e-14 -2.106633012932393127e-10 5.511521608826934759e-01 -7.142835923508907291e-14 -1.976903031360392270e-10 5.511521608965358476e-01 -6.975186550557357483e-14 -1.877946065877193359e-10 5.511521609064993221e-01 -6.830795903433389878e-14 -1.797644576673492743e-10 5.511521609142318034e-01 -6.698737777186208792e-14 -1.731327611824736505e-10 5.511521609204348415e-01 -6.578513997295560849e-14 -1.677071377206786822e-10 5.511521609254284026e-01 -6.474146716448689386e-14 -1.634092478412721441e-10 5.511521609293554835e-01 -6.390561940832882084e-14 -1.602145998470972676e-10 5.511521609322678206e-01 -6.332862419164222224e-14 -1.581266520562955671e-10 5.511521609341718531e-01 -6.306788851238875251e-14 -1.571730047983383117e-10 5.511521609350406026e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 new file mode 100644 index 000000000..b2919b1ec --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 @@ -0,0 +1 @@ +1.719939196594755595e-02 6.712673266946838334e-05 6.670490133272344063e-05 1.718459434919301226e-02 6.688354941461073359e-05 6.637433369859337367e-05 1.715478011330678551e-02 6.642990010240409362e-05 6.577451632405153148e-05 1.710950662791227428e-02 6.577055044034974235e-05 6.490808231478008294e-05 1.704809818892040474e-02 6.491117716972993911e-05 6.377949391037641123e-05 1.696963173952223403e-02 6.383725951155527637e-05 6.239853390873182249e-05 1.687291752463070463e-02 6.253455718540845633e-05 6.077595504508626181e-05 1.675647442744151311e-02 6.099385679336974939e-05 5.892224553062502259e-05 1.661849964936421703e-02 5.920486091371550440e-05 5.684839652691686711e-05 1.645683231445262129e-02 5.715647079290539923e-05 5.456559093022730103e-05 1.626891051571507235e-02 5.483741469883078015e-05 5.208514266293441750e-05 1.605172125632800192e-02 5.223662602780642983e-05 4.941784483796753997e-05 1.580174269169089610e-02 4.934374996935832224e-05 4.657347280140796542e-05 1.551487806619144746e-02 4.614997594659469259e-05 4.356063376985974960e-05 1.518638077459337488e-02 4.265007704110084793e-05 4.038763609937592251e-05 1.481077010253941534e-02 3.884484712126680655e-05 3.706341781158429459e-05 1.438173745240086711e-02 3.474270670493576898e-05 3.359790300822791594e-05 1.389204331662844891e-02 3.036295686707619993e-05 3.000406543830258282e-05 1.333340601054608734e-02 2.574125103031586447e-05 2.630179683430869148e-05 1.269638438179691159e-02 2.107281185167303371e-05 2.256006811021769927e-05 1.197025849957668135e-02 1.700339198188834713e-05 1.899385412585867953e-05 1.114291460556332027e-02 1.364408603931177866e-05 1.569715462632226022e-05 1.020074517860963120e-02 1.100554423329182886e-05 1.273639986063333465e-05 9.128579466982540691e-03 9.058541736686096218e-06 1.016265450922016436e-05 7.909667182965724602e-03 7.729031256413884771e-06 8.005805605637052180e-06 6.525747257365046954e-03 6.611123138399648756e-06 6.212737447252131038e-06 4.957245444416256280e-03 5.361067276765619205e-06 4.714317101534695480e-06 3.183658032730485223e-03 4.113517230596880945e-06 3.527307616905818495e-06 1.184194079594015148e-03 3.027279106412311948e-06 2.673317782462635221e-06 -1.035500736562029213e-03 2.278755306614754461e-06 2.177552124288882376e-06 -3.201367848117564561e-03 2.068376837209919445e-06 2.067826890808161179e-06 -5.171765337620817631e-03 2.423463170671602029e-06 2.344498366471845591e-06 -6.862374388584077320e-03 3.227461795456846819e-06 2.978654104379212751e-06 -8.187934912062653711e-03 4.351809093314373997e-06 3.929788465689262926e-06 -9.246338800634919253e-03 5.663792833431273213e-06 5.149443799358645974e-06 -1.012700085100350610e-02 7.033938491440285692e-06 6.585301842345805421e-06 -1.075550169081277742e-02 8.451557754349788571e-06 8.191676072860850047e-06 -1.094105308675169703e-02 9.979659884798012707e-06 9.927826189076969116e-06 -1.066799029564482679e-02 1.160475363104392404e-05 1.174986675405712331e-05 -1.017925904410655648e-02 1.331208586567513594e-05 1.361714001396670750e-05 -9.555906977131637184e-03 1.508653712364954593e-05 1.549352284070310069e-05 -8.768169747357112964e-03 1.691271413988706078e-05 1.734757125298710853e-05 -7.679504328224222298e-03 1.877255294464485046e-05 1.915609072463527734e-05 -6.313379222240420550e-03 2.062211030152478718e-05 2.093283444973722239e-05 -4.814598317459496853e-03 2.243522931803725059e-05 2.266975796783272728e-05 -3.472202735100402178e-03 2.419485340818696873e-05 2.435138882682870678e-05 -2.291584706759869968e-03 2.588628404843902180e-05 2.596430964123586679e-05 -1.260217990940201314e-03 2.749721928813672256e-05 2.749725089345327506e-05 -3.612420930454100353e-04 2.901819272186568674e-05 2.894153016016526623e-05 4.341220264033718410e-04 3.044221719887379285e-05 3.029077543087035576e-05 1.136883910065480865e-03 3.176438780221747224e-05 3.154060036846004445e-05 1.755261848712437282e-03 3.298171412978680086e-05 3.268846531037745084e-05 2.297035914839235839e-03 3.409304208552935031e-05 3.373360847395665571e-05 2.769423503242729630e-03 3.509873827197292187e-05 3.467675280476736704e-05 3.176543171585788968e-03 3.599998781835492430e-05 3.551976638742071208e-05 3.512780520088757720e-03 3.679196162928287671e-05 3.626638769370893852e-05 3.786554408247124175e-03 3.747691174657915994e-05 3.692057954135923725e-05 4.007195176773644188e-03 3.806125600874636796e-05 3.748585619417009164e-05 4.182584644470333478e-03 3.855107878693996178e-05 3.796552338709175691e-05 4.319257257220477514e-03 3.895194575326105891e-05 3.836258121374271199e-05 4.422496319008115649e-03 3.926876320267451111e-05 3.867965678164013481e-05 4.496419648112232048e-03 3.950565686765957157e-05 3.891894199410879699e-05 4.544051030123891569e-03 3.966586888458199399e-05 3.908213398142982187e-05 4.567375228106673561e-03 3.975174198281028199e-05 3.917045484161410610e-05 1.150961927403827326e-11 5.511521401995620462e-01 -1.935776648831548527e-08 1.092365906663678658e-11 5.511521413296205374e-01 -1.845969218303314823e-08 1.048537934607205443e-11 5.511521421814317145e-01 -1.787783371314129723e-08 1.008228461275558181e-11 5.511521428796468669e-01 -1.743817079756862027e-08 9.613434739503625790e-12 5.511521435361083077e-01 -1.700496961480305481e-08 9.012268809986206650e-12 5.511521442217126587e-01 -1.650095431449761110e-08 8.250504929113550253e-12 5.511521449687725172e-01 -1.589636027325822645e-08 7.332389901787784856e-12 5.511521457853897354e-01 -1.518884249749017418e-08 6.287403853236499090e-12 5.511521466662474555e-01 -1.438968208102320096e-08 5.162191102578776422e-12 5.511521475994088926e-01 -1.351592975852124740e-08 4.012342071394003693e-12 5.511521485700098255e-01 -1.258653724951714097e-08 2.894370274809169344e-12 5.511521495630185008e-01 -1.161974587544692449e-08 1.859396101513526157e-12 5.511521505640200047e-01 -1.063252989496897901e-08 9.485428800098126741e-13 5.511521515594925980e-01 -9.640545506242272978e-09 1.900570014641486702e-13 5.511521525370658425e-01 -8.658074169534106889e-09 -4.016118233523795957e-13 5.511521534861002491e-01 -7.697607083930708995e-09 -8.250238226182257562e-13 5.511521543981081628e-01 -6.769513041744596726e-09 -1.089704207629616594e-12 5.511521552669392809e-01 -5.881882289444144581e-09 -1.213337141534901524e-12 5.511521560888950066e-01 -5.040467935242874776e-09 -1.218917898089451306e-12 5.511521568624189182e-01 -4.249114230086169934e-09 -1.133915389540746096e-12 5.511521575823652430e-01 -3.515119549984391534e-09 -9.888475251341740643e-13 5.511521582396852192e-01 -2.848109574756759962e-09 -8.139095920285730066e-13 5.511521588241194980e-01 -2.258063483108209475e-09 -6.286741619737592112e-13 5.511521593458857948e-01 -1.734632294284797539e-09 -4.513946998983169099e-13 5.511521598054955895e-01 -1.276677703432231343e-09 -2.996102742442352352e-13 5.511521601900346568e-01 -8.947365586253558271e-10 -1.814871432341193085e-13 5.511521604964205734e-01 -5.897546863809995804e-10 -9.458235169492127758e-14 5.511521607408301771e-01 -3.457203167461267589e-10 -3.671102799393254265e-14 5.511521609300097380e-01 -1.571301548201370949e-10 -1.717955250989264156e-14 5.511521609965831514e-01 -9.131145542194535946e-11 -5.627623403988793820e-15 5.511521610482661426e-01 -4.073450692068689380e-11 -1.830099796449069528e-17 5.511521610892079481e-01 -2.687557535131344893e-13 1.574841333179930627e-16 5.511521610937800686e-01 4.372096706019343672e-12 2.179291255199804592e-16 5.511521610684814165e-01 -2.080560663881342177e-11 2.401581201593757428e-15 5.511521610402501103e-01 -4.895926755842107694e-11 1.944762829818197620e-13 5.511521586056309374e-01 -2.510248282251679389e-09 4.539725584503234840e-14 5.511521606234192072e-01 -4.672322712477341546e-10 4.738829155859501236e-14 5.511521606438006815e-01 -4.459036194133875773e-10 5.017773243980506155e-14 5.511521606057752098e-01 -4.834727763870750174e-10 4.758525656917777609e-14 5.511521605657073719e-01 -5.231986141887154679e-10 3.882359397802343515e-14 5.511521605367640797e-01 -5.518845818258667780e-10 2.492949313622357194e-14 5.511521605231570753e-01 -5.653112513001446718e-10 7.406182975562565341e-15 5.511521605226895604e-01 -5.656669391894129287e-10 -1.215122215643300910e-14 5.511521605270285340e-01 -5.612623423362276745e-10 -3.295095268547512366e-14 5.511521605303311144e-01 -5.579742285608494688e-10 -5.521838251546908399e-14 5.511521605249423139e-01 -5.636665903215214719e-10 -8.150837188442329540e-14 5.511521604952966946e-01 -5.947308204843190107e-10 -1.213261187454938045e-13 5.511521604011684339e-01 -6.944565928575578858e-10 -2.276014777415627137e-13 5.511521600319331249e-01 -1.090688864004339338e-09 -1.806513023630696274e-12 5.511521540217911852e-01 -7.651641304408799313e-09 -5.240014369684663910e-13 5.511521592938759539e-01 -2.005484160341183784e-09 -1.212296031981369758e-13 5.511521607001359513e-01 -4.125388421995174064e-10 -8.722236931354790260e-14 5.511521608226684910e-01 -2.693725847105387515e-10 -7.931046493082143302e-14 5.511521608578402454e-01 -2.283184924402783856e-10 -7.634925276761038707e-14 5.511521608755406421e-01 -2.086034965415720113e-10 -7.459150428269256656e-14 5.511521608879197398e-01 -1.957120585287059311e-10 -7.313343966557059716e-14 5.511521608978892095e-01 -1.859081099750322919e-10 -7.175878630065574785e-14 5.511521609062838278e-01 -1.779720208962519095e-10 -7.043751000818438239e-14 5.511521609133672728e-01 -1.714306704901829224e-10 -6.921177485468739576e-14 5.511521609192231441e-01 -1.660868873135271057e-10 -6.813047214272243086e-14 5.511521609238790864e-01 -1.618585641108475485e-10 -6.726784728446901337e-14 5.511521609273392075e-01 -1.587183718685170691e-10 -6.668437198027579657e-14 5.511521609295972901e-01 -1.566677728605937657e-10 -6.642231001322649312e-14 5.511521609306275771e-01 -1.557331093052670950e-10 1.067366120938567819e-11 -1.935776648831548527e-08 5.511521431238710633e-01 1.021183482575975053e-11 -1.845969218303314823e-08 5.511521438210402746e-01 9.919328273732960155e-12 -1.787783371314129723e-08 5.511521441680053979e-01 9.658760176652192736e-12 -1.743817079756862027e-08 5.511521443775931894e-01 9.315673065320694955e-12 -1.700496961480305481e-08 5.511521446068424757e-01 8.818078883249084590e-12 -1.650095431449761110e-08 5.511521449409612083e-01 8.136953334594140242e-12 -1.589636027325822645e-08 5.511521454096118822e-01 7.278081345326079355e-12 -1.518884249749017418e-08 5.511521460113912863e-01 6.273429959840864985e-12 -1.438968208102320096e-08 5.511521467304062449e-01 5.172547576870842248e-12 -1.351592975852124740e-08 5.511521475453343699e-01 4.034151395491652537e-12 -1.258653724951714097e-08 5.511521484336443510e-01 2.917992647554491899e-12 -1.161974587544692449e-08 5.511521493741847744e-01 1.878424733517381316e-12 -1.063252989496897901e-08 5.511521503475927952e-01 9.595971124887965291e-13 -9.640545506242272978e-09 5.511521513361630209e-01 1.924181445612519743e-13 -8.658074169534106889e-09 5.511521523237292719e-01 -4.066004867494716085e-13 -7.697607083930708995e-09 5.511521532959303693e-01 -8.346864348694247062e-13 -6.769513041744596726e-09 5.511521542404683727e-01 -1.100845592023414336e-12 -5.881882289444144581e-09 5.511521551472525760e-01 -1.223064268689931139e-12 -5.040467935242874776e-09 5.511521560084134963e-01 -1.225337259882162327e-12 -4.249114230086169934e-09 5.511521568177769614e-01 -1.136574570110385441e-12 -3.515119549984391534e-09 5.511521575658937522e-01 -9.883420942287301780e-13 -2.848109574756759962e-09 5.511521582426028854e-01 -8.113710616387984672e-13 -2.258063483108209475e-09 5.511521588382346515e-01 -6.255259178520895160e-13 -1.734632294284797539e-09 5.511521593633061933e-01 -4.488981683597256339e-13 -1.276677703432231343e-09 5.511521598196583716e-01 -2.980944870696845405e-13 -8.947365586253558271e-10 5.511521601991148378e-01 -1.805106357352147016e-13 -5.897546863809995804e-10 5.511521605027633885e-01 -9.382015590921116747e-14 -3.457203167461267589e-10 5.511521607464354711e-01 -3.619436286969724798e-14 -1.571301548201370949e-10 5.511521609344490757e-01 -1.690393728324740627e-14 -9.131145542194535946e-11 5.511521609995305715e-01 -5.575697060464207564e-15 -4.073450692068689380e-11 5.511521610490220935e-01 -2.736437520564259389e-17 -2.687557535131344893e-13 5.511521610890248724e-01 1.568053465610302315e-16 4.372096706019343672e-12 5.511521610937383242e-01 2.174133287526413616e-16 -2.080560663881342177e-11 5.511521610686833661e-01 2.392908518946572045e-15 -4.895926755842107694e-11 5.511521610406084903e-01 1.965509365840766923e-13 -2.510248282251679389e-09 5.511521585523549982e-01 4.552025290747657116e-14 -4.672322712477341546e-10 5.511521606208892310e-01 4.742125867714527214e-14 -4.459036194133875773e-10 5.511521606431699638e-01 5.016292433057147593e-14 -4.834727763870750174e-10 5.511521606060583167e-01 4.754130365692046430e-14 -5.231986141887154679e-10 5.511521605666750423e-01 3.877200010379522687e-14 -5.518845818258667780e-10 5.511521605382445621e-01 2.488991462643134132e-14 -5.653112513001446718e-10 5.511521605249959377e-01 7.393693442366314323e-15 -5.656669391894129287e-10 5.511521605247496902e-01 -1.212906390711532263e-14 -5.612623423362276745e-10 5.511521605292168946e-01 -3.289106374595391207e-14 -5.579742285608494688e-10 5.511521605324894990e-01 -5.514390809268825563e-14 -5.636665903215214719e-10 5.511521605265006230e-01 -8.159861391321530174e-14 -5.947308204843190107e-10 5.511521604940202712e-01 -1.224341352598097951e-13 -6.944565928575578858e-10 5.511521603885494169e-01 -2.348234928160064096e-13 -1.090688864004339338e-09 5.511521599637770885e-01 -1.956129096375506553e-12 -7.651641304408799313e-09 5.511521528027344408e-01 -5.860769915074915935e-13 -2.005484160341183784e-09 5.511521588436155694e-01 -1.292340147249856563e-13 -4.125388421995174064e-10 5.511521606472217227e-01 -8.857840270973604569e-14 -2.693725847105387515e-10 5.511521608143363782e-01 -7.851035419279938246e-14 -2.283184924402783856e-10 5.511521608624947444e-01 -7.467032277977913861e-14 -2.086034965415720113e-10 5.511521608848485299e-01 -7.258070017163333038e-14 -1.957120585287059311e-10 5.511521608986227339e-01 -7.107672499042487070e-14 -1.859081099750322919e-10 5.511521609084991669e-01 -6.980137363431135541e-14 -1.779720208962519095e-10 5.511521609161359470e-01 -6.864232789095474304e-14 -1.714306704901829224e-10 5.511521609222430618e-01 -6.758152222713550061e-14 -1.660868873135271057e-10 5.511521609271474720e-01 -6.665325774218395422e-14 -1.618585641108475485e-10 5.511521609309976144e-01 -6.590778651539732583e-14 -1.587183718685170691e-10 5.511521609338492222e-01 -6.539666165875408180e-14 -1.566677728605937657e-10 5.511521609357113993e-01 -6.516616391889506258e-14 -1.557331093052670950e-10 5.511521609365589436e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 new file mode 100644 index 000000000..b04831865 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 @@ -0,0 +1 @@ +1.720766903353992960e-02 6.712673240364842452e-05 6.670490108626119332e-05 1.719298022847327162e-02 6.688354917349438903e-05 6.637433347324535381e-05 1.716338556248604708e-02 6.642989989111473359e-05 6.577451612421388071e-05 1.711844633666995824e-02 6.577055026359329216e-05 6.490808214549058733e-05 1.705749284467645427e-02 6.491117703092936055e-05 6.377949377591227544e-05 1.697961021601139542e-02 6.383725941182556295e-05 6.239853381119218390e-05 1.688361923724005301e-02 6.253455712319055243e-05 6.077595498375613654e-05 1.676805190343103394e-02 6.099385676468269504e-05 5.892224550217712290e-05 1.663112136031247301e-02 5.920486091288620494e-05 5.684839652610927202e-05 1.647068582641797799e-02 5.715647081338764523e-05 5.456559095076968637e-05 1.628420601203704049e-02 5.483741473401079606e-05 5.208514269831571555e-05 1.606869549185516860e-02 5.223662607157148380e-05 4.941784488209893908e-05 1.582066344054361071e-02 4.934375001653104397e-05 4.657347284906382796e-05 1.553604912298846806e-02 4.614997599307863423e-05 4.356063381689207392e-05 1.521014756746910841e-02 4.265007708398618026e-05 4.038763614278569698e-05 1.483752596551282839e-02 3.884484715868498844e-05 3.706341784946671152e-05 1.441193058707400214e-02 3.474270673592729506e-05 3.359790303958845023e-05 1.392618443902047740e-02 3.036295689141765340e-05 3.000406546289170195e-05 1.337207662554033664e-02 2.574125104830591592e-05 2.630179685245107672e-05 1.274024554066844478e-02 2.107281186400266891e-05 2.256006812261701140e-05 1.202005976698990522e-02 1.700339198947167048e-05 1.899385413346095270e-05 1.119950277219134219e-02 1.364408604316665609e-05 1.569715463016341573e-05 1.026507197549429533e-02 1.100554423444300423e-05 1.273639986176074566e-05 9.201707158255644642e-03 9.058541736057313168e-06 1.016265450856425424e-05 7.992770393558144143e-03 7.729031254816282377e-06 8.005805604016440983e-06 6.620108712081153139e-03 6.611123136477652225e-06 6.212737445300371463e-06 5.064242443084469338e-03 5.361067274967163276e-06 4.714317099712187204e-06 3.304735478632547276e-03 4.113517229195584366e-06 3.527307615503401715e-06 1.320818783583201225e-03 3.027279105548599651e-06 2.673317781602658340e-06 -8.901083327286571497e-04 2.278755306081316828e-06 2.177552123765150470e-06 -3.065396834676581937e-03 2.068376836972744290e-06 2.067826890576520114e-06 -5.050552897229254254e-03 2.423463170645983941e-06 2.344498366448314169e-06 -6.761644112516061386e-03 3.227461795470871144e-06 2.978654104392542509e-06 -8.112599016120590825e-03 4.351809093247833630e-06 3.929788465622836908e-06 -9.181216153439759886e-03 5.663792833308059565e-06 5.149443799235741494e-06 -1.007433562402464469e-02 7.033938486909540339e-06 6.585301837766536938e-06 -1.072632012257225716e-02 8.451557753855180622e-06 8.191676072364819083e-06 -1.094353425061423898e-02 9.979659884712428498e-06 9.927826188991484857e-06 -1.069631606700133589e-02 1.160475363138787024e-05 1.174986675440338699e-05 -1.021744870764373578e-02 1.331208586641884272e-05 1.361714001470931992e-05 -9.603547471876550459e-03 1.508653712469378170e-05 1.549352284174571693e-05 -8.833459678664015713e-03 1.691271414116807953e-05 1.734757125426595210e-05 -7.767066675032636980e-03 1.877255294610733077e-05 1.915609072609284147e-05 -6.420834718545201901e-03 2.062211030310742759e-05 2.093283445131903609e-05 -4.920211111283457998e-03 2.243522931970551925e-05 2.266975796950608491e-05 -3.567211333762516142e-03 2.419485340992967465e-05 2.435138882857565464e-05 -2.376678574377389091e-03 2.588628405030659393e-05 2.596430964310633916e-05 -1.336190611095163308e-03 2.749721929029391558e-05 2.749725089562571467e-05 -4.298691802394400048e-04 2.901819272506737303e-05 2.894153016346485936e-05 3.713133446198814739e-04 3.044221721866077049e-05 3.029077545227462423e-05 1.079333774415499421e-03 3.176438780723478720e-05 3.154060037403846114e-05 1.702422575342495744e-03 3.298171413107827538e-05 3.268846531173310335e-05 2.248382339551281781e-03 3.409304208653416178e-05 3.373360847497514846e-05 2.724459231423815696e-03 3.509873827292100924e-05 3.467675280572270500e-05 3.135720026797372308e-03 3.599998781928790738e-05 3.551976638836314804e-05 3.476453216159429774e-03 3.679196163022590221e-05 3.626638769465039192e-05 3.754003360870916163e-03 3.747691174750813825e-05 3.692057954229713312e-05 3.977778302079064410e-03 3.806125600967092136e-05 3.748585619510746574e-05 4.155728217965017589e-03 3.855107878785266350e-05 3.796552338801991529e-05 4.294446121855468798e-03 3.895194575417592904e-05 3.836258121466188504e-05 4.399263866484369109e-03 3.926876320356236427e-05 3.867965678254353949e-05 4.474337820424311926e-03 3.950565686854117024e-05 3.891894199500844763e-05 4.522720461294434113e-03 3.966586888545855111e-05 3.908213398231935554e-05 4.546415557459232253e-03 3.975174198368902785e-05 3.917045484249861856e-05 1.124379931869220643e-11 5.511521401989626368e-01 -1.935841351429115791e-08 1.068254272358699679e-11 5.511521413290129123e-01 -1.846034814934950732e-08 1.027408998058894788e-11 5.511521421808095456e-01 -1.787850551040289174e-08 9.905528168303944524e-12 5.511521428790077115e-01 -1.743886122377381628e-08 9.474634165859584333e-12 5.511521435354553855e-01 -1.700567558995008580e-08 8.912539093504037754e-12 5.511521442210558508e-01 -1.650166565435186132e-08 8.188287019190832069e-12 5.511521449681285878e-01 -1.589705943338448584e-08 7.303702845549870186e-12 5.511521457847813332e-01 -1.518950564924520541e-08 6.286574551160031287e-12 5.511521466657003376e-01 -1.439028169662491015e-08 5.182673348452780155e-12 5.511521475989483720e-01 -1.351643860604680368e-08 4.047522087318860873e-12 5.511521485696557754e-01 -1.258693339415069893e-08 2.938135330587634489e-12 5.511521495627800249e-01 -1.162001802790125530e-08 1.906568825183546604e-12 5.511521505638913299e-01 -1.063268229413269174e-08 9.950268222235351917e-13 5.511521515594494103e-01 -9.640601494305080318e-09 2.329423361990660818e-13 5.511521525370643992e-01 -8.658077712328723820e-09 -3.641936430742544474e-13 5.511521534860784888e-01 -7.697621686808658634e-09 -7.940322944911115324e-13 5.511521543979897020e-01 -6.769617782389535027e-09 -1.065362753691833684e-12 5.511521552666405199e-01 -5.882164995684816938e-09 -1.195347090912788764e-12 5.511521560883340110e-01 -5.041015836648015701e-09 -1.206588261697937343e-12 5.511521568615262989e-01 -4.250002669372075316e-09 -1.126332066147028705e-12 5.511521575810958140e-01 -3.516399837255236973e-09 -9.849926473288025120e-13 5.511521582380271012e-01 -2.849798578494380019e-09 -8.127584164738010624e-13 5.511521588220997803e-01 -2.260136283318940185e-09 -6.293029450913584212e-13 5.511521593435717570e-01 -1.737019347213116293e-09 -4.529923020023661015e-13 5.511521598029908153e-01 -1.279267784340801185e-09 -3.015322705532040819e-13 5.511521601874694865e-01 -8.973861656373373035e-10 -1.832855995157782226e-13 5.511521604939404462e-01 -5.923023481320416498e-10 -9.598364863104476054e-14 5.511521607385827526e-01 -3.480045032003966609e-10 -3.757474025191286899e-14 5.511521609281296863e-01 -1.590108068873773524e-10 -1.771299034898742825e-14 5.511521609952499956e-01 -9.261896962241085490e-11 -5.864798637501380520e-15 5.511521610475662580e-01 -4.140909210779229826e-11 -4.391927574265215903e-17 5.511521610889511535e-01 -5.140827367412119686e-13 1.715086453772705563e-16 5.511521610937393234e-01 4.332831174106754494e-12 1.513887410876547534e-16 5.511521610684803063e-01 -2.080659314573204521e-11 2.278367481961941684e-15 5.511521610402135840e-01 -4.899432783941330235e-11 1.899455379625113068e-13 5.511521586055532218e-01 -2.510324466082188824e-09 4.490264714482788216e-14 5.511521606233507065e-01 -4.672998108815752970e-10 4.730270787552940163e-14 5.511521606438077869e-01 -4.458966340013474659e-10 5.052167883840936255e-14 5.511521606058522593e-01 -4.833954427332613350e-10 4.832896318673272088e-14 5.511521605657863088e-01 -5.231172197173016908e-10 3.986782951503364502e-14 5.511521605368231436e-01 -5.518225293869036179e-10 2.621051125816343297e-14 5.511521605231906040e-01 -5.652762271769840404e-10 8.868662136599932622e-15 5.511521605226950005e-01 -5.656615682293735280e-10 -1.056858058519397946e-14 5.511521605270374158e-01 -5.612528471115699621e-10 -3.128268501462715004e-14 5.511521605304121607e-01 -5.578913775721459780e-10 -5.347567658457378582e-14 5.511521605251552547e-01 -5.634529511221715852e-10 -7.964080116075407815e-14 5.511521604956814979e-01 -5.943484408425809568e-10 -1.191689243419147103e-13 5.511521604017403098e-01 -6.938913042591608016e-10 -2.243997898245069061e-13 5.511521600326927395e-01 -1.089938817921913829e-09 -1.786726045269459436e-12 5.511521540227259930e-01 -7.650715272933967494e-09 -5.189841187604374306e-13 5.511521592949527593e-01 -2.004409905900591651e-09 -1.199381289176239830e-13 5.511521607013160073e-01 -4.113497224068853493e-10 -8.621755856056185372e-14 5.511521608239140502e-01 -2.681024739049043217e-10 -7.836237992802480504e-14 5.511521608591191113e-01 -2.269979553438566608e-10 -7.541626996460634645e-14 5.511521608768014113e-01 -2.072864202597302569e-10 -7.364847706792762308e-14 5.511521608891201129e-01 -1.944469719894820574e-10 -7.220446163495824081e-14 5.511521608990276322e-01 -1.847017509930289891e-10 -7.083423009169807048e-14 5.511521609073625205e-01 -1.768258999667507354e-10 -6.952480605300450702e-14 5.511521609143911204e-01 -1.703423825329724973e-10 -6.829690398183426133e-14 5.511521609201985861e-01 -1.650509546242985757e-10 -6.724261811774589111e-14 5.511521609248141162e-01 -1.608671104193587100e-10 -6.638624667668800429e-14 5.511521609282430401e-01 -1.577617211897631018e-10 -6.580781169136277972e-14 5.511521609304798064e-01 -1.557349852814714842e-10 -6.554356378434271373e-14 5.511521609314992132e-01 -1.548124489046693648e-10 1.042719896619318982e-11 -1.935841351429115791e-08 5.511521431231726220e-01 9.986486801154351912e-12 -1.846034814934950732e-08 5.511521438203321743e-01 9.719490626731856674e-12 -1.787850551040289174e-08 5.511521441672800892e-01 9.489470681376607650e-12 -1.743886122377381628e-08 5.511521443768473416e-01 9.181208923542002080e-12 -1.700567558995008580e-08 5.511521446060790863e-01 8.720539251327147769e-12 -1.650166565435186132e-08 5.511521449401908246e-01 8.075623211860341507e-12 -1.589705943338448584e-08 5.511521454088527117e-01 7.249633443336263732e-12 -1.518950564924520541e-08 5.511521460106685311e-01 6.272622364703893631e-12 -1.439028169662491015e-08 5.511521467297489929e-01 5.193089962476587736e-12 -1.351643860604680368e-08 5.511521475447720420e-01 4.069532696420372134e-12 -1.258693339415069893e-08 5.511521484332011500e-01 2.962124045783573469e-12 -1.162001802790125530e-08 5.511521493738741340e-01 1.926080593438918644e-12 -1.063268229413269174e-08 5.511521503474122730e-01 1.006629438606728281e-12 -9.640601494305080318e-09 5.511521513360903013e-01 2.358279206230809016e-13 -8.658077712328723820e-09 5.511521523237205011e-01 -3.687180719021075485e-13 -7.697621686808658634e-09 5.511521532959205993e-01 -8.033259038266869828e-13 -6.769617782389535027e-09 5.511521542403757801e-01 -1.076256473256878706e-12 -5.882164995684816938e-09 5.511521551469850122e-01 -1.204921884804728665e-12 -5.041015836648015701e-09 5.511521560078783688e-01 -1.212937948927166847e-12 -4.250002669372075316e-09 5.511521568168927798e-01 -1.128972297457539521e-12 -3.516399837255236973e-09 5.511521575646025628e-01 -9.845009383190930151e-13 -2.849798578494380019e-09 5.511521582408823727e-01 -8.102436498178349529e-13 -2.260136283318940185e-09 5.511521588361073531e-01 -6.261818285015319774e-13 -1.737019347213116293e-09 5.511521593608438296e-01 -4.505187791928124553e-13 -1.279267784340801185e-09 5.511521598169800695e-01 -3.000462469393581990e-13 -8.973861656373373035e-10 5.511521601963780270e-01 -1.823331437867332905e-13 -5.923023481320416498e-10 5.511521605001463708e-01 -9.522257254679203343e-14 -3.480045032003966609e-10 5.511521607441138837e-01 -3.705433985772649198e-14 -1.590108068873773524e-10 5.511521609325678028e-01 -1.742766919971831788e-14 -9.261896962241085490e-11 5.511521609982481529e-01 -5.807337983523520383e-15 -4.140909210779229826e-11 5.511521610483718359e-01 -5.089578737354983002e-17 -5.140827367412119686e-13 5.511521610887905043e-01 1.701351139095099251e-16 4.332831174106754494e-12 5.511521610937004656e-01 1.509869087096243274e-16 -2.080659314573204521e-11 5.511521610686824779e-01 2.270004109583933712e-15 -4.899432783941330235e-11 5.511521610405748506e-01 1.919716683554967631e-13 -2.510324466082188824e-09 5.511521585522802802e-01 4.502422240739360567e-14 -4.672998108815752970e-10 5.511521606208227286e-01 4.733577444739967979e-14 -4.458966340013474659e-10 5.511521606431768472e-01 5.050918754756750035e-14 -4.833954427332613350e-10 5.511521606061359213e-01 4.828391608631327176e-14 -5.231172197173016908e-10 5.511521605667589752e-01 3.981461487940632085e-14 -5.518225293869036179e-10 5.511521605383097322e-01 2.616875810061634018e-14 -5.652762271769840404e-10 5.511521605250324640e-01 8.851257733283596241e-15 -5.656615682293735280e-10 5.511521605247550193e-01 -1.054724961264551410e-14 -5.612528471115699621e-10 5.511521605292271087e-01 -3.121770663943244416e-14 -5.578913775721459780e-10 5.511521605325740980e-01 -5.339695995542333494e-14 -5.634529511221715852e-10 5.511521605267150070e-01 -7.972814136744309671e-14 -5.943484408425809568e-10 5.511521604944001895e-01 -1.202616945646111708e-13 -6.938913042591608016e-10 5.511521603891081922e-01 -2.315239008243453951e-13 -1.089938817921913829e-09 5.511521599645177183e-01 -1.934724828688250947e-12 -7.650715272933967494e-09 5.511521528036518180e-01 -5.804985756064516118e-13 -2.004409905900591651e-09 5.511521588446872677e-01 -1.278783600244265403e-13 -4.113497224068853493e-10 5.511521606484199864e-01 -8.755991171992388262e-14 -2.681024739049043217e-10 5.511521608156314533e-01 -7.755501587582693302e-14 -2.269979553438566608e-10 5.511521608638583203e-01 -7.372788821349790250e-14 -2.072864202597302569e-10 5.511521608862244292e-01 -7.163924543844210218e-14 -1.944469719894820574e-10 5.511521608999560007e-01 -7.013883144285928668e-14 -1.847017509930289891e-10 5.511521609097775887e-01 -6.886399652958866370e-14 -1.768258999667507354e-10 5.511521609173536396e-01 -6.771416871767333033e-14 -1.703423825329724973e-10 5.511521609233999142e-01 -6.666234695991208654e-14 -1.650509546242985757e-10 5.511521609282475920e-01 -6.574985420717189904e-14 -1.608671104193587100e-10 5.511521609320488846e-01 -6.500813917222130397e-14 -1.577617211897631018e-10 5.511521609348618567e-01 -6.450712897602713600e-14 -1.557349852814714842e-10 5.511521609366973884e-01 -6.428164977997273187e-14 -1.548124489046693648e-10 5.511521609375313879e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 new file mode 100644 index 000000000..4ed9ce969 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 @@ -0,0 +1 @@ +1.721295036721734451e-02 6.712673211598307941e-05 6.670490081950747894e-05 1.719833101109900786e-02 6.688354891152763053e-05 6.637433322836087815e-05 1.716887648625218393e-02 6.642989965980925318e-05 6.577451590539713539e-05 1.712415060430064889e-02 6.577055006793076843e-05 6.490808195806892168e-05 1.706348748829126724e-02 6.491117687505381750e-05 6.377949362489370062e-05 1.698597749385840489e-02 6.383725929785905528e-05 6.239853369971054564e-05 1.689044813678616461e-02 6.253455705058646606e-05 6.077595491217876929e-05 1.677543977979850318e-02 6.099385673038053730e-05 5.892224546814600893e-05 1.663917574349344647e-02 5.920486091177206523e-05 5.684839652502240678e-05 1.647952642887269212e-02 5.715647083916808232e-05 5.456559097662456748e-05 1.629396697427812693e-02 5.483741477984106544e-05 5.208514274441522620e-05 1.607952790311147073e-02 5.223662613078247494e-05 4.941784494180467878e-05 1.583273817237159861e-02 4.934375008306843643e-05 4.657347291629032577e-05 1.554956001640854860e-02 4.614997606183171580e-05 4.356063388643919806e-05 1.522531500859121770e-02 4.265007715088150851e-05 4.038763621050970806e-05 1.485460088100761140e-02 3.884484722075094140e-05 3.706341791230791647e-05 1.443119887765129290e-02 3.474270679122035225e-05 3.359790309552031256e-05 1.394797184910202999e-02 3.036295693885474089e-05 3.000406551081653811e-05 1.339675401159413741e-02 2.574125108752354477e-05 2.630179689198243980e-05 1.276823444648033691e-02 2.107281189517444699e-05 2.256006815395380843e-05 1.205183813129992454e-02 1.700339201321977397e-05 1.899385415725917005e-05 1.123561047888494736e-02 1.364408606043832027e-05 1.569715464742198647e-05 1.030611576915033134e-02 1.100554424637104417e-05 1.273639987363437728e-05 9.248364213339344692e-03 9.058541743739051579e-06 1.016265451619682238e-05 8.045789494365048269e-03 7.729031259320825613e-06 8.005805608464805606e-06 6.680307569245398126e-03 6.611123138788110771e-06 6.212737447590208145e-06 5.132499128865464742e-03 5.361067275929808597e-06 4.714317100663564446e-06 3.381971325154171926e-03 4.113517229415139541e-06 3.527307615711116640e-06 1.407969392174824317e-03 3.027279105446231061e-06 2.673317781500067827e-06 -7.965506467413656843e-04 2.278755305966860654e-06 2.177552123653988407e-06 -2.977733455481294811e-03 2.068376836908302447e-06 2.067826890513496204e-06 -4.972186905860578356e-03 2.423463170631372623e-06 2.344498366434764183e-06 -6.696231234565619937e-03 3.227461795473075547e-06 2.978654104395773093e-06 -8.063808239355539295e-03 4.351809093232012748e-06 3.929788465606180006e-06 -9.139081605687892490e-03 5.663792833281853213e-06 5.149443799209220045e-06 -1.004011843075387940e-02 7.033938486306045457e-06 6.585301837156556325e-06 -1.070653577155281609e-02 8.451557753909792224e-06 8.191676072419649219e-06 -1.094394683151203584e-02 9.979659884968459453e-06 9.927826189249413166e-06 -1.071407880957648065e-02 1.160475363191492463e-05 1.174986675492620791e-05 -1.024152149876695304e-02 1.331208586718939029e-05 1.361714001548133116e-05 -9.633673638772205852e-03 1.508653712564603308e-05 1.549352284269552208e-05 -8.874323488512006822e-03 1.691271414222667759e-05 1.734757125532049117e-05 -7.822225237291480227e-03 1.877255294722611221e-05 1.915609072720962053e-05 -6.488779015713068941e-03 2.062211030423390687e-05 2.093283445243970811e-05 -4.988113161670612410e-03 2.243522932079603351e-05 2.266975797059254358e-05 -3.628313350716756615e-03 2.419485341096456256e-05 2.435138882960466414e-05 -2.431419318071098741e-03 2.588628405127860489e-05 2.596430964408243960e-05 -1.385076563559442010e-03 2.749721929123112365e-05 2.749725089657682425e-05 -4.739591523485466810e-04 2.901819272610700433e-05 2.894153016453239192e-05 3.309569451030824178e-04 3.044221722186931097e-05 3.029077545573263962e-05 1.042352396640172608e-03 3.176438780728337979e-05 3.154060037406913050e-05 1.668465229659840893e-03 3.298171413106951367e-05 3.268846531172054016e-05 2.217112294288576396e-03 3.409304208651129866e-05 3.373360847493998642e-05 2.695558071838491127e-03 3.509873827284897756e-05 3.467675280565772741e-05 3.109365022826470100e-03 3.599998781918287529e-05 3.551976638827716404e-05 3.452991700702481154e-03 3.679196163005348696e-05 3.626638769452183265e-05 3.732972709703424700e-03 3.747691174731124713e-05 3.692057954212250880e-05 3.958765563350454333e-03 3.806125600941796344e-05 3.748585619489000189e-05 4.138364275776920675e-03 3.855107878756508565e-05 3.796552338778019819e-05 4.278399431584325140e-03 3.895194575383368707e-05 3.836258121436942828e-05 4.384234036816399629e-03 3.926876320320372375e-05 3.867965678222908021e-05 4.460049202850799310e-03 3.950565686815673248e-05 3.891894199464233288e-05 4.508915825716490466e-03 3.966586888505558027e-05 3.908213398194559040e-05 4.532849875250227582e-03 3.975174198328113067e-05 3.917045484211030478e-05 1.095613397081323215e-11 5.511521401985970403e-01 -1.935880555269290127e-08 1.042057596433414104e-11 5.511521413286415427e-01 -1.846074647570244889e-08 1.004278450176409021e-11 5.511521421804278509e-01 -1.787891514045774313e-08 9.709865643111675681e-12 5.511521428786134713e-01 -1.743928460394935357e-08 9.318758622435209968e-12 5.511521435350501541e-01 -1.700611143225154642e-08 8.798572590483974915e-12 5.511521442206454013e-01 -1.650210808975193781e-08 8.115682938199146633e-12 5.511521449677231344e-01 -1.589749775642787399e-08 7.269400685698935079e-12 5.511521457843951977e-01 -1.518992490383253614e-08 6.285460411536010251e-12 5.511521466653500623e-01 -1.439066423844682559e-08 5.208453784077735955e-12 5.511521475986506102e-01 -1.351676659708996165e-08 4.093352356223616723e-12 5.511521485694239608e-01 -1.258719198451265319e-08 2.997346319600008901e-12 5.511521495626210410e-01 -1.162019880847234085e-08 1.973106218637771118e-12 5.511521505638028451e-01 -1.063278649821103143e-08 1.063779906906167971e-12 5.511521515594174359e-01 -9.640642401714403220e-09 2.998376666283024587e-13 5.511521525370624008e-01 -8.658081766074490919e-09 -3.021276893818964013e-13 5.511521534860680527e-01 -7.697627956657833016e-09 -7.387392356536309945e-13 5.511521543979231996e-01 -6.769675582814900476e-09 -1.017925665689531102e-12 5.511521552664651047e-01 -5.882329662673053204e-09 -1.156129461498360953e-12 5.511521560879973913e-01 -5.041342862102952239e-09 -1.175416483921707593e-12 5.511521568609838440e-01 -4.250540558901880616e-09 -1.102583961436972139e-12 5.511521575803176587e-01 -3.517182371230707500e-09 -9.677209835334849927e-13 5.511521582370041417e-01 -2.850838104559950033e-09 -8.008303772710203792e-13 5.511521588208475597e-01 -2.261418900734099523e-09 -6.216212069902853704e-13 5.511521593421312426e-01 -1.738502915092586535e-09 -4.484877595596141106e-13 5.511521598014261780e-01 -1.280883574282839505e-09 -2.992218118539822385e-13 5.511521601858621056e-01 -8.990446162327785056e-10 -1.823229538361239393e-13 5.511521604923819151e-01 -5.939019715933760666e-10 -9.576409366428380361e-14 5.511521607371665521e-01 -3.494431422061634473e-10 -3.767710891395697204e-14 5.511521609269410815e-01 -1.601992594044196056e-10 -1.782744669833678500e-14 5.511521609943960121e-01 -9.345596204951614450e-11 -5.929240445845408823e-15 5.511521610471139532e-01 -4.184434444575934867e-11 -5.853068583388004972e-17 5.511521610887827327e-01 -6.744288194837621236e-13 1.737132145498644102e-16 5.511521610937115678e-01 4.306344532639519234e-12 1.355682444771499907e-16 5.511521610684797512e-01 -2.080710179040346200e-11 2.252161361627504503e-15 5.511521610401906024e-01 -4.901647051611147232e-11 1.893420428048294971e-13 5.511521586055031507e-01 -2.510373647806366452e-09 4.495725796801629086e-14 5.511521606233041881e-01 -4.673457040907776911e-10 4.755873821221601097e-14 5.511521606438090082e-01 -4.458954598236297607e-10 5.104873314813767310e-14 5.511521606059016642e-01 -4.833459271123453165e-10 4.909951142735070996e-14 5.511521605658377121e-01 -5.230642479493962673e-10 4.082008047062512767e-14 5.511521605368623344e-01 -5.517813944196182784e-10 2.726911085656805681e-14 5.511521605232132526e-01 -5.652524989295393220e-10 9.987442966387723770e-15 5.511521605226993303e-01 -5.656572784206124303e-10 -9.442102275759914166e-15 5.511521605270418567e-01 -5.612480549135857038e-10 -3.019217099322405313e-14 5.511521605304605664e-01 -5.578417582022837131e-10 -5.244078930174357985e-14 5.511521605252867051e-01 -5.633207632901547776e-10 -7.866878971545750320e-14 5.511521604959228604e-01 -5.941082465345681717e-10 -1.182317149899083537e-13 5.511521604021025755e-01 -6.935329022246582895e-10 -2.233601598306526581e-13 5.511521600331764636e-01 -1.089460967409281549e-09 -1.783517504413031013e-12 5.511521540233245142e-01 -7.650122309124104859e-09 -5.189355289665292998e-13 5.511521592956452054e-01 -2.003719217243813544e-09 -1.199468913455386908e-13 5.511521607020777314e-01 -4.105825692333179972e-10 -8.624042360742396977e-14 5.511521608247205162e-01 -2.672806819565484605e-10 -7.843441309158790667e-14 5.511521608599493360e-01 -2.261414164331362712e-10 -7.552130291467565766e-14 5.511521608776249748e-01 -2.064267006581320498e-10 -7.382089447751411425e-14 5.511521608899055957e-01 -1.936195748501959040e-10 -7.240135218148223077e-14 5.511521608997735910e-01 -1.839113530777261947e-10 -7.108718510394105623e-14 5.511521609080702877e-01 -1.760737067581226890e-10 -6.981238372589967097e-14 5.511521609150638046e-01 -1.696270219126132408e-10 -6.863914555470223174e-14 5.511521609208401840e-01 -1.643690371174432359e-10 -6.760125877397316671e-14 5.511521609254298459e-01 -1.602136686352289888e-10 -6.677068756184130070e-14 5.511521609288386747e-01 -1.571305981423525883e-10 -6.621078283662278601e-14 5.511521609310617853e-01 -1.551191837018335948e-10 -6.595146015938489180e-14 5.511521609320741977e-01 -1.542044393343017922e-10 1.016044525788433388e-11 -1.935880555269290127e-08 5.511521431227522916e-01 9.741602331716402985e-12 -1.846074647570244889e-08 5.511521438199049605e-01 9.500673878906462187e-12 -1.787891514045774313e-08 5.511521441668405519e-01 9.302049022335230158e-12 -1.743928460394935357e-08 5.511521443763925943e-01 9.030190346277613044e-12 -1.700611143225154642e-08 5.511521446056103501e-01 8.609057617523781191e-12 -1.650210808975193781e-08 5.511521449397139838e-01 8.004045845184568908e-12 -1.589749775642787399e-08 5.511521454083788685e-01 7.215602326446723341e-12 -1.518992490383253614e-08 5.511521460102133396e-01 6.271535502029128145e-12 -1.439066423844682559e-08 5.511521467293311050e-01 5.218944842165977545e-12 -1.351676659708996165e-08 5.511521475444107754e-01 4.115632204117746247e-12 -1.258719198451265319e-08 5.511521484329127141e-01 3.021829784614994091e-12 -1.162019880847234085e-08 5.511521493736685207e-01 1.993307088385502147e-12 -1.063278649821103143e-08 5.511521503472894823e-01 1.076176559667642099e-12 -9.640642401714403220e-09 5.511521513360378988e-01 3.035519289922088602e-13 -8.658081766074490919e-09 5.511521523237122855e-01 -3.058768700270140061e-13 -7.697627956657833016e-09 5.511521532959168246e-01 -7.473940395182781010e-13 -6.769675582814900476e-09 5.511521542403254870e-01 -1.028331637348979012e-12 -5.882329662673053204e-09 5.511521551468304692e-01 -1.165390520182033455e-12 -5.041342862102952239e-09 5.511521560075606230e-01 -1.181601151700301850e-12 -4.250540558901880616e-09 5.511521568163594287e-01 -1.105174081235629311e-12 -3.517182371230707500e-09 5.511521575638156367e-01 -9.672423690794238515e-13 -2.850838104559950033e-09 5.511521582398259955e-01 -7.983700188792982360e-13 -2.261418900734099523e-09 5.511521588347936262e-01 -6.185492601714321537e-13 -1.738502915092586535e-09 5.511521593593159407e-01 -4.460704140162548011e-13 -1.280883574282839505e-09 5.511521598153115153e-01 -2.977564105289988776e-13 -8.990446162327785056e-10 5.511521601946668403e-01 -1.813817665643085847e-13 -5.939019715933760666e-10 5.511521604985044620e-01 -9.501485778097035877e-14 -3.494431422061634473e-10 5.511521607426524971e-01 -3.715693046811362058e-14 -1.601992594044196056e-10 5.511521609313794201e-01 -1.753883141499314953e-14 -9.345596204951614450e-11 5.511521609974278091e-01 -5.870361752854431537e-15 -4.184434444575934867e-11 5.511521610479529487e-01 -6.444557491325421710e-17 -6.744288194837621236e-13 5.511521610886378486e-01 1.733658548998054962e-16 4.306344532639519234e-12 5.511521610936751525e-01 1.343299218773930538e-16 -2.080710179040346200e-11 5.511521610686820338e-01 2.243482614486945224e-15 -4.901647051611147232e-11 5.511521610405535343e-01 1.913616876301035290e-13 -2.510373647806366452e-09 5.511521585522319855e-01 4.507905332476748612e-14 -4.673457040907776911e-10 5.511521606207774315e-01 4.759370199910946903e-14 -4.458954598236297607e-10 5.511521606431779574e-01 5.103200807249778396e-14 -4.833459271123453165e-10 5.511521606061855483e-01 4.905592678277543291e-14 -5.230642479493962673e-10 5.511521605668134871e-01 4.076442073851072263e-14 -5.517813944196182784e-10 5.511521605383529199e-01 2.722329766124028425e-14 -5.652524989295393220e-10 5.511521605250573330e-01 9.968038096534029670e-15 -5.656572784206124303e-10 5.511521605247593492e-01 -9.426577148354940974e-15 -5.612480549135857038e-10 5.511521605292323267e-01 -3.013124693639900107e-14 -5.578417582022837131e-10 5.511521605326249462e-01 -5.236795119408414104e-14 -5.633207632901547776e-10 5.511521605268479007e-01 -7.875203952025151817e-14 -5.941082465345681717e-10 5.511521604946392205e-01 -1.193105835213450212e-13 -6.935329022246582895e-10 5.511521603894627974e-01 -2.304563671188846337e-13 -1.089460967409281549e-09 5.511521599649897851e-01 -1.931266813415170220e-12 -7.650122309124104859e-09 5.511521528042393481e-01 -5.804679032761464065e-13 -2.003719217243813544e-09 5.511521588453761611e-01 -1.278909252944431302e-13 -4.105825692333179972e-10 5.511521606491925906e-01 -8.759507042147763233e-14 -2.672806819565484605e-10 5.511521608164687835e-01 -7.761999647692543881e-14 -2.261414164331362712e-10 5.511521608647420578e-01 -7.381387051429841039e-14 -2.064267006581320498e-10 5.511521608871219335e-01 -7.176780202684720655e-14 -1.936195748501959040e-10 5.511521609008276368e-01 -7.031345327145920070e-14 -1.839113530777261947e-10 5.511521609106150299e-01 -6.908146026147251275e-14 -1.760737067581226890e-10 5.511521609181530001e-01 -6.795388267596431858e-14 -1.696270219126132408e-10 5.511521609241606390e-01 -6.695480207488848551e-14 -1.643690371174432359e-10 5.511521609289723456e-01 -6.606431073194040527e-14 -1.602136686352289888e-10 5.511521609327423299e-01 -6.537425390018490676e-14 -1.571305981423525883e-10 5.511521609355305440e-01 -6.488089440724862222e-14 -1.551191837018335948e-10 5.511521609373489783e-01 -6.466996424246120561e-14 -1.542044393343017922e-10 5.511521609381743181e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 new file mode 100644 index 000000000..e0b477046 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 @@ -0,0 +1 @@ +1.721632942869843336e-02 6.712673204326235999e-05 6.670490075228683582e-05 1.720175449329284373e-02 6.688354884888213084e-05 6.637433316997968114e-05 1.717238960348169141e-02 6.642989961067368506e-05 6.577451585906936629e-05 1.712780017332296220e-02 6.577055003466895011e-05 6.490808192630051054e-05 1.706732277147334637e-02 6.491117685874950392e-05 6.377949360914917417e-05 1.699005109041411624e-02 6.383725929830569236e-05 6.239853370017957150e-05 1.689481694320208588e-02 6.253455706633385210e-05 6.077595492773033486e-05 1.678016603653742847e-02 6.099385675893397051e-05 5.892224549651151603e-05 1.664432818915119461e-02 5.920486095006603853e-05 5.684839656323524787e-05 1.648518158270052478e-02 5.715647088382809097e-05 5.456559102136532887e-05 1.630021057058287856e-02 5.483741482765272106e-05 5.208514279247298216e-05 1.608645650023426965e-02 5.223662617888073941e-05 4.941784499029032869e-05 1.584046096287895777e-02 4.934375012910946116e-05 4.657347296279683237e-05 1.555820086062808735e-02 4.614997610409174808e-05 4.356063392919126839e-05 1.523501471733340260e-02 4.265007718822385723e-05 4.038763624833542799e-05 1.486551976487506324e-02 3.884484725262264313e-05 3.706341794457445753e-05 1.444351957620214864e-02 3.474270681746791784e-05 3.359790312209671667e-05 1.396190243696526431e-02 3.036295695969637619e-05 3.000406553188113959e-05 1.341253135900296115e-02 2.574125110342915656e-05 2.630179690802911645e-05 1.278612777498370177e-02 2.107281190676286398e-05 2.256006816560004728e-05 1.207215265376144001e-02 1.700339202117923416e-05 1.899385416522654830e-05 1.125869093895701806e-02 1.364408606550349090e-05 1.569715465247324034e-05 1.033234957588064808e-02 1.100554424925472040e-05 1.273639987650265615e-05 9.278183718190299509e-03 9.058541745085359626e-06 1.016265451750178337e-05 8.079672746624340027e-03 7.729031259655966057e-06 8.005805608796395288e-06 6.718776610978390365e-03 6.611123138569952353e-06 6.212737447366392394e-06 5.176114544984542626e-03 5.361067275502351726e-06 4.714317100218249579e-06 3.431321357095292769e-03 4.113517228988618641e-06 3.527307615272877040e-06 1.463651479512458444e-03 3.027279105135444508e-06 2.673317781190135083e-06 -7.364435113205050707e-04 2.278755305765620872e-06 2.177552123446766031e-06 -2.921346635785978564e-03 2.068376836816357444e-06 2.067826890421239916e-06 -4.921693669552004539e-03 2.423463170622163681e-06 2.344498366426606409e-06 -6.653968554831440896e-03 3.227461795477976056e-06 2.978654104399682150e-06 -8.032148847265406510e-03 4.351809093201792307e-06 3.929788465577178444e-06 -9.111923044719425283e-03 5.663792833225202802e-06 5.149443799153701271e-06 -1.001800621021347801e-02 7.033938484143804971e-06 6.585301834970980928e-06 -1.069341885884439805e-02 8.451557753641867233e-06 8.191676072150485866e-06 -1.094373034617290158e-02 9.979659884861194588e-06 9.927826189140095094e-06 -1.072529824394265544e-02 1.160475363197610413e-05 1.174986675498730101e-05 -1.025677780553416532e-02 1.331208586741465192e-05 1.361714001569960308e-05 -9.652805316628819063e-03 1.508653712597981149e-05 1.549352284303230916e-05 -8.900097482833761731e-03 1.691271414265535080e-05 1.734757125574980135e-05 -7.857162016506663224e-03 1.877255294771064555e-05 1.915609072769330345e-05 -6.531917501015669855e-03 2.062211030476308901e-05 2.093283445297244440e-05 -5.031687966667522903e-03 2.243522932135812796e-05 2.266975797113974042e-05 -3.667529308007861505e-03 2.419485341154213400e-05 2.435138883017904735e-05 -2.466556558475318465e-03 2.588628405187327284e-05 2.596430964468336204e-05 -1.416458986790087140e-03 2.749721929191475378e-05 2.749725089725096761e-05 -5.022326464818290329e-04 2.901819272706800725e-05 2.894153016551862626e-05 3.050775714754186429e-04 3.044221722743031266e-05 3.029077546174225029e-05 1.018637427149941257e-03 3.176438780862413807e-05 3.154060037557926828e-05 1.646689716077626023e-03 3.298171413143581137e-05 3.268846531209158125e-05 2.197060371892891294e-03 3.409304208679374011e-05 3.373360847525880285e-05 2.677025579203547081e-03 3.509873827312724482e-05 3.467675280595348421e-05 3.092419122338037601e-03 3.599998781944954837e-05 3.551976638855804694e-05 3.437903613149849436e-03 3.679196163032407671e-05 3.626638769478422990e-05 3.719445505954883067e-03 3.747691174756482169e-05 3.692057954240356789e-05 3.946534158528983149e-03 3.806125600969238856e-05 3.748585619516907552e-05 4.127191695384666188e-03 3.855107878782736770e-05 3.796552338802255803e-05 4.268072799266158825e-03 3.895194575410748877e-05 3.836258121464354169e-05 4.374560461130654054e-03 3.926876320348634815e-05 3.867965678247208379e-05 4.450851666851720137e-03 3.950565686840221618e-05 3.891894199491624978e-05 4.500029130380998540e-03 3.966586888531105896e-05 3.908213398220562274e-05 4.524116650982753715e-03 3.975174198350990410e-05 3.917045484238004073e-05 1.088341324858335609e-11 5.511521401983781043e-01 -1.935905287392650625e-08 1.035793046496640453e-11 5.511521413284184989e-01 -1.846099803977157015e-08 9.993648932038448851e-12 5.511521421801973686e-01 -1.787917437380476180e-08 9.676603820526318837e-12 5.511521428783737742e-01 -1.743955328566450094e-08 9.302454307014297187e-12 5.511521435348017972e-01 -1.700638893371802923e-08 8.799019221792749104e-12 5.511521442203914933e-01 -1.650239080877548630e-08 8.131430329951738621e-12 5.511521449674700035e-01 -1.589777892560557618e-08 7.297954118762742310e-12 5.511521457841518368e-01 -1.519019493977046330e-08 6.323754384502730536e-12 5.511521466651272405e-01 -1.439091172493197600e-08 5.253113793143077216e-12 5.511521475984590968e-01 -1.351697987869787717e-08 4.141164009940978633e-12 5.511521485692729705e-01 -1.258736121554650374e-08 3.045444583515264415e-12 5.511521495625159028e-01 -1.162031818998013262e-08 2.019147245595322573e-12 5.511521505637427820e-01 -1.063285636565140997e-08 1.106039936810297335e-12 5.511521515593944542e-01 -9.640670808874800330e-09 3.371800158108160899e-13 5.511521525370602914e-01 -8.658085246599578341e-09 -2.702559888377770889e-13 5.511521534860630567e-01 -7.697631224189195080e-09 -7.124916669122593160e-13 5.511521543978853410e-01 -6.769710042264150455e-09 -9.970840299148868029e-13 5.511521552663607437e-01 -5.882430732158349621e-09 -1.140223850718881914e-12 5.511521560877929993e-01 -5.041546230333120713e-09 -1.163828067423053053e-12 5.511521568606505550e-01 -4.250877610406287966e-09 -1.094624500946232024e-12 5.511521575798357109e-01 -3.517675213289613502e-09 -9.626558136490209840e-13 5.511521582363668736e-01 -2.851495237652952993e-09 -7.979467003300715814e-13 5.511521588200639643e-01 -2.262232085835988469e-09 -6.202748985450020685e-13 5.511521593412266329e-01 -1.739445836443565601e-09 -4.481526197705951307e-13 5.511521598004405220e-01 -1.281912826659938121e-09 -2.994399706297396859e-13 5.511521601848468066e-01 -9.001033159843344919e-10 -1.827504109608611009e-13 5.511521604913950378e-01 -5.949253905783392183e-10 -9.619061452600818050e-14 5.511521607362673825e-01 -3.503658594011561482e-10 -3.798789559964448668e-14 5.511521609261843535e-01 -1.609638521024267571e-10 -1.802868655179560966e-14 5.511521609938472288e-01 -9.399976927329045862e-11 -6.021185332048495441e-15 5.511521610468211874e-01 -4.212942936247324000e-11 -6.773952395400081477e-17 5.511521610886723765e-01 -7.810403461679758233e-13 1.786135731043945635e-16 5.511521610936928051e-01 4.287953491736612014e-12 1.053480399748806808e-16 5.511521610684795291e-01 -2.080730230282507112e-11 2.195511289704798603e-15 5.511521610401762805e-01 -4.903003592259049864e-11 1.871798026228309928e-13 5.511521586054713984e-01 -2.510404707292487337e-09 4.468933356173399527e-14 5.511521606232736570e-01 -4.673757643174587908e-10 4.745147285114143815e-14 5.511521606438083420e-01 -4.458960731809470847e-10 5.110991266568574592e-14 5.511521606059329725e-01 -4.833145700428660997e-10 4.932477312783468611e-14 5.511521605658705747e-01 -5.230303714350802938e-10 4.115385830195983621e-14 5.511521605368875365e-01 -5.517548372500375722e-10 2.769778349888052705e-14 5.511521605232277965e-01 -5.652370668567506689e-10 1.047197576248177316e-14 5.511521605227022169e-01 -5.656542890733709660e-10 -8.912919485991267405e-15 5.511521605270444102e-01 -5.612453418984826179e-10 -2.963007633101755437e-14 5.511521605304908755e-01 -5.578110704055413942e-10 -5.186321954183102540e-14 5.511521605253699718e-01 -5.632377424557201273e-10 -7.807412345317684663e-14 5.511521604960765153e-01 -5.939563388023209683e-10 -1.175480858637728777e-13 5.511521604023338350e-01 -6.933052914696258058e-10 -2.223991567737833292e-13 5.511521600334856608e-01 -1.089156979793541695e-09 -1.777956501573905822e-12 5.511521540237077632e-01 -7.649744328661686029e-09 -5.175947729319826826e-13 5.511521592960891835e-01 -2.003278291078481150e-09 -1.195805966802069151e-13 5.511521607025665626e-01 -4.100923029093940162e-10 -8.595797939966918156e-14 5.511521608252384352e-01 -2.667551017300005915e-10 -7.815614815746904792e-14 5.511521608604825762e-01 -2.255933561621592902e-10 -7.525462697467076300e-14 5.511521608781553283e-01 -2.058749987500544849e-10 -7.355030697196152430e-14 5.511521608904113023e-01 -1.930885510479689269e-10 -7.214777529499949941e-14 5.511521609002536515e-01 -1.834040601764511689e-10 -7.081276310054880853e-14 5.511521609085257012e-01 -1.755909314146968016e-10 -6.955009957053171465e-14 5.511521609154964585e-01 -1.691678828792371058e-10 -6.836534423802788119e-14 5.511521609212527428e-01 -1.639313556065464013e-10 -6.731863226501941533e-14 5.511521609258256404e-01 -1.597942542698442923e-10 -6.652520662144538559e-14 5.511521609292214796e-01 -1.567254992451573900e-10 -6.595530678280489262e-14 5.511521609314357084e-01 -1.547239112177524518e-10 -6.572268748629599226e-14 5.511521609324436799e-01 -1.538141639764282053e-10 1.009322461267230794e-11 -1.935905287392650625e-08 5.511521431224728484e-01 9.683221129356519417e-12 -1.846099803977157015e-08 5.511521438196211875e-01 9.454346115648882495e-12 -1.787917437380476180e-08 5.511521441665488963e-01 9.270280616732053829e-12 -1.743955328566450094e-08 5.511521443760913908e-01 9.014445818752422608e-12 -1.700638893371802923e-08 5.511521446053003759e-01 8.609526638300366761e-12 -1.650239080877548630e-08 5.511521449393991245e-01 8.019597412387737695e-12 -1.589777892560557618e-08 5.511521454080664517e-01 7.243967833172845190e-12 -1.519019493977046330e-08 5.511521460099136904e-01 6.309748342566365028e-12 -1.439091172493197600e-08 5.511521467290562137e-01 5.263685604796067150e-12 -1.351697987869787717e-08 5.511521475441731877e-01 4.163689961964815336e-12 -1.258736121554650374e-08 5.511521484327229770e-01 3.070315431495665953e-12 -1.162031818998013262e-08 5.511521493735329624e-01 2.039813592097844277e-12 -1.063285636565140997e-08 5.511521503472082140e-01 1.118928627368127796e-12 -9.640670808874800330e-09 5.511521513360028157e-01 3.413776472876586276e-13 -8.658085246599578341e-09 5.511521523237065123e-01 -2.736103315129615667e-13 -7.697631224189195080e-09 5.511521532959147152e-01 -7.208176329290261899e-13 -6.769710042264150455e-09 5.511521542402941787e-01 -1.007267034743990017e-12 -5.882430732158349621e-09 5.511521551467326585e-01 -1.149343844742678557e-12 -5.041546230333120713e-09 5.511521560073582293e-01 -1.169954912025725299e-12 -4.250877610406287966e-09 5.511521568160185902e-01 -1.097206704047857644e-12 -3.517675213289613502e-09 5.511521575633115955e-01 -9.621911148893752156e-13 -2.851495237652952993e-09 5.511521582391483154e-01 -7.955017404546139085e-13 -2.262232085835988469e-09 5.511521588339496347e-01 -6.172442989758384835e-13 -1.739445836443565601e-09 5.511521593583331713e-01 -4.457388245226045086e-13 -1.281912826659938121e-09 5.511521598142367084e-01 -2.979802259086439050e-13 -9.001033159843344919e-10 5.511521601935628345e-01 -1.818270813544377875e-13 -5.949253905783392183e-10 5.511521604974431998e-01 -9.545309733381103967e-14 -3.503658594011561482e-10 5.511521607417055879e-01 -3.746686301465359010e-14 -1.609638521024267571e-10 5.511521609306069269e-01 -1.774605366033301668e-14 -9.399976927329045862e-11 5.511521609968889068e-01 -5.962617838101021922e-15 -4.212942936247324000e-11 5.511521610476752819e-01 -7.260313753621762820e-17 -7.810403461679758233e-13 5.511521610885349309e-01 1.772747175051361825e-16 4.287953491736612014e-12 5.511521610936571669e-01 1.053281095942295464e-16 -2.080730230282507112e-11 5.511521610686819228e-01 2.187963437447270497e-15 -4.903003592259049864e-11 5.511521610405406557e-01 1.891761123394317276e-13 -2.510404707292487337e-09 5.511521585522016764e-01 4.480989042528005235e-14 -4.673757643174587908e-10 5.511521606207477886e-01 4.748438453461561990e-14 -4.458960731809470847e-10 5.511521606431774023e-01 5.109310172243078020e-14 -4.833145700428660997e-10 5.511521606062169676e-01 4.927419814197126184e-14 -5.230303714350802938e-10 5.511521605668484591e-01 4.110120937712491406e-14 -5.517548372500375722e-10 5.511521605383810085e-01 2.765260724889126862e-14 -5.652370668567506689e-10 5.511521605250736533e-01 1.045172149637338543e-14 -5.656542890733709660e-10 5.511521605247624578e-01 -8.893839318952197376e-15 -5.612453418984826179e-10 5.511521605292351023e-01 -2.958404852093917544e-14 -5.578110704055413942e-10 5.511521605326560325e-01 -5.179356791988099638e-14 -5.632377424557201273e-10 5.511521605269306123e-01 -7.815111714379901316e-14 -5.939563388023209683e-10 5.511521604947894337e-01 -1.186364385468051186e-13 -6.933052914696258058e-10 5.511521603896868404e-01 -2.294701335818708221e-13 -1.089156979793541695e-09 5.511521599652886572e-01 -1.925257201702678001e-12 -7.649744328661686029e-09 5.511521528046121610e-01 -5.789577674909127793e-13 -2.003278291078481150e-09 5.511521588458140331e-01 -1.275198813521842989e-13 -4.100923029093940162e-10 5.511521606496843084e-01 -8.727625171228622249e-14 -2.667551017300005915e-10 5.511521608170021347e-01 -7.732424094863017835e-14 -2.255933561621592902e-10 5.511521608653052740e-01 -7.353298860301103949e-14 -2.058749987500544849e-10 5.511521608876958078e-01 -7.150540306503423945e-14 -1.930885510479689269e-10 5.511521609013851908e-01 -7.003239666372419342e-14 -1.834040601764511689e-10 5.511521609111510456e-01 -6.880238471832445385e-14 -1.755909314146968016e-10 5.511521609186648130e-01 -6.771152092349896423e-14 -1.691678828792371058e-10 5.511521609246479159e-01 -6.668068752101708988e-14 -1.639313556065464013e-10 5.511521609294366408e-01 -6.582130952189463715e-14 -1.597942542698442923e-10 5.511521609331867522e-01 -6.510033372219995462e-14 -1.567254992451573900e-10 5.511521609359592011e-01 -6.462086522133413309e-14 -1.547239112177524518e-10 5.511521609377667552e-01 -6.440022823816495054e-14 -1.538141639764282053e-10 5.511521609385865439e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 new file mode 100644 index 000000000..f1e2e8fb4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 @@ -0,0 +1 @@ +1.721848979898908324e-02 6.712673192145242210e-05 6.670490063903657921e-05 1.720394325798980592e-02 6.688354873430933732e-05 6.637433306260860568e-05 1.717463566457258853e-02 6.642989950338663526e-05 6.577451575740517870e-05 1.713013345720933861e-02 6.577054993593208128e-05 6.490808183159807996e-05 1.706977476683997977e-02 6.491117677040407594e-05 6.377949352350694681e-05 1.699265541848834354e-02 6.383725922198403937e-05 6.239853362546046419e-05 1.689760997148944538e-02 6.253455700286574112e-05 6.077595486512748498e-05 1.678318754749996006e-02 6.099385670837197181e-05 5.892224544630431571e-05 1.664762211764211214e-02 5.920486091168091771e-05 5.684839652493818460e-05 1.648879683610928945e-02 5.715647085630741453e-05 5.456559099380339176e-05 1.630420194437295564e-02 5.483741480938803442e-05 5.208514277413744969e-05 1.609088570668716286e-02 5.223662616808195025e-05 4.941784497942236742e-05 1.584539778671857982e-02 4.934375012407267122e-05 4.657347295771103649e-05 1.556372445931667597e-02 4.614997610317897182e-05 4.356063392828358110e-05 1.524121507776325310e-02 4.265007719005770389e-05 4.038763625018822786e-05 1.487249933242042882e-02 3.884484725604069890e-05 3.706341794803985905e-05 1.445139506078429482e-02 3.474270682159582110e-05 3.359790312623642418e-05 1.397080679707566643e-02 3.036295696386977189e-05 3.000406553609244849e-05 1.342261594703219978e-02 2.574125110720955608e-05 2.630179691181635661e-05 1.279756460787140858e-02 2.107281190986600645e-05 2.256006816873099615e-05 1.208513673815362482e-02 1.700339202353844453e-05 1.899385416759519801e-05 1.127344252902253915e-02 1.364408606711663973e-05 1.569715465409907265e-05 1.034911617538126875e-02 1.100554425022429361e-05 1.273639987746489405e-05 9.297241535879080185e-03 9.058541745550768655e-06 1.016265451795671968e-05 8.101327181530290980e-03 7.729031259749573362e-06 8.005805608871220485e-06 6.743361168859297004e-03 6.611123138469617913e-06 6.212737447212619492e-06 5.203987367576234403e-03 5.361067275275172407e-06 4.714317099982163709e-06 3.462858284672948490e-03 4.113517228760073905e-06 3.527307615044833324e-06 1.499234283636458618e-03 3.027279104974238468e-06 2.673317781016495023e-06 -6.978965788405388018e-04 2.278755305662842741e-06 2.177552123351406215e-06 -2.885157842819942916e-03 2.068376836761455733e-06 2.067826890371406851e-06 -4.889251559230993818e-03 2.423463170609756766e-06 2.344498366416368745e-06 -6.626767285110149452e-03 3.227461795482568245e-06 2.978654104401980150e-06 -8.011706557506275903e-03 4.351809093188863196e-06 3.929788465563879180e-06 -9.094468589958187854e-03 5.663792833205527921e-06 5.149443799131646227e-06 -1.000377162691906859e-02 7.033938483490738334e-06 6.585301834311243906e-06 -1.068484045842477657e-02 8.451557753610023876e-06 8.191676072117993682e-06 -1.094339525672049888e-02 9.979659884930934199e-06 9.927826189211330564e-06 -1.073241592166865321e-02 1.160475363217409299e-05 1.174986675518871189e-05 -1.026647789924258793e-02 1.331208586771803880e-05 1.361714001601530412e-05 -9.664985712106215210e-03 1.508653712638620604e-05 1.549352284344274744e-05 -8.916434181702391840e-03 1.691271414312630789e-05 1.734757125621577112e-05 -7.879367776299689430e-03 1.877255294823545700e-05 1.915609072822169954e-05 -6.559379479483174250e-03 2.062211030530560683e-05 2.093283445350816225e-05 -5.059619361099084237e-03 2.243522932190006981e-05 2.266975797169881266e-05 -3.692669196794029843e-03 2.419485341208146359e-05 2.435138883073945451e-05 -2.489083847778326714e-03 2.588628405246685320e-05 2.596430964525496698e-05 -1.436580766360725766e-03 2.749721929251997237e-05 2.749725089790402323e-05 -5.203491619558763643e-04 2.901819272792479802e-05 2.894153016638994873e-05 2.884946631964138892e-04 3.044221723214604662e-05 3.029077546684820556e-05 1.003441074108645317e-03 3.176438780966741839e-05 3.154060037670050951e-05 1.632735884426976493e-03 3.298171413167686340e-05 3.268846531235378199e-05 2.184210819109089381e-03 3.409304208696291630e-05 3.373360847540353706e-05 2.665149539484041978e-03 3.509873827327807089e-05 3.467675280610697336e-05 3.081540676969766503e-03 3.599998781957608154e-05 3.551976638867036351e-05 3.428216464870691843e-03 3.679196163045103679e-05 3.626638769494707707e-05 3.710759319052764783e-03 3.747691174766574058e-05 3.692057954249998734e-05 3.938678989113938468e-03 3.806125600977794567e-05 3.748585619526289289e-05 4.120015603592758549e-03 3.855107878792191013e-05 3.796552338815682292e-05 4.261439281623429116e-03 3.895194575416167178e-05 3.836258121470660838e-05 4.368345817073831377e-03 3.926876320352017525e-05 3.867965678255032931e-05 4.444942366241291971e-03 3.950565686848904045e-05 3.891894199496126450e-05 4.494319215016703319e-03 3.966586888536990403e-05 3.908213398224745939e-05 4.518505179236713930e-03 3.975174198359515627e-05 3.917045484244480825e-05 1.076160331081297282e-11 5.511521401982297785e-01 -1.935920754983413109e-08 1.024335766696377915e-11 5.511521413282677306e-01 -1.846115545618043853e-08 9.886361888389231852e-12 5.511521421800421594e-01 -1.787933675829096177e-08 9.577866953575361089e-12 5.511521428782132359e-01 -1.743972182418731696e-08 9.214108884359242438e-12 5.511521435346363740e-01 -1.700656328528707686e-08 8.722697566076826901e-12 5.511521442202235166e-01 -1.650256874000178815e-08 8.067962218711861798e-12 5.511521449673035811e-01 -1.589795618021919037e-08 7.247392116882516670e-12 5.511521457839928528e-01 -1.519036545152963618e-08 6.285369266116374148e-12 5.511521466649824674e-01 -1.439106823582639822e-08 5.225593116334719181e-12 5.511521475983355289e-01 -1.351711494934247475e-08 4.122899321020794496e-12 5.511521485691761590e-01 -1.258746853003858842e-08 3.034645796889589455e-12 5.511521495624490674e-01 -1.162039398537898282e-08 2.014110456926635608e-12 5.511521505637050344e-01 -1.063290077029466187e-08 1.105127161292660360e-12 5.511521515593803544e-01 -9.640688862771153505e-09 3.390138616994237602e-13 5.511521525370591812e-01 -8.658087399128429804e-09 -2.668379340887849775e-13 5.511521534860593929e-01 -7.697633155351319440e-09 -7.083637646337871855e-13 5.511521543978598059e-01 -6.769731724642895047e-09 -9.929106341375817155e-13 5.511521552662916879e-01 -5.882494732011854002e-09 -1.136443451373678330e-12 5.511521560876588843e-01 -5.041675326299733247e-09 -1.160724925732773719e-12 5.511521568604330623e-01 -4.251091877347558666e-09 -1.092265289862060340e-12 5.511521575795222949e-01 -3.517988846866913030e-09 -9.610426640091773301e-13 5.511521582359534266e-01 -2.851913781636485246e-09 -7.969771278980833765e-13 5.511521588195564814e-01 -2.262750417850144847e-09 -6.198094894248647026e-13 5.511521593406415453e-01 -1.740047295528750856e-09 -4.480590123706866859e-13 5.511521597998035871e-01 -1.282569822154058833e-09 -2.995403048469023369e-13 5.511521601841912199e-01 -9.007796117082587477e-10 -1.829775899798097411e-13 5.511521604907579919e-01 -5.955796855928333841e-10 -9.641915918768402035e-14 5.511521607356870689e-01 -3.509563451729904002e-10 -3.814910149840411656e-14 5.511521609256957444e-01 -1.614537600552021515e-10 -1.813146450624088902e-14 5.511521609934911803e-01 -9.435009148415887771e-11 -6.076087135461726023e-15 5.511521610466306731e-01 -4.231379029329368585e-11 -8.014651225594666778e-17 5.511521610885999900e-01 -8.504739017603125801e-13 1.832057766473458796e-16 5.511521610936802595e-01 4.275741872033373669e-12 9.241898436535996335e-17 5.511521610684794181e-01 -2.080740248417023836e-11 2.175836155853935001e-15 5.511521610401671767e-01 -4.903858001366859785e-11 1.865267362896636870e-13 5.511521586054509703e-01 -2.510424560806524411e-09 4.465748951559972117e-14 5.511521606232535619e-01 -4.673953928708112738e-10 4.752121329988923914e-14 5.511521606438073428e-01 -4.458970252877322569e-10 5.130790072460544927e-14 5.511521606059531786e-01 -4.832945226674204535e-10 4.962815973193545509e-14 5.511521605658920020e-01 -5.230085500946055661e-10 4.156025331904009532e-14 5.511521605369041898e-01 -5.517375842270966991e-10 2.816874101851453160e-14 5.511521605232376775e-01 -5.652269427131423154e-10 1.099678782709027527e-14 5.511521605227044374e-01 -5.656521972674172052e-10 -8.370401438355922594e-15 5.511521605270457425e-01 -5.612438257937127783e-10 -2.908813566502907994e-14 5.511521605305090832e-01 -5.577921320854747021e-10 -5.132388892635017531e-14 5.511521605254213751e-01 -5.631856510063933816e-10 -7.748054312950397374e-14 5.511521604961725496e-01 -5.938603331522170622e-10 -1.169428683164460800e-13 5.511521604024793852e-01 -6.931608341022993559e-10 -2.215423675673416366e-13 5.511521600336811710e-01 -1.088963637402754427e-09 -1.773240766164337878e-12 5.511521540239510131e-01 -7.649503428334469231e-09 -5.165514895289272318e-13 5.511521592963718463e-01 -2.002996828967367114e-09 -1.193395428572722796e-13 5.511521607028785352e-01 -4.097789542276175732e-10 -8.578880214724309130e-14 5.511521608255696147e-01 -2.664188438219313053e-10 -7.800532041952349678e-14 5.511521608608241918e-01 -2.252424303386193952e-10 -7.512809153967779500e-14 5.511521608784962778e-01 -2.055209028586943541e-10 -7.342334361324233210e-14 5.511521608907368197e-01 -1.927475289918059183e-10 -7.204685435696240395e-14 5.511521609005630706e-01 -1.830781122972167976e-10 -7.072720421799431840e-14 5.511521609088194662e-01 -1.752805912109371565e-10 -6.945555637856555737e-14 5.511521609157759016e-01 -1.688726088005699155e-10 -6.831116439283678313e-14 5.511521609215194184e-01 -1.636497711229837420e-10 -6.728480497182270038e-14 5.511521609260817689e-01 -1.595243318568651598e-10 -6.643838018052842657e-14 5.511521609294693924e-01 -1.564647207341681910e-10 -6.589646102072371846e-14 5.511521609316779591e-01 -1.544694115175494480e-10 -6.563743307314941825e-14 5.511521609326830440e-01 -1.535628580221406970e-10 9.979974358308881044e-12 -1.935920754983413109e-08 5.511521431223115330e-01 9.575850048904410047e-12 -1.846115545618043853e-08 5.511521438194568745e-01 9.352681922909241214e-12 -1.787933675829096177e-08 5.511521441663790322e-01 9.175578186415409232e-12 -1.743972182418731696e-08 5.511521443759145322e-01 8.928803596067684483e-12 -1.700656328528707686e-08 5.511521446051166340e-01 8.534807531620721963e-12 -1.650256874000178815e-08 5.511521449392107197e-01 7.956994563007477541e-12 -1.589795618021919037e-08 5.511521454078777138e-01 7.193760633254925050e-12 -1.519036545152963618e-08 5.511521460097308367e-01 6.271451281769358386e-12 -1.439106823582639822e-08 5.511521467288870157e-01 5.236123665431987525e-12 -1.351711494934247475e-08 5.511521475440255280e-01 4.145354426962566815e-12 -1.258746853003858842e-08 5.511521484326039610e-01 3.059447467353914821e-12 -1.162039398537898282e-08 5.511521493734470312e-01 2.034727799189598569e-12 -1.063290077029466187e-08 5.511521503471559225e-01 1.118020942006254049e-12 -9.640688862771153505e-09 5.511521513359797231e-01 3.432304498122728139e-13 -8.658087399128429804e-09 5.511521523237022935e-01 -2.701449267863008885e-13 -7.697633155351319440e-09 5.511521532959137160e-01 -7.166779234800977765e-13 -6.769731724642895047e-09 5.511521542402757490e-01 -1.003055727068151991e-12 -5.882494732011854002e-09 5.511521551466733726e-01 -1.145556604125919213e-12 -5.041675326299733247e-09 5.511521560072338843e-01 -1.166823962040927822e-12 -4.251091877347558666e-09 5.511521568158075368e-01 -1.094838053130782181e-12 -3.517988846866913030e-09 5.511521575629977354e-01 -9.605652812171936027e-13 -2.851913781636485246e-09 5.511521582387245433e-01 -7.945395019560117188e-13 -2.262750417850144847e-09 5.511521588334201693e-01 -6.167893634642589155e-13 -1.740047295528750856e-09 5.511521593577148881e-01 -4.456639995308125221e-13 -1.282569822154058833e-09 5.511521598135590283e-01 -2.981339987357135538e-13 -9.007796117082587477e-10 5.511521601928651704e-01 -1.820631674935685340e-13 -5.955796855928333841e-10 5.511521604967711818e-01 -9.568114085496997239e-14 -3.509563451729904002e-10 5.511521607411048462e-01 -3.764050298569133366e-14 -1.614537600552021515e-10 5.511521609301157643e-01 -1.784141363399237680e-14 -9.435009148415887771e-11 5.511521609965441826e-01 -6.012451004062239158e-15 -4.231379029329368585e-11 5.511521610474968691e-01 -8.284071942215237311e-17 -8.504739017603125801e-13 5.511521610884683176e-01 1.795725788959422072e-16 4.275741872033373669e-12 5.511521610936452875e-01 9.202898704220150794e-17 -2.080740248417023836e-11 5.511521610686818118e-01 2.165908406427662733e-15 -4.903858001366859785e-11 5.511521610405325511e-01 1.885163751640431240e-13 -2.510424560806524411e-09 5.511521585521824695e-01 4.477739762132338465e-14 -4.673953928708112738e-10 5.511521606207285817e-01 4.755561977978461996e-14 -4.458970252877322569e-10 5.511521606431765141e-01 5.129451306425290690e-14 -4.832945226674204535e-10 5.511521606062368406e-01 4.958989969546378069e-14 -5.230085500946055661e-10 5.511521605668706636e-01 4.151164759868559800e-14 -5.517375842270966991e-10 5.511521605383988831e-01 2.811857841993497710e-14 -5.652269427131423154e-10 5.511521605250840894e-01 1.098011812974512552e-14 -5.656521972674172052e-10 5.511521605247644562e-01 -8.358122055292600978e-15 -5.612438257937127783e-10 5.511521605292368786e-01 -2.902497705416381995e-14 -5.577921320854747021e-10 5.511521605326757944e-01 -5.123316103162277549e-14 -5.631856510063933816e-10 5.511521605269834589e-01 -7.757951276931117315e-14 -5.938603331522170622e-10 5.511521604948854680e-01 -1.179833842175861541e-13 -6.931608341022993559e-10 5.511521603898301702e-01 -2.285988126655494423e-13 -1.088963637402754427e-09 5.511521599654798376e-01 -1.920151245741639842e-12 -7.649503428334469231e-09 5.511521528048507479e-01 -5.778365268711398009e-13 -2.002996828967367114e-09 5.511521588460943644e-01 -1.272576827011360695e-13 -4.097789542276175732e-10 5.511521606499990567e-01 -8.713151568895694943e-14 -2.664188438219313053e-10 5.511521608173435283e-01 -7.717075124140390549e-14 -2.252424303386193952e-10 5.511521608656657634e-01 -7.342067401560538173e-14 -2.055209028586943541e-10 5.511521608880636247e-01 -7.134255801192855719e-14 -1.927475289918059183e-10 5.511521609017424606e-01 -6.993597472231197646e-14 -1.830781122972167976e-10 5.511521609114944376e-01 -6.870856435022445261e-14 -1.752805912109371565e-10 5.511521609189926618e-01 -6.757725777305666002e-14 -1.688726088005699155e-10 5.511521609249599996e-01 -6.661761966723348889e-14 -1.636497711229837420e-10 5.511521609297339586e-01 -6.574306605473312235e-14 -1.595243318568651598e-10 5.511521609334713023e-01 -6.505532073328666360e-14 -1.564647207341681910e-10 5.511521609362335372e-01 -6.457903059327643634e-14 -1.544694115175494480e-10 5.511521609380340969e-01 -6.433546120777005603e-14 -1.535628580221406970e-10 5.511521609388503329e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 new file mode 100644 index 000000000..08597e9b6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 @@ -0,0 +1 @@ +1.373666353899025139e-02 6.712672110484758101e-05 6.670489060346782191e-05 1.368394648580933959e-02 6.688353843747161403e-05 6.637432343271893300e-05 1.359223806777873703e-02 6.642988956635944133e-05 6.577450635355794383e-05 1.345980776411387358e-02 6.577054031147152387e-05 6.490807260900474207e-05 1.328422787279215367e-02 6.491116751507355160e-05 6.377948455314863649e-05 1.306229499067726452e-02 6.383725046495643848e-05 6.239852505608108654e-05 1.279002751236541120e-02 6.253454890937625303e-05 6.077594688245213254e-05 1.246257476598266849e-02 6.099384944673471676e-05 5.892223823822632949e-05 1.207415028256279312e-02 5.920485462654695793e-05 5.684839025372279896e-05 1.161799734826937831e-02 5.715646564940912039e-05 5.456558577643947700e-05 1.108643153581756122e-02 5.483741072833111054e-05 5.208513867074594751e-05 1.047071701375901047e-02 5.223662320358509072e-05 4.941784199028751497e-05 9.760959052645505618e-03 4.934374821362577966e-05 4.657347102683018659e-05 8.946060023365683123e-03 4.614997513987880600e-05 4.356063295224803098e-05 8.013936377738787448e-03 4.265007703435304466e-05 4.038763609032331548e-05 6.951683314977465285e-03 3.884484774881909728e-05 3.706341844396674666e-05 5.745423071307617299e-03 3.474270779669198458e-05 3.359790410913207382e-05 4.380498713936191446e-03 3.036295825871228744e-05 3.000406684005730898e-05 2.842069558432291313e-03 2.574125257088958368e-05 2.630179838294890196e-05 1.130075712032030041e-03 2.107281340921842005e-05 2.256006967185252341e-05 -7.069546820787581468e-04 1.700339345056386335e-05 1.899385559436134681e-05 -2.582916870958867732e-03 1.364408734344337927e-05 1.569715592696906226e-05 -4.373265356896885621e-03 1.100554533068940586e-05 1.273640095279585839e-05 -5.982468237851274601e-03 9.058542609547959640e-06 1.016265537687171976e-05 -7.349556653879032661e-03 7.729031909425319437e-06 8.005806254860519931e-06 -8.463062109429203908e-03 6.611123594701542270e-06 6.212737901392024623e-06 -9.379521147293706784e-03 5.361067564923804499e-06 4.714317388465322511e-06 -1.014542168803155009e-02 4.113517379233267076e-06 3.527307764702826316e-06 -1.069746468301832794e-02 3.027279150300321223e-06 2.673317825836078333e-06 -1.091705030120196721e-02 2.278755335873338796e-06 2.177552153175058935e-06 -1.076740337087958403e-02 2.068376852279830740e-06 2.067826905848401333e-06 -1.037836526764213119e-02 2.423463170988178476e-06 2.344498366843735830e-06 -9.874536176308292348e-03 3.227461798619695797e-06 2.978654107534810279e-06 -9.265689753556641262e-03 4.351809108736943224e-06 3.929788481089250255e-06 -8.473513040999100174e-03 5.663792843149224618e-06 5.149443809069330684e-06 -7.434790020242647984e-03 7.033926820126510293e-06 6.585290047746054206e-06 -6.178245562723674693e-03 8.451558351262473392e-06 8.191676671310220347e-06 -4.834317953134586315e-03 9.979660294653440705e-06 9.927826599183445821e-06 -3.620334931530992326e-03 1.160475401157629452e-05 1.174986713444931322e-05 -2.536865585574852189e-03 1.331208624059649420e-05 1.361714038852159866e-05 -1.574961204974291169e-03 1.508653749724492663e-05 1.549352321379509988e-05 -7.232843064911278694e-04 1.691271451112326838e-05 1.734757162366156727e-05 3.769714167986938994e-05 1.877255331170490780e-05 1.915609109114363502e-05 7.217488371353774322e-04 2.062211066494640095e-05 2.093283481265485833e-05 1.335814717783206842e-03 2.243522967855876923e-05 2.266975832790951297e-05 1.886051498971851384e-03 2.419485376707842329e-05 2.435138918535251855e-05 2.378136227812383853e-03 2.588628440990171264e-05 2.596431000257021858e-05 2.814136958843644308e-03 2.749721966610732998e-05 2.749725127236482428e-05 3.194254457828248506e-03 2.901819318339109014e-05 2.894153062877239361e-05 3.521320724698498352e-03 3.044221921745975787e-05 3.029077759893745626e-05 3.799658057993270804e-03 3.176438851759078269e-05 3.154060114576359963e-05 4.034484710513389950e-03 3.298171442307764413e-05 3.268846561150825489e-05 4.231746949067644557e-03 3.409304232708670765e-05 3.373360871668375200e-05 4.396840724513009432e-03 3.509873848959413101e-05 3.467675302138220617e-05 4.534420396913874107e-03 3.599998801874237399e-05 3.551976658590642373e-05 4.648471032902409469e-03 3.679196181537284393e-05 3.626638787755203226e-05 4.742392464969664989e-03 3.747691192036450316e-05 3.692057971284146400e-05 4.819028020566027554e-03 3.806125617194220013e-05 3.748585635515411750e-05 4.880731340252048890e-03 3.855107894114844234e-05 3.796552353924463082e-05 4.929486282236384721e-03 3.895194590003633070e-05 3.836258135862285936e-05 4.966929886029654295e-03 3.926876334353095383e-05 3.867965692075142538e-05 4.994365711391581669e-03 3.950565700410794642e-05 3.891894212892685025e-05 5.012775140247658669e-03 3.966586901813296727e-05 3.908213411342120421e-05 5.022836781642363822e-03 3.975174211498182485e-05 3.917045497225663252e-05 -5.500151666607322615e-14 5.511521608200300459e-01 -2.721293890774881578e-10 -5.348006779802408340e-14 5.511521608180414145e-01 -2.740551069510826915e-10 -5.066530703361410100e-14 5.511521608135669936e-01 -2.784149894095654804e-10 -4.659358816162153614e-14 5.511521608059500865e-01 -2.858787182328801345e-10 -4.122165471564999884e-14 5.511521607942766465e-01 -2.973772018629570962e-10 -3.433004346793797812e-14 5.511521607777398746e-01 -3.137309903922743545e-10 -2.552725348939239426e-14 5.511521607555464053e-01 -3.357451582591673832e-10 -1.424513091666318329e-14 5.511521607269938006e-01 -3.641340147529088578e-10 2.353062798100045774e-16 5.511521606916776062e-01 -3.993083346942835748e-10 1.869482508031005646e-14 5.511521606496225800e-01 -4.412426687232586892e-10 4.184239763153509858e-14 5.511521606013959351e-01 -4.893571352760252181e-10 7.014893768772302237e-14 5.511521605482093689e-01 -5.424126373321092238e-10 1.036635599356932453e-13 5.511521604920073258e-01 -5.984206284818538134e-10 1.418269896753338933e-13 5.511521604355433812e-01 -6.545672654513466155e-10 1.833091973820591854e-13 5.511521603824263149e-01 -7.071773683844376829e-10 2.259404662516650808e-13 5.511521603369646805e-01 -7.518949333103244052e-10 2.667323992704014940e-13 5.511521603039496453e-01 -7.839211436516620499e-10 3.019318798397147950e-13 5.511521602885319782e-01 -7.981383513098198078e-10 3.272365800679047548e-13 5.511521602958087129e-01 -7.895458931594356033e-10 3.386274852114067297e-13 5.511521603292194316e-01 -7.549338507939796348e-10 3.347601316519203190e-13 5.511521603862943319e-01 -6.971445151341872921e-10 3.152840755892441846e-13 5.511521604639127991e-01 -6.195659767864116359e-10 2.834879866022836975e-13 5.511521605534522861e-01 -5.308397009343291499e-10 2.441877028600625714e-13 5.511521606456978306e-01 -4.399450032978731226e-10 2.016167340147264029e-13 5.511521607342824147e-01 -3.528324076481157182e-10 1.566916184207069280e-13 5.511521608196109367e-01 -2.686663047119931276e-10 1.066710429943890246e-13 5.511521609083988027e-01 -1.805651814247127901e-10 5.405403580532119478e-14 5.511521609982864556e-01 -9.097341662724403193e-11 7.176981450280465153e-15 5.511521610772802671e-01 -1.211330055273011083e-11 1.207903210550608956e-14 5.511521610686717088e-01 -2.055233602790656704e-11 9.442287482361628969e-15 5.511521610728468135e-01 -1.658212512452871441e-11 2.982748415054754926e-16 5.511521610888833189e-01 -5.915824897589244437e-13 3.320333566738193677e-15 5.511521610827019302e-01 -6.671982459926880038e-12 1.564049721894080804e-14 5.511521610510032865e-01 -3.832982216504565357e-11 1.211953212181724715e-14 5.511521610156918660e-01 -7.360120158741778677e-11 -1.147683749203147388e-11 5.511521585723373473e-01 -2.543626899182389948e-09 6.423099425015562382e-13 5.511521605809929225e-01 -5.097089898408922634e-10 4.572437205544222133e-13 5.511521605958459302e-01 -4.938495912766638772e-10 4.307101035995892708e-13 5.511521605604778884e-01 -5.287205802605676925e-10 4.225066132994871241e-13 5.511521605284419589e-01 -5.604019362639261702e-10 4.124189744417864610e-13 5.511521605097645660e-01 -5.788444310044230059e-10 3.961656971220289345e-13 5.511521605061950879e-01 -5.823081791039646531e-10 3.744662366879928483e-13 5.511521605154265924e-01 -5.730968925577971546e-10 3.512703919359510142e-13 5.511521605308553617e-01 -5.577664268039431139e-10 3.275705638664282652e-13 5.511521605504041688e-01 -5.383503103243996008e-10 3.036730687881404902e-13 5.511521605732410123e-01 -5.156486219617856164e-10 2.799543171367619325e-13 5.511521605985126859e-01 -4.904923357668559732e-10 2.566444874072496177e-13 5.511521606256511996e-01 -4.634354868331003271e-10 2.339239245214432200e-13 5.511521606542117979e-01 -4.349163803577898265e-10 2.120729438318500437e-13 5.511521606835604326e-01 -4.055710087004050396e-10 1.913718788539526070e-13 5.511521607130183131e-01 -3.760857056013756979e-10 1.720612396061971069e-13 5.511521607419342939e-01 -3.471229052537857352e-10 1.543349989249154866e-13 5.511521607697077441e-01 -3.192954114581481920e-10 1.383107570782003264e-13 5.511521607958591584e-01 -2.930913849605035580e-10 1.240381922835246539e-13 5.511521608200294908e-01 -2.688739609217408333e-10 1.114984594081811040e-13 5.511521608419984730e-01 -2.468640471898817180e-10 1.006519062243630884e-13 5.511521608615960188e-01 -2.272313467653959222e-10 9.143704804166433972e-14 5.511521608787144366e-01 -2.100834784592905531e-10 8.377097035010259891e-14 5.511521608933133143e-01 -1.954604418057861859e-10 7.756349641639279596e-14 5.511521609053976478e-01 -1.833568180041312880e-10 7.272597403870567053e-14 5.511521609150008549e-01 -1.737388059527024926e-10 6.918052822548665811e-14 5.511521609221682327e-01 -1.665604312862687418e-10 6.686659939507631838e-14 5.511521609269419697e-01 -1.617790471370006597e-10 6.574921671919818885e-14 5.511521609293466017e-01 -1.593704039053126242e-10 -5.559441376694554179e-14 -2.721293890774881578e-10 5.511521608142031514e-01 -5.403961163184744738e-14 -2.740551069510826915e-10 5.511521608123450822e-01 -5.116532609723179577e-14 -2.784149894095654804e-10 5.511521608081080270e-01 -4.701514719910567241e-14 -2.858787182328801345e-10 5.511521608008097539e-01 -4.155471455354303494e-14 -2.973772018629570962e-10 5.511521607895019104e-01 -3.457185137704838782e-14 -3.137309903922743545e-10 5.511521607733500527e-01 -2.568080062017903533e-14 -3.357451582591673832e-10 5.511521607515370569e-01 -1.431735646671000850e-14 -3.641340147529088578e-10 5.511521607233373921e-01 2.358920095388196936e-16 -3.993083346942835748e-10 5.511521606883326152e-01 1.875975489497793822e-14 -4.412426687232586892e-10 5.511521606465482614e-01 4.196292240834368345e-14 -4.893571352760252181e-10 5.511521605985760797e-01 7.031261619045410911e-14 -5.424126373321092238e-10 5.511521605456805029e-01 1.038469558100675876e-13 -5.984206284818538134e-10 5.511521604898922400e-01 1.419854023627388088e-13 -6.545672654513466155e-10 5.511521604340825498e-01 1.833655319689581359e-13 -7.071773683844376829e-10 5.511521603819914406e-01 2.257819620107583824e-13 -7.518949333103244052e-10 5.511521603380206136e-01 2.662177250525314720e-13 -7.839211436516620499e-10 5.511521603069772235e-01 3.009091305849363170e-13 -7.981383513098198078e-10 5.511521602939485343e-01 3.255759413433372364e-13 -7.895458931594356033e-10 5.511521603038430639e-01 3.362975645428688821e-13 -7.549338507939796348e-10 5.511521603396444258e-01 3.319280990992823990e-13 -6.971445151341872921e-10 5.511521603981403006e-01 3.123047088639854824e-13 -6.195659767864116359e-10 5.511521604756778325e-01 2.807914599617506442e-13 -5.308397009343291499e-10 5.511521605635996135e-01 2.421256363038120212e-13 -4.399450032978731226e-10 5.511521606531596396e-01 2.003253003081719621e-13 -3.528324076481157182e-10 5.511521607388172317e-01 1.560454062702925320e-13 -2.686663047119931276e-10 5.511521608218313828e-01 1.064199904252616401e-13 -1.805651814247127901e-10 5.511521609092495666e-01 5.397685199429912262e-14 -9.097341662724403193e-11 5.511521609985462478e-01 7.179080032146043130e-15 -1.211330055273011083e-11 5.511521610772730506e-01 1.198223967803136338e-14 -2.055233602790656704e-11 5.511521610690025552e-01 9.464541944384051297e-15 -1.658212512452871441e-11 5.511521610727687648e-01 3.445262022608288049e-16 -5.915824897589244437e-13 5.511521610887132328e-01 3.312403306004423992e-15 -6.671982459926880038e-12 5.511521610827339046e-01 1.561740059294594426e-14 -3.832982216504565357e-11 5.511521610511167513e-01 1.210359369716532935e-14 -7.360120158741778677e-11 5.511521610158844897e-01 -1.159804881498518657e-11 -2.543626899182389948e-09 5.511521585188918770e-01 6.439696252014684787e-13 -5.097089898408922634e-10 5.511521605783619160e-01 4.575277351346104730e-13 -4.938495912766638772e-10 5.511521605952323100e-01 4.305551136240120741e-13 -5.287205802605676925e-10 5.511521605608585839e-01 4.220961973563882331e-13 -5.604019362639261702e-10 5.511521605295310877e-01 4.118640016673558072e-13 -5.788444310044230059e-10 5.511521605113225419e-01 3.955643723037132945e-13 -5.823081791039646531e-10 5.511521605079638952e-01 3.739020507864603691e-13 -5.730968925577971546e-10 5.511521605171546545e-01 3.507885708846885525e-13 -5.577664268039431139e-10 5.511521605323864703e-01 3.271857220439758199e-13 -5.383503103243996008e-10 5.511521605516701561e-01 3.033799037232419297e-13 -5.156486219617856164e-10 5.511521605742371044e-01 2.797357376678109757e-13 -4.904923357668559732e-10 5.511521605992787398e-01 2.564774142338341316e-13 -4.634354868331003271e-10 5.511521606262550499e-01 2.337836340106162543e-13 -4.349163803577898265e-10 5.511521606547337138e-01 2.119380017138451847e-13 -4.055710087004050396e-10 5.511521606840766863e-01 1.912265673622067871e-13 -3.760857056013756979e-10 5.511521607135897449e-01 1.718967779948091353e-13 -3.471229052537857352e-10 5.511521607425986513e-01 1.541486945220396470e-13 -3.192954114581481920e-10 5.511521607704789050e-01 1.381044919208799637e-13 -2.930913849605035580e-10 5.511521607967336811e-01 1.238153898930213039e-13 -2.688739609217408333e-10 5.511521608209959400e-01 1.112623829660866590e-13 -2.468640471898817180e-10 5.511521608430444141e-01 1.004054950600626403e-13 -2.272313467653959222e-10 5.511521608627099056e-01 9.118264783555289356e-14 -2.100834784592905531e-10 5.511521608798851668e-01 8.351054423347795557e-14 -1.954604418057861859e-10 5.511521608945303408e-01 7.729862400970102432e-14 -1.833568180041312880e-10 5.511521609066516447e-01 7.245804411925328948e-14 -1.737388059527024926e-10 5.511521609162833846e-01 6.891027064921020522e-14 -1.665604312862687418e-10 5.511521609234717456e-01 6.659472016418478000e-14 -1.617790471370006597e-10 5.511521609282603595e-01 6.547635634574151772e-14 -1.593704039053126242e-10 5.511521609306725411e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 new file mode 100644 index 000000000..d1dc41291 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 @@ -0,0 +1 @@ +1.613862623239226829e-02 6.712671536666208730e-05 6.670488480277831690e-05 1.610630298739268440e-02 6.688353277026988009e-05 6.637431770076788638e-05 1.604644765796956959e-02 6.642988394754509470e-05 6.577450066498785901e-05 1.595779803767565647e-02 6.577053473353205993e-05 6.490806695416472894e-05 1.583852888403956827e-02 6.491116198814088031e-05 6.377947894083339070e-05 1.568619731384032767e-02 6.383724501858027321e-05 6.239851951564146524e-05 1.549770775869297075e-02 6.253454359151927198e-05 6.077594146298127766e-05 1.526923453045686378e-02 6.099384432013480720e-05 5.892223300493227965e-05 1.499614271698999045e-02 5.920484976236346618e-05 5.684838528141223111e-05 1.467290906279661647e-02 5.715646111865156279e-05 5.456558114056068542e-05 1.429305789922521476e-02 5.483740659242448685e-05 5.208513443737276046e-05 1.384902113779804163e-02 5.223661950663651391e-05 4.941783820771886241e-05 1.333198865219996712e-02 4.934374497772054286e-05 4.657346772027137700e-05 1.273176528115462815e-02 4.614997236404654827e-05 4.356063012234045805e-05 1.203670655396666365e-02 4.265007469692129639e-05 4.038763371532383997e-05 1.123362070542338435e-02 3.884484581248912857e-05 3.706341648493667444e-05 1.030756140871208135e-02 3.474270621510654959e-05 3.359790251690229426e-05 9.241779745629133402e-03 3.036295698291355605e-05 3.000406556227323739e-05 8.017865114881781927e-03 2.574125155445745682e-05 2.630179736981263450e-05 6.616057361986601992e-03 2.107281261104875371e-05 2.256006887933586347e-05 5.015523975752678339e-03 1.700339283265672662e-05 1.899385498227922179e-05 3.194837571647474866e-03 1.364408687241775090e-05 1.569715546074883306e-05 1.141383595442276369e-03 1.100554497642035239e-05 1.273640060198104933e-05 -1.063147092116985444e-03 9.058542347039633678e-06 1.016265511658264892e-05 -3.253180118076162176e-03 7.729031719743326045e-06 8.005806066391116883e-06 -5.246729420048055689e-03 6.611123464786350337e-06 6.212737771981303490e-06 -6.936584838637372200e-03 5.361067486955800674e-06 4.714317310622938755e-06 -8.288485029379507457e-03 4.113517345324820415e-06 3.527307730795928454e-06 -9.361761692409218197e-03 3.027279149217579335e-06 2.673317824727022520e-06 -1.021293069518640524e-02 2.278755331203564419e-06 2.177552148551422443e-06 -1.074832104021551313e-02 2.068376847166118348e-06 2.067826900722069421e-06 -1.084167526569917300e-02 2.423463168626011533e-06 2.344498364466290530e-06 -1.053542048864889585e-02 3.227461793737481321e-06 2.978654102662746224e-06 -1.000213501274142304e-02 4.351809099802938599e-06 3.929788472163594834e-06 -9.316875684266839874e-03 5.663792847084670982e-06 5.149443812990251279e-06 -8.403399089677634007e-03 7.033939020502195026e-06 6.585302377030206803e-06 -7.178122981306562372e-03 8.451557853479113179e-06 8.191676172254838570e-06 -5.692072248018396029e-03 9.979659983785355958e-06 9.927826288132720443e-06 -4.189432821941412380e-03 1.160475374899904040e-05 1.174986687198164653e-05 -2.848367511612658141e-03 1.331208601218785123e-05 1.361714016035381289e-05 -1.668963155192154137e-03 1.508653730676472666e-05 1.549352302358279610e-05 -6.364912390719550377e-04 1.691271436655417522e-05 1.734757147929186905e-05 2.775542955583215838e-04 1.877255322191849721e-05 1.915609100139927453e-05 1.092670213636845640e-03 2.062211063987489656e-05 2.093283478739837549e-05 1.817739679660578542e-03 2.243522973341313450e-05 2.266975838233976546e-05 2.461207006149570414e-03 2.419485392985024771e-05 2.435138934769001497e-05 3.030536864836771115e-03 2.588628474367506922e-05 2.596431033717939001e-05 3.515481004046864394e-03 2.749722035573592442e-05 2.749725197068154069e-05 3.915030632430193183e-03 2.901819520533457179e-05 2.894153272068318534e-05 4.241840967111820508e-03 3.044226640309636450e-05 3.029082868796046944e-05 4.507725949512546466e-03 3.176438220878497609e-05 3.154059412881867250e-05 4.721752465563991939e-03 3.298171383760096289e-05 3.268846500015810524e-05 4.892897574890191226e-03 3.409304206410438375e-05 3.373360845148143605e-05 5.028511819608802967e-03 3.509873833501951537e-05 3.467675286693173167e-05 5.134925806382951985e-03 3.599998792523644183e-05 3.551976649236308659e-05 5.217375529155284485e-03 3.679196176298165386e-05 3.626638782464965442e-05 5.279410316063984018e-03 3.747691189767044407e-05 3.692057968923258900e-05 5.324689363964825797e-03 3.806125617129834667e-05 3.748585635332021663e-05 5.356992179139181444e-03 3.855107895698839214e-05 3.796552355372945664e-05 5.379456122496442151e-03 3.895194592811900334e-05 3.836258138526470185e-05 5.394590987949170711e-03 3.926876338054822486e-05 3.867965695629074589e-05 5.404339756215325793e-03 3.950565704743653448e-05 3.891894217076457901e-05 5.410126333949546312e-03 3.966586906564832399e-05 3.908213415943971819e-05 5.412892255748440531e-03 3.975174216489233325e-05 3.917045502066018799e-05 -5.793187016315502416e-12 5.511521582948903930e-01 -2.824806208772561744e-09 -5.720681795045177674e-12 5.511521583102125810e-01 -2.810776730271247204e-09 -5.669479654029123246e-12 5.511521583149072701e-01 -2.808737265597598369e-09 -5.624533055152160088e-12 5.511521583132581448e-01 -2.814171188474681990e-09 -5.568154327302964459e-12 5.511521583103976551e-01 -2.821647338761268300e-09 -5.480706205252422211e-12 5.511521583122920287e-01 -2.824756452512094766e-09 -5.343384237875275264e-12 5.511521583250561518e-01 -2.816850747377917776e-09 -5.140845038326100405e-12 5.511521583543733671e-01 -2.791678836248339933e-09 -4.863948186703906367e-12 5.511521584048632016e-01 -2.744053783547043251e-09 -4.512062734151703366e-12 5.511521584794148998e-01 -2.670580149333415822e-09 -4.094064225698260839e-12 5.511521585786959276e-01 -2.570213916462058407e-09 -3.626799640196669834e-12 5.511521587012191414e-01 -2.444253155738303162e-09 -3.132241677976026357e-12 5.511521588437118258e-01 -2.296008854435307972e-09 -2.634005267045116838e-12 5.511521590017335326e-01 -2.130202913103554240e-09 -2.154122548227303047e-12 5.511521591704037215e-01 -1.952236455704332607e-09 -1.710389500788301164e-12 5.511521593451643719e-01 -1.767404042011249668e-09 -1.314853036625756055e-12 5.511521595224551096e-01 -1.580144403516162020e-09 -9.738668525592228703e-13 5.511521597001377559e-01 -1.393496708736658447e-09 -6.891955470607996752e-13 5.511521598774830055e-01 -1.209015320873593371e-09 -4.595421799515130646e-13 5.511521600545526978e-01 -1.027347562190075714e-09 -2.831470066440502834e-13 5.511521602272112519e-01 -8.530535093355652995e-10 -1.557415530895732929e-13 5.511521603893009269e-01 -6.918645091852147487e-10 -7.078106764869816280e-14 5.511521605302371896e-01 -5.531568963785673216e-10 -1.832062330747004822e-14 5.511521606435288989e-01 -4.420383787710077983e-10 1.193474134040807548e-14 5.511521607330481798e-01 -3.539872808909272515e-10 2.677642657494635209e-14 5.511521608117339044e-01 -2.761792148704446353e-10 2.870303943739735420e-14 5.511521608946468032e-01 -1.938867746219254380e-10 2.014558924149775042e-14 5.511521609817034983e-01 -1.072803676700567265e-10 6.094239380630301752e-15 5.511521610613400179e-01 -2.793826331642564373e-11 7.409257702306397006e-15 5.511521610584574349e-01 -3.072112151592375945e-11 4.328575280334095889e-15 5.511521610725316211e-01 -1.689593467328104210e-11 -2.063892006804842488e-15 5.511521610971757967e-01 7.669820784202833621e-12 -1.561881116321392352e-15 5.511521610951010119e-01 5.702965343693295134e-12 6.706492808471934743e-15 5.511521610652584391e-01 -2.407846272131777272e-11 1.605497829753559688e-14 5.511521610325108567e-01 -5.677063825811373054e-11 7.235381930833456721e-13 5.511521585924402666e-01 -2.523505442005969709e-09 1.445265816761071046e-13 5.511521606029948783e-01 -4.876980834984619759e-10 1.463756363238668385e-13 5.511521606163884979e-01 -4.733278666251849726e-10 1.681328489471375066e-13 5.511521605757800923e-01 -5.134702317164942527e-10 1.940979697648603807e-13 5.511521605381695110e-01 -5.507378004013513672e-10 2.219387743828506738e-13 5.511521605132918555e-01 -5.753523130797199126e-10 2.515966051806804062e-13 5.511521605021527659e-01 -5.862973793585489844e-10 2.846798258805276578e-13 5.511521605011419078e-01 -5.871656386809584245e-10 3.261988871460138805e-13 5.511521605017840608e-01 -5.863999970289990173e-10 3.824249286516296237e-13 5.511521604991101997e-01 -5.890257363438153998e-10 4.664448940508415876e-13 5.511521604865734503e-01 -6.018731390892066672e-10 6.137276747228302973e-13 5.511521604496039117e-01 -6.404246277816435564e-10 9.462730834442499822e-13 5.511521603488708232e-01 -7.471286628122369736e-10 2.255867406399652721e-12 5.511521599742655875e-01 -1.149289411146237127e-09 4.739770954968953922e-11 5.511521539603033704e-01 -7.714700795318075523e-09 -6.117433929567938487e-12 5.511521592301876771e-01 -2.071332623911632281e-09 -4.134154412731924028e-13 5.511521606357170366e-01 -4.795582530235170961e-10 -1.086473275217638657e-13 5.511521607588552030e-01 -3.360091170807818244e-10 -1.626385963643853050e-14 5.511521607958591584e-01 -2.930919908651065248e-10 3.053226238420687217e-14 5.511521608162454067e-01 -2.704339791130027653e-10 5.910726893381930903e-14 5.511521608315682608e-01 -2.541968482716389284e-10 7.795784630958714917e-14 5.511521608445915099e-01 -2.408773080814293362e-10 9.079319356314987408e-14 5.511521608560712160e-01 -2.294039737630084480e-10 9.961091713394299975e-14 5.511521608661620331e-01 -2.194575237296251111e-10 1.056461717846655391e-13 5.511521608748175538e-01 -2.109930246501027766e-10 1.097432461387710120e-13 5.511521608819252016e-01 -2.040718943921972902e-10 1.125091189097477926e-13 5.511521608873564126e-01 -1.987938006294107905e-10 1.143819579409991382e-13 5.511521608909906167e-01 -1.952636765273268476e-10 1.156597265146427019e-13 5.511521608927253402e-01 -1.935751538574403323e-10 -5.856283916477112254e-12 -2.824806208772561744e-09 5.511521582336887937e-01 -5.785990663747638422e-12 -2.810776730271247204e-09 5.511521582463978497e-01 -5.739735415813018816e-12 -2.808737265597598369e-09 5.511521582457219459e-01 -5.701855166701010957e-12 -2.814171188474681990e-09 5.511521582364082850e-01 -5.653869962635832506e-12 -2.821647338761268300e-09 5.511521582241838413e-01 -5.575011468006716353e-12 -2.824756452512094766e-09 5.511521582159043531e-01 -5.445151656094238441e-12 -2.816850747377917776e-09 5.511521582187620671e-01 -5.247611408248230360e-12 -2.791678836248339933e-09 5.511521582395967345e-01 -4.972074677726545334e-12 -2.744053783547043251e-09 5.511521582841885092e-01 -4.617119036014185579e-12 -2.670580149333415822e-09 5.511521583564699123e-01 -4.191410265724602019e-12 -2.570213916462058407e-09 5.511521584578903399e-01 -3.712256036559279873e-12 -2.444253155738303162e-09 5.511521585873607743e-01 -3.202711850702965034e-12 -2.296008854435307972e-09 5.511521587415371126e-01 -2.687922172663853900e-12 -2.130202913103554240e-09 5.511521589154010359e-01 -2.191633943281027041e-12 -1.952236455704332607e-09 5.511521591029954203e-01 -1.733248112566824149e-12 -1.767404042011249668e-09 5.511521592982360218e-01 -1.326012055053666307e-12 -1.580144403516162020e-09 5.511521594957475845e-01 -9.768749399588548336e-13 -1.393496708736658447e-09 5.511521596915436305e-01 -6.875603274837716875e-13 -1.209015320873593371e-09 5.511521598832267443e-01 -4.562190963828281742e-13 -1.027347562190075714e-09 5.511521600694652134e-01 -2.801540247217757753e-13 -8.530535093355652995e-10 5.511521602453420821e-01 -1.539155203980629622e-13 -6.918645091852147487e-10 5.511521604056209833e-01 -7.002334924805703158e-14 -5.531568963785673216e-10 5.511521605421455527e-01 -1.816343452199026625e-14 -4.420383787710077983e-10 5.511521606511391447e-01 1.185589790194504978e-14 -3.539872808909272515e-10 5.511521607377365406e-01 2.663468529727648117e-14 -2.761792148704446353e-10 5.511521608146657814e-01 2.857760693670375565e-14 -1.938867746219254380e-10 5.511521608963448893e-01 2.006995416033628065e-14 -1.072803676700567265e-10 5.511521609825107415e-01 6.070024148422210364e-15 -2.793826331642564373e-11 5.511521610615625066e-01 7.358603081465208491e-15 -3.072112151592375945e-11 5.511521610588789866e-01 4.338210211519193759e-15 -1.689593467328104210e-11 5.511521610724563480e-01 -2.032918931768371055e-15 7.669820784202833621e-12 5.511521610969437601e-01 -1.559660726623658022e-15 5.702965343693295134e-12 5.511521610950848027e-01 6.691745188028083607e-15 -2.407846272131777272e-11 5.511521610653643544e-01 1.602451402478919251e-14 -5.677063825811373054e-11 5.511521610327265730e-01 7.312353379780762211e-13 -2.523505442005969709e-09 5.511521585390318778e-01 1.449142432612977779e-13 -4.876980834984619759e-10 5.511521606003817464e-01 1.464770094422780850e-13 -4.733278666251849726e-10 5.511521606157332442e-01 1.680874469590173811e-13 -5.134702317164942527e-10 5.511521605760572040e-01 1.939284108976318576e-13 -5.507378004013513672e-10 5.511521605391321854e-01 2.216516962476272169e-13 -5.753523130797199126e-10 5.511521605147797764e-01 2.511946740447223469e-13 -5.862973793585489844e-10 5.511521605040270444e-01 2.841576912809955773e-13 -5.871656386809584245e-10 5.511521605032985160e-01 3.255320866524284268e-13 -5.863999970289990173e-10 5.511521605041840299e-01 3.816159728963913423e-13 -5.890257363438153998e-10 5.511521605016057590e-01 4.657174010596883118e-13 -6.018731390892066672e-10 5.511521604884533909e-01 6.143449076529121427e-13 -6.404246277816435564e-10 5.511521604483159420e-01 9.547941312091841860e-13 -7.471286628122369736e-10 5.511521603354764265e-01 2.325694424382652742e-12 -1.149289411146237127e-09 5.511521599041907526e-01 5.130096101651164838e-11 -7.714700795318075523e-09 5.511521527380205399e-01 -6.825718358785333397e-12 -2.071332623911632281e-09 5.511521587754978357e-01 -4.394533700115297862e-13 -4.795582530235170961e-10 5.511521605774737376e-01 -1.110536181445460596e-13 -3.360091170807818244e-10 5.511521607447387172e-01 -1.634598494712027876e-14 -2.930919908651065248e-10 5.511521607947900137e-01 3.027205452277625642e-14 -2.704339791130027653e-10 5.511521608203527878e-01 5.836000519182023417e-14 -2.541968482716389284e-10 5.511521608378892045e-01 7.679662267844138185e-14 -2.408773080814293362e-10 5.511521608517591098e-01 8.934874857210468925e-14 -2.294039737630084480e-10 5.511521608633997982e-01 9.799537134609122028e-14 -2.194575237296251111e-10 5.511521608733210842e-01 1.039404649926955723e-13 -2.109930246501027766e-10 5.511521608816759565e-01 1.079973673415061607e-13 -2.040718943921972902e-10 5.511521608884655254e-01 1.107479978744083478e-13 -1.987938006294107905e-10 5.511521608936258421e-01 1.126132329088361077e-13 -1.952636765273268476e-10 5.511521608970731956e-01 1.138799088652973939e-13 -1.935751538574403323e-10 5.511521608987248744e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 new file mode 100644 index 000000000..47d681213 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 @@ -0,0 +1 @@ +1.671079062185677061e-02 6.712650932241691793e-05 6.670469455695523413e-05 1.668835434357365116e-02 6.688334461851878346e-05 6.637414254977154579e-05 1.664370115981337814e-02 6.642970879926770277e-05 6.577433559093484009e-05 1.657603316889778855e-02 6.577037045166633387e-05 6.490791007153818323e-05 1.648415326231630895e-02 6.491100845621766214e-05 6.377933055833176533e-05 1.636643623424858043e-02 6.383710311737700175e-05 6.239838098205000656e-05 1.622079295447389005e-02 6.253441438723122926e-05 6.077581428124809480e-05 1.604462063330673940e-02 6.099372861430938639e-05 5.892211834872158611e-05 1.583474319148289386e-02 5.920474790185584804e-05 5.684828379810827272e-05 1.558734093432498531e-02 5.715637296552180844e-05 5.456549292632159002e-05 1.529786991573738042e-02 5.483733157885462077e-05 5.208505910142572574e-05 1.496095987409299354e-02 5.223655673763017879e-05 4.941777498505196033e-05 1.457029648631334717e-02 4.934369333835271899e-05 4.657341558805442412e-05 1.411848815801783341e-02 4.614993061499590021e-05 4.356058790326382789e-05 1.359692384185303034e-02 4.265004155281075949e-05 4.038760016230814778e-05 1.299560954494068631e-02 3.884482000530911362e-05 3.706339034970829356e-05 1.230297659149418889e-02 3.474268654189490178e-05 3.359788260198641360e-05 1.150569290725696019e-02 3.036294233706780501e-05 3.000405075601536358e-05 1.058848669113097302e-02 2.574124094440054960e-05 2.630178666818533656e-05 9.533993494786880893e-03 2.107280516885543824e-05 2.256006139725767742e-05 8.322652080827106988e-03 1.700338780773878896e-05 1.899384995049199938e-05 6.932786182892237622e-03 1.364408362526558861e-05 1.569715222387085008e-05 5.340985197172970142e-03 1.100554297849488976e-05 1.273639861978573731e-05 3.522901717210147332e-03 9.058541195503793389e-06 1.016265397851823068e-05 1.454294387375641186e-03 7.729031108917969211e-06 8.005805463367904193e-06 -8.304984649591005616e-04 6.611123167485814876e-06 6.212737477620122281e-06 -3.106176696666370848e-03 5.361067353923928989e-06 4.714317178233976935e-06 -5.171931475834960247e-03 4.113517294746291013e-06 3.527307680289302832e-06 -6.922222352566257883e-03 3.027279139251142344e-06 2.673317814769401025e-06 -8.301133545109772027e-03 2.278755322897815143e-06 2.177552140301546000e-06 -9.394039486365694108e-03 2.068376843430733968e-06 2.067826896978344307e-06 -1.026001186281871869e-02 2.423463170132080582e-06 2.344498365951221872e-06 -1.077973590058344151e-02 3.227461794517650758e-06 2.978654103441495186e-06 -1.082173341662590570e-02 4.351809095962884240e-06 3.929788468328745492e-06 -1.046531758235376419e-02 5.663792839026332405e-06 5.149443804939536000e-06 -9.889890660598390365e-03 7.033938733454190404e-06 6.585302086943209750e-06 -9.140293890814145394e-03 8.451557795372212540e-06 8.191676113996935674e-06 -8.127092871302353874e-03 9.979659923380371925e-06 9.927826227689860484e-06 -6.793734683009476291e-03 1.160475367677359639e-05 1.174986679977790859e-05 -5.266272555691389398e-03 1.331208592419969158e-05 1.361714007244240798e-05 -3.779841155990722873e-03 1.508653719916588065e-05 1.549352291612187416e-05 -2.462641928767641576e-03 1.691271423499903179e-05 1.734757134794580045e-05 -1.310189994403090918e-03 1.877255306097971985e-05 1.915609084075665716e-05 -3.000670846266782765e-04 2.062211044070534472e-05 2.093283458864111864e-05 5.928731469504767981e-04 2.243522948180358994e-05 2.266975813127224067e-05 1.385573458735353276e-03 2.419485359982238951e-05 2.435138901819166077e-05 2.087613722203672615e-03 2.588628427706100019e-05 2.596430987011803338e-05 2.706405823794466071e-03 2.749721958170437959e-05 2.749725118971636372e-05 3.240965257745461858e-03 2.901819321145349836e-05 2.894153066515345142e-05 3.689812156417624292e-03 3.044222070340118352e-05 3.029077922496747910e-05 4.057546419066739192e-03 3.176438876176033543e-05 3.154060144059985790e-05 4.355977708188006961e-03 3.298171434953839950e-05 3.268846554433114249e-05 4.596306418919021523e-03 3.409304223931538505e-05 3.373360863051554429e-05 4.788253313379808342e-03 3.509873840604694139e-05 3.467675293813766481e-05 4.940194578548487946e-03 3.599998794146143247e-05 3.551976650849038384e-05 5.059251280904410696e-03 3.679196174383172292e-05 3.626638780575062819e-05 5.151152614921389837e-03 3.747691185355205538e-05 3.692057964577414062e-05 5.220761823954781986e-03 3.806125610883782543e-05 3.748585629185468806e-05 5.272359562622132810e-03 3.855107888086073680e-05 3.796552347883743942e-05 5.309640930090019778e-03 3.895194584182923623e-05 3.836258130036850723e-05 5.335707663932439705e-03 3.926876328680870134e-05 3.867965686404299647e-05 5.353061509970152149e-03 3.950565694838599918e-05 3.891894207326485939e-05 5.363597302734952887e-03 3.966586896300712794e-05 3.908213405838561794e-05 5.368567892373939804e-03 3.975174206010077127e-05 3.917045491748145128e-05 -2.118374321920382312e-10 5.511521404905856958e-01 -1.905684872753888698e-08 -1.938724328875963400e-10 5.511521416093084769e-01 -1.817029996899029214e-08 -1.808177570481294715e-10 5.511521424393334145e-01 -1.761060262135134517e-08 -1.699063987858375435e-10 5.511521431074516419e-01 -1.720158775890124844e-08 -1.591000775461518004e-10 5.511521437282541624e-01 -1.680475987858995036e-08 -1.473819094715896996e-10 5.511521443756258742e-01 -1.633983953007211761e-08 -1.345476722834445427e-10 5.511521450847935988e-01 -1.577412927930516135e-08 -1.208466704572164629e-10 5.511521458664916384e-01 -1.510262948567272456e-08 -1.067244558025700383e-10 5.511521467176485611e-01 -1.433434664376904035e-08 -9.266519248758141015e-11 5.511521476281583398e-01 -1.348446071752300381e-08 -7.910763409205909175e-11 5.511521485845849444e-01 -1.257044115748742242e-08 -6.639580597826807235e-11 5.511521495729395648e-01 -1.160941602346493372e-08 -5.477160950036150743e-11 5.511521505794644282e-01 -1.061761548757732153e-08 -4.438305591610677947e-11 5.511521515908835989e-01 -9.610351565528635259e-09 -3.529823308679061841e-11 5.511521525946054822e-01 -8.602024769960184476e-09 -2.751756951835798926e-11 5.511521535792287541e-01 -7.605799546887860538e-09 -2.098806468114260931e-11 5.511521545348777584e-01 -6.633378669427989066e-09 -1.561971260503455299e-11 5.511521554533057587e-01 -5.694954836971713819e-09 -1.129925245341159228e-11 5.511521563279409008e-01 -4.799244067535938348e-09 -7.901735496721964053e-12 5.511521571535291653e-01 -3.953967421001337111e-09 -5.308064943985199728e-12 5.511521579204701204e-01 -3.171146795619367248e-09 -3.402893715312224226e-12 5.511521586149799035e-01 -2.465562471425500569e-09 -2.068706530220201531e-12 5.511521592222414778e-01 -1.852254433457865363e-09 -1.169856463368661219e-12 5.511521597486694901e-01 -1.325096993297818903e-09 -5.988906153905846053e-13 5.511521601924259661e-01 -8.853825235714362059e-10 -2.705241089913135974e-13 5.511521605385081291e-01 -5.451708207728942204e-10 -1.043288325523307235e-13 5.511521607826487257e-01 -3.052144051145781134e-10 -3.043294052846309874e-14 5.511521609466897287e-01 -1.427127460458694779e-10 -3.872197646291455744e-15 5.511521610542234884e-01 -3.530180398539488347e-11 -8.964916644735341457e-16 5.511521610580901731e-01 -3.111515961491596864e-11 5.931910963886242401e-16 5.511521610721302755e-01 -1.729508768513960241e-11 -5.578228701481284908e-16 5.511521610961797046e-01 6.670802997744094621e-12 -7.817116095716659245e-16 5.511521610959642103e-01 6.567433378794728568e-12 2.866438789203821140e-15 5.511521610695265805e-01 -1.979721687304424024e-11 7.996639910072554424e-15 5.511521610400375026e-01 -4.921116156134488933e-11 4.364901881870386758e-13 5.511521586037422260e-01 -2.512167332414277080e-09 8.641968121389346235e-14 5.511521606195256551e-01 -4.711491663883299871e-10 8.597065245455337413e-14 5.511521606385095806e-01 -4.512121560556135392e-10 9.590740568433980010e-14 5.511521606009011087e-01 -4.883666871036989253e-10 1.061098108008645769e-13 5.511521605627512921e-01 -5.261768376424609346e-10 1.143399283068085375e-13 5.511521605358611353e-01 -5.528054850268443113e-10 1.200414622947688337e-13 5.511521605226984422e-01 -5.657789379756805064e-10 1.237410486889189423e-13 5.511521605199599660e-01 -5.683871575121097612e-10 1.270293365405595095e-13 5.511521605191563866e-01 -5.690866396245933543e-10 1.308153831548447840e-13 5.511521605151097347e-01 -5.731043133573394579e-10 1.364170357247429706e-13 5.511521605011436842e-01 -5.873905303670086213e-10 1.471136057455872697e-13 5.511521604626582471e-01 -6.274512299028711483e-10 1.722415378736660787e-13 5.511521603601060582e-01 -7.359483976647036262e-10 2.619863334005289154e-13 5.511521599834559026e-01 -1.140118531863051920e-09 1.698014367774796719e-12 5.511521539675181547e-01 -7.707474468498933869e-09 4.355414289920362349e-13 5.511521592357144783e-01 -2.065773882990151527e-09 9.852199647776368639e-14 5.511521606398264161e-01 -4.754095872749126659e-10 6.656367078097356263e-14 5.511521607618293794e-01 -3.329978185108669088e-10 5.476356601450003345e-14 5.511521607979541493e-01 -2.909677670217017956e-10 4.675725431157888130e-14 5.511521608176821463e-01 -2.689776640429314818e-10 3.995733655604619206e-14 5.511521608325279376e-01 -2.532265184597714191e-10 3.383945675756668678e-14 5.511521608452134569e-01 -2.402514370721254383e-10 2.833267109355872307e-14 5.511521608564624586e-01 -2.290130217640591047e-10 2.348326316846335804e-14 5.511521608664030625e-01 -2.192188808484630325e-10 1.935640244624351525e-14 5.511521608749652135e-01 -2.108484430353434762e-10 1.600372308578419310e-14 5.511521608820174611e-01 -2.039828280732979285e-10 1.345858687790212443e-14 5.511521608874171418e-01 -1.987360186992170825e-10 1.174076416124587992e-14 5.511521608910345815e-01 -1.952223392338219211e-10 1.086816751866159700e-14 5.511521608927621996e-01 -1.935408297186730680e-10 -1.961021069993541866e-10 -1.905684872753888698e-08 5.511521434350652449e-01 -1.809369870032201074e-10 -1.817029996899029214e-08 5.511521441205186056e-01 -1.708137884333861522e-10 -1.761060262135134517e-08 5.511521444449473117e-01 -1.625844817160427363e-10 -1.720158775890124844e-08 5.511521446233351718e-01 -1.540363715850709712e-10 -1.680475987858995036e-08 5.511521448154942382e-01 -1.441086029259565901e-10 -1.633983953007211761e-08 5.511521451096514923e-01 -1.326268848358458427e-10 -1.577412927930516135e-08 5.511521455384194024e-01 -1.199038221043142383e-10 -1.510262948567272456e-08 5.511521461030703950e-01 -1.064553786371333150e-10 -1.433434664376904035e-08 5.511521467900136750e-01 -9.283135812856908290e-11 -1.348446071752300381e-08 5.511521475798365488e-01 -7.952735729886009843e-11 -1.257044115748742242e-08 5.511521484515431446e-01 -6.693492293634925342e-11 -1.160941602346493372e-08 5.511521493851656572e-01 -5.533492880432740798e-11 -1.061761548757732153e-08 5.511521503621731322e-01 -4.490699879979656780e-11 -9.610351565528635259e-09 5.511521513653055981e-01 -3.574464963249082701e-11 -8.602024769960184476e-09 5.511521523783844412e-01 -2.786847649240757009e-11 -7.605799546887860538e-09 5.511521533864700562e-01 -2.124092793753504740e-11 -6.633378669427989066e-09 5.511521543759920760e-01 -1.578313281386424987e-11 -5.694954836971713819e-09 5.511521553347566993e-01 -1.138918762478736057e-11 -4.799244067535938348e-09 5.511521562518449935e-01 -7.938297282739622690e-12 -3.953967421001337111e-09 5.511521571170231448e-01 -5.311941246485081776e-12 -3.171146795619367248e-09 5.511521579158407125e-01 -3.390793503446066678e-12 -2.465562471425500569e-09 5.511521586325458522e-01 -2.052218660593341770e-12 -1.852254433457865363e-09 5.511521592518856538e-01 -1.156227852334266109e-12 -1.325096993297818903e-09 5.511521597797256478e-01 -5.911673150222330834e-13 -8.853825235714362059e-10 5.511521602154108024e-01 -2.677264960262319207e-13 -5.451708207728942204e-10 5.511521605498427290e-01 -1.038113546748617676e-13 -3.052144051145781134e-10 5.511521607856837424e-01 -3.043667148639717654e-14 -1.427127460458694779e-10 5.511521609466547567e-01 -3.887597471559112547e-15 -3.530180398539488347e-11 5.511521610539433791e-01 -8.912732077205668890e-16 -3.111515961491596864e-11 5.511521610584562136e-01 5.944851411396152947e-16 -1.729508768513960241e-11 5.511521610720594433e-01 -5.479877044259260747e-16 6.670802997744094621e-12 5.511521610959418949e-01 -7.809118393579088025e-16 6.567433378794728568e-12 5.511521610959504436e-01 2.856895441494378233e-15 -1.979721687304424024e-11 5.511521610696586970e-01 7.973798380774037237e-15 -4.921116156134488933e-11 5.511521610403190552e-01 4.411483409220029700e-13 -2.512167332414277080e-09 5.511521585504062237e-01 8.665633973338486445e-14 -4.711491663883299871e-10 5.511521606169488274e-01 8.603414864931488041e-14 -4.512121560556135392e-10 5.511521606378435578e-01 9.588370964421651702e-14 -4.883666871036989253e-10 5.511521606011432484e-01 1.060170058457347239e-13 -5.261768376424609346e-10 5.511521605636723331e-01 1.141907744254997741e-13 -5.528054850268443113e-10 5.511521605373040922e-01 1.198486054827023034e-13 -5.657789379756805064e-10 5.511521605245182087e-01 1.235150730139972298e-13 -5.683871575121097612e-10 5.511521605220374154e-01 1.267748300251702673e-13 -5.690866396245933543e-10 5.511521605214385611e-01 1.305484475787006277e-13 -5.731043133573394579e-10 5.511521605174495297e-01 1.362190472856458021e-13 -5.873905303670086213e-10 5.511521605028488757e-01 1.472835493530588158e-13 -6.274512299028711483e-10 5.511521604612089620e-01 1.738289540369500443e-13 -7.359483976647036262e-10 5.511521603466019714e-01 2.701646915754946561e-13 -1.140118531863051920e-09 5.511521599133422100e-01 1.837968026399424164e-12 -7.707474468498933869e-09 5.511521527452584168e-01 4.860628239406353490e-13 -2.065773882990151527e-09 5.511521587810886968e-01 1.047196697283982988e-13 -4.754095872749126659e-10 5.511521605816621650e-01 6.798048749146937967e-14 -3.329978185108669088e-10 5.511521607477876117e-01 5.485994897359687179e-14 -2.909677670217017956e-10 5.511521607969439573e-01 4.639935205028451819e-14 -2.689776640429314818e-10 5.511521608218289403e-01 3.946098080181150545e-14 -2.532265184597714191e-10 5.511521608388703086e-01 3.333817557365040504e-14 -2.402514370721254383e-10 5.511521608523889393e-01 2.788321739188535862e-14 -2.290130217640591047e-10 5.511521608637904857e-01 2.310335286320624911e-14 -2.192188808484630325e-10 5.511521608735573396e-01 1.904427221418277966e-14 -2.108484430353434762e-10 5.511521608818175100e-01 1.574961510575420922e-14 -2.039828280732979285e-10 5.511521608885515677e-01 1.324827755792679272e-14 -1.987360186992170825e-10 5.511521608936807981e-01 1.155913561887655273e-14 -1.952223392338219211e-10 5.511521608971120534e-01 1.070117385028068578e-14 -1.935408297186730680e-10 5.511521608987568488e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 new file mode 100644 index 000000000..772ebad72 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 @@ -0,0 +1 @@ +1.684830067513857360e-02 6.712674724827587779e-05 6.670491481709989786e-05 1.682902214545057423e-02 6.688356266383820015e-05 6.637434605321353533e-05 1.679016293382153135e-02 6.642991177899530610e-05 6.577452734546529358e-05 1.673111393850434600e-02 6.577056030529450023e-05 6.490809174709723359e-05 1.665094589819876569e-02 6.491118503159688542e-05 6.377950151609839877e-05 1.654838947798170298e-02 6.383726528408017694e-05 6.239853954852647049e-05 1.642180822482116123e-02 6.253456091666644825e-05 6.077595871972967607e-05 1.626916397956381169e-02 6.099385865898245522e-05 5.892224737930316811e-05 1.608797417153872561e-02 5.920486118648587677e-05 5.684839679740701324e-05 1.587526030479660330e-02 5.715646980259507390e-05 5.456558993717689187e-05 1.562748684148160261e-02 5.483741279245596899e-05 5.208514074596934314e-05 1.534048959109307261e-02 5.223662353686053762e-05 4.941784232668106633e-05 1.500939261125728945e-02 4.934374718670664968e-05 4.657346999024691213e-05 1.462851259661572013e-02 4.614997311304872691e-05 4.356063090307065453e-05 1.419124980316582678e-02 4.265007434044474971e-05 4.038763336473827191e-05 1.368996483139258216e-02 3.884484468172764207e-05 3.706341534098054913e-05 1.311584108681242318e-02 3.474270460493742536e-05 3.359790088279883109e-05 1.245873357737880063e-02 3.036295514325033137e-05 3.000406369616539677e-05 1.170700632871967718e-02 2.574124968611301553e-05 2.630179547913165996e-05 1.084736340987432768e-02 2.107281086543724856e-05 2.256006711938202038e-05 9.864682700244091496e-03 1.700339131275534454e-05 1.899385345674443703e-05 8.741867192713061174e-03 1.364408563332431475e-05 1.569715422308901712e-05 7.459739843022222296e-03 1.100554402977306438e-05 1.273639966092352487e-05 5.997030910612793919e-03 9.058541676773888848e-06 1.016265445279812576e-05 4.330645057090176490e-03 7.729031285035317794e-06 8.005805636591002182e-06 2.436395110208634807e-03 6.611123207881331973e-06 6.212737517740668767e-06 2.936101703000753953e-04 5.361067351835979221e-06 4.714317176552229440e-06 -1.978830615753656829e-03 4.113517287885270777e-06 3.527307673627345504e-06 -4.123776100882096951e-03 3.027279136667426310e-06 2.673317812200429293e-06 -6.023233109404093656e-03 2.278755321638372441e-06 2.177552139041972009e-06 -7.581835083119876743e-03 2.068376842768837012e-06 2.067826896314877799e-06 -8.790339981004823694e-03 2.423463170426829836e-06 2.344498366239512924e-06 -9.781048634477061687e-03 3.227461794903344670e-06 2.978654103825142243e-06 -1.053822819603704615e-02 4.351809095228527003e-06 3.929788467596500756e-06 -1.089337105304939712e-02 5.663792836559564940e-06 5.149443802479995419e-06 -1.076017526017589501e-02 7.033938587380341519e-06 6.585301939313352870e-06 -1.030383748471300209e-02 8.451557759418772540e-06 8.191676077944526650e-06 -9.688283708871540251e-03 9.979659878922978632e-06 9.927826183200334149e-06 -8.896582065189072991e-03 1.160475361578466107e-05 1.174986673880583600e-05 -7.812723642966401191e-03 1.331208584254852084e-05 1.361713999086356877e-05 -6.422281817273027202e-03 1.508653709458688667e-05 1.549352281167932363e-05 -4.887377781359326240e-03 1.691271410699790646e-05 1.734757122015026697e-05 -3.471819758343314046e-03 1.877255291020361329e-05 1.915609069025453527e-05 -2.227648681226578661e-03 2.062211026717430113e-05 2.093283441545381796e-05 -1.141069660130177715e-03 2.243522928472819155e-05 2.266975793459655373e-05 -1.896504879309241550e-04 2.419485337603618320e-05 2.435138879474362051e-05 6.531960459441436568e-04 2.588628401641796445e-05 2.596430960922512291e-05 1.400277999203173012e-03 2.749721925319742325e-05 2.749725085828274592e-05 2.060517508161209283e-03 2.901819267214736673e-05 2.894153010910557807e-05 2.642358556019567227e-03 3.044221690119714851e-05 3.029077510923038362e-05 3.148824426777186228e-03 3.176438770914330326e-05 3.154060026545663000e-05 3.574670920714802420e-03 3.298171409643572559e-05 3.268846527521827871e-05 3.924418674832719917e-03 3.409304205481234422e-05 3.373360844230655135e-05 4.209661287099431860e-03 3.509873823987895870e-05 3.467675277201710918e-05 4.440729628263409209e-03 3.599998778435328708e-05 3.551976635292600004e-05 4.626523588764636444e-03 3.679196159348462162e-05 3.626638765754589005e-05 4.774641839267641102e-03 3.747691170928455677e-05 3.692057950381957051e-05 4.891507232701677171e-03 3.806125597031570387e-05 3.748585615559903693e-05 4.982482322858784729e-03 3.855107874770582934e-05 3.796552334780804256e-05 5.051972180857891223e-03 3.895194571349781549e-05 3.836258117399790678e-05 5.103513092957821622e-03 3.926876316257555126e-05 3.867965674161745536e-05 5.139840698849770274e-03 3.950565682736290746e-05 3.891894195392997887e-05 5.162942698322258751e-03 3.966586884417427368e-05 3.908213394116293943e-05 5.174154401314921652e-03 3.975174194233484649e-05 3.917045480128972707e-05 2.608842676250358649e-11 5.511521404323863615e-01 -1.911573677380113137e-08 2.417288653492700465e-11 5.511521415526217105e-01 -1.822768693896139199e-08 2.216197055117915186e-11 5.511521423858869451e-01 -1.766476719814908901e-08 1.994722937788455374e-11 5.511521430588141035e-01 -1.725096226707173279e-08 1.747530167850295825e-11 5.511521436857548251e-01 -1.684800883888574989e-08 1.478479370466823031e-11 5.511521443402634945e-01 -1.637594829585421272e-08 1.198176293187186363e-11 5.511521450571448266e-01 -1.580249562160286458e-08 9.198002611785832614e-12 5.511521458466248635e-01 -1.512315048454310041e-08 6.560174226537393445e-12 5.511521467050549683e-01 -1.434749111023679227e-08 4.171880778888202288e-12 5.511521476217073889e-01 -1.349131881154690588e-08 2.105967259401860646e-12 5.511521485825124911e-01 -1.257274459354779680e-08 4.034243827010482846e-13 5.511521495728723963e-01 -1.160952305735806477e-08 -9.232555670674846574e-13 5.511521505784884312e-01 -1.061845441130540378e-08 -1.885003086732669530e-12 5.511521515856586673e-01 -9.615315958179106677e-09 -2.510599095030524770e-12 5.511521525815346045e-01 -8.614811887088224459e-09 -2.841150990327766230e-12 5.511521535546860528e-01 -7.630181649387928036e-09 -2.925022156096534796e-12 5.511521544954994800e-01 -6.672899136858259548e-09 -2.813530077938787803e-12 5.511521553963445452e-01 -5.752544962912951102e-09 -2.557539988311978764e-12 5.511521562516766837e-01 -4.876764797551079581e-09 -2.205153685416695400e-12 5.511521570577216922e-01 -4.051697861864266534e-09 -1.803048389766289040e-12 5.511521578068074856e-01 -3.287277229730449250e-09 -1.394834988748856606e-12 5.511521584873952939e-01 -2.595827614109071002e-09 -1.017428356214806351e-12 5.511521590869827847e-01 -1.989861769752985069e-09 -6.885863683032028362e-13 5.511521596139913326e-01 -1.461140810188398937e-09 -4.227732670235887320e-13 5.511521600677534716e-01 -1.009944763385401304e-09 -2.301285915933615156e-13 5.511521604349394199e-01 -6.472621000970158200e-10 -1.064167824907953670e-13 5.511521607125362543e-01 -3.735655488084868713e-10 -3.729396106287693280e-14 5.511521609107553621e-01 -1.776834316369975440e-10 -6.455913584790844343e-15 5.511521610414169547e-01 -4.797183964873543864e-11 -2.155934217889526439e-15 5.511521610558370865e-01 -3.347095003278500073e-11 -6.870577772075903366e-17 5.511521610721287212e-01 -1.730023148423604965e-11 -2.630736839452844700e-16 5.511521610954310813e-01 5.966509813846617000e-12 -3.960176929488624420e-16 5.511521610943637128e-01 4.990127908179935624e-12 2.132081632434271151e-15 5.511521610687607486e-01 -2.055695205789533024e-11 5.529872746395285462e-15 5.511521610414723549e-01 -4.778191866322242035e-11 2.904163389513934429e-13 5.511521586066808753e-01 -2.509221840749997706e-09 5.046624070948872512e-14 5.511521606229070613e-01 -4.677539646305761187e-10 4.151325855126667699e-14 5.511521606418710029e-01 -4.478561818052801051e-10 3.491846955438926357e-14 5.511521606036459131e-01 -4.856495416159910992e-10 2.445864087988369905e-14 5.511521605641545030e-01 -5.247952874733308021e-10 9.760934406674832783e-15 5.511521605360691911e-01 -5.525996515344730033e-10 -7.959661505891755361e-15 5.511521605228230092e-01 -5.656591509249117194e-10 -2.703505638602696142e-14 5.511521605212166275e-01 -5.671616623169966772e-10 -4.650170775388289413e-14 5.511521605224594111e-01 -5.658385106277720405e-10 -6.626001613352058696e-14 5.511521605210468744e-01 -5.672006018512480477e-10 -8.736917174928547206e-14 5.511521605100394572e-01 -5.784201699987710026e-10 -1.135294284930753241e-13 5.511521604745870384e-01 -6.152334365999133571e-10 -1.562654170616490738e-13 5.511521603749960363e-01 -7.204652810677792869e-10 -2.773197976801776866e-13 5.511521600010982347e-01 -1.121554453384799586e-09 -2.104189668082807502e-12 5.511521539874826292e-01 -7.686332036399922470e-09 -6.170756060052933985e-13 5.511521592573827011e-01 -2.042818387045844225e-09 -1.545806796146075583e-13 5.511521606627496350e-01 -4.512374944040355930e-10 -1.179393685185212649e-13 5.511521607856899596e-01 -3.080450729571656196e-10 -1.114044148370059676e-13 5.511521608224089208e-01 -2.656622098290083899e-10 -1.103508892700626202e-13 5.511521608423758378e-01 -2.437213443434164518e-10 -1.103897620571443414e-13 5.511521608571153807e-01 -2.283745410302874118e-10 -1.104280411544224207e-13 5.511521608693613627e-01 -2.161148780100907009e-10 -1.101894491087092484e-13 5.511521608798736205e-01 -2.058438556738244217e-10 -1.096716454297215037e-13 5.511521608888573232e-01 -1.971816986344342908e-10 -1.089750199035848967e-13 5.511521608963512175e-01 -1.900000636106764599e-10 -1.082294299911353223e-13 5.511521609023483093e-01 -1.842640603328599955e-10 -1.075645027852724291e-13 5.511521609068303906e-01 -1.799757953341840606e-10 -1.070920915003985010e-13 5.511521609097764784e-01 -1.771530025026718079e-10 -1.068977570120967567e-13 5.511521609111527109e-01 -1.758303968038655942e-10 2.415803765802641155e-11 -1.911573677380113137e-08 5.511521433754802413e-01 2.256645498539479009e-11 -1.822768693896139199e-08 5.511521440624227441e-01 2.094074201606641571e-11 -1.766476719814908901e-08 5.511521443900549988e-01 1.909107733288769982e-11 -1.725096226707173279e-08 5.511521445732124880e-01 1.692139504823108127e-11 -1.684800883888574989e-08 5.511521447714824440e-01 1.445787353153917989e-11 -1.637594829585421272e-08 5.511521450727805416e-01 1.181159674360135247e-11 -1.580249562160286458e-08 5.511521455093169042e-01 9.126759479766404801e-12 -1.512315048454310041e-08 5.511521460818735729e-01 6.543920101039645170e-12 -1.434749111023679227e-08 5.511521467762943161e-01 4.179497172072494820e-12 -1.349131881154690588e-08 5.511521475725456032e-01 2.117186320512808606e-12 -1.257274459354779680e-08 5.511521484489830813e-01 4.067061674731970456e-13 -1.160952305735806477e-08 5.511521493849951270e-01 -9.327363153804636364e-13 -1.061845441130540378e-08 5.511521503614520423e-01 -1.907191975364226045e-12 -9.615315958179106677e-09 5.511521513605887046e-01 -2.542219507779940784e-12 -8.614811887088224459e-09 5.511521523658748922e-01 -2.877204236291840839e-12 -7.630181649387928036e-09 5.511521533622475433e-01 -2.960115518935515599e-12 -6.672899136858259548e-09 5.511521543363289144e-01 -2.842982781306965056e-12 -5.752544962912951102e-09 5.511521552765307197e-01 -2.578241301608981070e-12 -4.876764797551079581e-09 5.511521561730470253e-01 -2.216172940444382022e-12 -4.051697861864266534e-09 5.511521570173312234e-01 -1.805688808449919222e-12 -3.287277229730449250e-09 5.511521577971888464e-01 -1.391575336188519829e-12 -2.595827614109071002e-09 5.511521584995439094e-01 -1.011080873219392222e-12 -1.989861769752985069e-09 5.511521591118888619e-01 -6.819479570963594179e-13 -1.461140810188398937e-09 5.511521596423023528e-01 -4.179442176087034530e-13 -1.009944763385401304e-09 5.511521600909586871e-01 -2.276059496921086349e-13 -6.472621000970158200e-10 5.511521604492077842e-01 -1.054931021274384317e-13 -3.735655488084868713e-10 5.511521607190497107e-01 -3.709862873392000774e-14 -1.776834316369975440e-10 5.511521609126218690e-01 -6.456569115087631478e-15 -4.797183964873543864e-11 5.511521610414084060e-01 -2.150847305472643966e-15 -3.347095003278500073e-11 5.511521610559930728e-01 -6.898116614788134028e-17 -1.730023148423604965e-11 5.511521610720426789e-01 -2.596968498765096773e-16 5.966509813846617000e-12 5.511521610952793138e-01 -3.972647765703611451e-16 4.990127908179935624e-12 5.511521610943959093e-01 2.124650313485068228e-15 -2.055695205789533024e-11 5.511521610689049666e-01 5.514257940586376254e-15 -4.778191866322242035e-11 5.511521610417426942e-01 2.935184842301130138e-13 -2.509221840749997706e-09 5.511521585533586398e-01 5.060393081300308394e-14 -4.677539646305761187e-10 5.511521606203578783e-01 4.154462276604576656e-14 -4.478561818052801051e-10 5.511521606411939889e-01 3.491163732007257671e-14 -4.856495416159910992e-10 5.511521606038329857e-01 2.443816606033625668e-14 -5.247952874733308021e-10 5.511521605650325784e-01 9.748224981305378980e-15 -5.525996515344730033e-10 5.511521605375077071e-01 -7.946926682422886622e-15 -5.656591509249117194e-10 5.511521605246333388e-01 -2.698704822334196673e-14 -5.671616623169966772e-10 5.511521605232324594e-01 -4.641246969689941836e-14 -5.658385106277720405e-10 5.511521605246326727e-01 -6.612723773366139543e-14 -5.672006018512480477e-10 5.511521605233199450e-01 -8.722899314026716439e-14 -5.784201699987710026e-10 5.511521605118944178e-01 -1.136093594420768466e-13 -6.152334365999133571e-10 5.511521604737227298e-01 -1.576046648332854350e-13 -7.204652810677792869e-10 5.511521603627018706e-01 -2.858831806842593604e-13 -1.121554453384799586e-09 5.511521599328761400e-01 -2.277769069051067050e-12 -7.686332036399922470e-09 5.511521527676482846e-01 -6.890804065601317013e-13 -2.042818387045844225e-09 5.511521588054080212e-01 -1.643931912590787149e-13 -4.512374944040355930e-10 5.511521606071512203e-01 -1.202285087732659704e-13 -3.080450729571656196e-10 5.511521607738825157e-01 -1.112606048606853298e-13 -2.656622098290083899e-10 5.511521608231298996e-01 -1.091650344989341523e-13 -2.437213443434164518e-10 5.511521608476607215e-01 -1.087437553917318651e-13 -2.283745410302874118e-10 5.511521608639896597e-01 -1.086163952091983084e-13 -2.161148780100907009e-10 5.511521608765141966e-01 -1.083724304402665664e-13 -2.058438556738244217e-10 5.511521608867201438e-01 -1.079260426888560680e-13 -1.971816986344342908e-10 5.511521608951851503e-01 -1.073263283865657116e-13 -1.900000636106764599e-10 5.511521609021418078e-01 -1.066759261984709739e-13 -1.842640603328599955e-10 5.511521609076767136e-01 -1.060866036816425709e-13 -1.799757953341840606e-10 5.511521609118099629e-01 -1.056635457895235487e-13 -1.771530025026718079e-10 5.511521609145330070e-01 -1.054905483891994997e-13 -1.758303968038655942e-10 5.511521609158123169e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 new file mode 100644 index 000000000..c0c44fd22 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 @@ -0,0 +1 @@ +1.701030840996054297e-02 6.712676713334509565e-05 6.670493328461960696e-05 1.699296624267677275e-02 6.688358085192915318e-05 6.637436307934456935e-05 1.695801556740624341e-02 6.642992798684574330e-05 6.577454269637968089e-05 1.690491836823251534e-02 6.577057425191731464e-05 6.490810512066535565e-05 1.683285349929638033e-02 6.491119649486393433e-05 6.377951263274547105e-05 1.674069942210072715e-02 6.383727416742538113e-05 6.239854824568308572e-05 1.662701070021436675e-02 6.253456727820668978e-05 6.077596499675085593e-05 1.648998793868652543e-02 6.099386269810331998e-05 5.892225139014369662e-05 1.632744071576312100e-02 5.920486320601422016e-05 5.684839881324360757e-05 1.613674297537261854e-02 5.715647016372053720e-05 5.456559029936706881e-05 1.591478028732052144e-02 5.483741187343907190e-05 5.208513982210150192e-05 1.565788831044484519e-02 5.223662170078782800e-05 4.941784047574990127e-05 1.536178175040133972e-02 4.934374475961584731e-05 4.657346753854768844e-05 1.502147311233030351e-02 4.614997037126535051e-05 4.356062812972362534e-05 1.463118064142372721e-02 4.265007150532147315e-05 4.038763049500762115e-05 1.418422507370719135e-02 3.884484192008532750e-05 3.706341254564300642e-05 1.367291525367373209e-02 3.474270203356210918e-05 3.359789828190076430e-05 1.308842342347713711e-02 3.036295283591009602e-05 3.000406136560869306e-05 1.242065219927721530e-02 2.574124768185943074e-05 2.630179345879105264e-05 1.165809720333329039e-02 2.107280917705240064e-05 2.256006542154042569e-05 1.078771205423442389e-02 1.700338993244838369e-05 1.899385207206501417e-05 9.794785629308919508e-03 1.364408453738333288e-05 1.569715312613605111e-05 8.662849872738449461e-03 1.100554318408410600e-05 1.273639881615677191e-05 7.373642002026285953e-03 9.058541048145356359e-06 1.016265382586808068e-05 5.907157351809907281e-03 7.729030840340038929e-06 8.005805193545924764e-06 4.241843931630280215e-03 6.611122911621502696e-06 6.212737222907818108e-06 2.355075223285590415e-03 5.361067169768765438e-06 4.714316995841140817e-06 2.245293820621841949e-04 4.113517192947402311e-06 3.527307579808045878e-06 -2.034598301210873393e-03 3.027279101744627201e-06 2.673317777846168016e-06 -4.151803923244577060e-03 2.278755306271852654e-06 2.177552123862964987e-06 -6.028763801412588552e-03 2.068376837725581668e-06 2.067826891266353910e-06 -7.573879914826294954e-03 2.423463170999915388e-06 2.344498366791816946e-06 -8.759992577848074377e-03 3.227461795457543080e-06 2.978654104380048349e-06 -9.746000063092136873e-03 4.351809093393142132e-06 3.929788465767380540e-06 -1.051995036279615957e-02 5.663792833345570419e-06 5.149443799274766843e-06 -1.090874159078391616e-02 7.033938466142982649e-06 6.585301816781236377e-06 -1.080864277005538950e-02 8.451557743313504922e-06 8.191676061795054076e-06 -1.036928796977470979e-02 9.979659867969207851e-06 9.927826172237037635e-06 -9.778237119432044502e-03 1.160475360756810097e-05 1.174986673059021780e-05 -9.035639146913923558e-03 1.331208583690722381e-05 1.361713998522709644e-05 -8.012684540365824087e-03 1.508653709167426731e-05 1.549352280877058538e-05 -6.682579831148923247e-03 1.691271410698661721e-05 1.734757122013901159e-05 -5.151691040704410238e-03 1.877255291322569132e-05 1.915609069327150739e-05 -3.726837064234695025e-03 2.062211027347040206e-05 2.093283442173689152e-05 -2.472363207895130355e-03 2.243522929483160393e-05 2.266975794467553090e-05 -1.375418969011573452e-03 2.419485339105069600e-05 2.435138880972704043e-05 -4.183232816082121854e-04 2.588628403863597747e-05 2.596430963145243974e-05 4.282275441390572630e-04 2.749721928816452896e-05 2.749725089354574395e-05 1.178365586787474524e-03 2.901819274287726396e-05 2.894153018200575328e-05 1.840830002644214388e-03 3.044221750842174626e-05 3.029077576647719647e-05 2.423951574282323228e-03 3.176438791299931899e-05 3.154060049299623581e-05 2.934970394376110615e-03 3.298171415485867794e-05 3.268846533735470482e-05 3.371088564282621013e-03 3.409304210414550141e-05 3.373360849268277879e-05 3.730763051282031360e-03 3.509873829040330848e-05 3.467675282258727329e-05 4.024678380280400335e-03 3.599998783794544789e-05 3.551976640604954835e-05 4.263161545323747650e-03 3.679196165036497789e-05 3.626638771366994755e-05 4.455081939869413692e-03 3.747691176918705884e-05 3.692057956281022467e-05 4.607971648492591860e-03 3.806125603280259155e-05 3.748585621710764899e-05 4.728142627731686358e-03 3.855107881229706535e-05 3.796552341140710482e-05 4.820794939143351401e-03 3.895194577973449092e-05 3.836258123925500555e-05 4.890112465689522812e-03 3.926876323004452411e-05 3.867965680813117155e-05 4.939344034184400128e-03 3.950565689570751586e-05 3.891894202134346090e-05 4.970868838187409919e-03 3.966586891309516942e-05 3.908213400916845683e-05 4.986245651175879104e-03 3.975174201157469418e-05 3.917045486961995624e-05 4.597349597848138029e-11 5.511521402279838666e-01 -1.932791803252088017e-08 4.236097748328004488e-11 5.511521413580215967e-01 -1.842985203714219561e-08 3.836982099486935323e-11 5.511521422097397371e-01 -1.784806414007445652e-08 3.389385219556707394e-11 5.511521429076889911e-01 -1.740864041748814177e-08 2.893856872934386065e-11 5.511521435635763355e-01 -1.697598953619772560e-08 2.366813891056918631e-11 5.511521442481511768e-01 -1.647299248038956659e-08 1.834330316720647493e-11 5.511521449935945505e-01 -1.587002688507245660e-08 1.323712347944667622e-11 5.511521458079244873e-01 -1.516484220833158792e-08 8.579702570482448158e-12 5.511521466858195772e-01 -1.436873328027675065e-08 4.533006241628900439e-12 5.511521476154425114e-01 -1.349865698003885018e-08 1.186950360864730283e-12 5.511521485821468946e-01 -1.257334848870582290e-08 -1.432648323601388037e-12 5.511521495712328189e-01 -1.161071109999093519e-08 -3.350346371865693595e-12 5.511521505687116962e-01 -1.062727936971972972e-08 -4.626786461194743220e-12 5.511521515615434019e-01 -9.638206314670413377e-09 -5.345722373249141092e-12 5.511521525378415554e-01 -8.657260536095541112e-09 -5.602793303383345295e-12 5.511521534873915495e-01 -7.696475176910638728e-09 -5.496397473215344138e-12 5.511521544020064889e-01 -6.765884462595390244e-09 -5.120870313241098442e-12 5.511521552756518672e-01 -5.873433249789491483e-09 -4.561793572912125590e-12 5.511521561045104045e-01 -5.024974112264690832e-09 -3.893538532264352186e-12 5.511521568866365461e-01 -4.224735367935752051e-09 -3.183355351459008892e-12 5.511521576162171643e-01 -3.480696297599475380e-09 -2.490775971119785123e-12 5.511521582833255328e-01 -2.803409549670527553e-09 -1.863117313873277241e-12 5.511521588767003266e-01 -2.203944734996069901e-09 -1.317214901334352794e-12 5.511521594055444062e-01 -1.673089449330466043e-09 -8.674685458817090679e-13 5.511521598694654189e-01 -1.210741652914280762e-09 -5.263884204961908319e-13 5.511521602548816734e-01 -8.282140860602899075e-10 -2.884839965303543533e-13 5.511521605583241668e-01 -5.268512462053545184e-10 -1.322318299071276143e-13 5.511521607958675961e-01 -2.905852836065203348e-10 -4.137871265371600753e-14 5.511521609729487237e-01 -1.148299578408345213e-10 -1.752245406250620226e-14 5.511521610226125523e-01 -6.603748592652048159e-11 -5.111961067771800988e-15 5.511521610602111432e-01 -2.920643345013642296e-11 3.100120076574351561e-16 5.511521610926781722e-01 3.112027914878660870e-12 1.581808477517425581e-16 5.511521610941061411e-01 4.703150989914121743e-12 2.966970205073969251e-16 5.511521610687135642e-01 -2.059765475810521031e-11 2.315878167140748414e-15 5.511521610412490890e-01 -4.799854125100212152e-11 1.691789803125355572e-13 5.511521586068536260e-01 -2.509051182721895728e-09 3.436097245327722309e-14 5.511521606235861848e-01 -4.670691124798578910e-10 3.055948698284136226e-14 5.511521606426478259e-01 -4.470602238498087955e-10 2.670190974984219084e-14 5.511521606043001675e-01 -4.849816101234730956e-10 1.881734397047649948e-14 5.511521605645497424e-01 -5.244019565458765822e-10 6.848315824402185411e-15 5.511521605361351384e-01 -5.525387524295642391e-10 -7.970949832535806704e-15 5.511521605229066090e-01 -5.655702269558547150e-10 -2.401297788694916441e-14 5.511521605219671383e-01 -5.664081883056827597e-10 -4.020560570115509958e-14 5.511521605243800970e-01 -5.639371522741663552e-10 -5.615660229888873501e-14 5.511521605243902000e-01 -5.639065875929313819e-10 -7.235465832132638097e-14 5.511521605148115288e-01 -5.737125582133833547e-10 -9.131141441520345948e-14 5.511521604806493002e-01 -6.092108032682453544e-10 -1.212983127442095091e-13 5.511521603820440651e-01 -7.133798737363403039e-10 -2.065899009003471450e-13 5.511521600087539996e-01 -1.113738936093074340e-09 -1.496965072017529434e-12 5.511521539953936344e-01 -7.678116295891208622e-09 -4.132195925691880615e-13 5.511521592652286472e-01 -2.034536260167014977e-09 -9.615772609164400011e-14 5.511521606701681453e-01 -4.433103971523875891e-10 -6.860621249513628218e-14 5.511521607924559918e-01 -3.007679353230842257e-10 -6.088006702337816015e-14 5.511521608284992713e-01 -2.591050745607201308e-10 -5.675872842192616592e-14 5.511521608478064937e-01 -2.378952327816368375e-10 -5.350940247060376818e-14 5.511521608619209811e-01 -2.232553292499120959e-10 -5.052553747740121672e-14 5.511521608735919786e-01 -2.116508920568673862e-10 -4.770256290167810643e-14 5.511521608835915353e-01 -2.019636412335477717e-10 -4.508041068438395000e-14 5.511521608921337023e-01 -1.938016975610461423e-10 -4.273834642267218804e-14 5.511521608992616672e-01 -1.870313905241016753e-10 -4.076045882233638897e-14 5.511521609049696568e-01 -1.816176561476259735e-10 -3.921989361211152912e-14 5.511521609092381313e-01 -1.775656648240360515e-10 -3.817119272961116851e-14 5.511521609120435539e-01 -1.748975368797114259e-10 -3.765790623937522106e-14 5.511521609133498423e-01 -1.736513911691102240e-10 4.262555736773414009e-11 -1.932791803252088017e-08 5.511521431552240946e-01 3.959258601467870361e-11 -1.842985203714219561e-08 5.511521438523986349e-01 3.629165640941322936e-11 -1.784806414007445652e-08 5.511521441993181281e-01 3.246464545557152187e-11 -1.740864041748814177e-08 5.511521444086970867e-01 2.803804212499793282e-11 -1.697598953619772560e-08 5.511521446374240130e-01 2.315503014712594746e-11 -1.647299248038956659e-08 5.511521449705404363e-01 1.808861792606652837e-11 -1.587002688507245660e-08 5.511521454375551965e-01 1.313760000857970319e-11 -1.516484220833158792e-08 5.511521460369592784e-01 8.559756697802202907e-12 -1.436873328027675065e-08 5.511521467528360807e-01 4.541687347149083540e-12 -1.349865698003885018e-08 5.511521475639502565e-01 1.193318481874178999e-12 -1.257334848870582290e-08 5.511521484479856570e-01 -1.444224997542120595e-12 -1.161071109999093519e-08 5.511521493841342600e-01 -3.384435541045491505e-12 -1.062727936971972972e-08 5.511521503534861921e-01 -4.680539007707846253e-12 -9.638206314670413377e-09 5.511521513388610849e-01 -5.411950159739711089e-12 -8.657260536095541112e-09 5.511521523246352139e-01 -5.672541777108141882e-12 -7.696475176910638728e-09 5.511521532969401171e-01 -5.561013586184473846e-12 -6.765884462595390244e-09 5.511521542438485577e-01 -5.173539483634930625e-12 -5.873433249789491483e-09 5.511521551554465770e-01 -4.598581909494709728e-12 -5.024974112264690832e-09 5.511521560237873096e-01 -3.914014535243330518e-12 -4.224735367935752051e-09 5.511521568423191075e-01 -3.190368231954326373e-12 -3.480696297599475380e-09 5.511521576008989731e-01 -2.488528302186609467e-12 -2.803409549670527553e-09 5.511521582883892600e-01 -1.855847626806525961e-12 -2.203944734996069901e-09 5.511521588939367611e-01 -1.308878001562463831e-12 -1.673089449330466043e-09 5.511521594267930757e-01 -8.609892944358017396e-13 -1.210741652914280762e-09 5.511521598876212291e-01 -5.224387999916249551e-13 -8.282140860602899075e-10 5.511521602673571385e-01 -2.862041906915919046e-13 -5.268512462053545184e-10 5.511521605666848123e-01 -1.309179285689420661e-13 -2.905852836065203348e-10 5.511521608016716200e-01 -4.081083041258977245e-14 -1.148299578408345213e-10 5.511521609761225182e-01 -1.732985435123424839e-14 -6.603748592652048159e-11 5.511521610240714963e-01 -5.117504863960055656e-15 -2.920643345013642296e-11 5.511521610601478605e-01 2.926070273396778050e-16 3.112027914878660870e-12 5.511521610923195702e-01 1.576411530976983358e-16 4.703150989914121743e-12 5.511521610940761651e-01 2.955302216200349800e-16 -2.059765475810521031e-11 5.511521610688698836e-01 2.309029279894106175e-15 -4.799854125100212152e-11 5.511521610415325290e-01 1.709863680682179991e-13 -2.509051182721895728e-09 5.511521585535271717e-01 3.445445739681572810e-14 -4.670691124798578910e-10 5.511521606210485480e-01 3.058132650639365307e-14 -4.470602238498087955e-10 5.511521606420095587e-01 2.669601949747156468e-14 -4.849816101234730956e-10 5.511521606045148847e-01 1.880169311320351904e-14 -5.244019565458765822e-10 5.511521605654240430e-01 6.839485446582324286e-15 -5.525387524295642391e-10 5.511521605375638844e-01 -7.958182979860916456e-15 -5.655702269558547150e-10 5.511521605247279298e-01 -2.397007547539137048e-14 -5.664081883056827597e-10 5.511521605239888544e-01 -4.012939623684019864e-14 -5.639371522741663552e-10 5.511521605265149448e-01 -5.604826027804925671e-14 -5.639065875929313819e-10 5.511521605265653490e-01 -7.224557366331130988e-14 -5.737125582133833547e-10 5.511521605165384807e-01 -9.138204249295920117e-14 -6.092108032682453544e-10 5.511521604797059437e-01 -1.223416652687031986e-13 -7.133798737363403039e-10 5.511521603698249505e-01 -2.129830045377929158e-13 -1.113738936093074340e-09 5.511521599408547578e-01 -1.620522254705928785e-12 -7.678116295891208622e-09 5.511521527761804595e-01 -4.615408026704069298e-13 -2.034536260167014977e-09 5.511521588141504724e-01 -1.022567635012034642e-13 -4.433103971523875891e-10 5.511521606156217779e-01 -6.985228057420778234e-14 -3.007679353230842257e-10 5.511521607817093660e-01 -6.069044405931200307e-14 -2.591050745607201308e-10 5.511521608301895858e-01 -5.604148932928016319e-14 -2.378952327816368375e-10 5.511521608539110550e-01 -5.261969644949252592e-14 -2.232553292499120959e-10 5.511521608694429641e-01 -4.962574337582342192e-14 -2.116508920568673862e-10 5.511521608812244288e-01 -4.686381589154660389e-14 -2.019636412335477717e-10 5.511521608907696823e-01 -4.432698032424932218e-14 -1.938016975610461423e-10 5.511521608986720278e-01 -4.206923026706256500e-14 -1.870313905241016753e-10 5.511521609051698301e-01 -4.016221051937299026e-14 -1.816176561476259735e-10 5.511521609103483543e-01 -3.867312123854241278e-14 -1.775656648240360515e-10 5.511521609142224776e-01 -3.765802768316938033e-14 -1.748975368797114259e-10 5.511521609167769897e-01 -3.716031591300322923e-14 -1.736513911691102240e-10 5.511521609179733661e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 new file mode 100644 index 000000000..ceb741065 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 @@ -0,0 +1 @@ +1.708232349966676278e-02 6.712673933944084614e-05 6.670490751617054622e-05 1.706599159884072958e-02 6.688355564912015652e-05 6.637433952491531540e-05 1.703308120092475800e-02 6.642990591901372518e-05 6.577452182494018936e-05 1.698309393758010502e-02 6.577055582441606338e-05 6.490808747120525586e-05 1.691526903834774179e-02 6.491118208676439720e-05 6.377949867385709101e-05 1.682856727250368542e-02 6.383726392716237074e-05 6.239853822813383629e-05 1.672164917790415831e-02 6.253456107962119452e-05 6.077595888481588927e-05 1.659284729482567167e-02 6.099386016594198363e-05 5.892224887749566834e-05 1.644013201841195912e-02 5.920486378331775174e-05 5.684839938957464368e-05 1.626107059944004521e-02 5.715647319323930494e-05 5.456559333495372309e-05 1.605277875717793165e-02 5.483741667379863109e-05 5.208514464834468035e-05 1.581186430657722380e-02 5.223662762683650837e-05 4.941784644987245832e-05 1.553436216702992756e-02 4.934375124363112378e-05 4.657347408863019987e-05 1.521566013234458559e-02 4.614997694621620039e-05 4.356063478110268496e-05 1.485041486765758222e-02 4.265007781319608561e-05 4.038763688104381156e-05 1.443245780425995474e-02 3.884484770870763522e-05 3.706341840632874956e-05 1.395469098874177125e-02 3.474270714561701970e-05 3.359790345405595568e-05 1.340897360099873800e-02 3.036295719361688109e-05 3.000406576814274869e-05 1.278600091314905166e-02 2.574125127001431992e-05 2.630179707588773286e-05 1.207517910811056749e-02 2.107281202670538561e-05 2.256006828616379642e-05 1.126450180525668046e-02 1.700339210984125595e-05 1.899385425418969708e-05 1.034043732653437513e-02 1.364408613379187156e-05 1.569715472096673003e-05 9.287841392658211306e-03 1.100554430440322634e-05 1.273639993188865319e-05 8.089916112834796141e-03 9.058541791075999444e-06 1.016265456382313703e-05 6.728245334855066304e-03 7.729031298280898845e-06 8.005805647789357115e-06 5.182947974605629955e-03 6.611123170440782486e-06 6.212737479571106821e-06 3.433005461494493052e-03 5.361067300634107262e-06 4.714317125562671372e-06 1.456837807813450569e-03 4.113517247114451168e-06 3.527307633424048134e-06 -7.520971974839577544e-04 3.027279116165919205e-06 2.673317792100992211e-06 -2.947903667069822538e-03 2.278755311982207430e-06 2.177552129539345696e-06 -4.957269617621875776e-03 2.068376839382254023e-06 2.067826892935536942e-06 -6.694222249269812797e-03 2.423463170828646173e-06 2.344498366627974092e-06 -8.071099556765810520e-03 3.227461795329263752e-06 2.978654104252142986e-06 -9.155132398603774840e-03 4.351809093782741712e-06 3.929788466155123424e-06 -1.006009652310661286e-02 5.663792834050860026e-06 5.149443799977213807e-06 -1.071925651401983183e-02 7.033938500042092466e-06 6.585301851041656568e-06 -1.093833351444793191e-02 8.451557750443082883e-06 8.191676068944274731e-06 -1.068781674431596232e-02 9.979659875180914126e-06 9.927826179453317889e-06 -1.019989019792669552e-02 1.160475361483386489e-05 1.174986673785311367e-05 -9.573289389085607934e-03 1.331208584326821932e-05 1.361713999158218813e-05 -8.777454647229098947e-03 1.508653709590008589e-05 1.549352281299089655e-05 -7.675400594854039915e-03 1.691271410777238257e-05 1.734757122092378762e-05 -6.285966251271946428e-03 1.877255290948800937e-05 1.915609068954092018e-05 -4.768488987046302745e-03 2.062211026429424342e-05 2.093283441257885939e-05 -3.406960721872945210e-03 2.243522927932745188e-05 2.266975792919903278e-05 -2.209829954633037510e-03 2.419485336804977720e-05 2.435138878675027223e-05 -1.164256854547730553e-03 2.588628400585071682e-05 2.596430959862052113e-05 -2.509163564554965295e-04 2.749721923945775263e-05 2.749725084437823591e-05 5.585826606644436840e-04 2.901819265002557666e-05 2.894153008617759897e-05 1.274823091556380331e-03 3.044221675263042575e-05 3.029077494801766225e-05 1.906239551755201534e-03 3.176438769101786884e-05 3.154060024463131533e-05 2.460826088495756889e-03 3.298171410347169625e-05 3.268846528258117698e-05 2.945870918914990713e-03 3.409304206655566321e-05 3.373360845457759897e-05 3.358810193096657421e-03 3.509873825519548956e-05 3.467675278780927276e-05 3.698385055419625700e-03 3.599998780293596343e-05 3.551976637186104210e-05 3.975394962818158684e-03 3.679196161501615848e-05 3.626638767929191598e-05 4.199531243625499385e-03 3.747691173340030984e-05 3.692057952801714018e-05 4.379056322358608651e-03 3.806125599662120651e-05 3.748585618187477144e-05 4.520915678877454602e-03 3.855107877581251028e-05 3.796552337579544092e-05 4.630845227116132945e-03 3.895194574303753387e-05 3.836258120335269415e-05 4.713468684102874347e-03 3.926876319321446769e-05 3.867965677202616856e-05 4.772381536031781481e-03 3.950565685880038622e-05 3.891894198510531788e-05 4.810219585267649575e-03 3.966586887613983344e-05 3.908213397284631524e-05 4.828710953851045838e-03 3.975174197457888357e-05 3.917045483323974207e-05 1.817959172901466443e-11 5.511521402137409265e-01 -1.934267196095108421e-08 1.715816848245907422e-11 5.511521413437642236e-01 -1.844462767040880423e-08 1.630198897451969554e-11 5.511521421954768130e-01 -1.786285891502244586e-08 1.546635094248336895e-11 5.511521428934766931e-01 -1.742340218289289816e-08 1.453046919435925661e-11 5.511521435495355670e-01 -1.699059859405107007e-08 1.342787589726266628e-11 5.511521442344756716e-01 -1.648725236084111931e-08 1.214471766993066708e-11 5.511521449805477646e-01 -1.588366693656065501e-08 1.070496214265862917e-11 5.511521457958226122e-01 -1.517753423601151218e-08 9.157006104515838413e-12 5.511521466750007869e-01 -1.438012275311532661e-08 7.562525008646765753e-12 5.511521476062241076e-01 -1.350840699241152112e-08 5.987309921736836116e-12 5.511521485747746807e-01 -1.258119216644426902e-08 4.493400358799021097e-12 5.511521495658294745e-01 -1.161650602365409030e-08 3.133668902205495841e-12 5.511521505652312580e-01 -1.063105628167230057e-08 1.948164388993238073e-12 5.511521515597395116e-01 -9.640204128084713602e-09 9.621522406368090087e-13 5.511521525372569119e-01 -8.657940522721284656e-09 1.858290040383143854e-13 5.511521534873716766e-01 -7.696509053497173256e-09 -3.843425656414447816e-13 5.511521544017412566e-01 -6.766113691078879279e-09 -7.631635270795560582e-13 5.511521552742427721e-01 -5.874799889879429891e-09 -9.736386839662992956e-13 5.511521561010604975e-01 -5.028426627142446109e-09 -1.043885547378631685e-12 5.511521568803569027e-01 -4.231115490226015247e-09 -1.005962480806071699e-12 5.511521576065404604e-01 -3.490616973776464584e-09 -8.943674317681705798e-13 5.511521582700021904e-01 -2.817145039940886538e-09 -7.427981943483676249e-13 5.511521588598663479e-01 -2.221348414685849684e-09 -5.742842588350599631e-13 5.511521593857481305e-01 -1.693554839309210160e-09 -4.095276865937943067e-13 5.511521598476469830e-01 -1.233220298243455396e-09 -2.675691408359044481e-13 5.511521602323027347e-01 -8.512984840386142132e-10 -1.576186549459351691e-13 5.511521605364754217e-01 -5.489102213024452650e-10 -7.806478071963261313e-14 5.511521607763735231e-01 -3.099361531387873750e-10 -2.695742075210912849e-14 5.511521609587466397e-01 -1.286836669996377391e-10 -1.181209946756317522e-14 5.511521610147095407e-01 -7.366644678268270889e-11 -3.455288753729757644e-15 5.511521610570513374e-01 -3.226997733458114363e-11 1.387428024798480804e-16 5.511521610920301351e-01 2.459591165551820557e-12 2.990135122441377084e-17 5.511521610941021443e-01 4.696578060058418760e-12 6.862967081380124879e-16 5.511521610685371497e-01 -2.075798713614003394e-11 3.021167872133130111e-15 5.511521610407880134e-01 -4.844406965360940077e-11 2.030780902439223876e-13 5.511521586065332157e-01 -2.509364734022321120e-09 4.149055008502228342e-14 5.511521606238458659e-01 -4.668122875828121212e-10 3.777119309933092226e-14 5.511521606432117082e-01 -4.464899601955411577e-10 3.396767370647672329e-14 5.511521606048007671e-01 -4.844636845337691356e-10 2.517834008715204214e-14 5.511521605648480593e-01 -5.240920998188742714e-10 1.107413370226291463e-14 5.511521605362114107e-01 -5.524620298479828344e-10 -7.185184745191947675e-15 5.511521605229431353e-01 -5.655303020775093994e-10 -2.775065901318032248e-14 5.511521605226323839e-01 -5.657271719152777481e-10 -4.938176415142497903e-14 5.511521605263790535e-01 -5.619299171472131937e-10 -7.166075318172712669e-14 5.511521605282305725e-01 -5.600890655977344089e-10 -9.535557628011155589e-14 5.511521605207515551e-01 -5.678384890048607467e-10 -1.240966755091123706e-13 5.511521604886981951e-01 -6.012596034386217838e-10 -1.700050895544190617e-13 5.511521603921374357e-01 -7.033741311366347891e-10 -2.994415874821451287e-13 5.511521600205605553e-01 -1.101945444860965601e-09 -2.252756391139398523e-12 5.511521540084718396e-01 -7.664911142678275440e-09 -6.352010409027822892e-13 5.511521592791303048e-01 -2.020319631022494617e-09 -1.475447064921005898e-13 5.511521606844924648e-01 -4.284676632627916839e-10 -1.061960523368612223e-13 5.511521608065924616e-01 -2.859552896878218516e-10 -9.608788921546297265e-14 5.511521608419105434e-01 -2.449490509889375123e-10 -9.176821357975784458e-14 5.511521608604195155e-01 -2.245382612247591430e-10 -8.885822290289893206e-14 5.511521608737206535e-01 -2.107624340942649344e-10 -8.631228347633129129e-14 5.511521608845943998e-01 -2.000355433628559918e-10 -8.388394623239646726e-14 5.511521608938392269e-01 -1.911952813721230759e-10 -8.156496602587800504e-14 5.511521609016929446e-01 -1.838130589050837112e-10 -7.943530124067115713e-14 5.511521609082190576e-01 -1.777262501278581958e-10 -7.759051435762920425e-14 5.511521609134284461e-01 -1.728785311564917800e-10 -7.612702407493218625e-14 5.511521609173136715e-01 -1.692606920780024897e-10 -7.512652740407383361e-14 5.511521609198594129e-01 -1.668859868406682589e-10 -7.465371417297480828e-14 5.511521609210348061e-01 -1.657876541768426392e-10 1.685710831026280571e-11 -1.934267196095108421e-08 5.511521431399407644e-01 1.603815676582165254e-11 -1.844462767040880423e-08 5.511521438370858839e-01 1.542021691792142629e-11 -1.786285891502244586e-08 5.511521441839717372e-01 1.481518534910445233e-11 -1.742340218289289816e-08 5.511521443933646847e-01 1.407915375106537065e-11 -1.699059859405107007e-08 5.511521446222237275e-01 1.313748089238150580e-11 -1.648725236084111931e-08 5.511521449556712193e-01 1.197668296051709733e-11 -1.588366693656065501e-08 5.511521454232949369e-01 1.062495198250415445e-11 -1.517753423601151218e-08 5.511521460236483705e-01 9.136087735939556900e-12 -1.438012275311532661e-08 5.511521467408457831e-01 7.577274000213827370e-12 -1.350840699241152112e-08 5.511521475536379500e-01 6.019561661049463671e-12 -1.258119216644426902e-08 5.511521484396403325e-01 4.529897558348316408e-12 -1.161650602365409030e-08 5.511521493779193426e-01 3.165646967205888878e-12 -1.063105628167230057e-08 5.511521503493875818e-01 1.970840051217073628e-12 -9.640204128084713602e-09 5.511521513366484104e-01 9.740860311300255639e-13 -8.657940522721284656e-09 5.511521523238442910e-01 1.881439668883626948e-13 -7.696509053497173256e-09 5.511521532968822745e-01 -3.888583963164798194e-13 -6.766113691078879279e-09 5.511521542436504939e-01 -7.710054264008373829e-13 -5.874799889879429891e-09 5.511521551541210817e-01 -9.814852283150440017e-13 -5.028426627142446109e-09 5.511521560203321846e-01 -1.049391163468972314e-12 -4.231115490226015247e-09 5.511521568358368484e-01 -1.008243548078872404e-12 -3.490616973776464584e-09 5.511521575907282200e-01 -8.936976243800850408e-13 -2.817145039940886538e-09 5.511521582742288095e-01 -7.401157450435895589e-13 -2.221348414685849684e-09 5.511521588759440426e-01 -5.709229460472436724e-13 -1.693554839309210160e-09 5.511521594056358886e-01 -4.067458614197352831e-13 -1.233220298243455396e-09 5.511521598644624209e-01 -2.657755113375785837e-13 -8.512984840386142132e-10 5.511521602437559064e-01 -1.564826598800243097e-13 -5.489102213024452650e-10 5.511521605444136274e-01 -7.730192614386982948e-14 -3.099361531387873750e-10 5.511521607824628743e-01 -2.655600615384577944e-14 -1.286836669996377391e-10 5.511521609626086615e-01 -1.165347377984996390e-14 -7.366644678268270889e-11 5.511521610167071650e-01 -3.448321636627680464e-15 -3.226997733458114363e-11 5.511521610571775698e-01 1.287642411075479133e-16 2.459591165551820557e-12 5.511521610916626512e-01 2.973561146243910029e-17 4.696578060058418760e-12 5.511521610940653959e-01 6.832732329645033568e-16 -2.075798713614003394e-11 5.511521610687242223e-01 3.011476514933773169e-15 -4.844406965360940077e-11 5.511521610411019845e-01 2.052467879022802596e-13 -2.509364734022321120e-09 5.511521585532203060e-01 4.160367854027873717e-14 -4.668122875828121212e-10 5.511521606213025670e-01 3.779760686503868085e-14 -4.464899601955411577e-10 5.511521606425863196e-01 3.395891488868462112e-14 -4.844636845337691356e-10 5.511521606050507893e-01 2.515678417914779215e-14 -5.240920998188742714e-10 5.511521605657458966e-01 1.105979810311886012e-14 -5.524620298479828344e-10 5.511521605376410449e-01 -7.173407070718241760e-15 -5.655303020775093994e-10 5.511521605247715616e-01 -2.770066393299722025e-14 -5.657271719152777481e-10 5.511521605246859634e-01 -4.928742847476661447e-14 -5.619299171472131937e-10 5.511521605285305547e-01 -7.152475706751673963e-14 -5.600890655977344089e-10 5.511521605303600913e-01 -9.522234104127251949e-14 -5.678384890048607467e-10 5.511521605223473896e-01 -1.242139605007993229e-13 -6.012596034386217838e-10 5.511521604875605496e-01 -1.715091723795854443e-13 -7.033741311366347891e-10 5.511521603797437940e-01 -3.088111574784731553e-13 -1.101945444860965601e-09 5.511521599526352233e-01 -2.438981788062160099e-12 -7.664911142678275440e-09 5.511521527895137940e-01 -7.099057232423970088e-13 -2.020319631022494617e-09 5.511521588286892870e-01 -1.570302911872788532e-13 -4.284676632627916839e-10 5.511521606310016974e-01 -1.079574570920006682e-13 -2.859552896878218516e-10 5.511521607972305059e-01 -9.546844457290758040e-14 -2.449490509889375123e-10 5.511521608451317444e-01 -9.022999584327202942e-14 -2.245382612247591430e-10 5.511521608680559625e-01 -8.699772883429120328e-14 -2.107624340942649344e-10 5.511521608826698282e-01 -8.441882646849042296e-14 -2.000355433628559918e-10 5.511521608934868421e-01 -8.209669183768376646e-14 -1.911952813721230759e-10 5.511521609020851864e-01 -7.993864699931289145e-14 -1.838130589050837112e-10 5.511521609091093454e-01 -7.797154060263277748e-14 -1.777262501278581958e-10 5.511521609148362089e-01 -7.626721588367134837e-14 -1.728785311564917800e-10 5.511521609193771321e-01 -7.491126157325592999e-14 -1.692606920780024897e-10 5.511521609227634233e-01 -7.398016895919274784e-14 -1.668859868406682589e-10 5.511521609249890874e-01 -7.354053030042744017e-14 -1.657876541768426392e-10 5.511521609260200405e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 new file mode 100644 index 000000000..2ebdccfd3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 @@ -0,0 +1 @@ +1.713477698953392095e-02 6.712673775002379873e-05 6.670490604346691400e-05 1.711912395300437331e-02 6.688355408266165932e-05 6.637433806170960592e-05 1.708758341762308883e-02 6.642990430482690006e-05 6.577452029893566046e-05 1.703968153973756117e-02 6.577055411447303094e-05 6.490808583398467756e-05 1.697469499491697370e-02 6.491118025660798233e-05 6.377949690114623378e-05 1.689163571938829406e-02 6.383726197460965434e-05 6.239853631829441643e-05 1.678923022575696741e-02 6.253455902170674098e-05 6.077595685576170495e-05 1.666589322524608674e-02 6.099385803475986456e-05 5.892224676253725242e-05 1.651969519008901141e-02 5.920486162104448197e-05 5.684839723245865259e-05 1.634832341028488040e-02 5.715647104692072065e-05 5.456559118459836951e-05 1.614903603370955454e-02 5.483741459042181828e-05 5.208514255383608601e-05 1.591860851707095278e-02 5.223662564930893742e-05 4.941784445633009643e-05 1.565327187588112443e-02 4.934374940778831246e-05 4.657347223407157217e-05 1.534864212308078776e-02 4.614997527894333358e-05 4.356063309442787798e-05 1.499964035192833008e-02 4.265007633163073371e-05 4.038763538110884936e-05 1.460040308791880383e-02 3.884484642047150911e-05 3.706341710206697692e-05 1.414418286325435335e-02 3.474270604981524599e-05 3.359790234541154297e-05 1.362323953760866992e-02 3.036295628236232607e-05 3.000406484756791407e-05 1.302872381339576641e-02 2.574125053017993123e-05 2.630179633012437443e-05 1.235055585912742462e-02 2.107281144166487551e-05 2.256006769803412329e-05 1.157730409140364167e-02 1.700339166031601226e-05 1.899385380357505721e-05 1.069607185959152960e-02 1.364408579865978942e-05 1.569715438592646288e-05 9.692405280355864683e-03 1.100554406198933742e-05 1.273639969009743005e-05 8.550240564918900471e-03 9.058541622376074334e-06 1.016265439579070438e-05 7.251917752842354514e-03 7.729031186334246267e-06 8.005805536277200253e-06 5.778298234705885224e-03 6.611123099766791975e-06 6.212737409105982776e-06 4.109036756284921779e-03 5.361067258463725797e-06 4.714317083530700172e-06 2.223073242483456814e-03 4.113517224350351772e-06 3.527307610817089443e-06 9.942739863833427883e-05 3.027279106202265565e-06 2.673317782284505463e-06 -2.136193067527132096e-03 2.278755307034543566e-06 2.177552124685150647e-06 -4.220097605988774696e-03 2.068376837541075022e-06 2.067826891116833114e-06 -6.065891327715239832e-03 2.423463170805375637e-06 2.344498366600760618e-06 -7.586534911913248719e-03 3.227461795458096616e-06 2.978654104380614167e-06 -8.750576523709887450e-03 4.351809093334847630e-06 3.929788465709140248e-06 -9.725386246142055449e-03 5.663792833340972724e-06 5.149443799269060382e-06 -1.050152072281932206e-02 7.033938479332243632e-06 6.585301830109927454e-06 -1.091022146711084426e-02 8.451557749966484548e-06 8.191676068466382130e-06 -1.084346563277923184e-02 9.979659877982389202e-06 9.927826182256886830e-06 -1.042176568050747452e-02 1.160475362091818895e-05 1.174986674393535572e-05 -9.855496697486391608e-03 1.331208585255742637e-05 1.361714000086276391e-05 -9.154233241011175762e-03 1.508653710834979309e-05 1.549352282542389010e-05 -8.195205069123065456e-03 1.691271412306968579e-05 1.734757123619640152e-05 -6.934572091581161016e-03 1.877255292718740654e-05 1.915609070720879079e-05 -5.435054286739417727e-03 2.062211028415544825e-05 2.093283443240262197e-05 -4.006612047362821671e-03 2.243522930129911044e-05 2.266975795112929855e-05 -2.746369879701437804e-03 2.419485339242510182e-05 2.435138881109051953e-05 -1.642343815866283271e-03 2.588628403371263234e-05 2.596430962650196246e-05 -6.807533561223263769e-04 2.749721927410573699e-05 2.749725087931558366e-05 1.664203690111292931e-04 2.901819270660126196e-05 2.894153014447893094e-05 9.168864875246272254e-04 3.044221715198048019e-05 3.029077538026310516e-05 1.579114389357641566e-03 3.176438780200338297e-05 3.154060036849625680e-05 2.161211874356697409e-03 3.298171413052055500e-05 3.268846531129919209e-05 2.670772713174267548e-03 3.409304208684569372e-05 3.373360847525251448e-05 3.113434949287211765e-03 3.509873827412183768e-05 3.467675280672836351e-05 3.482645690879011911e-03 3.599998782147271028e-05 3.551976639023328160e-05 3.784680935669635423e-03 3.679196163338822856e-05 3.626638769743280706e-05 4.029752677833396343e-03 3.747691175163199608e-05 3.692057954599483851e-05 4.226590240376074635e-03 3.806125601469392838e-05 3.748585619969360027e-05 4.382546946290049109e-03 3.855107879369893911e-05 3.796552339344244403e-05 4.503705523839223943e-03 3.895194576073235707e-05 3.836258122082171869e-05 4.594975519269350016e-03 3.926876321072726012e-05 3.867965678932559678e-05 4.660178383866506353e-03 3.950565687616044844e-05 3.891894200226360330e-05 4.702117553571557966e-03 3.966586889339530404e-05 3.908213398990547071e-05 4.722631938629855836e-03 3.975174199178632402e-05 3.917045485025554300e-05 1.659017468630103125e-11 5.511521402053181085e-01 -1.935160320882036856e-08 1.559170998527053015e-11 5.511521413354139032e-01 -1.845348709861994639e-08 1.468780214748485002e-11 5.511521421872837001e-01 -1.787156165087343942e-08 1.375640791083813917e-11 5.511521428855480353e-01 -1.743183928294362866e-08 1.270031277402381138e-11 5.511521435420060344e-01 -1.699863149610558955e-08 1.147532318584934073e-11 5.511521442275051363e-01 -1.649471473608626031e-08 1.008680321497333630e-11 5.511521449743105316e-01 -1.589037525966716719e-08 8.573780020719129758e-12 5.511521457904885457e-01 -1.518330707655132023e-08 6.994732834770471642e-12 5.511521466707094419e-01 -1.438480734731076972e-08 5.416206422366364323e-12 5.511521476030548650e-01 -1.351191027174761311e-08 3.903933107049085838e-12 5.511521485727168823e-01 -1.258351225889758274e-08 2.515872784574653000e-12 5.511521495647572211e-01 -1.161775955796313093e-08 1.297826091793800550e-12 5.511521505648868668e-01 -1.063149674514378448e-08 2.808915208646122081e-13 5.511521515597306298e-01 -9.640227066485009197e-09 -5.194131120001689301e-13 5.511521525370688401e-01 -8.658072459741522047e-09 -1.102407123038785162e-12 5.511521534863973448e-01 -7.697378519813512721e-09 -1.480144341405881292e-12 5.511521543993270766e-01 -6.768404532479990080e-09 -1.674418082786696955e-12 5.511521552697495885e-01 -5.879188854068157681e-09 -1.713473071332322489e-12 5.511521560939344200e-01 -5.035508879072788943e-09 -1.628926056990774118e-12 5.511521568702071328e-01 -4.241322961291501020e-09 -1.455487723419839249e-12 5.511521575932145645e-01 -3.504138191036157724e-09 -1.229499513773631641e-12 5.511521582536325070e-01 -2.833867572158170867e-09 -9.852120836687679869e-13 5.511521588408871963e-01 -2.240830050665222392e-09 -7.429841832855307579e-13 5.511521593648787132e-01 -1.715031458081818526e-09 -5.214743397658997073e-13 5.511521598258385390e-01 -1.255656434667987616e-09 -3.382431314221100330e-13 5.511521602106526085e-01 -8.734814911817993375e-10 -1.997890364428741830e-13 5.511521605161356918e-01 -5.695709704157088273e-10 -1.008288804299350728e-13 5.511521607584647375e-01 -3.278840603390017767e-10 -3.692107454942065996e-14 5.511521609445070302e-01 -1.427152896041513295e-10 -1.675976327913841342e-14 5.511521610061183019e-01 -8.200918286973899295e-11 -5.296467658449921734e-15 5.511521610529886983e-01 -3.619232072030148591e-11 1.154722451806042521e-16 5.511521610907639257e-01 1.223296483280825981e-12 1.587342513670089686e-16 5.511521610939605909e-01 4.549788750706598670e-12 2.384025213466439690e-16 5.511521610685204964e-01 -2.077105414537354572e-11 2.311280662034517475e-15 5.511521610405907268e-01 -4.863229818108253414e-11 1.823682413018444021e-13 5.511521586062358979e-01 -2.509655227198275826e-09 4.101395123826436280e-14 5.511521606237905768e-01 -4.668666714032849381e-10 4.057266825536399084e-14 5.511521606435340059e-01 -4.461679569773115205e-10 4.005199738490519439e-14 5.511521606051706934e-01 -4.840841330481253406e-10 3.446754679459731603e-14 5.511521605651396039e-01 -5.237870176364415893e-10 2.352384121665701243e-14 5.511521605363755016e-01 -5.522914281458247401e-10 8.112118310231518127e-15 5.511521605229702248e-01 -5.655036047575591453e-10 -1.005126219709777004e-14 5.511521605226799014e-01 -5.656761358222706785e-10 -2.952055948801385837e-14 5.511521605268293600e-01 -5.614701909029006683e-10 -4.968909387755774331e-14 5.511521605294102955e-01 -5.589064285028748551e-10 -7.098025024522084237e-14 5.511521605228754117e-01 -5.657299300762512336e-10 -9.623475983860923062e-14 5.511521604918324657e-01 -5.981629218416102146e-10 -1.353571061709359288e-13 5.511521603962505900e-01 -6.993123764450517217e-10 -2.428659036070826300e-13 5.511521600255566700e-01 -1.096990852780888798e-09 -1.853406337801639187e-12 5.511521540141353093e-01 -7.659247849084998999e-09 -5.242155258709628255e-13 5.511521592852222096e-01 -2.014157947663624812e-09 -1.204958479626876181e-13 5.511521606907894277e-01 -4.220132240560907281e-10 -8.590602510272594618e-14 5.511521608129116290e-01 -2.793886168842412695e-10 -7.716154169948040534e-14 5.511521608479372780e-01 -2.386119670614415495e-10 -7.323146648713172718e-14 5.511521608660052696e-01 -2.186174224072553064e-10 -7.048615283729345257e-14 5.511521608788687576e-01 -2.052828980019744479e-10 -6.808059998929272578e-14 5.511521608893266144e-01 -1.949944534203251546e-10 -6.581122296416141796e-14 5.511521608981893028e-01 -1.865688648450702272e-10 -6.367853626730804039e-14 5.511521609057032922e-01 -1.795616943757476789e-10 -6.174047668696540826e-14 5.511521609119387488e-01 -1.737987841189906866e-10 -6.007772443307350536e-14 5.511521609169115488e-01 -1.692160301143297319e-10 -5.876696219799887713e-14 5.511521609206172512e-01 -1.657994888612208013e-10 -5.787105953067175665e-14 5.511521609230425334e-01 -1.635598896112065293e-10 -5.744627176694154665e-14 5.511521609241575304e-01 -1.625293259229893996e-10 1.538440467207404895e-11 -1.935160320882036856e-08 5.511521431304704510e-01 1.457495104972140615e-11 -1.845348709861994639e-08 5.511521438276864027e-01 1.389421238997405903e-11 -1.787156165087343942e-08 5.511521441747276873e-01 1.317796477385941533e-11 -1.743183928294362866e-08 5.511521443843865331e-01 1.230644289504629872e-11 -1.699863149610558955e-08 5.511521446136538049e-01 1.122764147354828434e-11 -1.649471473608626031e-08 5.511521449476823875e-01 9.947628778482634541e-12 -1.589037525966716719e-08 5.511521454160800415e-01 8.509993568922793114e-12 -1.518330707655132023e-08 5.511521460174007014e-01 6.978971743255363861e-12 -1.438480734731076972e-08 5.511521467357319848e-01 5.426918648450093845e-12 -1.351191027174761311e-08 5.511521475497654921e-01 3.925053067723695523e-12 -1.258351225889758274e-08 5.511521484370245361e-01 2.536355198245511111e-12 -1.161775955796313093e-08 5.511521493764539592e-01 1.311088341005534557e-12 -1.063149674514378448e-08 5.511521503488242546e-01 2.841652421099741529e-13 -9.640227066485009197e-09 5.511521513365893465e-01 -5.258489310286736654e-13 -8.658072459741522047e-09 5.511521523237516984e-01 -1.116117804825003115e-12 -7.697378519813512721e-09 5.511521532961064507e-01 -1.497502806237437836e-12 -6.768404532479990080e-09 5.511521542414766772e-01 -1.691580261605742732e-12 -5.879188854068157681e-09 5.511521551498339555e-01 -1.727248585981737581e-12 -5.035508879072788943e-09 5.511521560132934816e-01 -1.637520836535352060e-12 -4.241322961291501020e-09 5.511521568255713932e-01 -1.458858188853701943e-12 -3.504138191036157724e-09 5.511521575770088610e-01 -1.228737891821798441e-12 -2.833867572158170867e-09 5.511521582571458078e-01 -9.819069675751142093e-13 -2.240830050665222392e-09 5.511521588559465945e-01 -7.389553782908963340e-13 -1.715031458081818526e-09 5.511521593835343458e-01 -5.182580188763215688e-13 -1.255656434667987616e-09 5.511521598413805512e-01 -3.362406351383427082e-13 -8.734814911817993375e-10 5.511521602210268655e-01 -1.985146312986772384e-13 -5.695709704157088273e-10 5.511521605234268595e-01 -9.990888473137864253e-14 -3.278840603390017767e-10 5.511521607644757070e-01 -3.637249279351709039e-14 -1.427152896041513295e-10 5.511521609487820550e-01 -1.650766897542000973e-14 -8.200918286973899295e-11 5.511521610086057565e-01 -5.267025344193551408e-15 -3.619232072030148591e-11 5.511521610533907101e-01 1.015505578064483685e-16 1.223296483280825981e-12 5.511521610904556168e-01 1.582069029037815868e-16 4.549788750706598670e-12 5.511521610939131843e-01 2.372904626248556501e-16 -2.077105414537354572e-11 5.511521610687138972e-01 2.303322667613766795e-15 -4.863229818108253414e-11 5.511521610409223504e-01 1.843150590278145069e-13 -2.509655227198275826e-09 5.511521585529364220e-01 4.112578556170054317e-14 -4.668666714032849381e-10 5.511521606212490543e-01 4.060117553004877685e-14 -4.461679569773115205e-10 5.511521606429080622e-01 4.004115731711573412e-14 -4.840841330481253406e-10 5.511521606054401445e-01 3.443735978513502537e-14 -5.237870176364415893e-10 5.511521605660651968e-01 2.349279037011701372e-14 -5.522914281458247401e-10 5.511521605378184585e-01 8.099205486725988359e-15 -5.655036047575591453e-10 5.511521605247978739e-01 -1.003279347096412020e-14 -5.656761358222706785e-10 5.511521605247408084e-01 -2.946366435168920325e-14 -5.614701909029006683e-10 5.511521605289999570e-01 -4.959449195664726446e-14 -5.589064285028748551e-10 5.511521605315456984e-01 -7.088209480391129695e-14 -5.657299300762512336e-10 5.511521605244408262e-01 -9.633251748482270366e-14 -5.981629218416102146e-10 5.511521604906201022e-01 -1.365718259719362211e-13 -6.993123764450517217e-10 5.511521603837548078e-01 -2.505098252290237740e-13 -1.096990852780888798e-09 5.511521599575486263e-01 -2.006736345190037132e-12 -7.659247849084998999e-09 5.511521527951769306e-01 -5.860407804712711905e-13 -2.014157947663624812e-09 5.511521588349215239e-01 -1.283122760379521660e-13 -4.220132240560907281e-10 5.511521606376175164e-01 -8.728253851640750099e-14 -2.793886168842412695e-10 5.511521608040543807e-01 -7.654935684941968875e-14 -2.386119670614415495e-10 5.511521608517951920e-01 -7.185775433738838426e-14 -2.186174224072553064e-10 5.511521608743319423e-01 -6.885683919931450890e-14 -2.052828980019744479e-10 5.511521608885021628e-01 -6.644113150479566240e-14 -1.949944534203251546e-10 5.511521608988569909e-01 -6.427786546958953929e-14 -1.865688648450702272e-10 5.511521609070055838e-01 -6.229164268042224227e-14 -1.795616943757476789e-10 5.511521609136162958e-01 -6.050251742403082573e-14 -1.737987841189906866e-10 5.511521609189830029e-01 -5.896778866982194059e-14 -1.692160301143297319e-10 5.511521609232282737e-01 -5.775297854725520129e-14 -1.657994888612208013e-10 5.511521609263897448e-01 -5.692101139909804771e-14 -1.635598896112065293e-10 5.511521609284645296e-01 -5.652473085922103339e-14 -1.625293259229893996e-10 5.511521609294198765e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 new file mode 100644 index 000000000..5677de76e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 @@ -0,0 +1 @@ +1.716607023163032805e-02 6.712673397489208867e-05 6.670490254301343332e-05 1.715083445336837084e-02 6.688355061390774295e-05 6.637433481944311103e-05 1.712013603553473248e-02 6.642990118229077554e-05 6.577451734536573602e-05 1.707351647352834539e-02 6.577055138581163146e-05 6.490808322028881030e-05 1.701027584362403353e-02 6.491117796747237221e-05 6.377949468320146605e-05 1.692945802486673854e-02 6.383726015455691951e-05 6.239853453769728944e-05 1.682983067395428869e-02 6.253455767541427871e-05 6.077595552818937553e-05 1.670985969261164217e-02 6.099385714070865372e-05 5.892224587526038749e-05 1.656767783521957693e-02 5.920486113542650032e-05 5.684839674802864482e-05 1.640104702553544375e-02 5.715647091014936198e-05 5.456559104762753797e-05 1.620731388598812411e-02 5.483741473432429312e-05 5.208514269856573257e-05 1.598335791943642295e-02 5.223662600368422575e-05 4.941784481361551214e-05 1.572553174210152005e-02 4.934374990566331486e-05 4.657347273704517759e-05 1.542959275941762319e-02 4.614997586033649609e-05 4.356063368259237094e-05 1.509062572920793002e-02 4.265007694587135957e-05 4.038763600296335274e-05 1.470295580321366417e-02 3.884484702722622719e-05 3.706341771637263458e-05 1.426005192981773945e-02 3.474270661908836314e-05 3.359790292136810244e-05 1.375442101368445566e-02 3.036295679371342954e-05 3.000406536417264114e-05 1.317749406748939915e-02 2.574125097149987189e-05 2.630179677500625127e-05 1.251950692359237241e-02 2.107281180773930838e-05 2.256006806604372489e-05 1.176938004117055771e-02 1.700339195182300415e-05 1.899385409573693431e-05 1.091460446824520786e-02 1.364408602116247824e-05 1.569715460823453910e-05 9.941145957291811983e-03 1.100554422457359317e-05 1.273639985203943831e-05 8.833384146485554270e-03 9.058541734822681332e-06 1.016265450749848858e-05 7.574111633134894897e-03 7.729031258892936755e-06 8.005805608249340753e-06 6.144627621422465297e-03 6.611123142990455522e-06 6.212737451953759359e-06 4.524973420861299646e-03 5.361067281765332820e-06 4.714317106600638602e-06 2.694371160588617583e-03 4.113517234822132855e-06 3.527307621151601637e-06 6.319425834628735307e-04 3.027279109209723806e-06 2.673317785237651105e-06 -1.607561093244242161e-03 2.278755308316708774e-06 2.177552125957519494e-06 -3.733193042597741408e-03 2.068376837951883884e-06 2.067826891533787199e-06 -5.641732705292781640e-03 2.423463170741331052e-06 2.344498366541275188e-06 -7.247411685131509296e-03 3.227461795412457211e-06 2.978654104334419108e-06 -8.481923754476285854e-03 4.351809093510096206e-06 3.929788465883568896e-06 -9.498323821922328297e-03 5.663792833758554885e-06 5.149443799684922219e-06 -1.032806636650972047e-02 7.033938501765433513e-06 6.585301852781868818e-06 -1.085107440428375626e-02 8.451557754889423097e-06 8.191676073402554722e-06 -1.090854720905152023e-02 9.979659883752890940e-06 9.927826188031767729e-06 -1.054751942381316164e-02 1.160475362824309610e-05 1.174986675125713562e-05 -1.001922482459517705e-02 1.331208586126104396e-05 1.361714000955761810e-05 -9.358107639122242166e-03 1.508653711798835548e-05 1.549352283504993843e-05 -8.488999973257095252e-03 1.691271413319223434e-05 1.734757124630102347e-05 -7.311905785616917494e-03 1.877255293722268360e-05 1.915609071722573805e-05 -5.867683581756972730e-03 2.062211029364484306e-05 2.093283444187435106e-05 -4.397448032838530488e-03 2.243522930987327260e-05 2.266975795968800405e-05 -3.097264451503864858e-03 2.419485339978975176e-05 2.435138881844519480e-05 -1.956047709060777361e-03 2.588628403962520692e-05 2.596430963241944982e-05 -9.608777353898350282e-04 2.749721927820988267e-05 2.749725088344669209e-05 -8.951084652988265233e-05 2.901819270758866520e-05 2.894153014546753020e-05 6.827441232111798597e-04 3.044221711406219650e-05 3.029077533912306051e-05 1.364634091503801700e-03 3.176438778184120023e-05 3.154060034581713937e-05 1.964323992513952125e-03 3.298171412482555270e-05 3.268846530516644316e-05 2.489500633497109764e-03 3.409304208187725595e-05 3.373360847022587538e-05 2.947256930101382292e-03 3.509873826868886671e-05 3.467675280142968453e-05 3.335829505946318052e-03 3.599998781527757229e-05 3.551976638428204844e-05 3.654367023575753708e-03 3.679196162638149071e-05 3.626638769073307461e-05 3.913282701222680314e-03 3.747691174384116999e-05 3.692057953853672018e-05 4.121598039554516535e-03 3.806125600617186891e-05 3.748585619151073345e-05 4.286922910778201423e-03 3.855107878452454230e-05 3.796552338459771244e-05 4.415559073245258273e-03 3.895194575099881009e-05 3.836258121140140450e-05 4.512597141253055395e-03 3.926876320054060473e-05 3.867965677943381727e-05 4.582002043733972123e-03 3.950565686562965373e-05 3.891894199201090645e-05 4.626683838219528000e-03 3.966586888262648629e-05 3.908213397940691068e-05 4.648551984442779797e-03 3.975174198089392755e-05 3.917045483962859989e-05 1.281504297699230771e-11 5.511521402023373817e-01 -1.935478351223872520e-08 1.212295607321613051e-11 5.511521413324182994e-01 -1.845668433781024189e-08 1.156526602378864426e-11 5.511521421842662249e-01 -1.787478467958008584e-08 1.102774650505019870e-11 5.511521428825165714e-01 -1.743508103638494177e-08 1.041117716708914639e-11 5.511521435389894474e-01 -1.700186300902267600e-08 9.655270450984303501e-12 5.511521442245557179e-01 -1.649788201311955965e-08 8.740510753339279172e-12 5.511521449715029997e-01 -1.589340026354385315e-08 7.679728809667810479e-12 5.511521457879139385e-01 -1.518609376055870615e-08 6.509114851048885910e-12 5.511521466684640158e-01 -1.438725295516263648e-08 5.279435064490895241e-12 5.511521476012247733e-01 -1.351392118900651072e-08 4.047835582862455238e-12 5.511521485713601898e-01 -1.258502271627824327e-08 2.870248073271488084e-12 5.511521495638856960e-01 -1.161875069017721165e-08 1.795701091023848716e-12 5.511521505644508823e-01 -1.063201306311381425e-08 8.622846862604221085e-13 5.511521515596093934e-01 -9.640387379593077134e-09 9.482751164997244964e-14 5.511521525370688401e-01 -8.658072684199765554e-09 -4.956524032854954422e-13 5.511521534862600102e-01 -7.697484564560490551e-09 -9.108712245567344232e-13 5.511521543987469851e-01 -6.768934467649125785e-09 -1.163066979785959468e-12 5.511521552684022218e-01 -5.880484708023413087e-09 -1.272153131559511332e-12 5.511521560915116913e-01 -5.037899532135495708e-09 -1.262851624715231911e-12 5.511521568664594639e-01 -4.245080569887221205e-09 -1.163980731831825910e-12 5.511521575879935186e-01 -3.509432459178988652e-09 -1.006996825732622959e-12 5.511521582469238734e-01 -2.840727852352582425e-09 -8.226278273064875758e-13 5.511521588328291976e-01 -2.249120312285812417e-09 -6.305375767223204645e-13 5.511521593557635601e-01 -1.724443623864292817e-09 -4.489156487456416730e-13 5.511521598160934454e-01 -1.265726697132438938e-09 -2.950194675159263818e-13 5.511521602008004894e-01 -8.836317193807144718e-10 -1.764874297373167745e-13 5.511521605067479790e-01 -5.791686009639116499e-10 -9.035709964130471695e-14 5.511521607501110864e-01 -3.363147263218885991e-10 -3.391361609626004807e-14 5.511521609376965891e-01 -1.494674786456979681e-10 -1.547759826220212810e-14 5.511521610018099704e-01 -8.620088477203978682e-11 -4.885658973517567835e-15 5.511521610509294566e-01 -3.817034486824466341e-11 5.142774404369569226e-17 5.511521610901354284e-01 6.193303132278570683e-13 1.130947325768317641e-16 5.511521610939075222e-01 4.496453378265000845e-12 4.136513651974087706e-16 5.511521610684909644e-01 -2.079741003411662122e-11 2.728863045298038135e-15 5.511521610404068738e-01 -4.880900835368724331e-11 2.048014313407751851e-13 5.511521586059382471e-01 -2.509947009572090081e-09 4.593688996750234102e-14 5.511521606236448045e-01 -4.670101214811094248e-10 4.634316965878483403e-14 5.511521606437111975e-01 -4.459921564008768569e-10 4.737690530610808787e-14 5.511521606054677891e-01 -4.837827331656330462e-10 4.317116425292660219e-14 5.511521605654073896e-01 -5.235090060151520279e-10 3.316240339351514410e-14 5.511521605365513610e-01 -5.521078636227861260e-10 1.823466755749745295e-14 5.511521605230450538e-01 -5.654273523000821551e-10 -1.598372586441093769e-17 5.511521605226799014e-01 -5.656761585843985763e-10 -2.003116592465766434e-14 5.511521605269618096e-01 -5.613327771396840342e-10 -4.111493167432380796e-14 5.511521605299342097e-01 -5.583777055282256501e-10 -6.361560046377966419e-14 5.511521605239915189e-01 -5.646178396797403317e-10 -9.032218656456708609e-14 5.511521604936521213e-01 -5.963621354256216426e-10 -1.312529597499976788e-13 5.511521603987905582e-01 -6.968052865545069617e-10 -2.418784992687487789e-13 5.511521600288195044e-01 -1.093764192525222358e-09 -1.891324620996800766e-12 5.511521540180173151e-01 -7.655385224996448601e-09 -5.443777089457081449e-13 5.511521592895811672e-01 -2.009779475734690550e-09 -1.261908500633661561e-13 5.511521606954750130e-01 -4.172508361540185208e-10 -9.087446539658035041e-14 5.511521608177878395e-01 -2.743683395656152550e-10 -8.259451519680031645e-14 5.511521608528597849e-01 -2.334812712347328372e-10 -7.942660150838539443e-14 5.511521608707140585e-01 -2.136624796213153962e-10 -7.749288918899735012e-14 5.511521608833401809e-01 -2.005497895737852017e-10 -7.587142767387911264e-14 5.511521608935591177e-01 -1.905026336568400354e-10 -7.433328561915655837e-14 5.511521609021924339e-01 -1.823205030485850573e-10 -7.285293248569393713e-14 5.511521609094947038e-01 -1.755449746796282230e-10 -7.147402400542534850e-14 5.511521609155430879e-01 -1.699905106060844336e-10 -7.026437958962186165e-14 5.511521609203593464e-01 -1.655840492869361490e-10 -6.929775915815507357e-14 5.511521609239435904e-01 -1.623049739376445792e-10 -6.863988049284224624e-14 5.511521609262860499e-01 -1.601593937228434601e-10 -6.833866895419431386e-14 5.511521609273590805e-01 -1.591765368266342892e-10 1.188395119716847024e-11 -1.935478351223872520e-08 5.511521431270772764e-01 1.133268455172245169e-11 -1.845668433781024189e-08 5.511521438242739102e-01 1.094064246842367980e-11 -1.787478467958008584e-08 5.511521441712851077e-01 1.056426890421861703e-11 -1.743508103638494177e-08 5.511521443809198617e-01 1.008849813178730996e-11 -1.700186300902267600e-08 5.511521446101921295e-01 9.447044353019076949e-12 -1.649788201311955965e-08 5.511521449442812193e-01 8.620056447858793201e-12 -1.589340026354385315e-08 5.511521454128207598e-01 7.622716705985257345e-12 -1.518609376055870615e-08 5.511521460143844475e-01 6.494541736261246248e-12 -1.438725295516263648e-08 5.511521467330683377e-01 5.289947815465035814e-12 -1.351392118900651072e-08 5.511521475475559262e-01 4.069782714276322304e-12 -1.258502271627824327e-08 5.511521484353429923e-01 2.893640615962603618e-12 -1.161875069017721165e-08 5.511521493753268608e-01 1.814061949493092534e-12 -1.063201306311381425e-08 5.511521503482128548e-01 8.723297356094363309e-13 -9.640387379593077134e-09 5.511521513363772939e-01 9.600557434034686942e-14 -8.658072684199765554e-09 5.511521523237412623e-01 -5.018121446543699175e-13 -7.697484564560490551e-09 5.511521532960246272e-01 -9.215462433869075946e-13 -6.768934467649125785e-09 5.511521542409925090e-01 -1.174975535568901580e-12 -5.880484708023413087e-09 5.511521551485877302e-01 -1.282366709024147523e-12 -5.037899532135495708e-09 5.511521560109344797e-01 -1.269511235786867569e-12 -4.245080569887221205e-09 5.511521568218038514e-01 -1.166696313278829481e-12 -3.509432459178988652e-09 5.511521575716402666e-01 -1.006429815976388160e-12 -2.840727852352582425e-09 5.511521582501305305e-01 -8.199649587621143052e-13 -2.249120312285812417e-09 5.511521588474174171e-01 -6.272475937587419444e-13 -1.724443623864292817e-09 5.511521593738154534e-01 -4.462858783271978013e-13 -1.265726697132438938e-09 5.511521598309743197e-01 -2.933928583769899904e-13 -8.836317193807144718e-10 5.511521602105694528e-01 -1.754446930974700274e-13 -5.791686009639116499e-10 5.511521605136145974e-01 -8.957437265478453964e-14 -3.363147263218885991e-10 5.511521607559674019e-01 -3.341934701048448084e-14 -1.494674786456979681e-10 5.511521609420876322e-01 -1.523530032605837644e-14 -8.620088477203978682e-11 5.511521610045274633e-01 -4.850071367375814057e-15 -3.817034486824466341e-11 5.511521610514906744e-01 4.206516453480050924e-17 6.193303132278570683e-13 5.511521610898751922e-01 1.120116829775175110e-16 4.496453378265000845e-12 5.511521610938596716e-01 4.117192622065791900e-16 -2.079741003411662122e-11 5.511521610686903605e-01 2.719184912111166164e-15 -4.880900835368724331e-11 5.511521610407524863e-01 2.069870004862024100e-13 -2.509947009572090081e-09 5.511521585526503175e-01 4.606195826940893242e-14 -4.670101214811094248e-10 5.511521606211079449e-01 4.637605667182122609e-14 -4.459921564008768569e-10 5.511521606430824782e-01 4.736293679846921958e-14 -4.837827331656330462e-10 5.511521606057459000e-01 4.313221343157584333e-14 -5.235090060151520279e-10 5.511521605663538548e-01 3.311883900325864808e-14 -5.521078636227861260e-10 5.511521605380100830e-01 1.820382867038617666e-14 -5.654273523000821551e-10 5.511521605248755895e-01 -1.584732974842213889e-17 -5.656761585843985763e-10 5.511521605247408084e-01 -1.999193642381300046e-14 -5.613327771396840342e-10 5.511521605291425097e-01 -4.103578641631294540e-14 -5.583777055282256501e-10 5.511521605320792716e-01 -6.352742109268810089e-14 -5.646178396797403317e-10 5.511521605255489398e-01 -9.041503069129772483e-14 -5.963621354256216426e-10 5.511521604924022322e-01 -1.324407170537945633e-13 -6.968052865545069617e-10 5.511521603862293839e-01 -2.495212269575103295e-13 -1.093764192525222358e-09 5.511521599607395183e-01 -2.047876389463727066e-12 -7.655385224996448601e-09 5.511521527990201896e-01 -6.087198977018805135e-13 -2.009779475734690550e-09 5.511521588393196724e-01 -1.344450235041416592e-13 -4.172508361540185208e-10 5.511521606424579778e-01 -9.230918025093273733e-14 -2.743683395656152550e-10 5.511521608092229130e-01 -8.184803889791664601e-14 -2.334812712347328372e-10 5.511521608571429143e-01 -7.780898625506240098e-14 -2.136624796213153962e-10 5.511521608795458826e-01 -7.555656980816377738e-14 -2.005497895737852017e-10 5.511521608935122662e-01 -7.389924670228079816e-14 -1.905026336568400354e-10 5.511521609036239555e-01 -7.246073180064096096e-14 -1.823205030485850573e-10 5.511521609115141995e-01 -7.113637737086842949e-14 -1.755449746796282230e-10 5.511521609178717807e-01 -6.992283011562215829e-14 -1.699905106060844336e-10 5.511521609230066732e-01 -6.885956860484515045e-14 -1.655840492869361490e-10 5.511521609270543243e-01 -6.800567615651293285e-14 -1.623049739376445792e-10 5.511521609300609192e-01 -6.741957033659485020e-14 -1.601593937228434601e-10 5.511521609320295667e-01 -6.715167214005167517e-14 -1.591765368266342892e-10 5.511521609329310678e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener new file mode 100644 index 000000000..1b4d65d49 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0664002017488833 +1 0.06667365593451077 +2 0.06713695988020449 +3 0.067796836613134 +4 0.06866237205023622 +5 0.06974516641578213 +6 0.07105889989080325 +7 0.07261928732543141 +8 0.07444371611586816 +9 0.07655047817475837 +10 0.07895728260094416 +11 0.08168057099484198 +12 0.08473451999776835 +13 0.08812944707942322 +14 0.09186839129225591 +15 0.09594214806092592 +16 0.10032690227836429 +17 0.10498255406688793 +18 0.1098483232060156 +19 0.11483878775895508 +20 0.11984423882995195 +21 0.12473074060960117 +22 0.12934285866875134 +23 0.13355751682838457 +24 0.13728858183497364 +25 0.14045734977473875 +26 0.14299335108782182 +27 0.14482932783769725 +28 0.1459060307534103 +29 0.1461792955843088 +30 0.14563969678111466 +31 0.1443661433411809 +32 0.1424681582326872 +33 0.1400627264874011 +34 0.1372639231049528 +35 0.13412314641315637 +36 0.13065684232605987 +37 0.12688922552029253 +38 0.12285209286630051 +39 0.11859195676558423 +40 0.11420121555320153 +41 0.10977446753411108 +42 0.10539040288983371 +43 0.10111213382221786 +44 0.09698737769505618 +45 0.09305199775204236 +46 0.08933203292791317 +47 0.08584340092115128 +48 0.08259161577465039 +49 0.07957772981052592 +50 0.07680039166659965 +51 0.0742562926126846 +52 0.07194009948668192 +53 0.06984509215414765 +54 0.0679640798031597 +55 0.0662898936478203 +56 0.06481532387567544 +57 0.06353338989102478 +58 0.06243760826185266 +59 0.06152211383217668 +60 0.060781716178440644 +61 0.06021200342435023 +62 0.05980949590339288 +63 0.05957143220707113 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz new file mode 100644 index 000000000..00113f45d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.070571367386998 -1.974799801769878e-05 -1.9771178540014944e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.0718473443181664 -1.987211165941734e-05 -1.9899551288344118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0739995623938667 -2.0112522562216087e-05 -2.0147736841617664e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0770447593409105 -2.0460429767174882e-05 -2.0506252577627274e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.0810048397953103 -2.0905143891446237e-05 -2.0963450350487837e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.0859077436572875 -2.1433933650344404e-05 -2.150497190304288e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.091785833035111 -2.2031573294588305e-05 -2.2113688032067307e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.0986763748907187 -2.2680191692969447e-05 -2.276983306601563e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.106621011267111 -2.3359435111598943e-05 -2.3451223002361653e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.1156640700490454 -2.4046658032876445e-05 -2.413355764361509e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.125848685211275 -2.4717142592137046e-05 -2.4790791224643602e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.1372174121758856 -2.534438825188339e-05 -2.539559949129101e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.1498124818439455 -2.590043764215583e-05 -2.5919889844368953e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.1636747059543717 -2.635621451003324e-05 -2.633531419254953e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.178836528138095 -2.6681865854005902e-05 -2.6613761484890003e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.1953181349239865 -2.6847187527928186e-05 -2.6727886639345033e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.21313306610275 -2.6822150387706843e-05 -2.6651672548648967e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.232286823593361 -2.6577381459110935e-05 -2.6360896248049773e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.2527697455450624 -2.6084515518448184e-05 -2.5833467391195525e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.274550108792876 -2.5316269923377855e-05 -2.504961452942146e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.297582380985114 -2.424987358172993e-05 -2.399291661708992e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.321811977659147 -2.2879736984150653e-05 -2.2654684532970384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.347169382839471 -2.1214154941781136e-05 -2.1034587862791187e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.3735585777968575 -1.9271737447416662e-05 -1.914075185815995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.4008689506481797 -1.7078584953952025e-05 -1.6989668444125805e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.428979348433055 -1.466573474795671e-05 -1.4605756427896154e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.4577579593531436 -1.2063534635746473e-05 -1.2019731450693276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.4870566559986376 -9.301474070549956e-06 -9.26692095182171e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.5167173817721276 -6.4130892958516e-06 -6.3866549052724545e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.546578597088741 -3.4379064997519634e-06 -3.421372045307226e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.5764789558676076 -4.2100417056215174e-07 -4.154538894527361e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.606261446389075 2.5900009145006493e-06 2.586225586146799e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.6357757791378837 5.549241300117769e-06 5.539861396310451e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.664877334527358 8.41536745875219e-06 8.404134464433443e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.693427940729297 1.1152777019709476e-05 1.1141362952990739e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.7213048248084415 1.3731443865494569e-05 1.371830607663582e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.748402612827402 1.612519468338217e-05 1.610658687378885e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.774626460032595 1.8310828168681452e-05 1.8282925231022628e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.799893260729304 2.0269474890364766e-05 2.0229334965419635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.8241364359536862 2.198680660362312e-05 2.1933065929289577e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.847312464524109 2.3453186639864707e-05 2.338638388792695e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8693905855822006 2.466380085370361e-05 2.4586245082969145e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.890351061198904 2.5618784905701677e-05 2.5533831885458882e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.9101861656224197 2.6323338469876775e-05 2.6234023075608607e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9289034641492373 2.6786862045375394e-05 2.669583344288244e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.94651520436692 2.7022374445599042e-05 2.6932106037085585e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.963035595940167 2.7046102279650066e-05 2.6958953450277214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9784794363208755 2.687702922941901e-05 2.6795233183220657e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9928694519489754 2.6536409462813327e-05 2.6462027183974525e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.006231215427587 2.6047321018307744e-05 2.5982182880233604e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.018588530701608 2.543423293986042e-05 2.53798796586159e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0299641236248633 2.4722557642813533e-05 2.4680186537988778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.04038226764309 2.393820164319065e-05 2.3908618817458852e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0498679663260337 2.3107145380269723e-05 2.3090717175611894e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0584445224466896 2.2255056597126162e-05 2.2251643366422472e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.0661326662270794 2.1406922063585835e-05 2.1415775178526685e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.0729519683125197 2.0586416163775735e-05 2.0606350355962306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.0789205365216494 1.9815514859627336e-05 1.9845129574393313e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.0840545225140987 1.9114240200724986e-05 1.915205186827103e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.0883681449160285 1.8500392954712808e-05 1.854491337914434e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.09187388789215 1.7989309395176827e-05 1.8039089201843406e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.094582367651359 1.7593674998920045e-05 1.764732299149796e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.0965018628453564 1.7323432929472504e-05 1.7379618064048753e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.0976395187837706 1.71858469072733e-05 1.7243287137539115e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener new file mode 100644 index 000000000..92db6261f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.051333281550313324 +1 0.051499955363093194 +2 0.051787702801461534 +3 0.05220471847265196 +4 0.05276264096835856 +5 0.05347695267256018 +6 0.054367115787132526 +7 0.05545700008187273 +8 0.056775165282265054 +9 0.058354886287776145 +10 0.06023362065221712 +11 0.062452781722932574 +12 0.06505701961104628 +13 0.06809264091395671 +14 0.07160406414417671 +15 0.07562951547991927 +16 0.08019737641838721 +17 0.08532038822774221 +18 0.09098773418659739 +19 0.09715237865488138 +20 0.10371597163132877 +21 0.11052804005173529 +22 0.11738106248638033 +23 0.1240066006705141 +24 0.13008807261644603 +25 0.13538982434441077 +26 0.139767993126606 +27 0.14309758170155162 +28 0.14526382118016282 +29 0.14616792382361748 +30 0.14575465987594782 +31 0.14413181711542095 +32 0.14151405820966442 +33 0.13813067235048104 +34 0.13413572504103535 +35 0.12955438571344982 +36 0.1244162877763492 +37 0.11877684652986194 +38 0.11279846496260197 +39 0.1066866776803444 +40 0.10060940613794503 +41 0.09469791062653166 +42 0.08905000055179445 +43 0.08372749303913941 +44 0.07875826477205652 +45 0.07415552767970494 +46 0.06992240147222695 +47 0.06605444437714549 +48 0.06254032872231992 +49 0.059364435455593445 +50 0.05650899726526013 +51 0.05395415336101867 +52 0.05167714735152695 +53 0.0496564217914778 +54 0.04787270349170621 +55 0.04630900807777758 +56 0.04495029412599795 +57 0.04378339397788243 +58 0.04279697429359291 +59 0.04198142628989 +60 0.04132874264268565 +61 0.040832455591959964 +62 0.040487635357711445 +63 0.04029066344696545 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz new file mode 100644 index 000000000..88ab14702 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9894292479695213 -2.9615127649984973e-05 -2.954191783113394e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9905209670914408 -2.991363703930515e-05 -2.985096013362627e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9923885260334004 -3.0495186171088184e-05 -3.045215565920055e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9950580821882966 -3.134259134210931e-05 -3.1327208668018574e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9985653044640443 -3.243502723216518e-05 -3.245380656929519e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.0029562921652238 -3.374758484252058e-05 -3.38044104252575e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.008286514670109 -3.525041957796329e-05 -3.5345954170736435e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.014621418654998 -3.690844810807243e-05 -3.703991654831893e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.0220361534502835 -3.8681585509578014e-05 -3.8842533620988805e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.030614237981283 -4.05250169371004e-05 -4.0705138508916085e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0404442550591226 -4.238949357865671e-05 -4.257460799060058e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.051619871143616 -4.422172741485884e-05 -4.439399991097857e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0642391556222037 -4.596479775100013e-05 -4.610330546141413e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.0784022851896227 -4.7558486547982304e-05 -4.764028165934302e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0942038493470596 -4.893945861751164e-05 -4.89413909787358e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.1117268073162943 -5.0041346908879136e-05 -4.994308358377355e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.1310438803936 -5.079522534986968e-05 -5.058315858211956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.1522135757773806 -5.113043644925478e-05 -5.080174608256984e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.1752714995963895 -5.097517116337386e-05 -5.0542138159669847e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.2002218946193555 -5.0256539772117195e-05 -4.9751445664571496e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.2270417044167 -4.8907206030883216e-05 -4.8383015837904746e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.25568287388535 -4.68922062162063e-05 -4.640537535361332e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2860674732863666 -4.420765636123571e-05 -4.3804210305651965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.318079466812348 -4.087938542035722e-05 -4.058352575733408e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.351574877861254 -3.6957766767896144e-05 -3.676668706992015e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.3863849995647604 -3.2509451596844247e-05 -3.2396514227543664e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.422316687725039 -2.7601929795121568e-05 -2.7532421485648622e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.4591479832163907 -2.2297367709674592e-05 -2.224733413309293e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.4966355630359356 -1.6664411060878754e-05 -1.6626008107305517e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.534524359257488 -1.0786356099720716e-05 -1.076230773598527e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.5725556040309248 -4.7620520536238924e-06 -4.7559520325133514e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.6104756452696134 1.3008482615429074e-06 1.2913602531165837e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.6480414182074425 7.297677472020775e-06 7.2800317613412764e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.6850218087231927 1.3134669123022057e-05 1.3116312712618501e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.721200200920078 1.873196681530965e-05 1.8715248332229088e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.7563833665565527 2.4022216953118747e-05 2.4002576480967412e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.7904054786901327 2.8946922440345635e-05 2.891570875527773e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.823125144569492 3.345536168468603e-05 3.3404246427933656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.854427858292927 3.750690196859605e-05 3.743016693979597e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.8842304534721226 4.107151772843525e-05 4.0967407078307474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.9124858516751164 4.4130211436200646e-05 4.400107937842202e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.939171704489991 4.667482773764293e-05 4.652649256708423e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.964285377010969 4.870764713217335e-05 4.854788183672962e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.9878414737163754 5.0240970912124915e-05 5.007700843347424e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 3.0098720007814173 5.129518317075481e-05 5.113349925746853e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 3.03041617233961 5.189751737177381e-05 5.17440511116988e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.0495168911211885 5.208115745271433e-05 5.194124552508117e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.0672185458152184 5.188430684404805e-05 5.176244074561696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0835720942171547 5.1349207376748504e-05 5.124880296732515e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0986303293780226 5.052125697402656e-05 5.0444614253473356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.112443661642474 4.944819664343203e-05 4.939656975762365e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.1250602951141255 4.817928832282193e-05 4.815300336982503e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.136528058458419 4.6764496673857114e-05 4.676307571205041e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1468935319801394 4.525372980635384e-05 4.5275985078861685e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1561999355542545 4.369614169054357e-05 4.3740199068584945e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1644863256545497 4.213946235820326e-05 4.2202678681034115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1717886735210414 4.0628850106355717e-05 4.07081797611322e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1781395823084164 3.920618281434048e-05 3.9298584167733116e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.183567876040233 3.790958367112162e-05 3.801223537075171e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.188098624074944 3.6772926470580354e-05 3.6883330048689516e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.191753318999364 3.5825388214581084e-05 3.594139981700684e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.194549792708353 3.5091113513602225e-05 3.521093080302721e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1965018628453565 3.458906784295463e-05 3.47111899381832e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.197620330925452 3.433320307408093e-05 3.44563779426472e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener new file mode 100644 index 000000000..ac4597702 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04190876747135735 +1 0.041920088735621 +2 0.041943217025232134 +3 0.04197914777236345 +4 0.04202943506348141 +5 0.04209626804577452 +6 0.042182578335365276 +7 0.04229218328173832 +8 0.04242997125007986 +9 0.04260213637113936 +10 0.042816471371944796 +11 0.043082727954943625 +12 0.04341305443480354 +13 0.043822519501103704 +14 0.04432972835209367 +15 0.044957532034339456 +16 0.045733821233028264 +17 0.04669238013137153 +18 0.047873751936101466 +19 0.04932603243803338 +20 0.05110545851090071 +21 0.05327659204811242 +22 0.05591181521247091 +23 0.0590897520367581 +24 0.06289212264850834 +25 0.06739843856334064 +26 0.07267789561525202 +27 0.07877787235149848 +28 0.0857086797050146 +29 0.09342430739487176 +30 0.10178420744905577 +31 0.11051833059526216 +32 0.1192239427806562 +33 0.1273618332715952 +34 0.13437377223014874 +35 0.13995103252868624 +36 0.14386709698492647 +37 0.145917665844633 +38 0.14594715691396856 +39 0.14404607219397567 +40 0.14060543682144333 +41 0.13604330582703347 +42 0.13052953060728245 +43 0.12409818744487276 +44 0.11684840942211118 +45 0.10910976155449764 +46 0.10125730444371918 +47 0.09358389415207309 +48 0.08630254488334099 +49 0.07953552513717896 +50 0.07334184018464693 +51 0.0677485510987431 +52 0.06275860485172198 +53 0.05835734554993165 +54 0.054517670666586734 +55 0.05119944398030612 +56 0.04835898622438526 +57 0.045957336956464756 +58 0.04396059672344129 +59 0.042339945743186995 +60 0.04107158766257789 +61 0.040136656452036026 +62 0.039521114202071 +63 0.039215659474268603 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz new file mode 100644 index 000000000..425c17112 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8950947685770183 -5.100020867385895e-06 -4.6895380446007e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.895372724021385 -5.164334318841226e-06 -4.749635261696173e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8959324566932887 -5.2941916938143395e-06 -4.8710632531023625e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8967816773887705 -5.4920261743083306e-06 -5.0562698953842336e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8979321202761057 -5.761410448127307e-06 -5.308864712508523e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8993997441338821 -6.1069593816697965e-06 -5.633537686769727e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9012049999607217 -6.5341916541383404e-06 -6.035945664087528e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9033731640235265 -7.049346842391893e-06 -6.522560085218425e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.905934734738546 -7.659151186536994e-06 -7.100468406574065e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.908925890766667 -8.370522444695685e-06 -7.7771199072925e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.912389006227581 -9.190203809879406e-06 -8.56000440180725e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9163732168480785 -1.0124315943369243e-05 -9.456250422630228e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.920935027966217 -1.1177815783252299e-05 -1.0472127522826008e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9261389513760756 -1.2353851367136105e-05 -1.1612435997969077e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9320581527285376 -1.3653003800556517e-05 -1.287976687106473e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9387750842407112 -1.5072411348028342e-05 -1.4273616187342426e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.946382068393259 -1.660477641524001e-05 -1.5789340911287333e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9549817866175916 -1.8237263644904494e-05 -1.741694981237018e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.96468761215247 -1.9950307157106157e-05 -1.9139733763997334e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9756237077076633 -2.17163554725401e-05 -2.0932756754057092e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9879247857774376 -2.3498678919381052e-05 -2.2761276637441373e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.001735401983213 -2.5250577307689894e-05 -2.4579264003189098e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.017208619603048 -2.6914617121176304e-05 -2.6328035771225686e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.034503846915922 -2.8422233345008568e-05 -2.7935252445059312e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0537836096087387 -2.9693858985829564e-05 -2.9314555962977662e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0752089812317864 -3.063969476203259e-05 -3.036617921042996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.0989333608796636 -3.116082200042428e-05 -3.097883207593786e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1250942675556597 -3.115079380765429e-05 -3.1033267061363705e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.153802828187216 -3.0497911161619438e-05 -3.0407936019161863e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.185130689683803 -2.9087182536814326e-05 -2.898678247857788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2190942153165003 -2.6801717660992e-05 -2.6668849710078672e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2556412599030016 -2.3536817160730632e-05 -2.3377774968214665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.294645460392858 -1.9228489734318263e-05 -1.9073588429142748e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3359055313974446 -1.3884011376581398e-05 -1.376874427115767e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3791506964542695 -7.605249040178157e-06 -7.544231450466205e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.4240501849513842 -5.687030324475929e-07 -5.50458210139891e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4702198559105333 7.0282886584673905e-06 7.0133430020352325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.517231481262297 1.4967676678340866e-05 1.4916796936986852e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5646310650703863 2.298334693969296e-05 2.2909380195130556e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.611963415155412 3.080274175034897e-05 3.074190461892755e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.6587915533966 3.8215872995412856e-05 3.819469222973272e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.7047070560947524 4.5085026742698814e-05 4.5095746583148826e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.7493386909159057 5.131150260584945e-05 5.132686248273719e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.792364344263743 5.682292504058026e-05 5.6821880751162415e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8335226250957413 6.157926931406114e-05 6.155819226155432e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.872619381560204 6.55768014300381e-05 6.554417123384368e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9095213189073243 6.884404188111294e-05 6.881335537594423e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.944145270939175 7.143448206889088e-05 7.141948480216476e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.976448311334598 7.34195476561614e-05 7.342999772782847e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.006418951592256 7.488223064487765e-05 7.49190437505325e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.034069828152482 7.590847877607198e-05 7.596175052301838e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.059431607552022 7.65801911340881e-05 7.663070401277953e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.082547770001524 7.697138458135054e-05 7.699398069629116e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1034702120711706 7.714625711331638e-05 7.711414672000215e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.12225559071452 7.715814511237144e-05 7.704778695980804e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.138962326349594 7.704929035811265e-05 7.684539072545172e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.153648023669918 7.685502319549961e-05 7.655205197369798e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1663673832898684 7.660708563216139e-05 7.620788893379254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1771706367968164 7.633456856303105e-05 7.5848050559076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1861023924167426 7.606379669733997e-05 7.550262989523555e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.193200797818841 7.581782561011782e-05 7.519660780700216e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.198496945065552 7.561586657266375e-05 7.494985538242183e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2020144590812674 7.547277815471765e-05 7.477718228176792e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.203769225372395 7.539867654034172e-05 7.46884044966086e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener new file mode 100644 index 000000000..c220958ad --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04190112347991632 +1 0.04191227222750605 +2 0.04193504739395501 +3 0.04197042782422024 +4 0.04201994168798369 +5 0.04208574159563933 +6 0.04217071020819507 +7 0.04227860113177584 +8 0.04241422118397822 +9 0.042583661402873 +10 0.042794585339684235 +11 0.0430565840548092 +12 0.0433816075310742 +13 0.04378448147259509 +14 0.04428351599324344 +15 0.04490120753726749 +16 0.04566502615786451 +17 0.046608265191370644 +18 0.04777090708953561 +19 0.049200424935613704 +20 0.05095239095406812 +21 0.05309069838799945 +22 0.05568712003578204 +23 0.0588198271956021 +24 0.06257038445017278 +25 0.06701863650402974 +26 0.07223484669127235 +27 0.07826848798827281 +28 0.08513330769874043 +29 0.09278856389495131 +30 0.10110314169930694 +31 0.10981747812682267 +32 0.11854004522019156 +33 0.12674291669958238 +34 0.13385625058511375 +35 0.13955600534242216 +36 0.1436133990185933 +37 0.14582318486847906 +38 0.14602295759975162 +39 0.1442714719930307 +40 0.14094719229696237 +41 0.13647362444228398 +42 0.13104755756314748 +43 0.12470261152469449 +44 0.11752673115133551 +45 0.10982886031336865 +46 0.10198894378796454 +47 0.09430611772204446 +48 0.08699989561291781 +49 0.08020040509123763 +50 0.07397006082848108 +51 0.0683382518477484 +52 0.06330973269025028 +53 0.05887119799539318 +54 0.054996742193373624 +55 0.05164789751609006 +56 0.048780991888003396 +57 0.04635682480064937 +58 0.04434126467534778 +59 0.04270527891481764 +60 0.041424885527479006 +61 0.04048106531781924 +62 0.039859663134455756 +63 0.03955129837109909 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz new file mode 100644 index 000000000..35fd04d0b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8949055662847083 -5.152162084366482e-06 -4.745764823500667e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.895181101871981 -5.217102869499377e-06 -4.80654416575866e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8957359565332543 -5.348137026776369e-06 -4.929257274237608e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8965777639414942 -5.547543112512544e-06 -5.116193843281624e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8977181412651092 -5.818666982561284e-06 -5.3707309204839426e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8991728888574702 -6.165830951577445e-06 -5.697258477680526e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.900962255854965 -6.594204839003973e-06 -6.101074530837611e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9031112708032412 -7.109634621370661e-06 -6.588243772122229e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.905650135781485 -7.71842176104306e-06 -7.165412175463887e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.908614681511888 -8.427043928872852e-06 -7.839568288710485e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9120468795044492 -9.24180708076332e-06 -8.617739814266718e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9159954052503567 -1.0168417900767946e-05 -9.506612116314813e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9205162436521173 -1.1211465225636655e-05 -1.0512053419408285e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.925673324030494 -1.2373799626938765e-05 -1.163853011416891e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9315391668930375 -1.3655802209487783e-05 -1.288839510896344e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9381955178311414 -1.5054537472988325e-05 -1.4261033249485369e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.945733935020958 -1.6562790964908173e-05 -1.575185098563752e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.954256285350956 -1.8168000441104672e-05 -1.7351103575081953e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9638750896492423 -1.9851099962274454e-05 -1.904256398547673e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.974713639265508 -2.1585308824180117e-05 -2.0802054431603578e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9869057838397046 -2.3334965941495475e-05 -2.2595900846918413e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.00059526303582 -2.5054654693476292e-05 -2.437944644258556e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0159344232184058 -2.66884168787141e-05 -2.6095679196778026e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.033082123902936 -2.8169314118422778e-05 -2.767419699121647e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.052200599690814 -2.9419487868253338e-05 -2.903077468605057e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0734510041383465 -3.0350833074464744e-05 -3.0067854978346007e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.09698732773581 -3.086612286550992e-05 -3.067628633543527e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.12294836123037 -3.086066537764307e-05 -3.073869986332153e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1514473806590826 -3.0224561400728538e-05 -3.013490464268135e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.182559279862579 -2.8844767633421533e-05 -2.874939180821124e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2163050237971835 -2.660637852264559e-05 -2.648072280010979e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2526378992961122 -2.3404157056203663e-05 -2.3250969910847505e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2914373526433685 -1.9169964979422627e-05 -1.901687981979901e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.33250788225089 -1.3903008438010424e-05 -1.3785348080971111e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3755839173423583 -7.694387332574764e-06 -7.629733209154692e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.4203392759759668 -7.146238227153109e-07 -6.935722269968617e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4663939523921594 6.840753303497581e-06 6.82864045778394e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.513323086355808 1.4758666347229044e-05 1.4710296440084038e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5606743371739626 2.277867425126805e-05 2.2703461821182454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6079921112008786 3.06251410225674e-05 3.055847419263321e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.654837860763116 3.80803239048431e-05 3.805229281586868e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.700800836746957 4.5000654044616666e-05 4.50079963868114e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.7455068088260246 5.128612424233093e-05 5.130211274945847e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7886294979032775 5.686205718999907e-05 5.6863537560353965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8299024044914716 6.168507753115422e-05 6.166597707986015e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8691257746448917 6.574767123938044e-05 6.571532295178553e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.906161522373144 6.907526463240125e-05 6.90428534325143e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.94092251010044 7.171899502056058e-05 7.170057238148552e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9733625877893353 7.374859549615813e-05 7.375489349838055e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.003467705197862 7.524610505594345e-05 7.527971757270702e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.031248458813082 7.62976807945669e-05 7.635047789653674e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0567339166895313 7.698615256893628e-05 7.704040417691142e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.079966332507684 7.738688006258118e-05 7.741840974051719e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1009966836165805 7.756566831068089e-05 7.754800197574823e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1198809567375556 7.757772661825212e-05 7.748676782376893e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1366770947154494 7.746712924126584e-05 7.72861699164721e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1514424053104753 7.727012233029726e-05 7.699209815000943e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.164231427050356 7.701892325518257e-05 7.66453896243946e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.175094322875011 7.674293601620056e-05 7.628187184734602e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1840756930058642 7.646874968511397e-05 7.59322732464893e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1912137121810358 7.621966914463541e-05 7.562214863848882e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.196539515068156 7.601513732107625e-05 7.537185973822071e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2000767702441815 7.587021044630686e-05 7.51966035173306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.201841397703709 7.579515006974185e-05 7.510646438872808e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener new file mode 100644 index 000000000..e818027bc --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04189628391620653 +1 0.041907323373906694 +2 0.041929874833646186 +3 0.04196490662795677 +4 0.042013930500640485 +5 0.04207907590391665 +6 0.0421631944669496 +7 0.04226999938569372 +8 0.042404245773605555 +9 0.0425719592932915 +10 0.04278072156317679 +11 0.04304002172688188 +12 0.043361683899869934 +13 0.043760379522009445 +14 0.044254231279711474 +15 0.04486551025609772 +16 0.04562141898567497 +17 0.046554938340937276 +18 0.04770569337409733 +19 0.04912075962732308 +20 0.050855284001361786 +21 0.05297273027084682 +22 0.05554447723937128 +23 0.058648398825604894 +24 0.06236594737626685 +25 0.06677716146015887 +26 0.07195295990127763 +27 0.07794411878050164 +28 0.08476653742079225 +29 0.09238274814335581 +30 0.10066753374473396 +31 0.10936803997834117 +32 0.11809986654555682 +33 0.12634236316194136 +34 0.13351985713168565 +35 0.13929733176772335 +36 0.1434444768861111 +37 0.1457554940480348 +38 0.14606420354961566 +39 0.1444096914945241 +40 0.14116124134723615 +41 0.13674474011543822 +42 0.13137456932122168 +43 0.12508481225274135 +44 0.11795725554866583 +45 0.11028683929066119 +46 0.10245610451117247 +47 0.09476820472488676 +48 0.08744670777316393 +49 0.0806268401705663 +50 0.07437334134526351 +51 0.06871710581760616 +52 0.06366406002466193 +53 0.05920177671828256 +54 0.05530507394288428 +55 0.051936577127561674 +56 0.049052692833963164 +57 0.04661406779662805 +58 0.04458642246150086 +59 0.042940588399494994 +60 0.0416524650318594 +61 0.04070293526055379 +62 0.040077768962522985 +63 0.039767534892597864 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz new file mode 100644 index 000000000..a124de321 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8947851274956027 -5.184569661831169e-06 -4.780746052277871e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8950591196264228 -5.249935991269749e-06 -4.841986919211064e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8956108629313704 -5.38177095408252e-06 -4.965572011396933e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8964479418573035 -5.582253252718596e-06 -5.153688906935528e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8975818988918038 -5.8545822277326325e-06 -5.409564548009973e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8990284332616256 -6.202891172864509e-06 -5.737395156979022e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9008076652431092 -6.632124424355883e-06 -6.14224694970594e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.902944465237774 -7.14787343393264e-06 -6.629921760119157e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9054688461310896 -7.75616478915734e-06 -7.206780098603869e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9084164164888464 -8.463191101570493e-06 -7.879512364478856e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.911828890734002 -9.27497471346435e-06 -8.654846865010017e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9157546504433165 -1.0196953209380487e-05 -9.539181323455182e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9202493481217249 -1.1233475320963889e-05 -1.0538122713429751e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9253765410209218 -1.2387196365126674e-05 -1.1655918909495565e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9312083374860987 -1.3658364234573058e-05 -1.2894765156029469e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9378260315893594 -1.5043990714113999e-05 -1.4253969365127665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9453206930327245 -1.6536908839500242e-05 -1.5728963360828643e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.953793667994485 -1.8124725354133536e-05 -1.7310153316045235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9633569322171271 -1.9788688617039395e-05 -1.8981613405043905e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9741332196234407 -2.1502506052207776e-05 -2.071964341755961e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.986255827562412 -2.323119609866492e-05 -2.249124503957348e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9998679729946278 -2.4930159695213464e-05 -2.4252632202621783e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0151215423956437 -2.6544379764975647e-05 -2.5947855255406603e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0321750422547185 -2.8007957135168948e-05 -2.7507746445285115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.051190518093723 -2.9244126203219794e-05 -2.8849442924561212e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.072329170672319 -3.0165866734052493e-05 -2.9876803227369345e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.095745363479534 -3.067703521290943e-05 -3.0482052319248733e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1215786938935213 -3.06740607965863e-05 -3.054903963426455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1499438040129233 -3.0048183933980617e-05 -2.995846859899953e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.18091765401003 -2.86875723580523e-05 -2.8595216932352195e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.21452412371792 -2.647861051490505e-05 -2.635756909825979e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2507199632518065 -2.3315870370459627e-05 -2.3166642036055076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.289388325678912 -1.9128750096292632e-05 -1.897717047426371e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.330337403475771 -1.3911500368776416e-05 -1.3792612528768056e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.373304975135935 -7.748383799404712e-06 -7.681515892986215e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.417967794581098 -8.05696413738496e-07 -7.829004347602262e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4639485047461536 6.722234951747012e-06 6.71185711456117e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.510824392314502 1.4625241229950242e-05 1.4578553996475766e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.558144191100308 2.264673221074789e-05 2.2570998824371542e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6054520951248406 3.050965201346922e-05 3.0439410051259475e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.6523085636036643 3.79912884982702e-05 3.7958705060289386e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.698301370239445 4.494399519875651e-05 4.4948847408969456e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.7430543615683227 5.1266829688519196e-05 5.128299233545161e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.786238608788138 5.688374620733897e-05 5.688682688878233e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8275843586057086 6.174931177260328e-05 6.173160053792185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.866888305555324 6.585359069637209e-05 6.582160421523342e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9040092924844165 6.921999859027109e-05 6.918666825893286e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9388576348462285 7.189813903926782e-05 7.187766429685601e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9713851140498155 7.395664494090802e-05 7.396031583418657e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0015760331937735 7.547688691754664e-05 7.550832925337906e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.02943967865953 7.654509580770699e-05 7.659731299310662e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0550040912727283 7.724466214704674e-05 7.730089763757368e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0783107359350566 7.76517812380231e-05 7.768852686315523e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.09940999831891 7.783326128730157e-05 7.782430779597877e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1183574332586868 7.784546732112942e-05 7.776646526063805e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1352106776164947 7.77336951448344e-05 7.756709959493157e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1500268467327097 7.753484656342726e-05 7.727262453618136e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1628603734712217 7.728147321054287e-05 7.692434257336152e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.173761375297395 7.700319077147207e-05 7.655851709364482e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.182774446098795 7.672676034038222e-05 7.620628351316276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.18993777700517 7.64756457274523e-05 7.589356406107737e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.195282529255332 7.626943640635788e-05 7.564103459437777e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.19883239887066 7.612331339318662e-05 7.546414018358929e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.2006033276030563 7.604762998944867e-05 7.5373137244459e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener new file mode 100644 index 000000000..ea6e46bdd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041893194545286803 +1 0.04190416430686307 +2 0.041926573107446304 +3 0.041961382581028335 +4 0.04201009400488142 +5 0.042074822074995806 +6 0.042158398647329405 +7 0.04226451116876075 +8 0.04239788180676558 +9 0.04256449456535044 +10 0.042771878851080275 +11 0.043029458855995656 +12 0.043348978471638724 +13 0.04374501080009371 +14 0.04423555902579416 +15 0.04484275050552148 +16 0.04559361710077131 +17 0.04652094024260626 +18 0.047664116713822265 +19 0.04906996792176053 +20 0.05079336851582768 +21 0.05289750679779858 +22 0.055453507909553244 +23 0.05853905262363751 +24 0.06223551678426397 +25 0.06662305590417485 +26 0.07177299811383939 +27 0.0777369397030407 +28 0.08453213980582987 +29 0.09212319131119805 +30 0.10038859382054334 +31 0.10907979033504547 +32 0.11781692566332927 +33 0.1260840033375966 +34 0.13330230048462352 +35 0.13912928683748174 +36 0.1433336350927979 +37 0.1457092052023126 +38 0.14608760797734582 +39 0.14449567470983662 +40 0.14129631180244404 +41 0.13691652159688794 +42 0.13158200535880082 +43 0.1253274946332697 +44 0.11823120975875165 +45 0.11057888046994681 +46 0.1027544559205986 +47 0.09506366259704169 +48 0.08773262780429705 +49 0.08089985610521704 +50 0.07463164058079062 +51 0.0689598456643313 +52 0.06389115372324804 +53 0.059413704718590934 +54 0.0555027659978752 +55 0.05212166261610249 +56 0.04922688615920054 +57 0.046778985655057254 +58 0.04474358682496325 +59 0.04309143424163736 +60 0.04179835134430192 +61 0.040845158289268026 +62 0.04021757689517635 +63 0.03990614345230872 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz new file mode 100644 index 000000000..d0026ca45 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8947079768256523 -5.204865147437134e-06 -4.802507976924209e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.894980981379237 -5.270518580957707e-06 -4.864061781199086e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8955307339029879 -5.402895399878576e-06 -4.988239858505211e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8963647873733993 -5.604110065799059e-06 -5.177164032551676e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8974946365343803 -5.877267650343919e-06 -5.433964583588275e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8989359159620496 -6.226379809743363e-06 -5.762712944383561e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9007086635518635 -6.656245735805535e-06 -6.1683259932492806e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9028376486027487 -7.172292971212752e-06 -6.656436152526726e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.905352763046988 -7.780370985393091e-06 -7.233219852947007e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9082894734232838 -8.48648855879627e-06 -7.905175088111664e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9116893297951036 -9.296484920616162e-06 -8.678836742855878e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9156005258341668 -1.0215623609246334e-05 -9.560416405496355e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9200785015355037 -1.1248097628017197e-05 -1.0555351547001976e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9251865762751883 -1.239643501409844e-05 -1.166774760397955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.930996594885822 -1.3660795815948255e-05 -1.2899696008484267e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9375895627584583 -1.5038155208451937e-05 -1.4250452170118069e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9450562372781475 -1.6521373458085582e-05 -1.5715460491412334e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.95349763168276 -1.8098162011741877e-05 -1.7285219640479505e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9630253731704514 -1.9749966653128907e-05 -1.8943992022531888e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9737618392015792 -2.1450803210887507e-05 -2.066837808565619e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.985839973907779 -2.3166120850308813e-05 -2.2425806630396083e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.999402659896469 -2.4851839916732752e-05 -2.4173043369999744e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0146014893799444 -2.645354238936253e-05 -2.5854813290870793e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.031594742814394 -2.7905991719677026e-05 -2.7402734015058705e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0505443443888454 -2.913312031363421e-05 -2.8734811243100843e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.071611524447786 -3.0048601775664795e-05 -2.975580844378243e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.0949508841788496 -3.055698580229129e-05 -3.0358833333562854e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.120702535683957 -3.055541760151133e-05 -3.0428520740086557e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1489819932102363 -2.9935861761509287e-05 -2.984615684087173e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1798675365316385 -2.8587246812917173e-05 -2.8496882341773656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2133849033958395 -2.639678412266393e-05 -2.6278820114545666e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2494930578647 -2.3258986809734143e-05 -2.311249607098485e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.288077523372152 -1.9101757046589183e-05 -1.895139622207738e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3289488556460434 -1.3916264575780528e-05 -1.3796831511441126e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.371846982492969 -7.782446745722426e-06 -7.71431184282335e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.416450536692653 -8.637264740960753e-07 -8.399201109556976e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4623838568680787 6.646371974970047e-06 6.637000527907664e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.509225601737712 1.4539425789386458e-05 1.449378592561719e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5565251973956045 2.25613803778682e-05 2.248539184177841e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6038267139147586 3.0434515672486144e-05 3.036203911457984e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.650689976709297 3.793294905983966e-05 3.789738870512627e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.696701815634483 4.490630362412236e-05 4.4909430756766336e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.741484844259748 5.1252976079237635e-05 5.1269163287504245e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7847084416846153 5.6896090891066394e-05 5.690020458124208e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.826100775192595 6.178893450126702e-05 6.177219328372322e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8654562742195813 6.592002441271463e-05 6.588838518842861e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9026318128052644 6.93114754087251e-05 6.927768297143114e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9375360732490847 7.201189613686782e-05 7.199022398947189e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.970119510257496 7.408920532570541e-05 7.409127449051786e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0003653700354866 7.562432203505797e-05 7.565439960682852e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0282820983925904 7.670349570627532e-05 7.675530916837157e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0538970769107987 7.74104584734645e-05 7.746788359669338e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.077251264131969 7.782192878187901e-05 7.786190186888465e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0983946657677164 7.800534575888003e-05 7.80018521040246e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1173825591831696 7.801779751999227e-05 7.794636452155895e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.134272385133945 7.79053727139194e-05 7.77479505649619e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.149121135036387 7.770542315832043e-05 7.745336422842561e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.161983173508699 7.745072656740418e-05 7.710420671585507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1729085884187556 7.717103763082247e-05 7.67370196468066e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.18194196921165 7.689322723497846e-05 7.638319774777458e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.189121517206625 7.664085915196578e-05 7.606889729033312e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1944784104212918 7.643361460623868e-05 7.581499431343483e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1980363622792747 7.628675270024002e-05 7.563709206344425e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.199811328352653 7.621068419611643e-05 7.554555666814928e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener new file mode 100644 index 000000000..a70398bc2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041891224895152124 +1 0.04190215022291224 +2 0.04192446807319051 +3 0.04195913580959552 +4 0.04200764803681465 +5 0.042072110043344456 +6 0.04215534107889665 +7 0.042261012173715085 +8 0.04239382448928322 +9 0.04255973546709604 +10 0.0427662412198763 +11 0.043022724518458476 +12 0.043340878087975335 +13 0.04373521230249169 +14 0.044223654104929004 +15 0.04482823913557161 +16 0.045575890313696486 +17 0.046499261719503235 +18 0.04763760430842543 +19 0.04903757703204434 +20 0.050753880341968996 +21 0.0528495260272313 +22 0.055395476276634895 +23 0.058469287047334374 +24 0.06215228318792485 +25 0.06652469191286386 +26 0.07165809877539783 +27 0.07760461884618047 +28 0.08438237369401985 +29 0.09195726049081913 +30 0.10021013154665162 +31 0.10889518083347778 +32 0.11763545419189651 +33 0.12591793095263132 +34 0.1331622089358044 +35 0.13902076907170102 +36 0.14326161120353967 +37 0.14567837981409174 +38 0.14610134850232134 +39 0.14454966388617393 +40 0.1413819375612364 +41 0.13702572825631126 +42 0.13171398185015334 +43 0.12548199997311907 +44 0.11840586490122801 +45 0.11076533083818534 +46 0.10294513264516854 +47 0.09525264316343797 +48 0.08791561405555194 +49 0.08107464986400466 +50 0.07479706653686623 +51 0.06911535169353057 +52 0.06403667384609679 +53 0.05954953811223001 +54 0.05562949493948561 +55 0.05224031502480873 +56 0.049338559994586244 +57 0.046884716451280756 +58 0.04484434955812766 +59 0.0431881482461641 +60 0.04189188734447817 +61 0.04093634685911633 +62 0.04030721785234237 +63 0.03999501583580433 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz new file mode 100644 index 000000000..c1dcd648f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8946586789989965 -5.2174122228782045e-06 -4.816682602086411e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8949310522991487 -5.283261154322763e-06 -4.878435649554147e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.895479532326985 -5.4160080467744745e-06 -5.002991179786227e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8963116519421301 -5.617725815473759e-06 -5.192428961492306e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8974388753689173 -5.89145855924812e-06 -5.449817449769258e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8988767958557784 -6.241139246594177e-06 -5.779148258654037e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.90064539863562 -6.6714731511403035e-06 -6.185242741108464e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9027693883755539 -7.1877817171155655e-06 -6.673624945277116e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9052785796843683 -7.79579970715573e-06 -7.2503535316015325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9082083483026264 -8.501416761758388e-06 -7.92180337721009e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9116001392153297 -9.31035331117105e-06 -8.694385571173829e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9155020259584379 -1.0227759797889639e-05 -9.57419252809697e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9199693126549908 -1.1257727771793668e-05 -1.0566553132220194e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9250651665842857 -1.2402701961852842e-05 -1.1675481479321645e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9308612640813299 -1.3662784305188165e-05 -1.2903002286018852e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9374384259350275 -1.5034924635262016e-05 -1.4248336969662304e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.944887209799507 -1.6511998740444014e-05 -1.5706937458372555e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.953308415973918 -1.80817832087735e-05 -1.7269360943952817e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9628134487129527 -1.9725848383955706e-05 -1.891998947181918e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9735244574350754 -2.1418405812773587e-05 -2.0635614938852323e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.985574160259612 -2.3125178853254628e-05 -2.238393841125878e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9991052257863104 -2.4802419019744335e-05 -2.4122077590571538e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.014269057782205 -2.6396090738748427e-05 -2.5795188119407102e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.031223791797256 -2.7841380975121703e-05 -2.7335389347799686e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0501312739539066 -2.9062668725663505e-05 -2.866124235743439e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.071152752901293 -2.9974071920788516e-05 -2.9678089990866097e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.094442981054004 -3.0480584419496906e-05 -3.0279606179431574e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1201423987069976 -3.047980997220289e-05 -3.035093103576172e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.148367076661321 -2.9864175584695134e-05 -2.9773727985243547e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.179196137168203 -2.8523092317902405e-05 -2.8433312119209232e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.212656503538666 -2.63443009809711e-05 -2.6227708860202295e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2487085548573544 -2.322230330366334e-05 -2.307707274409322e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2872393300526443 -1.908407631789816e-05 -1.8934104529510843e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3280608964075626 -1.3918853722977315e-05 -1.3798760224868436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3709145582667577 -7.803828812160812e-06 -7.734621537746708e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.415480151040219 -9.005165178886027e-07 -8.758716973394315e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4613830988358547 6.598088322161077e-06 6.5894650021201695e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.5082029385517437 1.4484631604863868e-05 1.4439709537807796e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5554895418029444 2.250670453003413e-05 2.2430564195807956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.602786904016518 3.0386263779303566e-05 3.0312283445144177e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.6496544465987446 3.789540188756766e-05 3.785774478919682e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6956783969249294 4.488194671680843e-05 4.488368376438484e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.740480580221862 5.124383982941972e-05 5.125971789402086e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.783729295102974 5.690369346365528e-05 5.6908135500281214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.825151380130197 6.181398921611348e-05 6.179752911431782e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8645398178936823 6.596225734250148e-05 6.593048662226043e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.901750221803815 6.936977501310867e-05 6.933531728760855e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.936690228284718 7.208450960046999e-05 7.20616852888148e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.969309442286094 7.417391979790582e-05 7.41745585737375e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.999590432826521 7.571862821810202e-05 7.574740541254459e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0275411071796894 7.680488564464828e-05 7.685599652533593e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0531884244868484 7.751663702250646e-05 7.757436984386669e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.076573018747992 7.793093212882697e-05 7.797251761251315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0977446520841316 7.81156106573832e-05 7.811517098556977e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.116758423919164 7.812821810652215e-05 7.806121883354767e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1336716493464007 7.801535346934488e-05 7.786343679003902e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1485412401936923 7.781467077810964e-05 7.756879918695899e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1614215171763074 7.755909894537367e-05 7.721909918331988e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1723625490380254 7.727848442841177e-05 7.685105651429436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1814089222365776 7.699976945992336e-05 7.649623167141474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1885988445003606 7.674658210658962e-05 7.618093048840221e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.193963504500889 7.653866233201462e-05 7.592615693940158e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.197526626738813 7.639131914187403e-05 7.574761538084735e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.19930417559225 7.631499999891348e-05 7.565574208460529e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener new file mode 100644 index 000000000..4dd14351e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04188996657777692 +1 0.041900863526889834 +2 0.041923123290036494 +3 0.04195770050408234 +4 0.0420060855131063 +5 0.04207037759868062 +6 0.042153387961075615 +7 0.04225877714797312 +8 0.04239123290766601 +9 0.042556695720057956 +10 0.04276264043735885 +11 0.043018423378940955 +12 0.043335704593480864 +13 0.04372895439217363 +14 0.044216051019865206 +15 0.04481897152736948 +16 0.04556456922968684 +17 0.04648541682458694 +18 0.04762067205218661 +19 0.04901688998007385 +20 0.05072865960581607 +21 0.05281887968573434 +22 0.05535840789837423 +23 0.058424719865035474 +24 0.06209910701146486 +25 0.066461841209792 +26 0.07158467096788483 +27 0.07752004091605551 +28 0.08428662141762541 +29 0.09185113866674895 +30 0.10009593976347193 +31 0.10877697963014449 +32 0.11751915734160046 +33 0.12581135530799012 +34 0.13307220508135698 +35 0.13895092600109205 +36 0.1432150762092829 +37 0.1456581628459286 +38 0.14610963278888334 +39 0.14458378473150957 +40 0.14143639238751873 +41 0.13709530919860483 +42 0.1317981110496677 +43 0.1255805307751963 +44 0.11851733915702649 +45 0.1108844393473955 +46 0.10306701924110809 +47 0.09537350522366975 +48 0.08803268331193705 +49 0.08118650169152661 +50 0.07490294300227612 +51 0.06921489462993596 +52 0.06412983710469453 +53 0.05963651004553192 +54 0.05571064347467451 +55 0.05231629164973843 +56 0.049410067695638174 +57 0.04695241828952321 +58 0.044908869850933196 +59 0.04325007570479916 +60 0.041951779568970234 +61 0.04099473574992911 +62 0.040364615621776574 +63 0.040051921394414956 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz new file mode 100644 index 000000000..03f537d8c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8946271398760188 -5.225674326534558e-06 -4.825299010770842e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.894899109419571 -5.2916432707833165e-06 -4.887187119363123e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.895446775546507 -5.4246169236537335e-06 -5.0119991824009696e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8962776582522902 -5.626641858383424e-06 -5.2017878008586234e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8974032022448168 -5.9007235149928205e-06 -5.459581488696508e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8988389743444964 -6.250744972334116e-06 -5.7893202884395674e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9006049261077105 -6.681351960823729e-06 -6.195763822662202e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9027257208707462 -7.197798664507583e-06 -6.684366088456167e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.90523112379517 -7.80574713701134e-06 -7.261109594481661e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9081564525570596 -8.511011512938801e-06 -7.932289568040796e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.911543084944227 -9.319236953174516e-06 -8.704236947962577e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9154390176656064 -1.0235502275610576e-05 -9.582966901477077e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9198994679528358 -1.126383482718653e-05 -1.0573737795484804e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9249875058165546 -1.2406626692887115e-05 -1.1680504208512654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9307746998326776 -1.3663943213980859e-05 -1.290524706979121e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9373417527292698 -1.503271850069238e-05 -1.424716492717185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.944779094420871 -1.650583865094421e-05 -1.570171339007281e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.953187389015454 -1.8071122182861637e-05 -1.7259485953697328e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9626778981716309 -1.9710219250651552e-05 -1.890494006963599e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9733726254423485 -2.1397466597219028e-05 -2.0614988994520776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.985404144367682 -2.309876285158577e-05 -2.235750689012247e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9989149866301472 -2.477057117183863e-05 -2.4089835630680675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.014056435407754 -2.635910038661744e-05 -2.5757405486377288e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0309865334809216 -2.7799808120986523e-05 -2.7292656105029734e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0498670769172844 -2.9017358809225584e-05 -2.8614503494832755e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.070859325905254 -2.992615438489003e-05 -2.9628661207129954e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.094118129360892 -3.0431472525075695e-05 -3.0229166038632114e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1197841372029558 -3.043120969346356e-05 -3.0301482705393987e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1479737758413475 -2.981808737647457e-05 -2.9727518169822278e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.178766705931564 -2.8481822464053572e-05 -2.8392702192500464e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.212190608326317 -2.6310492811714702e-05 -2.6195001186767487e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2482067670047514 -2.319860216518191e-05 -2.3054335836613523e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2867031902053014 -1.9072547471747827e-05 -1.8922911325537084e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3274929122114663 -1.3920337147790386e-05 -1.3799825996184825e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3703181182985524 -7.817417906453827e-06 -7.747436062366614e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.4148594137053774 -9.240550242396838e-07 -8.987028790194439e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4607429171896102 6.567104365739194e-06 6.559199249699151e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.507548727689012 1.4449371230768683e-05 1.4405220830461087e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.554827002764131 2.2471398928987787e-05 2.239554565206991e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6021216915269947 3.035498083996165e-05 3.028046212828326e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.648991957297969 3.7870917165324084e-05 3.7832354620149705e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6950236423421674 4.4865869090935684e-05 4.48671592704662e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.73983806768427 5.123747267698633e-05 5.1253610279762644e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7831028413206846 5.690802039625416e-05 5.6913142731370934e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8245439522388858 6.182948478653381e-05 6.181367386648955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8639534578924675 6.598876546999072e-05 6.595736191042346e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9011861646946615 6.940660101072146e-05 6.937213695273768e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.936149039492901 7.213054584672816e-05 7.210735952696322e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.968791143171844 7.422776215706213e-05 7.42278049024549e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.999094611103431 7.577867899885721e-05 7.580687723786092e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0270670057098226 7.686954249543517e-05 7.692038513930809e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.052735015597897 7.75844301862082e-05 7.764246694994407e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.076139066907417 7.800060124858014e-05 7.804325146392526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.097328765727429 7.818614923009226e-05 7.81876256634651e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.116359097484316 7.819890905789125e-05 7.813464424699091e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.133287296790556 7.808580578382377e-05 7.793725285196824e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1481702244493515 7.78846917365719e-05 7.764256848804073e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.161062173004411 7.762859424139345e-05 7.729250801913218e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1720131988989606 7.734741862733973e-05 7.692390566845112e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1810678866287674 7.706815229061926e-05 7.656842835474966e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1882644479839457 7.681446374419966e-05 7.62524778961691e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1936340784233743 7.660612985522283e-05 7.599714036390405e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1972005095141953 7.645849099769777e-05 7.581818499920253e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1989797112554377 7.638201772451874e-05 7.572609308953489e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener new file mode 100644 index 000000000..3389bbc33 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04371373853924163 +1 0.04377279682441858 +2 0.043879440899471794 +3 0.04403866981965937 +4 0.044257913475114395 +5 0.04454746472268966 +6 0.044920952995220455 +7 0.045396038507791545 +8 0.04599521819759 +9 0.04674671691079392 +10 0.04768535494532812 +11 0.04885365412601556 +12 0.050302891004951604 +13 0.0520938643658403 +14 0.05429674872306641 +15 0.05699012466246713 +16 0.06025926559406508 +17 0.06419186949563181 +18 0.06887030575536993 +19 0.07435995273343649 +20 0.08069519692535944 +21 0.08786317188330431 +22 0.09578305995093409 +23 0.10426424462585888 +24 0.11299201995525958 +25 0.12153034115023935 +26 0.1293276999083341 +27 0.13591030997143946 +28 0.1410287785347692 +29 0.1444829668230005 +30 0.14609038340530406 +31 0.14572913793329656 +32 0.14355547696383517 +33 0.1399531080024541 +34 0.1352948085878865 +35 0.12968556019599656 +36 0.12314313621155477 +37 0.11576558764683059 +38 0.10789191818215327 +39 0.09988032370245704 +40 0.09201439807054475 +41 0.0845022184881069 +42 0.07745968861051876 +43 0.07094874882391104 +44 0.06500061370561551 +45 0.05962302621834198 +46 0.05480580219755224 +47 0.05051658601487003 +48 0.046707214814439374 +49 0.04333178293410624 +50 0.04034827448886562 +51 0.03771853964990129 +52 0.03540804513061452 +53 0.03338583491221042 +54 0.03162453234588845 +55 0.03010017935527278 +56 0.02879190936785377 +57 0.02768178681578717 +58 0.026754607301713192 +59 0.025997602311532565 +60 0.02540027513953168 +61 0.024954285786171548 +62 0.024653374813461255 +63 0.024493207033670958 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz new file mode 100644 index 000000000..4c85b6bac --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.92479820821466 -2.3309567153614935e-05 -2.2720386483107385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.925529539077169 -2.3799148727890006e-05 -2.32224133116635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9268294897361136 -2.4758341507054243e-05 -2.4205310747225572e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9287240835853154 -2.6166482735296483e-05 -2.5647797501544824e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9312499184897716 -2.799921182817904e-05 -2.752476105865621e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.934455068145866 -3.022744693141057e-05 -2.98054422996273e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9383990360788836 -3.281620726027869e-05 -3.245271269073706e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.943153707546518 -3.5724058455962664e-05 -3.542279247394234e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9488039246545936 -3.890308079361455e-05 -3.866507235123782e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.955447572522225 -4.229882289680538e-05 -4.212196429519972e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.963194653193207 -4.5850213751372115e-05 -4.5728738089561874e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.972168132103515 -4.94895431713935e-05 -4.941346547351479e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9825043417655723 -5.314239624665733e-05 -5.309697151013283e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.994352372993371 -5.6727445684468146e-05 -5.6692755690683835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.007870307918806 -6.0156027085158746e-05 -6.0106940483607235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.0232218717201818 -6.333167046837596e-05 -6.323865462939384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0405757440970413 -6.614984262466391e-05 -6.598092729997819e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0600997964466883 -6.849742253421255e-05 -6.822177540200282e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.0819503592227684 -7.025104384794905e-05 -6.984579661910421e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.106258397717625 -7.127316334896938e-05 -7.07366054719994e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1331204287470515 -7.141606589162124e-05 -7.078184662312268e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.1625912373916707 -7.055875211249342e-05 -6.988539680196473e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.194673749904038 -6.861300960162608e-05 -6.797210201323669e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.229308399817824 -6.553159401679397e-05 -6.499295768001037e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.266376887223972 -6.131959469182547e-05 -6.09319069101125e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.3057080286723304 -5.604777070684699e-05 -5.581314056681226e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3470805991232497 -4.9827106798958765e-05 -4.9701420020779724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.390220999601711 -4.2772854196576336e-05 -4.269717655303836e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.4348059382696343 -3.499669807092489e-05 -3.4932529999396784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.480470603132379 -2.662373420290193e-05 -2.656574599927365e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.5268234116810153 -1.7815127384931018e-05 -1.7774728142259696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.5734657434516115 -8.766912945754458e-06 -8.748300726433559e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.6200087949294026 3.1927099173551256e-07 3.2466780812701995e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.666080461788052 9.261933270219657e-06 9.265738132713077e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.711332090117266 1.7908474959039507e-05 1.7914907784736767e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.7554480628097395 2.613154686621462e-05 2.613537293710691e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.7981547194290135 3.382470532613696e-05 3.381569001550386e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.839225153935033 4.0900862837490995e-05 4.086997061122992e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.8784845596019 4.7294255279446275e-05 4.7236516617813294e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.9158110322065975 5.2960865345852606e-05 5.2876178876359986e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.951132180079015 5.7877333580052634e-05 5.777038497515608e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.9844134060197485 6.203908442150987e-05 6.19184355654877e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 3.0156503172947953 6.5458197023884e-05 6.533427047060786e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 3.044863059613534 6.816137158806694e-05 6.804300693886844e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 3.0720927614512017 7.018647412819967e-05 7.007944484378024e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 3.0973931563725223 7.157967224511434e-05 7.148652306509956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.1208262490390326 7.239340939762308e-05 7.231371033804117e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.142459076504152 7.268476061592121e-05 7.261559638053656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.162364696907433 7.25140026859153e-05 7.245062751233139e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.180618198637129 7.194350269849672e-05 7.188014198387779e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.1972932694302933 7.103675788901315e-05 7.096746299100067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.2124613614776787 6.985739437916357e-05 6.977693521996941e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.2261919192553528 6.846833808076981e-05 6.837295908523478e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.238551263917111 6.693162714526306e-05 6.68191381636456e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.2496009915279407 6.530800091773223e-05 6.517743214407655e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.259397230201954 6.365625020876716e-05 6.350728723512863e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.267991025506514 6.203193774433818e-05 6.186484740865745e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.2754280871424513 6.0486547755952795e-05 6.030221726646524e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.2817485327340257 5.906689149599563e-05 5.8866756343816e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.2869869095970974 5.7814512252216745e-05 5.760045378849618e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.29117232649902 5.676517280264541e-05 5.653942264399849e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.294328459694895 5.5948509456554105e-05 5.571357868587529e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2964734183869573 5.538796050407633e-05 5.514660605068508e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.297620330925452 5.510115199500064e-05 5.485639704044741e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener new file mode 100644 index 000000000..88f4c1114 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04234439533764382 +1 0.04236839918367198 +2 0.04241646418346911 +3 0.042491041261955256 +4 0.04259592864722523 +5 0.0427364938749353 +6 0.04291997426332715 +7 0.043155883611461984 +8 0.043456532068844596 +9 0.04383767518487475 +10 0.04431930181258359 +11 0.04492660150786696 +12 0.04569109948336716 +13 0.046651938453812235 +14 0.047857224189416805 +15 0.04936536982338376 +16 0.051246305276850423 +17 0.053582133156981245 +18 0.05646672187031824 +19 0.06000354373929622 +20 0.06430080989636294 +21 0.06946206310883705 +22 0.07557047018988694 +23 0.08266564556459426 +24 0.09071642386380709 +25 0.09958258888219103 +26 0.10895817794979358 +27 0.11836689708293813 +28 0.1271626427898523 +29 0.1346624827671432 +30 0.14049189952087515 +31 0.14438781779879103 +32 0.1461183316080246 +33 0.1455386658906989 +34 0.14288462745816183 +35 0.13865439360417323 +36 0.1332488873430738 +37 0.12672450310693636 +38 0.11912366851096838 +39 0.11071997429279795 +40 0.10198346160961576 +41 0.09330364699146029 +42 0.08497176507698755 +43 0.0771570468546294 +44 0.06994829599404244 +45 0.06339300110857964 +46 0.05750629211475038 +47 0.05227498284978294 +48 0.04764859783869698 +49 0.04356838475978137 +50 0.03997986115273254 +51 0.036833192146592995 +52 0.03408329023461092 +53 0.031689780850504994 +54 0.029616866329690503 +55 0.02783313847620978 +56 0.026311487396144147 +57 0.025028536469708564 +58 0.023964278035207696 +59 0.023101911060134962 +60 0.022427684836963575 +61 0.02193076017963605 +62 0.02160309437298838 +63 0.021439339957655675 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz new file mode 100644 index 000000000..54bdcf47b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9043635681982705 -2.3574664737804618e-06 -1.5397985465406904e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9048105633209322 -2.7177608342399073e-06 -1.898146200288798e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9056908003447979 -3.429033185197331e-06 -2.6057209628847055e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9070200400959174 -4.485420444307854e-06 -3.6570873640669584e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9088215754820397 -5.882155453810695e-06 -5.048052569302132e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9111267217819135 -7.6144064405881e-06 -6.7743645974462586e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9139753068873389 -9.676325726903756e-06 -8.830939781121699e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9174164031740366 -1.2060330367428353e-05 -1.1211266469280338e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9215091311331909 -1.4756449864971422e-05 -1.3906743399618697e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9263235185470224 -1.7751513178314547e-05 -1.690583448957746e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9319413413575892 -2.10281260541375e-05 -2.0192964261938985e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9384572734046674 -2.456349766034613e-05 -2.3747188261991633e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9459800472079374 -2.8328028034451463e-05 -2.7540522532319264e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9546335183461465 -3.2283595167012166e-05 -3.1535852202013807e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9645573047457148 -3.638152073453732e-05 -3.568440543340355e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9759073380559127 -4.0560416724592786e-05 -3.9923059412096665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9888564570639893 -4.474403437173501e-05 -4.417168581622764e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.003593896760544 -4.883880558172852e-05 -4.833048281276236e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.0203234100931824 -5.273081855745851e-05 -5.227767017465835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.0392598586655946 -5.6281788824456207e-05 -5.5868200245259076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.060623851805577 -5.9328531750137885e-05 -5.893548892133e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.0846308945698953 -6.169946947701013e-05 -6.130079896562089e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.1114734690620978 -6.321478364782044e-05 -6.278265426183996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.141295580349001 -6.368353449352105e-05 -6.320926468764245e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.1741725783268615 -6.292004179981589e-05 -6.242949772820317e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.210097671609064 -6.0779346213361455e-05 -6.032598758225549e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.248975979849285 -5.718776508489356e-05 -5.683168886346341e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.2906297437535494 -5.218423629801967e-05 -5.1951922892723266e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.3348059382696342 -4.592097644387481e-05 -4.5777791634917916e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.3811738889642644 -3.8583267723281397e-05 -3.8472081483582665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4293232283559085 -3.0346456135051507e-05 -3.0249903554367233e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.478780021539536 -2.1434388633311783e-05 -2.13683512469113e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5290432018813616 -1.2140449822425741e-05 -1.2110853012062934e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.579613861313698 -2.7680185965670163e-06 -2.761025571539499e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.630008491701989 6.4240422198967984e-06 6.422583048046855e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6797654792217624 1.5229367322623172e-05 1.5223151813907907e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.7284574475471914 2.3485795774409485e-05 2.347258567160085e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.775709737014369 3.1071481348260974e-05 3.105056711754361e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.8212192000440464 3.790399991656536e-05 3.7878111911277255e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.8647627388024834 4.393987521889933e-05 4.391398875740664e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.9061865838321896 4.917081362962761e-05 4.9150710691837515e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.9453942777438735 5.361843786472015e-05 5.360838353227041e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.982335906468645 5.7328213221599804e-05 5.732715727459007e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 3.016998703531696 6.036055233959352e-05 6.0359646007444474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 3.0493993554945726 6.27828710599343e-05 6.276511522097818e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 3.0795768518118565 6.46636954482279e-05 6.460589866664239e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.1075867068744163 6.606817767466444e-05 6.594500397687752e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.1334961190553403 6.705416756766916e-05 6.684437603272461e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.157380237051859 6.767276492842254e-05 6.73642696697139e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.179318301741303 6.797263897177988e-05 6.756325279387656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.1993905189366725 6.80017410474991e-05 6.749767903780615e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.2176758616909913 6.780742088469688e-05 6.722095899069421e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.2342505248167663 6.743586719504821e-05 6.678288796054374e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.249186648588034 6.693144063326089e-05 6.622918496311525e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.2625513302429 6.633602512051017e-05 6.560123973889089e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.274406008351491 6.568847736918379e-05 6.493601091612761e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.2848061867355307 6.502412004135624e-05 6.42660521877788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.293801225005649 6.437451334898567e-05 6.361965473187706e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.3014342284811242 6.376717424833377e-05 6.302099303726131e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.307742039604898 6.322521425167444e-05 6.249027004115932e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.312755291646201 6.276744748045058e-05 6.204399405712043e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.3164984729277367 6.240878431501535e-05 6.169536056008451e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.31898998158741 6.216082833132373e-05 6.145476942080818e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.3202422646486256 6.203274941913098e-05 6.133060331085558e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener new file mode 100644 index 000000000..ac3be1528 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04231656490895323 +1 0.042336762809028004 +2 0.042378052489083634 +3 0.04244226282974432 +4 0.04253224752178663 +5 0.04265202434489661 +6 0.04280696967870729 +7 0.043004075794746584 +8 0.04325228010880712 +9 0.04356287677386368 +10 0.043950021422365024 +11 0.04443133893036542 +12 0.04502864103573455 +13 0.045768754124141775 +14 0.04668444573323813 +15 0.04781541866745719 +16 0.0492093110013863 +17 0.05092259468680595 +18 0.053021199003867106 +19 0.05558059198280212 +20 0.058684927809034136 +21 0.062424709599573434 +22 0.06689222673835961 +23 0.07217375562692263 +24 0.07833652660707639 +25 0.08540865785574313 +26 0.09335220387387985 +27 0.10201730975668992 +28 0.11109913352878645 +29 0.12013349855733638 +30 0.1284951788762275 +31 0.13557801392595056 +32 0.14104888250592384 +33 0.14465041760882258 +34 0.14615608500327512 +35 0.14543811843260246 +36 0.14274974602637228 +37 0.13857232305696274 +38 0.1332896579869666 +39 0.12696565416953873 +40 0.11965224688183355 +41 0.11159703925342612 +42 0.10323691680820642 +43 0.09493451406059365 +44 0.08696145860175497 +45 0.0794837096161297 +46 0.0725831489889727 +47 0.06630202198059178 +48 0.06065263498151688 +49 0.05562477796892386 +50 0.051185157477042054 +51 0.047280296617014515 +52 0.04385865202849526 +53 0.04087345769019551 +54 0.03828279806280522 +55 0.036049534030144555 +56 0.03414113637536859 +57 0.03252946567892822 +58 0.031190537988946682 +59 0.03010429411312098 +60 0.029254382228693622 +61 0.028627966864195404 +62 0.028215569980439743 +63 0.028010930217530393 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz new file mode 100644 index 000000000..e8da1e1e4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9038388331314848 5.698536736320816e-07 1.1290180629367577e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.904220363458139 4.4389542697350707e-07 1.0095747382564004e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9049889110233125 1.8988447627589312e-07 7.684414742619577e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.90615548589555 -1.9753292944332575e-07 4.0002429014501395e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9077368046118404 -7.265405641500772e-07 -1.0422716356024385e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9097555618942592 -1.4077625865124074e-06 -7.554693953192855e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9122407898213216 -2.253824521808497e-06 -1.5670778902071553e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9152283023197108 -3.2788271086441376e-06 -2.55417985248935e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.918761221979587 -4.497699554015382e-06 -3.733067126516505e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.922890584405618 -5.9254018380265275e-06 -5.1204555193977045e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9276760127982777 -7.575953025786163e-06 -6.732557509855707e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9331864517377133 -9.461273368088894e-06 -8.58394172183588e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9395009453856655 -1.1589812338024467e-05 -1.0686132048112176e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9467094392402293 -1.3964938310632951e-05 -1.304589745418351e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9549135761447582 -1.6583071719167955e-05 -1.5663186383789955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9642274444205894 -1.9431573467954114e-05 -1.8528692194298156e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.974778220678466 -2.2486392603352305e-05 -2.1621042682664642e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9867066314159105 -2.570942322513759e-05 -2.490359200430806e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.0001671268406636 -2.9045508595686295e-05 -2.832086775229247e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.0153276172685186 -3.241894385682509e-05 -3.17948086126933e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.0323685638556466 -3.573057267197226e-05 -3.522139694711719e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.051481141876455 -3.886030194760903e-05 -3.846965094672999e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0728640837699572 -4.1667507703254776e-05 -4.1381962705768466e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0967183568521306 -4.399237373770205e-05 -4.377777640459725e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.1232352690593963 -4.56581206163419e-05 -4.546219184976732e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.15257501756976 -4.647150889990407e-05 -4.623987925195038e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.1848389827674644 -4.622067141626852e-05 -4.593025104344344e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.220050194802684 -4.470320740344736e-05 -4.4381462908685316e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.2581422521203933 -4.1780308853106125e-05 -4.1493411906960015e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.298961142696549 -3.744384853385056e-05 -3.724946161333574e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.342273505465722 -3.1845064125990966e-05 -3.1740215043882384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.3877612980278493 -2.5201050287707027e-05 -2.5145868048986387e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.435016681655949 -1.7729541982841655e-05 -1.770788108783422e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.4835631281119506 -9.69940997077131e-06 -9.713670766968289e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.532896645529289 -1.4376954425932356e-06 -1.47344445834695e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.582511981476462 6.749246380210344e-06 6.715914582301642e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.6319087626852085 1.4623926810823502e-05 1.4601016783586861e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.680598515385747 2.2006139820941445e-05 2.1987445048542396e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7281290708491888 2.8761247908343198e-05 2.8741728886643453e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7741223032088365 3.4800649519847865e-05 3.4782511872173486e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.8182914405998827 4.008230234885231e-05 4.007125626783367e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.860430042537471 4.460627792546947e-05 4.460819181605814e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.9003990731983094 4.8407960954145466e-05 4.8425683308588556e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.938113703159167 5.155026963608926e-05 5.157928807154999e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9735325183173305 5.411202549260218e-05 5.413657789474284e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 3.006648885878958 5.617587539015603e-05 5.616911737581659e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.037483332524887 5.7819596382423816e-05 5.774753662845888e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.066076979253715 5.910935817802774e-05 5.893844070756152e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0924869408381226 6.009527703975397e-05 5.9802808193535256e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.1167814646332865 6.081808110078547e-05 6.039688308673685e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.1390351048639924 6.13151688300516e-05 6.0772570984988586e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.1593249605044105 6.16226965534016e-05 6.097703322547115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.177727890785579 6.177577640990062e-05 6.105213270808306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1943183874161005 6.180794860339532e-05 6.103407072646633e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.2091670459074058 6.175052795160348e-05 6.0953312428960636e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.222339481010774 6.163218075535107e-05 6.083482218582735e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.233895588013838 6.147883225382208e-05 6.0698498287783946e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.2438890814698595 6.13121413845217e-05 6.055941297491275e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.2523671863281205 6.114865094809774e-05 6.04283147882392e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.259370444056758 6.1000166094095175e-05 6.031242015290682e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2649326238881895 6.087461631028677e-05 6.021626348722421e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2690807016945453 6.077702546974523e-05 6.014249171823521e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2718348757982745 6.0710411437919616e-05 6.0092552004136126e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.273208597006055 6.0676541791426664e-05 6.006725849216844e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener new file mode 100644 index 000000000..3f45c655e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.042088744413916156 +1 0.04210428149256628 +2 0.04213604523791847 +3 0.04218544909864358 +4 0.04225470075102366 +5 0.042346911648582494 +6 0.04246625059729074 +7 0.04261814782168433 +8 0.042809557540910696 +9 0.04304928842450113 +10 0.04334841221332773 +11 0.04372076089081081 +12 0.0441835214898591 +13 0.04475793404213838 +14 0.045470091063186655 +15 0.0463518245705576 +16 0.04744164664467103 +17 0.048785679026471386 +18 0.05043846264773974 +19 0.052463475506141576 +20 0.05493310352229413 +21 0.05792770228248838 +22 0.06153325992226248 +23 0.06583703282414399 +24 0.07092039956354898 +25 0.07684810883447224 +26 0.08365270609036946 +27 0.09131224181122999 +28 0.09971402935088211 +29 0.10860521741246201 +30 0.11758395014083117 +31 0.12609440121935803 +32 0.13350642086169745 +33 0.13944145352444956 +34 0.14364005822719678 +35 0.14587145411584898 +36 0.14595660424021498 +37 0.14398079802593797 +38 0.14036782191546796 +39 0.1355681404838385 +40 0.1297439031797784 +41 0.12292919419310921 +42 0.11525211261401658 +43 0.10710332283476995 +44 0.09887559611948059 +45 0.0908716745187629 +46 0.08330288548441715 +47 0.07627845296459117 +48 0.06985459576280433 +49 0.06405492989453869 +50 0.05887807226127574 +51 0.054303888578283284 +52 0.05029041776875599 +53 0.04678598035031476 +54 0.04374315914565484 +55 0.04111944103004751 +56 0.03887723900238802 +57 0.03698379829296657 +58 0.035411036663021166 +59 0.03413535468352987 +60 0.03313744084941658 +61 0.032402089247400435 +62 0.03191804216965744 +63 0.03167786608450653 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz new file mode 100644 index 000000000..96da9f908 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8992377696771305 -2.4314150304199494e-06 -1.9070819654733822e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8995714268158068 -2.5145080384154506e-06 -1.9848027511456223e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9002434785176934 -2.6833405793644183e-06 -2.142933534257312e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9012634781084639 -2.943170208656056e-06 -2.3868683869701266e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.902645956463107 -3.3016981078136197e-06 -2.7245371152713614e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9044106635082718 -3.7688284738526844e-06 -3.166165155770922e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.906582888443784 -4.356307308645491e-06 -3.7239595966247675e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9091938567757036 -5.0772684379681775e-06 -4.411704670976655e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9122812011594474 -5.9456856609864204e-06 -5.244254563875975e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9158895014549175 -6.97570853271297e-06 -6.236913169226133e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9200708871441754 -8.180872136322946e-06 -7.404685827662849e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.924885692138877 -9.573171511307989e-06 -8.761386754605175e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9304031478254033 -1.1161991186809736e-05 -1.0318582688822955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9367020945512587 -1.2952881528348548e-05 -1.2084352264007857e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.943871684286473 -1.4946175525846125e-05 -1.4061841079472016e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9520120373585854 -1.7135444623912406e-05 -1.6247597809053998e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.961234803568854 -1.950579296828792e-05 -1.8629682424187195e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9716635620588396 -2.2031975096310987e-05 -2.118554199249268e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.983433973937925 -2.4676295478698772e-05 -2.3879664155384792e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9966935762823415 -2.7386182727217016e-05 -2.666103484228257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.011601074948531 -3.0092343839708424e-05 -2.9460751684796827e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.028324955938075 -3.27108637182728e-05 -3.2191016008757996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0470411882341426 -3.514302191230037e-05 -3.474418316337717e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.067929734093796 -3.727564222162443e-05 -3.699293800984737e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.091169513907649 -3.898228366573795e-05 -3.8792257694215044e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.11693138795257 -4.012509023720548e-05 -3.998399471291908e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.145366745947713 -4.055223156732037e-05 -4.0404210964629156e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1765854722014875 -4.009231106671659e-05 -3.98942157268235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.2106333874508235 -3.856640938650025e-05 -3.831377231673804e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.247478256527688 -3.582470127237623e-05 -3.555652245631403e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.287001749220857 -3.1793441740736674e-05 -3.157223971508864e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.3290045288720664 -2.6527135272660785e-05 -2.6393474365902037e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.373214538352732 -2.0203610845046616e-05 -2.0146149967297176e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.419283559944299 -1.304020951513216e-05 -1.302800741594035e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.466787012971946 -5.2652378009033106e-06 -5.286012364750997e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.515248004122567 2.8406128359715693e-06 2.798142639660091e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.5641740704868243 1.097243455629281e-05 1.0934654600958404e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.6130778602248963 1.8873043127713535e-05 1.8859474488705417e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.6614835754484103 2.6353418812605053e-05 2.6358192519046133e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.708936941518349 3.3270479170629903e-05 3.327592945705999e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.755030944623973 3.95209917980221e-05 3.9515893614677356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.7994339811480353 4.5043502927271174e-05 4.5028567431639046e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.8418986277441345 4.981849577331233e-05 4.9801188689731144e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.882250473117543 5.386274326018282e-05 5.3853306044207034e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.920375441537646 5.722253819530466e-05 5.722957041173356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9562079145823463 5.996642976059287e-05 5.999146430252046e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9897208259405463 6.217519159283544e-05 6.220863853120505e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.020917576680385 6.393106774164902e-05 6.395222927840133e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.049825039633153 6.531074753328928e-05 6.52907605500414e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0764878489706606 6.638079106132334e-05 6.628780305653786e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.100963543533455 6.719403122459858e-05 6.70006918359338e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.1233181082251065 6.779022692330842e-05 6.748057635504697e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.143621804173958 6.820299370861223e-05 6.777355476228947e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1619458937988467 6.846329643020575e-05 6.792097136588705e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.17836016786663 6.860047797594376e-05 6.795933957096715e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.192931111205149 6.864221275080588e-05 6.79202636305897e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.2057205699170614 6.861416708170804e-05 6.783048774529675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.216784811851118 6.853954722943051e-05 6.77121156394533e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.2261738749883992 6.843872940691963e-05 6.758297672248745e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.2339311249063343 6.832905573604279e-05 6.745708447656801e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2400929648852204 6.822477447922182e-05 6.734513359587738e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2446886541929985 6.813708453729172e-05 6.725498677795304e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2477401999519313 6.807422101942577e-05 6.719210499266661e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.2492622965939777 6.804151306619349e-05 6.715988094246444e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener new file mode 100644 index 000000000..aba262f5f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04202427419527589 +1 0.04203819343951703 +2 0.04206663922950997 +3 0.042110856155735996 +4 0.042172787479328296 +5 0.0422551707394483 +6 0.0423616718678849 +7 0.04249706355690327 +8 0.04266745506039303 +9 0.04288058191379515 +10 0.04314616505603532 +11 0.04347634922953382 +12 0.043886229855924726 +13 0.044394475134901745 +14 0.04502404487826873 +15 0.04580299815477217 +16 0.0467653662816581 +17 0.047952043613821015 +18 0.049411613001676645 +19 0.051200972463545324 +20 0.05338556152127221 +21 0.05603889802814633 +22 0.05924103056727636 +23 0.06307539515993507 +24 0.06762345618227601 +25 0.07295644418592767 +26 0.07912353489693238 +27 0.0861360146134591 +28 0.09394617997244799 +29 0.10240480470714856 +30 0.11122729486361727 +31 0.11998914092971706 +32 0.12812290551922187 +33 0.13507106977153135 +34 0.14052883463476248 +35 0.1442608376718066 +36 0.146053492102032 +37 0.14575843859482807 +38 0.1435297943821569 +39 0.1397901285284156 +40 0.13494860151963053 +41 0.1291207337094112 +42 0.12234472821579757 +43 0.11476399938422355 +44 0.10676613418653115 +45 0.09872173428658386 +46 0.09091567347901552 +47 0.08354634398854648 +48 0.07671614963014885 +49 0.07047725282011548 +50 0.06485101076398221 +51 0.05983526420819895 +52 0.055410669872433295 +53 0.05154062482211275 +54 0.048176589337751916 +55 0.04527337329472695 +56 0.042790658445638875 +57 0.04069305750615932 +58 0.03895006005161101 +59 0.03753591280243378 +60 0.03642946955875758 +61 0.03561403639324741 +62 0.035077230278710965 +63 0.034810863699555966 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz new file mode 100644 index 000000000..8794c94b6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8978159796825167 -4.028610513499038e-06 -3.5650418598073504e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8981282718087522 -4.0869727683485146e-06 -3.6183793999256646e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8987572191689226 -4.206022971906942e-06 -3.727407575399803e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8997116226590098 -4.390363417395252e-06 -3.896803942025078e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.901004870074107 -4.646743061806468e-06 -4.133449618403866e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9026551590969478 -4.983863718122925e-06 -4.446249752868138e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9046857931632908 -5.412104688152744e-06 -4.845891880964082e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.907125548533084 -5.943170628362143e-06 -5.344533185349511e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9100091099054584 -6.589657778021608e-06 -5.955407674703047e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9133775704833509 -7.364525695633537e-06 -6.692343483644135e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9172789903641543 -8.28046491119391e-06 -7.569177557247376e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9217690043180742 -9.349150551073257e-06 -8.599053164533597e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.926911466177327 -1.0580371950411062e-05 -9.793583386320717e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9327791119019855 -1.1981029471207051e-05 -1.1161862566667591e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.939454216559495 -1.3553992186108183e-05 -1.2709307865882701e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9470292115223764 -1.5296815034791746e-05 -1.4436316295155833e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9556072166610987 -1.7200318971807092e-05 -1.633672780111371e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9653024276234572 -1.924703803193928e-05 -1.8396091896528034e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9762402798560805 -2.1409534009868644e-05 -2.0589749574128474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9885572882524152 -2.364856120064625e-05 -2.288076149589036e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.00240043373405 -2.591151744416489e-05 -2.5217872436916455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.017925935462007 -2.8132762561826876e-05 -2.7534122077446155e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.035297210029664 -3.0233210104471703e-05 -2.9745635496295267e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0546817780290514 -3.21204904733199e-05 -3.1751183444460355e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0762468362017565 -3.3689956261570975e-05 -3.343296940427967e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.1001531727667557 -3.482651220757587e-05 -3.4659102677812204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.12654707053516 -3.5404883907845567e-05 -3.528778501451466e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.155549764648997 -3.5288882388122176e-05 -3.5173817137458714e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.187241449101104 -3.433170434677546e-05 -3.417865264670666e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.2216412469413713 -3.2382111963383574e-05 -3.218211519082495e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.258695743970447 -2.931386600620474e-05 -2.909503626316568e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.298272333589189 -2.5065145749805486e-05 -2.4877568140152216e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.34016016609659 -1.9678649425653198e-05 -1.9561187779697415e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3840807088697686 -1.3311990509938088e-05 -1.3262273421389856e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.4296922257989753 -6.172196302415008e-06 -6.166135431919723e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.47659098904163 1.5222610535815657e-06 1.4960176452932645e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.5243239630512706 9.510793929241758e-06 9.460672970232615e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.572418860855003 1.7499810062347594e-05 1.7452423524710218e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.6204109674756384 2.523457359668248e-05 2.521592437834687e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.667854301410021 3.253192704968164e-05 3.254091241464369e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.714327751533159 3.925885580255501e-05 3.927388303294857e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.759449235700605 4.531640598202856e-05 4.531875965953587e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.8028962212115336 5.064288829176215e-05 5.062882800533428e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8444226748734183 5.5216711586253376e-05 5.5193666154045674e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.88385346895518 5.905278268306527e-05 5.903280041396174e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.921072739716549 6.219534901548507e-05 6.219029006304804e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9560126651993572 6.471063007020991e-05 6.472749656207732e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9886433068644154 6.66792434042409e-05 6.671499935510214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0189645168713075 6.818567204245428e-05 6.822567338032754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.046999060372 6.931045076278708e-05 6.933030711301838e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0727866765433838 7.012551264650555e-05 7.009512222305992e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0963791635907234 7.069125036165483e-05 7.058047954425384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.1178364444089217 7.10543257648549e-05 7.084028490141883e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.137222864471989 7.125135348279761e-05 7.092271363785741e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.154603911432096 7.13146226906527e-05 7.087110187092866e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.17004370397338 7.127431182678016e-05 7.07241191911124e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1836031098069544 7.115900285074346e-05 7.051572495370694e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1953383586180606 7.099541083017548e-05 7.027516221157547e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.2053000381483887 7.080787470968041e-05 7.002706823375144e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.213532381977822 7.06178758437018e-05 6.979169601359021e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2200727755139966 7.044366583652507e-05 6.958521218712614e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.224951422177844 7.030001595484498e-05 6.942002632672218e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2281911250958575 7.019806804802454e-05 6.930510739378674e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.229807150894914 7.014525476365761e-05 6.924624869771312e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener new file mode 100644 index 000000000..2f9c5154b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04196953734854048 +1 0.041982244582010456 +2 0.04200821034582581 +3 0.04204856445668673 +4 0.04210507099661592 +5 0.04218021520097934 +6 0.0422773254634851 +7 0.042400735818370526 +8 0.04255599564613359 +9 0.0427501346602363 +10 0.042991992324205495 +11 0.04329262147675258 +12 0.04366577571654324 +13 0.04412848842402384 +14 0.044701747305799906 +15 0.04541126080788455 +16 0.046288299984122636 +17 0.04737057924044942 +18 0.04870310910550324 +19 0.05033891071988255 +20 0.052339422008515414 +21 0.05477434724113537 +22 0.0577206049623673 +23 0.06125991898479421 +24 0.06547448682037978 +25 0.07044007697947366 +26 0.07621589855431567 +27 0.08283072682273204 +28 0.09026515712253111 +29 0.09842335493072557 +30 0.10708536882685105 +31 0.11589740119638758 +32 0.12436590372587204 +33 0.13189207122712596 +34 0.13806809596268665 +35 0.14264654374109662 +36 0.14541030270912325 +37 0.14617172195436134 +38 0.14489282271958023 +39 0.14190099182296279 +40 0.1376338743489742 +41 0.13237158088241263 +42 0.12615227010197355 +43 0.11904056059282447 +44 0.11129692262292946 +45 0.10332175096641658 +46 0.09544087764730547 +47 0.08789775407896246 +48 0.08084439696876068 +49 0.07435460255496354 +50 0.06846520139114567 +51 0.06318604172890484 +52 0.05850686694643862 +53 0.05440275857283308 +54 0.05083267331271065 +55 0.04775009156419277 +56 0.045113020120012136 +57 0.04288441988003665 +58 0.04103223220376689 +59 0.03952931446396736 +60 0.03835332683167748 +61 0.03748660122359935 +62 0.036916014663044935 +63 0.0366328826046249 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz new file mode 100644 index 000000000..dbecbd925 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8965568666991899 -4.588078527096859e-06 -4.144636128281333e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8968537720169967 -4.649680265378605e-06 -4.201588280315056e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.897451707121282 -4.774708913838731e-06 -4.317332196128768e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8983589923935953 -4.966779282465679e-06 -4.495529818456639e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8995882868365117 -5.2311961539958015e-06 -4.741574000506416e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.901156801625892 -5.574805101535365e-06 -5.062452595469091e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9030865837235402 -6.005777874684609e-06 -5.466564594934753e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9054048682033031 -6.533335976123867e-06 -5.9634798557790925e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.90814449709151 -7.16740709233778e-06 -6.563633846784319e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9113444012725052 -7.918201938663792e-06 -7.277947941838295e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.915050140219553 -8.795701644810472e-06 -8.117363024949191e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.919314491809013 -9.809045182895552e-06 -9.092272341299037e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9241980810422366 -1.0965806008849506e-05 -1.0211837286843315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9297700318627806 -1.227114789863771e-05 -1.1483168554625725e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9361086200889457 -1.3726852015512181e-05 -1.2910354888634859e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9433018973785112 -1.5330211672080035e-05 -1.4493324097527434e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9514482456400255 -1.7072796317905898e-05 -1.6226525165516502e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.960656807863374 -1.8939089110164678e-05 -1.8097426463781383e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.97104772438198 -2.090500438895976e-05 -2.0084837809619745e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9827520825070737 -2.2936284772901693e-05 -2.215708210168009e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9959114617791214 -2.4987110771800983e-05 -2.427016223716368e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.01067692644118 -2.7000052398315022e-05 -2.6366368712770393e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.027207281281395 -2.8905522297323557e-05 -2.8373013133070546e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0456663675561173 -3.062172280376228e-05 -3.0201752763540088e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.06621913443754 -3.205533584683959e-05 -3.174888667527909e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0890261823659753 -3.310301896298905e-05 -3.28970242430309e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.1142364447532302 -3.365222412299664e-05 -3.351826051727239e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.14197766378892 -3.358186224220077e-05 -3.347933781323716e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.172344334038455 -3.276405373463894e-05 -3.2649456155080185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.2053812016232643 -3.106469250246989e-05 -3.091038712199254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2410667872766408 -2.835653945592035e-05 -2.8166866576069723e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.279305508409514 -2.455034999739649e-05 -2.43592707077872e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.3199244127652574 -1.9629793511110425e-05 -1.9481217452528926e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3626768662750344 -1.36818318623962e-05 -1.3598397073347778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.407253157403654 -6.882733496065429e-06 -6.852695356659494e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.4532858288218593 5.63905955266529e-07 5.582069885873884e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.500355102061761 8.438188392970528e-06 8.399999212009082e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.548005264865397 1.647262065273241e-05 1.6413605370784385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5957723572825437 2.4385640865350934e-05 2.433756791480932e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6432065948049908 3.1951309017661184e-05 3.193790428477724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.689883042525204 3.90147095439944e-05 3.9028349114356225e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.735408692599177 4.546230071496612e-05 4.547806186719656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.779435859361417 5.1211052159955535e-05 5.121044194652228e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.821677131679718 5.6213111435807304e-05 5.619420608773319e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8619172173260976 6.0458957422459255e-05 6.0430591439415186e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9000059657040556 6.397281215796824e-05 6.394802841917511e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9358472340065043 6.680535107891478e-05 6.679678476226381e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9693884618268553 6.90265863629903e-05 6.904196791106214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.000611224369587 7.071878954617557e-05 7.075598761327601e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0295236398292738 7.196681021723425e-05 7.201245198845529e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0561539453932443 7.285104320383582e-05 7.28824117585492e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0805449768051045 7.344343107027165e-05 7.343226857092276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.102749509571541 7.380516706466512e-05 7.372270603869284e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1228265057808087 7.39850017250833e-05 7.380817753713556e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1408378764512594 7.402115525012008e-05 7.373728435698962e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1568455563244426 7.394687397973563e-05 7.35536887968507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1709092461545434 7.379290349763545e-05 7.32963529411441e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1830847230815653 7.358803985085553e-05 7.299951662731125e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.193422596205607 7.335887294319743e-05 7.269266870215398e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.2019674056524723 7.312927606471794e-05 7.240059406520661e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.208756982629277 7.29198840015618e-05 7.214350273071068e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.213822004889515 7.274765692083532e-05 7.193721380831316e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2171856967003376 7.262555506316466e-05 7.179335698604439e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.2188636350774367 7.256231629483702e-05 7.171955489078067e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener new file mode 100644 index 000000000..998c568de --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04194012329997676 +1 0.0419521527720407 +2 0.04197673071603981 +3 0.04201492071450579 +4 0.042068383330353086 +5 0.04213945780608267 +6 0.04223127684347383 +7 0.0423479195747651 +8 0.04249460918456512 +9 0.04267796294328453 +10 0.04290630354352807 +11 0.04319004137591249 +12 0.04354213739377418 +13 0.043978654965528045 +14 0.04451940581496669 +15 0.04518868868634656 +16 0.046016108209447036 +17 0.0470374435580314 +18 0.048295509361406835 +19 0.049840911989420346 +20 0.051732549718657476 +21 0.05403763290195245 +22 0.056830909467142116 +23 0.060192675277374035 +24 0.0642050389512481 +25 0.06894581974657119 +26 0.07447942632040912 +27 0.08084415902670551 +28 0.08803569170908836 +29 0.0959846924924321 +30 0.10451073757849966 +31 0.11330148182934606 +32 0.12190845862746806 +33 0.12975264186924948 +34 0.13634518357850636 +35 0.14141951638896344 +36 0.14475603579009552 +37 0.14615639749646314 +38 0.14550795089347615 +39 0.14303136108064418 +40 0.13915060455463096 +41 0.13423546836663236 +42 0.12836573963304282 +43 0.12158638058012451 +44 0.11406459514991728 +45 0.10618772705186642 +46 0.09830626145919072 +47 0.09068791479618038 +48 0.08351692956180229 +49 0.07688710924212741 +50 0.07084561933972346 +51 0.06541050079324771 +52 0.06057774915293659 +53 0.05632755741924666 +54 0.052626672314726494 +55 0.04942988447376093 +56 0.046694269321995004 +57 0.044381843181182865 +58 0.042459645772376604 +59 0.04089971510052133 +60 0.03967900106955908 +61 0.03877925220373704 +62 0.038186900383236216 +63 0.03789296111654189 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz new file mode 100644 index 000000000..f1bd1f9a8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8958581999206419 -4.8680277599829295e-06 -4.441486175283861e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8961459056046055 -4.930283294765563e-06 -4.499300155433196e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8967252932130516 -5.056332382568e-06 -4.616474885276018e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8976043845889603 -5.249218528324607e-06 -4.796084048528479e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.898795385760316 -5.513409235422537e-06 -5.042656473224096e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9003148944051365 -5.85467247809568e-06 -5.362067728142766e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9021841755492694 -6.279900402858112e-06 -5.761391372266775e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9044295043506394 -6.796879729073745e-06 -6.248702654577927e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9070825740587725 -7.414002694181318e-06 -6.8328266089667534e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.910180966103793 -8.139907735622323e-06 -7.523021133973093e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9137686776313751 -8.983039935388208e-06 -8.328583209633614e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.917896699499042 -9.951120464885866e-06 -9.258364489756397e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9226236345788605 -1.1050513907659269e-05 -1.0320180439346198e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9280163419159135 -1.2285483027799712e-05 -1.1520095857771568e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9341505865620696 -1.365732252595812e-05 -1.2861569292954984e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.941111667357038 -1.516336744533048e-05 -1.4344440594497384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9489949851220238 -1.6795877371615153e-05 -1.5963749543203163e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9579065011480619 -1.8540802924107974e-05 -1.7708379648901188e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9679630199395537 -2.0376447214243715e-05 -1.9559533062321877e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9792922103290278 -2.227203750525472e-05 -2.1489060005193865e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9920322547875058 -2.4186428784395714e-05 -2.345774761198459e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.0063309876467694 -2.606764992610705e-05 -2.5413867175631144e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0223443490416435 -2.7852242479312654e-05 -2.7291844711173174e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0402339433245773 -2.9465032350338127e-05 -2.9011405882114994e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0601634503043096 -3.081954160505814e-05 -3.0477523791579954e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0822935984364452 -3.181913591824302e-05 -3.158153744639648e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.106775377215175 -3.235805590932343e-05 -3.220366911839773e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1337411513059066 -3.2322661978050236e-05 -3.2217383399124684e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.163293356125858 -3.159362080684683e-05 -3.1496121728321614e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1954904019624393 -3.0047135165487627e-05 -2.99222635481677e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2303295068839653 -2.755943377875317e-05 -2.7397294165103147e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.267736499190767 -2.4031005752814797e-05 -2.3852197598088504e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.307561480199159 -1.9418452831223412e-05 -1.9262137523914124e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.349579772444302 -1.3765782740204285e-05 -1.3664393762959254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.393500368458386 -7.216629660059491e-06 -7.171251838809915e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.438974050327761 3.508735420831755e-08 4.1452419075679566e-08 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.485599635417053 7.783645297046363e-06 7.756505134795124e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.53293522100764 1.578689183477721e-05 1.5728447776133324e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5805205644803024 2.376284864336961e-05 2.3698628884683257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6279031331805185 3.145945242826066e-05 3.1423163497891604e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.674652386274464 3.86968719669288e-05 3.869788235446143e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.7203688335236267 4.535361781526583e-05 4.537116858667671e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.76469325974449 5.133718015605995e-05 5.134603451360962e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.807320507323918 5.6586250796125705e-05 5.6575176450877983e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8480111230205596 6.107575375470371e-05 6.104892379575989e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.886593503056448 6.481666855909687e-05 6.478581389991801e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9229534271367204 6.784933707726341e-05 6.782825791942204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9570235073162943 7.02361514540329e-05 7.023641363387885e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9887735400158935 7.205492371024401e-05 7.208102046684253e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.018202150794045 7.33909203441837e-05 7.343653239344367e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.045330037042902 7.432813130358481e-05 7.437640801729877e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0701941662053636 7.49440100731309e-05 7.497037543641385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.092842839189349 7.530662517041693e-05 7.528297779018778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.113331553729586 7.547305271003923e-05 7.537286236681931e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1317196526204834 7.548834891530693e-05 7.529248829266743e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1480674175722756 7.538910438117983e-05 7.508877186811404e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.162433581181935 7.520793242564115e-05 7.480373856189447e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1748734425356244 7.497502362979176e-05 7.447462007108964e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.185437466777092 7.471828895417412e-05 7.413379670636859e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.194170260932313 7.446294950077127e-05 7.380875928804382e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2011098380919285 7.423097720030838e-05 7.352214064158206e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2062870997554676 7.404056781188734e-05 7.329180979832711e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2097254816531935 7.390571531829176e-05 7.313099999455114e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.211440721863998 7.383590292839817e-05 7.304843691922246e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener new file mode 100644 index 000000000..559de7f50 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04192071540988187 +1 0.0419323074659327 +2 0.041955990079457384 +3 0.04199278480627341 +4 0.042044286552461875 +5 0.04211274201613616 +6 0.04220115993157387 +7 0.04231345807011824 +8 0.04245465327597851 +9 0.04263110210922754 +10 0.0428508008207388 +11 0.04312375419806772 +12 0.04346242297780677 +13 0.0438822585251563 +14 0.044402330603632356 +15 0.04504604824880446 +16 0.04584196357317651 +17 0.0468246318442424 +18 0.048035475967952594 +19 0.04952356670692098 +20 0.05134617851734779 +21 0.05356891217067314 +22 0.05626508828932307 +23 0.05951401310273079 +24 0.06339760837238655 +25 0.0679948020022467 +26 0.07337303174070849 +27 0.07957628194545846 +28 0.08660933980433268 +29 0.09441758277051122 +30 0.10284529374457874 +31 0.11160603143573884 +32 0.12027940154082536 +33 0.12830925439547033 +34 0.13516063745919746 +35 0.14054456422087022 +36 0.14423765400455962 +37 0.14603739091462428 +38 0.1458015548287259 +39 0.14367160724352815 +40 0.14005436089814596 +41 0.13535457306281404 +42 0.12970263347716052 +43 0.1231355859872112 +44 0.11577438033651932 +45 0.10797666764720155 +46 0.10010848771379521 +47 0.09245291308885899 +48 0.08521233556481599 +49 0.07849720207998781 +50 0.07236163578686053 +51 0.06682912146252433 +52 0.06189983727812716 +53 0.05755706525847329 +54 0.05377159904088672 +55 0.05050090727634307 +56 0.04770150555426588 +57 0.04533480856129836 +58 0.043367278846348535 +59 0.04177042806829096 +60 0.04052074871552562 +61 0.03959961291343041 +62 0.03899316496290895 +63 0.03869222642449964 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz new file mode 100644 index 000000000..5d907ce46 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8953880328055166 -5.0130787712638725e-06 -4.596255343379978e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8956697612924167 -5.076576070612137e-06 -4.655448155008299e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.896237099989678 -5.204921343507293e-06 -4.775189603145139e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8970978804057614 -5.400786528779379e-06 -4.958172241477491e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8982640198412206 -5.668094505885149e-06 -5.2083651588148084e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8997517250567304 -6.011911615174307e-06 -5.530922135909751e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9015817630398908 -6.438294456032044e-06 -5.932054348191314e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.903779797855278 -6.954088759238604e-06 -6.4188609495151826e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9063767918539674 -7.5666738296934055e-06 -6.999109734504425e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9094094684586695 -8.283642442170246e-06 -7.680958548426498e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.9129208322015752 -9.112406184253573e-06 -8.47260582614492e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9169607395204846 -1.005971537072823e-05 -9.381856705446286e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9215865108180312 -1.11310822617166e-05 -1.0415589176962866e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9268635702125572 -1.2330096930659368e-05 -1.1579103386693028e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9328660939612572 -1.3657627037861727e-05 -1.2875336788972256e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9396776413462518 -1.5110896708000047e-05 -1.4303929254858241e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9473917324560697 -1.66824453539696e-05 -1.5860125635680215e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.956112325265467 -1.8358973868179214e-05 -1.7533509355058717e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9659541291665434 -2.0120093936217227e-05 -1.930657191992844e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.977042673054979 -2.193700353593643e-05 -2.1153140284933235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9895140226968455 -2.3771252900918377e-05 -2.303674539328656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.003514013995765 -2.5574089426429172e-05 -2.4909152667608896e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.01919683589849 -2.7285733495280377e-05 -2.6709008370162234e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0367227595465063 -2.8835045685809015e-05 -2.836089176327729e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0562547704935983 -3.013976698021906e-05 -2.9775070191315354e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0779538215461404 -3.110743901272365e-05 -3.0848302488412675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.1019723907024526 -3.1636488282068106e-05 -3.1465965016780276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.128446010867251 -3.161769471125333e-05 -3.150592054151664e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.15748244925535 -3.093646831226285e-05 -3.0844592020810614e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1891482741174926 -2.9474589035779926e-05 -2.9365210648000647e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2234525462395376 -2.711220918282908e-05 -2.6967703208554634e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2603346088926632 -2.374609228953151e-05 -2.3578382977981898e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.299658996939004 -1.9319553439378824e-05 -1.916282789624497e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.341215365364151 -1.3853409377993662e-05 -1.3742722400934995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.384724909225187 -7.46636214749746e-06 -7.411235127803613e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.429849678336601 -3.42864483703564e-07 -3.2909696795593646e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.476199032751295 7.316890058572454e-06 7.297316354531806e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.523339414598455 1.5286139116514928e-05 1.5231740651636708e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.57081425902459 2.3291056197035297e-05 2.322002298332427e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.61816918789958 3.106581168067886e-05 3.101445253265021e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.6649696781561163 3.8412475714453565e-05 3.8401061437919206e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.710810904530623 4.5201095380382286e-05 4.521571469464244e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.755326257938455 5.13350108412465e-05 5.134847434765659e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.798200159478623 5.6745829198609515e-05 5.6740739749077724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8391793715052205 6.139909344921678e-05 6.137526267337509e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.878078532051734 6.529689674446522e-05 6.526431447609267e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.914771793957555 6.847246159242888e-05 6.844492062519706e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9491821595391614 7.098282716266558e-05 7.097341542381775e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9812717020586406 7.290196714647324e-05 7.291866486167306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.011032897327867 7.431405143075688e-05 7.43550464291655e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.038481544479951 7.530444737898028e-05 7.53571033204611e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0636507863322797 7.595343886239649e-05 7.599634432776649e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0865860014272815 7.6332825578528e-05 7.633948934665525e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.107340507449314 7.650416889405788e-05 7.644759460449442e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.125972003370495 7.651768424519157e-05 7.637563715872254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1425396514597224 7.64130563029271e-05 7.617263684682473e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.157101510333914 7.622439105117741e-05 7.588246211318034e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.169712525706377 7.598275808302583e-05 7.554409775090243e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.180423029835724 7.571676616530362e-05 7.519161299403245e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.189277638190774 7.545230743682428e-05 7.485408796822535e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.196314452014182 7.521202009590526e-05 7.455558944122418e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2015644936511505 7.501472626329336e-05 7.431520850511981e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2050513175471917 7.487495339559412e-05 7.414714017124631e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.206790753846926 7.480257515468446e-05 7.406077512536044e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 new file mode 100644 index 000000000..7ab572db3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 @@ -0,0 +1 @@ +1.727383303901745479e-02 9.876045985552216080e-05 9.301372163904792812e-05 1.725965036487376453e-02 9.903296422322807276e-05 9.329785760897939490e-05 1.723106007309421414e-02 9.956761471920773734e-05 9.385710205058722514e-05 1.718760795879083550e-02 1.003438914951457965e-04 9.467355317945790841e-05 1.712860185230593787e-02 1.013315037473431108e-04 9.572073782516736203e-05 1.705309839468980432e-02 1.024909693080474856e-04 9.696405707962897570e-05 1.695988508623337207e-02 1.037743758618825651e-04 9.836136457634600289e-05 1.684745733078327895e-02 1.051263146205977589e-04 9.986366447657460952e-05 1.671399012500478579e-02 1.064849758664791020e-04 1.014159139504167216e-04 1.655730396744246880e-02 1.077833948716652539e-04 1.029579133843452329e-04 1.637482449008172136e-02 1.089508363226908476e-04 1.044252669438727044e-04 1.616353524829612642e-02 1.099143054934201031e-04 1.057503967539088292e-04 1.591992305337416869e-02 1.106001749670933496e-04 1.068635962071205894e-04 1.563991520563156462e-02 1.109359165246224800e-04 1.076941121448503341e-04 1.531880800676637192e-02 1.108519286692303282e-04 1.081712523510421943e-04 1.495118602645078079e-02 1.102834507606511775e-04 1.082255243796680392e-04 1.453083181417766205e-02 1.091725543321596468e-04 1.077898245488184589e-04 1.405062614746193858e-02 1.074702000501406775e-04 1.068007120558834341e-04 1.350243958181548097e-02 1.051383438114447769e-04 1.051998221693285020e-04 1.287701714319420404e-02 1.021520660633386040e-04 1.029354930347903924e-04 1.216385965032427095e-02 9.850168245408583503e-05 9.996470014182481337e-05 1.135110759802385356e-02 9.419476864618741598e-05 9.625540636951097743e-05 1.042543705672739282e-02 8.925799424258686336e-05 9.178943677904237582e-05 9.371981988663766888e-03 8.373860657710494092e-05 8.656596615126032268e-05 8.174304119689616149e-03 7.770533093862153388e-05 8.060565145883772623e-05 6.814440388895224784e-03 7.124835651042790198e-05 7.395533735287364231e-05 5.273069239329630786e-03 6.447795474182070380e-05 6.669309788478391683e-05 3.529850493512150592e-03 5.752112655889230657e-05 5.893314379738244838e-05 1.564008500679232860e-03 5.051548806989974896e-05 5.082981988244174786e-05 -6.360958036632190227e-04 4.357541628624850294e-05 4.258350576582113265e-05 -2.830310340706148134e-03 3.617097866584258073e-05 3.448502374140691780e-05 -4.844214584222945527e-03 2.816769406016551082e-05 2.665248869309457181e-05 -6.594061415177154828e-03 1.990528396653173287e-05 1.918651019803476219e-05 -7.993078852302050799e-03 1.203985439445222588e-05 1.233878119343504988e-05 -9.087774815752534818e-03 6.219049174407898834e-06 6.803049194916287488e-06 -1.000742582528402376e-02 3.110452334575398169e-06 3.200542223193799929e-06 -1.069934570915073192e-02 1.274164383519764496e-06 1.408083450309705753e-06 -1.096942489298423709e-02 6.821408442325081452e-07 1.314570769652686566e-06 -1.076791963106161001e-02 3.051907752271295032e-06 3.129955718070008314e-06 -1.030761396249101763e-02 7.853747603154791744e-06 6.736075830434458834e-06 -9.710639865800278769e-03 1.318541695007172153e-05 1.163698649880599216e-05 -8.966647294758708225e-03 1.792850279461740499e-05 1.732365920739451892e-05 -7.934275668239884616e-03 2.306672784326020264e-05 2.343140223888938597e-05 -6.618336452019358412e-03 2.882553680551470801e-05 2.959544462302374592e-05 -5.120479058678744852e-03 3.505761333585043736e-05 3.558358883311735785e-05 -3.753129911485434886e-03 4.134598833370841699e-05 4.153359546500197006e-05 -2.548208049675364240e-03 4.746633660210726685e-05 4.731435169642162061e-05 -1.493512788805755748e-03 5.326358121242644834e-05 5.277143267427324082e-05 -5.744910153884352083e-04 5.860336931087591528e-05 5.778806551649603323e-05 2.365336683252724365e-04 6.322166304470301450e-05 6.234585377909795749e-05 9.528980440722933237e-04 6.710375251076490738e-05 6.648617069429822789e-05 1.582923401194022417e-03 7.032399225828891878e-05 7.025195579926990573e-05 2.134541141321846802e-03 7.296374557798316761e-05 7.368148530392251098e-05 2.615145479200166670e-03 7.510355382844396402e-05 7.680448685395513224e-05 3.030928733205361450e-03 7.683988756418429949e-05 7.964517405242436997e-05 3.377774045574535519e-03 7.861646644413388123e-05 8.227659514335519393e-05 3.661236113113291307e-03 8.049641603513580865e-05 8.468652921785852308e-05 3.890567089390303476e-03 8.236917054529611687e-05 8.683883846474603615e-05 4.073571877971898098e-03 8.414003130964540513e-05 8.870869329199827856e-05 4.216712840588885888e-03 8.572999660325585861e-05 9.028001308339974338e-05 4.325209080886620316e-03 8.707517545176822861e-05 9.154314832875224935e-05 4.403124515458753385e-03 8.812595910325828064e-05 9.249287137535040998e-05 4.453441112598670662e-03 8.884612708742146091e-05 9.312672820984942493e-05 4.478115131312937480e-03 8.921204068014498834e-05 9.344378465597305583e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.270549420881450509e-18 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 -8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 -2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 -1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893900247e-01 0.000000000000000000e+00 6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.016439536705160407e-17 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener new file mode 100644 index 000000000..4dd14351e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04188996657777692 +1 0.041900863526889834 +2 0.041923123290036494 +3 0.04195770050408234 +4 0.0420060855131063 +5 0.04207037759868062 +6 0.042153387961075615 +7 0.04225877714797312 +8 0.04239123290766601 +9 0.042556695720057956 +10 0.04276264043735885 +11 0.043018423378940955 +12 0.043335704593480864 +13 0.04372895439217363 +14 0.044216051019865206 +15 0.04481897152736948 +16 0.04556456922968684 +17 0.04648541682458694 +18 0.04762067205218661 +19 0.04901688998007385 +20 0.05072865960581607 +21 0.05281887968573434 +22 0.05535840789837423 +23 0.058424719865035474 +24 0.06209910701146486 +25 0.066461841209792 +26 0.07158467096788483 +27 0.07752004091605551 +28 0.08428662141762541 +29 0.09185113866674895 +30 0.10009593976347193 +31 0.10877697963014449 +32 0.11751915734160046 +33 0.12581135530799012 +34 0.13307220508135698 +35 0.13895092600109205 +36 0.1432150762092829 +37 0.1456581628459286 +38 0.14610963278888334 +39 0.14458378473150957 +40 0.14143639238751873 +41 0.13709530919860483 +42 0.1317981110496677 +43 0.1255805307751963 +44 0.11851733915702649 +45 0.1108844393473955 +46 0.10306701924110809 +47 0.09537350522366975 +48 0.08803268331193705 +49 0.08118650169152661 +50 0.07490294300227612 +51 0.06921489462993596 +52 0.06412983710469453 +53 0.05963651004553192 +54 0.05571064347467451 +55 0.05231629164973843 +56 0.049410067695638174 +57 0.04695241828952321 +58 0.044908869850933196 +59 0.04325007570479916 +60 0.041951779568970234 +61 0.04099473574992911 +62 0.040364615621776574 +63 0.040051921394414956 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz new file mode 100644 index 000000000..03f537d8c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8946271398760188 -5.225674326534558e-06 -4.825299010770842e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.894899109419571 -5.2916432707833165e-06 -4.887187119363123e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.895446775546507 -5.4246169236537335e-06 -5.0119991824009696e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8962776582522902 -5.626641858383424e-06 -5.2017878008586234e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8974032022448168 -5.9007235149928205e-06 -5.459581488696508e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8988389743444964 -6.250744972334116e-06 -5.7893202884395674e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9006049261077105 -6.681351960823729e-06 -6.195763822662202e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9027257208707462 -7.197798664507583e-06 -6.684366088456167e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.90523112379517 -7.80574713701134e-06 -7.261109594481661e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9081564525570596 -8.511011512938801e-06 -7.932289568040796e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.911543084944227 -9.319236953174516e-06 -8.704236947962577e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9154390176656064 -1.0235502275610576e-05 -9.582966901477077e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9198994679528358 -1.126383482718653e-05 -1.0573737795484804e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9249875058165546 -1.2406626692887115e-05 -1.1680504208512654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9307746998326776 -1.3663943213980859e-05 -1.290524706979121e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9373417527292698 -1.503271850069238e-05 -1.424716492717185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.944779094420871 -1.650583865094421e-05 -1.570171339007281e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.953187389015454 -1.8071122182861637e-05 -1.7259485953697328e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9626778981716309 -1.9710219250651552e-05 -1.890494006963599e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9733726254423485 -2.1397466597219028e-05 -2.0614988994520776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.985404144367682 -2.309876285158577e-05 -2.235750689012247e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9989149866301472 -2.477057117183863e-05 -2.4089835630680675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.014056435407754 -2.635910038661744e-05 -2.5757405486377288e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0309865334809216 -2.7799808120986523e-05 -2.7292656105029734e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0498670769172844 -2.9017358809225584e-05 -2.8614503494832755e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.070859325905254 -2.992615438489003e-05 -2.9628661207129954e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.094118129360892 -3.0431472525075695e-05 -3.0229166038632114e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1197841372029558 -3.043120969346356e-05 -3.0301482705393987e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1479737758413475 -2.981808737647457e-05 -2.9727518169822278e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.178766705931564 -2.8481822464053572e-05 -2.8392702192500464e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.212190608326317 -2.6310492811714702e-05 -2.6195001186767487e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2482067670047514 -2.319860216518191e-05 -2.3054335836613523e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2867031902053014 -1.9072547471747827e-05 -1.8922911325537084e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3274929122114663 -1.3920337147790386e-05 -1.3799825996184825e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3703181182985524 -7.817417906453827e-06 -7.747436062366614e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.4148594137053774 -9.240550242396838e-07 -8.987028790194439e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4607429171896102 6.567104365739194e-06 6.559199249699151e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.507548727689012 1.4449371230768683e-05 1.4405220830461087e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.554827002764131 2.2471398928987787e-05 2.239554565206991e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.6021216915269947 3.035498083996165e-05 3.028046212828326e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.648991957297969 3.7870917165324084e-05 3.7832354620149705e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6950236423421674 4.4865869090935684e-05 4.48671592704662e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.73983806768427 5.123747267698633e-05 5.1253610279762644e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7831028413206846 5.690802039625416e-05 5.6913142731370934e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8245439522388858 6.182948478653381e-05 6.181367386648955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8639534578924675 6.598876546999072e-05 6.595736191042346e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9011861646946615 6.940660101072146e-05 6.937213695273768e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.936149039492901 7.213054584672816e-05 7.210735952696322e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.968791143171844 7.422776215706213e-05 7.42278049024549e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.999094611103431 7.577867899885721e-05 7.580687723786092e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0270670057098226 7.686954249543517e-05 7.692038513930809e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.052735015597897 7.75844301862082e-05 7.764246694994407e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.076139066907417 7.800060124858014e-05 7.804325146392526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.097328765727429 7.818614923009226e-05 7.81876256634651e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.116359097484316 7.819890905789125e-05 7.813464424699091e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.133287296790556 7.808580578382377e-05 7.793725285196824e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1481702244493515 7.78846917365719e-05 7.764256848804073e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.161062173004411 7.762859424139345e-05 7.729250801913218e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1720131988989606 7.734741862733973e-05 7.692390566845112e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1810678866287674 7.706815229061926e-05 7.656842835474966e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1882644479839457 7.681446374419966e-05 7.62524778961691e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1936340784233743 7.660612985522283e-05 7.599714036390405e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1972005095141953 7.645849099769777e-05 7.581818499920253e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1989797112554377 7.638201772451874e-05 7.572609308953489e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz new file mode 100644 index 000000000..b7c941ca3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005010508174177688 2.880141698218864e-06 2.659473977688845e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.000505731984652697 2.9165006244063527e-06 2.6935837424852152e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005151464703787807 2.9897893405538334e-06 2.7623741807585497e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005293988647536939 3.1011358199240455e-06 2.8669765879716553e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005486467129722798 3.252196517279274e-06 3.009060136138709e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005731011373683852 3.445111599920587e-06 3.1907963882121183e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006030273709696027 3.682441572206831e-06 3.4148086204597325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006387449225388285 3.967082289029679e-06 3.6841028151652482e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006806269888151341 4.302154403481119e-06 4.001976244905471e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.000729098600334379 4.690862388412898e-06 4.371898537812508e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007846328257909343 5.136317586446236e-06 4.79735900450369e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008477441585479468 5.641319199038137e-06 5.281672917397186e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.000918977959018366 6.208086907157791e-06 5.827738436774011e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0009988945193813033 6.837939113614044e-06 6.437735137135464e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0010880459444634087 7.530911831388253e-06 7.112754811907943e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0011869435989032466 8.285315288705059e-06 7.852355739007727e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0012960133558410697 9.097228643060683e-06 8.654033267744839e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014155353062609184 9.959938044394604e-06 9.512602982672253e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001545563978430439 1.0863329935542299e-05 1.0419498574645277e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0016858245300475914 1.1793259956895301e-05 1.1361995735164115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018355799135251 1.2730933064142816e-05 1.2322388239061923e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0019934638471937574 1.3652353832777404e-05 1.327716496813784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0021572748213821357 1.4527875142456375e-05 1.419624969787255e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.00232372773480264 1.5321924323752095e-05 1.5042406394156668e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002488162680816023 1.5992980016810927e-05 1.5770945439676976e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0026442156899678317 1.6493864662326865e-05 1.6329900654495044e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002783464919479201 1.6772371847327867e-05 1.666087019012208e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0028950790706707545 1.6772226987116835e-05 1.670072767729067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029655139049724957 1.6434303297096218e-05 1.6384385883121654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029783486643399906 1.5697818002827464e-05 1.564869917256409e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029180801211318185 1.4501084972503415e-05 1.4437431513826034e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0027774641243684525 1.278595971759301e-05 1.2706447018830111e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0025549109073469346 1.0511875756533794e-05 1.0429403471172655e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002255148340938154 7.672223902097584e-06 7.605803920454809e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018884306549855673 4.308586773280921e-06 4.2700161286752325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0014625602879105362 5.092949235752104e-07 4.95322033948823e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0009868523728680872 -3.619473763276723e-06 -3.6151168414875923e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.00047893685675401307 -7.96380218022102e-06 -7.939468591678524e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 3.530477438730657e-05 -1.2385160082413421e-05 -1.234335338491442e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0005325857262817188 -1.6730213289771892e-05 -1.668914214078875e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0010004251125810912 -2.0872637838105642e-05 -2.0851384007995674e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0014292142803359396 -2.4727920708622863e-05 -2.4728631793859303e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018071524363355467 -2.8239643794679583e-05 -2.824853806932455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002121044644027006 -3.1364978424714566e-05 -3.1367801610784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002362483296822944 -3.407745415914167e-05 -3.406873993639046e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025350393159975886 -3.63698506964063e-05 -3.6352542556684896e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002650202785526583 -3.8253598140928166e-05 -3.8234603200890495e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002718901028178075 -3.975490622398154e-05 -3.9742127033735385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.00275092379976032 -4.091079152569403e-05 -4.0910815084909634e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027545521060843865 -4.1765582694719316e-05 -4.178112421508513e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002736585679037901 -4.236681446831179e-05 -4.239483650135785e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027028444779164077 -4.276082636401755e-05 -4.2792813451773205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002658259634966319 -4.299019994442671e-05 -4.30137067027851e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002606953084952551 -4.309246511542289e-05 -4.3093278854867036e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025523299758952664 -4.309949772208943e-05 -4.306407803267972e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024972609662667327 -4.303716060816085e-05 -4.295528533873251e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002444164337346623 -4.2926316166392555e-05 -4.279286941471461e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023948813207254832 -4.278516747847537e-05 -4.25999328307637e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002350777874996688 -4.263019693114402e-05 -4.2396776848603205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023128509070616137 -4.247627868614102e-05 -4.2200854758938395e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022818137832638463 -4.233645769553823e-05 -4.202671798089454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022581633311467737 -4.222163402240049e-05 -4.188598814817942e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022422305037931006 -4.214026254701479e-05 -4.178735651218564e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022342166099583 -4.209811413723659e-05 -4.1736599857153466e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..bb6a9c240 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0026422684125283935 1.0884151784643673e-05 1.0896927779613405e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0026508558212976355 1.095255728649753e-05 1.0967680697280016e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0026650990115527112 1.1085060275124511e-05 1.1104468701317897e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0026847329173591626 1.127681008299612e-05 1.1302065424004143e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002709353087074789 1.1521915233655251e-05 1.15540509645615e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0027383997844794934 1.1813358852033914e-05 1.1852511738528695e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0027711204773091308 1.2142749233511634e-05 1.2188006948530475e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0028065392775141573 1.250023666550174e-05 1.2549642701979164e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0028434134770780614 1.287460314358513e-05 1.2925192237940836e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.002880179322960277 1.325336754179739e-05 1.3301262450053821e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0029148893905362166 1.3622906555610938e-05 1.3663498158578205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.002945170832769486 1.3968614356514076e-05 1.399683954178565e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.002968176733194069 1.4275082179635167e-05 1.428580330292288e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0029805310900656696 1.4526284585340354e-05 1.4514765330191754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.002978300816058654 1.4705768027332552e-05 1.4668232157114699e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002957647277916273 1.4796885425189734e-05 1.4731132482627247e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0029153473665308655 1.4783086151249245e-05 1.4689126921834646e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0028484957799799287 1.4648181227286073e-05 1.4528864935365823e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002754690043154893 1.4376537098962445e-05 1.4238171381089697e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0026322963494654246 1.3953116878992028e-05 1.3806149182346819e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002480640151439093 1.3365370230714955e-05 1.3223747844346644e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0023001519875567003 1.2610216483971474e-05 1.2486178339145003e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002092430106010159 1.1692227341847834e-05 1.1593258558202013e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.001858862853873094 1.0621659742091016e-05 1.0549466751500612e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0016006300616233195 9.412899005719398e-06 9.36389247917215e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0013196465891901585 8.0830514003001e-06 8.049994219580213e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0010186878082760423 6.6488431848683745e-06 6.624700964763707e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0007027592263207662 5.126527535300533e-06 5.107483509241082e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0003786059951944522 3.534588024667843e-06 3.5200186531730666e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -5.352088494991685e-05 1.8948095969615545e-06 1.885696596661904e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 0.00026568199721098564 2.32037358432976e-07 2.28978309004868e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 0.0005750042221474241 -1.427484601250529e-06 -1.4254038208694825e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 0.0008714040855598774 -3.058476334966405e-06 -3.0533065807121906e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.0011521861689291226 -4.638147961252597e-06 -4.631956872158315e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.00141495168306276 -6.146877156560963e-06 -6.140586269022113e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0016565300932428427 -7.568114961344976e-06 -7.560874040623541e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.001873707644049373 -8.887435897733226e-06 -8.877180163262725e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0020641468245299046 -1.0092052516505258e-05 -1.0076673752113855e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.002226422424461447 -1.1171564889971666e-05 -1.114944168359219e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0023604139900985973 -1.2118075975041352e-05 -1.2088456686244018e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002468740474752123 -1.2926274500994243e-05 -1.2889456019897026e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0025546767054558882 -1.3593507141197084e-05 -1.3550762110551832e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0026212930485554967 -1.4119848665261721e-05 -1.4073026624563835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002671427358275382 -1.4508164884760057e-05 -1.4458938512190607e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002707668659771677 -1.4763636905112001e-05 -1.4713466294127064e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027323247929936048 -1.4893440073458617e-05 -1.4843688445028324e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002747434747269618 -1.4906517720473808e-05 -1.4858485454828552e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027547583291830952 -1.4813332743456986e-05 -1.4768250675826198e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002755799969190708 -1.4625599422982502e-05 -1.4584603469253743e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027518766327772172 -1.43560372698294e-05 -1.43201362442605e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027441392061743545 -1.4018132450455018e-05 -1.39881755220348e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027335909019859704 -1.3625891072493692e-05 -1.3602538146501783e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027210997464172646 -1.3193591568238111e-05 -1.3177286929904901e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002707411021964941 -1.273555311294237e-05 -1.2726498672442391e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002693162950393912 -1.2265922538672769e-05 -1.2264041329194132e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0026789011100542704 -1.1798471357617476e-05 -1.1803350771049497e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0026650872412306926 -1.1346247757750543e-05 -1.1357234530853744e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002652108982271125 -1.0921363837982525e-05 -1.093768605202584e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002640289128158375 -1.053485479421127e-05 -1.0555694776493668e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002629892787364928 -1.0196531557992888e-05 -1.0221069086130943e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.002621132923460851 -9.914846749657373e-06 -9.942282997680271e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0026141756337873722 -9.696791997159153e-06 -9.72636020420658e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0026091454322259297 -9.547847496565871e-06 -9.578814054908669e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002606125249482514 -9.472016663095088e-06 -9.503674970139563e-06 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..2d7682eaf --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001883760909718643 1.6322441605227365e-05 1.6282091855354656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0018966619675293548 1.6486965700256653e-05 1.6452421188241346e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0019185656623403277 1.6807487761018533e-05 1.678377140139888e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001949511870093031 1.727453695234515e-05 1.7266058758276704e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0019895160178731368 1.7876635354001052e-05 1.788698562624408e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002038551855585949 1.8600054317502754e-05 1.8631373860233375e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002096501874568409 1.942834492970221e-05 1.9480999026967922e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.002163115772327773 2.0342170937219724e-05 2.0414630052176635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0022379460618002583 2.131943944796795e-05 2.1408146347395264e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0023202593065719916 2.2335450663067013e-05 2.2434725056632046e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0024089172383899658 2.336306099336146e-05 2.346508720155312e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0025022791791875732 2.4372900631805374e-05 2.446784899033802e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0025980814025706187 2.533359761450045e-05 2.540993643842267e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0026932891559394764 2.6211962639061126e-05 2.6257044191454132e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.002783911690992785 2.697308837958631e-05 2.697415340465101e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0028648561069145235 2.7580396492652597e-05 2.7526238448664822e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0029298406142217385 2.7995898224603236e-05 2.787901716726252e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002971294193621249 2.8180650546450485e-05 2.7999492140522817e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0029803046655592466 2.8095075748595054e-05 2.7856408672780555e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.002948010116666279 2.7699000504277267e-05 2.7420616795349938e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002868895903413367 2.695531229676533e-05 2.666640373908338e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0027396116464303557 2.5844740794311424e-05 2.5576422912308293e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0025591088405104924 2.4365145340192177e-05 2.4142785174774204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0023291988960112563 2.253076161843598e-05 2.2367697925781598e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020546163078697405 2.0369353023163596e-05 2.026403903468382e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0017395399412620369 1.7917654503431624e-05 1.7855408828273858e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.001387508853885373 1.5212863256818872e-05 1.517455360183919e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0010038749375851604 1.2289242399791932e-05 1.2261666285931918e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0005982818050399754 9.184626169485258e-06 9.163460298631152e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.00018423297109171168 5.9449234746407955e-06 5.931669166997341e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 0.00022425616359005048 2.6246152805749755e-06 2.62125324075721e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 0.0006179814685869888 -7.169653305987494e-07 -7.117359942501466e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 0.0009912272113921496 -4.022130709637606e-06 -4.012405238062643e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.001339030741258096 -7.239201272347688e-06 -7.229084097083925e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.001655655652421879 -1.032416399171265e-05 -1.0314949563632663e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0019338616031889645 -1.3239896787869579e-05 -1.3229071899198553e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.002168103789981237 -1.5954158859883456e-05 -1.5936955369902714e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0023552530023580975 -1.8438994892541877e-05 -1.8410822608318168e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.00249824217239885 -2.0672010075759605e-05 -2.0629717398805185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0026033134006731903 -2.263665575524828e-05 -2.2579274945437933e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0026764506223990315 -2.4322461402393694e-05 -2.4251289989683087e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0027231346580408665 -2.57249321760769e-05 -2.564317692625791e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002748269614546617 -2.6845324978476764e-05 -2.6757269990625873e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0027560624427724494 -2.7690419693446823e-05 -2.760005141900093e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0027500037861249204 -2.8271451058037618e-05 -2.8182338619816495e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002733104725441547 -2.8603428854627287e-05 -2.8518845593732642e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002707956580429593 -2.8704642482100285e-05 -2.8627529720823093e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0026767743255071688 -2.8596147843722103e-05 -2.852898108020828e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026414254963229144 -2.830122661592218e-05 -2.82458885086856e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0026034713966902358 -2.784489996218715e-05 -2.780265816112248e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0025642146228401982 -2.7253480442000682e-05 -2.7225026172317075e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0025247578842906 -2.6554118878872116e-05 -2.653963187022374e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002486060274723122 -2.5774353404053933e-05 -2.5773570237883346e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0024488825282588922 -2.4941690980127256e-05 -2.495395702166559e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0024138132003758903 -2.4083222924011278e-05 -2.4107505243130717e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002381305639780563 -2.3225255745868726e-05 -2.3260097558813076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002351701884644044 -2.239267853869484e-05 -2.2436401249363376e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023252564253151515 -2.1608572386189455e-05 -2.165949959179939e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023021565700827766 -2.089394896633773e-05 -2.0950525672428354e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002282537553954488 -2.0267477893841593e-05 -2.032832706450846e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022664938969980137 -1.9745240136332726e-05 -1.9809180181721122e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022540892921487734 -1.934054304805496e-05 -1.9406580606057414e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022453655252727732 -1.906383949171197e-05 -1.9131147348413954e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022403434303462457 -1.8922819071400595e-05 -1.899070716640279e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz new file mode 100644 index 000000000..b1ab25d14 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005090972444601614 2.810887522660721e-06 2.5846490277925876e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005138744482446504 2.846334020417444e-06 2.6177717388702157e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005234819996440104 2.9179051932672712e-06 2.684697038750481e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005380264533103175 3.0269420947295306e-06 2.7867740798922436e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005576682462723143 3.1754138194083554e-06 2.9259922592302752e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005826222447807373 3.365863860892433e-06 3.1049364706416576e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006131581612910316 3.6013338511506023e-06 3.3267244969799737e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006496005464527016 3.8852627464529586e-06 3.5949230868035304e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006923279512532001 4.221357728570229e-06 3.913438507030233e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007417707186108262 4.61343153484127e-06 4.286376443955577e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007984066943874759 5.065200690666979e-06 4.717864924990756e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008627539369126597 5.5800386117397235e-06 5.211832856235106e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009353592428856233 6.160677325198596e-06 5.771735715409233e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0010167809870510805 6.808851878774178e-06 6.4002191957928826e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0011075643854926368 7.524882550038377e-06 7.098711345314856e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0012082068326664838 8.307192087294067e-06 7.866934408214277e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0013191104316383742 9.151758405665665e-06 8.702329365433131e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014405182478076772 1.0051507270246076e-05 9.59938952867327e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0015724302006675079 1.099565490403618e-05 1.0548905626702693e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0017144939293003477 1.1969016249675876e-05 1.1537134122557088e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018658655381329516 1.2951347669162557e-05 1.2544926807879254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0020250350363600696 1.3916910251887994e-05 1.354691447334432e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002189611820499473 1.4834049391229812e-05 1.4510753812549799e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002356067153971223 1.5664975331088392e-05 1.5396574755672102e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0025194339000411885 1.6365834551123567e-05 1.6156780870371e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0026729696196196363 1.688713398321352e-05 1.6736385295856178e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0028077986372493364 1.717435438685565e-05 1.7074050246678464e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029125630460118436 1.7168827326738648e-05 1.7104052206534788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029731330341508507 1.680898964543878e-05 1.675939965122896e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002972594122000254 1.6031463515166783e-05 1.597612780609626e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0028968273414535874 1.4771824609763408e-05 1.469859415147801e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0027398299556359025 1.2972367643302526e-05 1.2884711195192958e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0025011332574879446 1.059782367155466e-05 1.0512449482451607e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.00218684066026452 7.652202874792514e-06 7.588673160535707e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018072823520440464 4.1916494441172e-06 4.158019467682992e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0013699243219328417 3.1344190535158025e-07 3.0338623210799846e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0008851784923852562 -3.873656482874352e-06 -3.865419152032869e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0003729822497652182 -8.24946734775483e-06 -8.221424868351894e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0001401427250924134 -1.2667321334878993e-05 -1.2626554403764676e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0006331039947221361 -1.697699768318321e-05 -1.694346716672582e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0010944881042054533 -2.106276098933945e-05 -2.105108716456132e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0015146851710132352 -2.484870992201139e-05 -2.485461818524195e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018808580857437372 -2.8280445549957785e-05 -2.828891117929853e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0021804094219102757 -3.1318077935536226e-05 -3.1317502373166774e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0024065691869618565 -3.3939547360750354e-05 -3.392793069771182e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025658735949723108 -3.61427958254953e-05 -3.612481162234597e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002669944941825029 -3.7943542460903866e-05 -3.792662952726385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027295275444557954 -3.937126916857048e-05 -3.936300339260395e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027541649781418743 -4.0465342356898805e-05 -4.0471101936481655e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002751788420880334 -4.1271503247118455e-05 -4.1291792869856536e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027289887520485193 -4.183712212244016e-05 -4.1866482960894674e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002691410253825679 -4.22073378401912e-05 -4.223517812244482e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026438206803997676 -4.242294495405389e-05 -4.243539885163565e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.00259019466098773 -4.251932632796204e-05 -4.250162861529347e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025338177137093627 -4.252587842433227e-05 -4.246505429005311e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002477512764741972 -4.246588289127768e-05 -4.235350316809128e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024235840761749746 -4.2358812124774795e-05 -4.219182888113094e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002373763893299763 -4.22221608009257e-05 -4.2002142677919964e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002329332148325764 -4.207196242934077e-05 -4.180381698005205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0022912189617263555 -4.192272593040292e-05 -4.161343763469145e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022600869118370487 -4.178715843411493e-05 -4.144477289942053e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022363953457975017 -4.1675848274170595e-05 -4.130877476735903e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002220448921073606 -4.159698478339273e-05 -4.121360561477162e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002212432270452029 -4.155614351848922e-05 -4.116467554662434e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz new file mode 100644 index 000000000..8747fdb44 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005058430728231948 2.8396252670814026e-06 2.6156385384944002e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005105814920321858 2.875417521150239e-06 2.649137204329484e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005201110751951233 2.94763728010998e-06 2.7167707992616536e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005345375872916964 3.057540375197849e-06 2.819801293276899e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005540203034200945 3.206970882098131e-06 2.9600899534543334e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005787725865475763 3.398311053873759e-06 3.14005632225847e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006090623523038444 3.6344102476831527e-06 3.362620412638585e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006452121318568563 3.918490486124386e-06 3.6311247927888807e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006875983363840162 4.2540248337982574e-06 3.949232405603148e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007366491934521192 4.644583472993496e-06 4.320795004330634e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007928406595068623 5.0936419449339296e-06 4.749685922339179e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008566894056661197 5.604345500868291e-06 5.239589812545487e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.000928741717391026 6.179223288088187e-06 5.793740959593987e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0010095568335028104 6.819846405274388e-06 6.41460102432814e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0010996828685102852 7.5264248991684565e-06 7.103466817279124e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.001199623008975866 8.297340862438719e-06 7.859999294821505e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.001309789150362073 9.128618033980961e-06 8.681666711892155e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014304395568639965 1.0013332705787829e-05 9.563098232692257e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0015615965133487263 1.0940976644209073e-05 1.0495350293278486e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0017029393562551767 1.189678960622875e-05 1.1465097255077433e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018536678274515168 1.286111690760254e-05 1.2453779583540659e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0020123305712405424 1.3808927079657885e-05 1.343678459299407e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002176614073321076 1.4709378638757825e-05 1.4382689984399643e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0023430888474112407 1.5525578352774578e-05 1.525269347812245e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002506912822835591 1.621461431673092e-05 1.6000374206315927e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0026614975091867198 1.6727927239854577e-05 1.6571963250637776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002798151676318484 1.7011930321776423e-05 1.690730150797207e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029057312163343254 1.7008922415544494e-05 1.6941700858747793e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029703437286906463 1.6658332333990492e-05 1.6608917818036515e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029752568198334692 1.5897856017281568e-05 1.5845289425101227e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002905756570298819 1.4664163021518445e-05 1.4594907598489591e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0027553626325377786 1.2899251740002145e-05 1.2814822313787983e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.002523148494301663 1.0565567626416703e-05 1.0481194409859432e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002214660390182614 7.662673146253467e-06 7.597824386196702e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018402619991946592 4.240778206607407e-06 4.205143946761095e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0014075046983160464 3.9386646425550463e-07 3.8226383178090123e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0009263280010480216 -3.770295966702075e-06 -3.7636199456100595e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0004157442017851492 -8.134270852072542e-06 -8.107611673217877e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 9.79323950855461e-05 -1.2554515540337626e-05 -1.2513062046955166e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0005926790678880882 -1.6879112658255353e-05 -1.6842369090864147e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.001056706989434943 -2.098805281513823e-05 -2.097260341987229e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.001480434779650579 -2.480220772712647e-05 -2.4806254474894556e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018514311315997773 -2.8266458210059644e-05 -2.8275270310315577e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002156829918820871 -3.1339645704256474e-05 -3.1340461613576785e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0023891392741144206 -3.399786378826222e-05 -3.3987336533253716e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025537430751836447 -3.6236971090179254e-05 -3.621914226156378e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026622456715252197 -3.807098137996945e-05 -3.805311787710826e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002725466147713874 -3.952807909674116e-05 -3.9517925419401965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027530502659584696 -4.0646697785014804e-05 -4.0650168942550235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027530695999432504 -4.1472053415142506e-05 -4.1490579026396394e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027321962968313764 -4.2051631656033984e-05 -4.2080730892883925e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0026961453808944554 -4.243108436232672e-05 -4.246098525330479e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026497503065520023 -4.265194618645704e-05 -4.266932383658992e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002597044879060316 -4.275048571577458e-05 -4.2740748877097914e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025413608103564776 -4.2757131678051544e-05 -4.270699954190205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024855402505517036 -4.2696175694714744e-05 -4.2596439571785394e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024319357382934395 -4.258759490998486e-05 -4.2434361282184115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023823230547653923 -4.244914599687174e-05 -4.224327212902339e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023380164748389495 -4.2297035033673714e-05 -4.2042918520608655e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002299972765609061 -4.214591664475417e-05 -4.185023649623264e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.002268874758516123 -4.2008635366584095e-05 -4.167931064832618e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002245196740300181 -4.189590721001791e-05 -4.154136338004672e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022292538458734525 -4.181603044978883e-05 -4.1444770535158775e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002221237350653934 -4.177466076103284e-05 -4.1395090159630784e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz new file mode 100644 index 000000000..094af7ffc --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.000503770597492631 2.857486773436737e-06 2.634918518332518e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005084842491475941 2.8935135671692906e-06 2.668671554489735e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005179640408517077 2.9661746918306885e-06 2.7367857451264083e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.000532315230193523 3.07667094398413e-06 2.840466778639932e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005516963453042081 3.2267656470903756e-06 2.9814931911882456e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005763197819663234 3.418736874926575e-06 3.1621777397927875e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006064522984020399 3.6553097090974714e-06 3.3853126802751424e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006424151226892295 3.939565890305413e-06 3.654095705943245e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006845832816206521 4.274826985309501e-06 3.972032425841529e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007333836283016144 4.6645060653430715e-06 4.34281026801309e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007892908817090353 5.111922357375321e-06 4.770137553548002e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008528207868835026 5.620072797877446e-06 5.25754040144587e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009245192507307047 6.191354199693576e-06 5.808109107331993e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0010049459967115038 6.827230046478201e-06 6.424184896451166e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.001094650904044545 7.5278369648309715e-06 7.106977682485806e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0011941407479410242 8.291527993492646e-06 7.856106019692072e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0013038335371801809 9.114353044628794e-06 8.669052148016541e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014239970647757223 9.989481548082356e-06 9.540528408927e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0015546676756720457 1.0906578496406272e-05 1.046175724915328e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0016955446711026962 1.1851152679512002e-05 1.1419676246589532e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018458553179047852 1.2803923934470574e-05 1.2396098309151946e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0020041852880972673 1.3740311392320507e-05 1.3366890650581126e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0021682697966358745 1.4629992272243798e-05 1.4301216499652033e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0023347421508689505 1.5436646102747363e-05 1.5160953900017874e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0024988394753583686 1.6117963356075445e-05 1.5900432814096924e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002654070852094555 1.6625982641607573e-05 1.6466664665207074e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0027918620701484487 1.6907714253410346e-05 1.6800249010193787e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029012048295289075 1.6906074897425874e-05 1.6837169213630333e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029683577774194557 1.6561121512024905e-05 1.651167471126722e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002976718045377979 1.5811217501548773e-05 1.5760315609085827e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029112157362836013 1.4593743407934159e-05 1.4527031169568806e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0027650492703947148 1.2850592342358898e-05 1.2768344823356059e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0025370032856635656 1.0542851954510559e-05 1.0459308518252206e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.00223226861409265 7.667353492246965e-06 7.60182820229911e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018611854596205482 4.270538475991925e-06 4.233684084861847e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0014313957965852325 4.440613196139434e-07 4.314972665359216e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.000952558653383756 -3.7049743210059957e-06 -3.6992545536135857e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.00044308874296853425 -8.060733310340725e-06 -8.035001540715982e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 7.086915607363054e-05 -1.24817953995664e-05 -1.2440054779998454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0005667265870732902 -1.6815460641308816e-05 -1.6776746632037758e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0010324167668869073 -2.0938980758392104e-05 -2.0921022326133257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0014583558450226451 -2.4770980081785818e-05 -2.477365438793074e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018323828109606862 -2.825582397502905e-05 -2.8264732052814776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002141478414047406 -3.135159965303527e-05 -3.13532975772704e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002377733996062046 -3.4033266629252806e-05 -3.402350504398257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002545761544937593 -3.6295348827801616e-05 -3.6277719409596394e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026571305053808697 -3.815075181363243e-05 -3.8132381729485546e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027227070709906105 -3.962681470979789e-05 -3.961553001126988e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027522001989606615 -4.076136468610215e-05 -4.076338790686575e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027537719890516755 -4.1599249336905336e-05 -4.161657884824907e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002734148558697284 -4.2187994975212106e-05 -4.221677458979112e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002699090257694202 -4.25735624749646e-05 -4.260455678709845e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002653472702504007 -4.2797947041776974e-05 -4.2818199472479125e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002601367719493355 -4.289797016313141e-05 -4.2893035427039555e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002546138133867013 -4.2904697545053966e-05 -4.286115538868363e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002490638160995808 -4.28430940685393e-05 -4.275127457118248e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024372497296736373 -4.2733498243167196e-05 -4.2588974006165374e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023877767814936895 -4.25938509721625e-05 -4.2397017649688766e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002343555822164231 -4.24404750044754e-05 -4.219539214596135e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023055608797809424 -4.228811977498935e-05 -4.20012578468704e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.002274487913481147 -4.214971741339191e-05 -4.182890184503886e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002250820898939984 -4.203606470043394e-05 -4.168971968372861e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022348817692504756 -4.195552868593971e-05 -4.15922239469379e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022268661113385526 -4.191381561441093e-05 -4.154206748037076e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz new file mode 100644 index 000000000..50ace9491 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005024426040259796 2.8686726741888226e-06 2.6469126501308115e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005071403988660258 2.9048577059566247e-06 2.6808381623801835e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.000516588312566185 2.977817475783001e-06 2.7492791780473794e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005308912773264665 3.0887173737479546e-06 2.8534051448551167e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005502073421313537 3.239268766787812e-06 2.994941323527885e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005747482821186893 3.431682687903399e-06 3.1761316930348017e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006047801123772066 3.6686042220312566e-06 3.3996862014831985e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006406232236091526 3.95302477105015e-06 3.668709170618649e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006826517518472576 4.2881682826765885e-06 3.986604753586422e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007312916639658101 4.677346509240946e-06 4.356954333602753e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007870168779506473 5.123777754532523e-06 4.78335962656702e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008503425339054551 5.63036302911191e-06 5.2692441628037735e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009218142799394961 6.1994133158261184e-06 5.817604816188375e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0010019921275550895 6.8323219478245365e-06 6.430704306978881e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0010914270559517427 7.529177136160777e-06 7.1096953324722805e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0011906280981942277 8.28831174193595e-06 7.85416751006156e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.00130001712458495 9.105790685588757e-06 8.661610012356833e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014198679601881226 9.974841104517437e-06 9.526786159755047e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0015502258626696735 1.0885236802315383e-05 1.0441022142878613e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0016908028010536107 1.1822656546783873e-05 1.1391421248121996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018408435193222668 1.2768057570705677e-05 1.2360031788515571e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0019989572136935503 1.3697145277154821e-05 1.3323025093482907e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002162910072234717 1.4579927056366942e-05 1.4249936219826118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002329375332282899 1.538044764364261e-05 1.5103076072157341e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002493640499527814 1.60567822201367e-05 1.5837253315130727e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.00264927675611573 1.6561351806372133e-05 1.63999781287526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0027877844070542694 1.684154876131065e-05 1.6732336599945773e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0028982416885010107 1.684068444406175e-05 1.677074496465203e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029670035778884846 1.6499214903929076e-05 1.6449773843059335e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002977554517577292 1.5755922860535075e-05 1.5706118286978626e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002914608031081911 1.4548644615016319e-05 1.4483628497011172e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002771149673560017 1.2819240844934588e-05 1.2738502157693332e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0025457807211763236 1.052797467683211e-05 1.0445102983459248e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002243465597485435 7.66997929523316e-06 7.604153503716971e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018745101730033022 4.289312342468005e-06 4.251759643489563e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.001446629244691539 4.760447127881709e-07 4.629237842956729e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0009693106106058877 -3.663162277408698e-06 -3.6579971841077306e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.00046058582033767584 -8.013435944819156e-06 -7.988281435270896e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 5.35231319255871e-05 -1.2434753552421815e-05 -1.2392872306537908e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0005500802125203363 -1.6774049084599648e-05 -1.6734103473081265e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0010168238308207252 -2.0906826850824367e-05 -2.088722768447498e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.001444160881341922 -2.4750206288971343e-05 -2.4751929814886084e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018201056935841665 -2.8248188528334628e-05 -2.8257110143152774e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0021315494973209257 -3.13584034521496e-05 -3.136067072137998e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0023703337123034836 -3.4055104781784085e-05 -3.404587782355555e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025405656832899093 -3.633196391413301e-05 -3.631452588729258e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026537812699476 -3.8201169459812945e-05 -3.81825446849699e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027208766007720203 -3.968951217997939e-05 -3.967756752910668e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002751600346823238 -4.0834425628658074e-05 -4.08355660533161e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002754172657519255 -4.168050852054217e-05 -4.169708583922383e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027353551552480614 -4.227529742162438e-05 -4.230385452323226e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027009372617390537 -4.2664941478570435e-05 -4.2696591459338855e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002655821658814672 -4.289172422827721e-05 -4.291375548156579e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026041045951507164 -4.299281489153181e-05 -4.299088935610814e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002549169360625221 -4.2999677706578186e-05 -4.296030725511857e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002493878064275719 -4.293771453175107e-05 -4.28509509741498e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024406307136531713 -4.2827511902073825e-05 -4.268858907814042e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002391249397313139 -4.268713532556824e-05 -4.249615016052657e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023470849516700238 -4.253298416373844e-05 -4.2293774213896426e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023091225351506146 -4.237986836369591e-05 -4.209876450960418e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022780665742032553 -4.224077514935349e-05 -4.1925537133253934e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002254407295248447 -4.212655187010201e-05 -4.178559795882941e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002238471017992932 -4.204560861322914e-05 -4.168754674928444e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002230456111806505 -4.2003683292790585e-05 -4.163709681835145e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz new file mode 100644 index 000000000..a51198f79 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005015938746143956 2.87558802193352e-06 2.6547250254215914e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005062815292819459 2.9118808028046157e-06 2.6887603509872905e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005157090573134215 2.985044539457277e-06 2.7574094006503352e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005299811823912312 3.0962217236060176e-06 2.861818443429621e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005492556463900472 3.247090116898185e-06 3.0036786649829943e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005737438265249286 3.4398173834201874e-06 3.1851900520131577e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006037112612179744 3.6769968449008205e-06 3.4090099036243915e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006394778037056096 3.96156142682705e-06 3.678182810889544e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.000681417017726164 4.296671856018914e-06 3.9960480176042745e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.000729954299860277 4.685574220564699e-06 4.366119051074569e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007855630511490494 5.131421347957681e-06 4.791929396896865e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008487580186245226 5.637051915710057e-06 5.276836902546535e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009200846767432672 6.204720990380122e-06 5.8237785940890224e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0010001032105714897 6.8357759896228105e-06 6.434966849087272e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0010893652889352526 7.5302730963026546e-06 7.111517594480629e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0011883813709622055 8.286531204540768e-06 7.853001712759228e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0012975757735003484 9.100623789701002e-06 8.656912524277924e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.001417226149894866 9.965813891865357e-06 9.518045604892302e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0015473834204898754 1.0871943966138837e-05 1.0427793085181646e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0016877676088774864 1.1804800650799714e-05 1.1373363768956956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018376345778755342 1.2745492300549948e-05 1.2336956029057081e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.001995608496446892 1.366990684297668e-05 1.3294935194009447e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002159475274148501 1.4548262454972826e-05 1.421707367771858e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0023259335818651226 1.534483729215135e-05 1.5065958913259685e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0024903030267257056 1.6017952675174465e-05 1.5796705664806725e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0026461943735549406 1.652027451579139e-05 1.6357143435471243e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002785155443085408 1.679943997407331e-05 1.6688670382729357e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0028963196791137683 1.6799013135773562e-05 1.6727981231435108e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029661035547825275 1.6459704912657718e-05 1.640985452275463e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029780489655666185 1.572056397196409e-05 1.5671081421431307e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002916735939768416 1.4519718418051556e-05 1.4455458418723835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002775010757216965 1.2799022651287329e-05 1.2718978514524036e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0025513580332757685 1.0518229905004417e-05 1.0435572629732307e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002250597818240371 7.671406309306046e-06 7.605216518290555e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018830063505718845 4.301097114594078e-06 4.262953375737638e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.001456350573688394 4.963216249309957e-07 4.827385788256597e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0009800121346233421 -3.636550637817744e-06 -3.6317978763414327e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0004717775693961828 -7.9832360116044e-06 -7.958477117265842e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 4.241541809501877e-05 -1.2404618840728673e-05 -1.236265393097385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.000539415114753953 -1.674745494939541e-05 -1.670668052834535e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.001006828061444739 -2.0886132645683862e-05 -2.0865377854536418e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0014350523559197275 -2.4736781926867813e-05 -2.4737739304393465e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018122150286835898 -2.8243153064503235e-05 -2.825190429412207e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002125153792305446 -3.1362593626461805e-05 -3.136504186454782e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0023655566514559387 -3.406891374201719e-05 -3.405984172134076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002537204550808117 -3.6355240684654166e-05 -3.6337730183533945e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026516067728754875 -3.823330141275961e-05 -3.821430996288399e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002719678492109154 -3.9729533247367905e-05 -3.9716953578673784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027511934993735008 -4.0881116193086874e-05 -4.0881468255766956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027544090677929047 -4.173248557713099e-05 -4.1748346190038104e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027361099502343825 -4.2331178705271364e-05 -4.235934857761754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027021041854150235 -4.272346201533625e-05 -4.2755281584594725e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026573117974225038 -4.2951801658513554e-05 -4.2974721587717135e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026058446906088153 -4.305358762863413e-05 -4.305334530256399e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025510994403958186 -4.3060536251472885e-05 -4.3023609457381587e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.00249594332777559 -4.2998330662782065e-05 -4.291460145667712e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024427875925635695 -4.288772396381453e-05 -4.2752211305001355e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023934659847826465 -4.274686499588852e-05 -4.255947339226269e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002349338552395867 -4.2592203698431916e-05 -4.235662587985618e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002311397609959354 -4.2438589341221565e-05 -4.2161063400894864e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.002280353029073178 -4.229904458427117e-05 -4.1987284472483475e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022566990566462324 -4.218444915118095e-05 -4.184686548036336e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002240764834306593 -4.210324063351315e-05 -4.1748461914521925e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002232750521591687 -4.2061177172937965e-05 -4.1697825748751715e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz new file mode 100644 index 000000000..b7c941ca3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005010508174177688 2.880141698218864e-06 2.659473977688845e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.000505731984652697 2.9165006244063527e-06 2.6935837424852152e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005151464703787807 2.9897893405538334e-06 2.7623741807585497e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005293988647536939 3.1011358199240455e-06 2.8669765879716553e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005486467129722798 3.252196517279274e-06 3.009060136138709e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005731011373683852 3.445111599920587e-06 3.1907963882121183e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006030273709696027 3.682441572206831e-06 3.4148086204597325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006387449225388285 3.967082289029679e-06 3.6841028151652482e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006806269888151341 4.302154403481119e-06 4.001976244905471e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.000729098600334379 4.690862388412898e-06 4.371898537812508e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0007846328257909343 5.136317586446236e-06 4.79735900450369e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008477441585479468 5.641319199038137e-06 5.281672917397186e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.000918977959018366 6.208086907157791e-06 5.827738436774011e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0009988945193813033 6.837939113614044e-06 6.437735137135464e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0010880459444634087 7.530911831388253e-06 7.112754811907943e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0011869435989032466 8.285315288705059e-06 7.852355739007727e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0012960133558410697 9.097228643060683e-06 8.654033267744839e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014155353062609184 9.959938044394604e-06 9.512602982672253e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001545563978430439 1.0863329935542299e-05 1.0419498574645277e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0016858245300475914 1.1793259956895301e-05 1.1361995735164115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018355799135251 1.2730933064142816e-05 1.2322388239061923e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0019934638471937574 1.3652353832777404e-05 1.327716496813784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0021572748213821357 1.4527875142456375e-05 1.419624969787255e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.00232372773480264 1.5321924323752095e-05 1.5042406394156668e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002488162680816023 1.5992980016810927e-05 1.5770945439676976e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0026442156899678317 1.6493864662326865e-05 1.6329900654495044e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002783464919479201 1.6772371847327867e-05 1.666087019012208e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0028950790706707545 1.6772226987116835e-05 1.670072767729067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029655139049724957 1.6434303297096218e-05 1.6384385883121654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029783486643399906 1.5697818002827464e-05 1.564869917256409e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029180801211318185 1.4501084972503415e-05 1.4437431513826034e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0027774641243684525 1.278595971759301e-05 1.2706447018830111e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0025549109073469346 1.0511875756533794e-05 1.0429403471172655e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002255148340938154 7.672223902097584e-06 7.605803920454809e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0018884306549855673 4.308586773280921e-06 4.2700161286752325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0014625602879105362 5.092949235752104e-07 4.95322033948823e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0009868523728680872 -3.619473763276723e-06 -3.6151168414875923e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.00047893685675401307 -7.96380218022102e-06 -7.939468591678524e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 3.530477438730657e-05 -1.2385160082413421e-05 -1.234335338491442e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0005325857262817188 -1.6730213289771892e-05 -1.668914214078875e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0010004251125810912 -2.0872637838105642e-05 -2.0851384007995674e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0014292142803359396 -2.4727920708622863e-05 -2.4728631793859303e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0018071524363355467 -2.8239643794679583e-05 -2.824853806932455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002121044644027006 -3.1364978424714566e-05 -3.1367801610784e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002362483296822944 -3.407745415914167e-05 -3.406873993639046e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025350393159975886 -3.63698506964063e-05 -3.6352542556684896e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002650202785526583 -3.8253598140928166e-05 -3.8234603200890495e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002718901028178075 -3.975490622398154e-05 -3.9742127033735385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.00275092379976032 -4.091079152569403e-05 -4.0910815084909634e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027545521060843865 -4.1765582694719316e-05 -4.178112421508513e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002736585679037901 -4.236681446831179e-05 -4.239483650135785e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027028444779164077 -4.276082636401755e-05 -4.2792813451773205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002658259634966319 -4.299019994442671e-05 -4.30137067027851e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002606953084952551 -4.309246511542289e-05 -4.3093278854867036e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025523299758952664 -4.309949772208943e-05 -4.306407803267972e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024972609662667327 -4.303716060816085e-05 -4.295528533873251e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002444164337346623 -4.2926316166392555e-05 -4.279286941471461e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023948813207254832 -4.278516747847537e-05 -4.25999328307637e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002350777874996688 -4.263019693114402e-05 -4.2396776848603205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023128509070616137 -4.247627868614102e-05 -4.2200854758938395e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022818137832638463 -4.233645769553823e-05 -4.202671798089454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022581633311467737 -4.222163402240049e-05 -4.188598814817942e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022422305037931006 -4.214026254701479e-05 -4.178735651218564e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022342166099583 -4.209811413723659e-05 -4.1736599857153466e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..4d85b81c3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.000995946940732114 1.2847118310773131e-05 1.25223901109508e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0010073235934696544 1.3116952253464381e-05 1.2799083282434357e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0010274724254745549 1.364561342660209e-05 1.3340809328173609e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0010566697097469972 1.4421713507666868e-05 1.4135839020159485e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0010952836935518779 1.5431826107900486e-05 1.5170331540947454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0011437691344682718 1.6659922700461783e-05 1.64273339356647e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0012026394286786459 1.808672355025993e-05 1.78863827327128e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0012724442468097427 1.9689392020887517e-05 1.9523348623834295e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0013537291227688675 2.14415170524358e-05 2.1310338185062342e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0014469730078959947 2.331308765111165e-05 2.3215611650629444e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.001552494462074089 2.5270444395479204e-05 2.5203492821952727e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.001670361980223584 2.7276268670240184e-05 2.723433828264363e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0018002705514515217 2.928954653681387e-05 2.9264510595111476e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0019413727789944582 3.126545428207561e-05 3.124633481703321e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0020920392533842263 3.315512433053712e-05 3.312807014401147e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002249596813797965 3.49053870440465e-05 3.485412116337597e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.002410061845931552 3.6458628718306565e-05 3.636553067206491e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002567788851742552 3.7752502458784324e-05 3.7600578946168843e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0027150784894391516 3.871901463558261e-05 3.849566174962929e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.002841823334693982 3.9282358007461575e-05 3.8986632974020037e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002935293180827677 3.936111905266932e-05 3.90115677322318e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.002980058913397073 3.8888608710571305e-05 3.85174874759924e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0029587972684100676 3.7816208520783274e-05 3.7462970918383874e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028602685133684385 3.611787966198854e-05 3.5821009080928976e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0026807833850996904 3.3796427131525095e-05 3.358275217280604e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0024223138556291844 3.089084994932132e-05 3.0761533040584476e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0020931871143031484 2.746231759307796e-05 2.7393045053664216e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0017031680956809691 2.3574351026404428e-05 2.353264112962232e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.001259701927905656 1.9288505772783137e-05 1.925313940148748e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0007743404751761105 1.4673728642198903e-05 1.4641768318451486e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.00026816074455682194 9.818845958287502e-06 9.796579828382828e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 0.00023387923693701017 4.831903016135119e-06 4.821644851233737e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 0.0007144181019564847 -1.759668970681805e-07 -1.7894136408536243e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.0011635261290279498 -5.1047345377472845e-06 -5.106831595933181e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0015720380956296238 -9.870294675489847e-06 -9.873840141274804e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0019269077873443083 -1.440245852792286e-05 -1.4404567275163629e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.002215980420826777 -1.8642559438712185e-05 -1.8637590630773857e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0024330854182575807 -2.2542598943303877e-05 -2.2525572626039226e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.002585335259682001 -2.6066331004380102e-05 -2.6034508216242675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0026834287636017785 -2.9189495388530844e-05 -2.9142820257854955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0027373166696183383 -3.1899217480737535e-05 -3.1840272526023294e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.002755856743892175 -3.4192975450922266e-05 -3.4126479573192686e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002746332667103179 -3.607742675072874e-05 -3.6009124363074235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0027149064338237955 -3.7567287253580034e-05 -3.7502050321377695e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026668875249400963 -3.86834268950018e-05 -3.862443747359418e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002606781727346182 -3.945129104796499e-05 -3.9399951676096143e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0025383721582174054 -3.9899784038128914e-05 -3.9855857729203544e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002465036021933325 -4.006036289172995e-05 -4.0022242873927605e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0023897406461582307 -3.996624928958404e-05 -3.993131992570386e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002314764512054771 -3.9651816988616824e-05 -3.961689559382643e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0022418137607852556 -3.915206262731336e-05 -3.9113870594521316e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002172138196530023 -3.85020538801498e-05 -3.8457708640680507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0021066240364247387 -3.773647249941525e-05 -3.768390415990358e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.00204587657184847 -3.6889510946341015e-05 -3.6827512401023804e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.001990292007603325 -3.599464584223598e-05 -3.592268258046486e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0019401134849993554 -3.508427986940895e-05 -3.500217860456577e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.001895470992237714 -3.4189036544354485e-05 -3.40969443447469e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0018564187971443686 -3.333729151252998e-05 -3.323569736489425e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0018229615545610031 -3.25548448968505e-05 -3.2444539975216745e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0017950674926261016 -3.1864593370138274e-05 -3.174661458525921e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0017726850384046653 -3.128624766479068e-05 -3.1161824976986154e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0017557565170963315 -3.0836141896709966e-05 -3.0706659294743935e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0017442289732561228 -3.052719413015544e-05 -3.0394171101580306e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.00173805812754183 -3.0369119000559546e-05 -3.0234221778420206e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..6c34c387b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0006661627426084955 1.299322741719885e-06 8.486632965682031e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0006736203177326395 1.497899757115428e-06 1.0461673803527849e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0006882743902044398 1.8899190504687431e-06 1.4361487398898314e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0007103238204917994 2.472149171274805e-06 2.0156116039982047e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0007400546041993537 3.241962690231506e-06 2.782245082863717e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007778389710570596 4.1966965651431e-06 3.733705687889961e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0008241304939680431 5.333127835787868e-06 4.867191544815488e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0008794581801034968 6.647077145460133e-06 6.179113743092872e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0009444153407598186 8.133049233086236e-06 7.664731678415455e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0010196411913479988 9.783784850834847e-06 9.31768721395016e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.001105791757678193 1.158969711839799e-05 1.112939589176849e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0012035021559542104 1.3538224819413943e-05 1.3088314130393282e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0013133314855658313 1.5613053870588743e-05 1.51790185112188e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0014356838683232927 1.779317324403374e-05 1.7381053092935506e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0015706953445715724 2.0051753776558693e-05 1.9667537171810336e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0017180850374610365 2.2354961332445546e-05 2.2003680472277185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0018769635952640385 2.4660771239839693e-05 2.4345320096575417e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0020455749662279814 2.6917613241394232e-05 2.663745004874759e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0022209628369422776 2.906270460395576e-05 2.8812950893481297e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0023985578084991226 3.101982954057571e-05 3.079187930134932e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0025716852915548026 3.269904848834898e-05 3.248242208385083e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0027309885366821364 3.4005795940322986e-05 3.378606782640819e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0028638339582261908 3.484096462029447e-05 3.460279557534109e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002953839121323517 3.5099317661914836e-05 3.48379228334654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002980740585245394 3.467851701380327e-05 3.440815258862433e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002923955469576159 3.3498668015094396e-05 3.324879842581182e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002773698055883887 3.1519160314411446e-05 3.132290813545767e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002528628657477337 2.876145461045292e-05 2.8633414575073776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0021958780350829063 2.530944540637657e-05 2.5230528789484805e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0017884508820552834 2.1265251387577046e-05 2.1203970851283687e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0013161239646989236 1.6725514880238014e-05 1.6672299716735116e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0007926725520451611 1.1813609616879643e-05 1.1777212968652322e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00024394259354955486 6.6912351562272475e-06 6.674922810234435e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.00029867561660538273 1.5255994314335312e-06 1.5217452105770629e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.000814356363221777 -3.5406247524256023e-06 -3.539820526707105e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0012909169818621938 -8.393698711887899e-06 -8.39027302082721e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0017156850039047515 -1.294424709596985e-05 -1.2936966319258656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0020715512718613685 -1.7125114093342707e-05 -1.7113587169885308e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.002345426101721663 -2.0890871467947052e-05 -2.0876603237886223e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.002538024705273825 -2.4217557184894494e-05 -2.4203289805699843e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0026623043903946037 -2.7100600194492886e-05 -2.708952041688563e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0027310216971635675 -2.955191790337768e-05 -2.95463764363197e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002755579530937514 -3.159656860847808e-05 -3.159598662100166e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002745353307440473 -3.326784886651621e-05 -3.3267349339593594e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002708138561329728 -3.4602915064079304e-05 -3.4593128895066684e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002650631675838399 -3.5639535490316953e-05 -3.560768066924209e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002578495407916654 -3.641361890462909e-05 -3.634573145490446e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0024965454421030605 -3.695704936497094e-05 -3.6841422307107986e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002409255246869896 -3.729799063719435e-05 -3.712796280867126e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002320278719604749 -3.746326686424537e-05 -3.723763278757383e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.00223236014060723 -3.7479306536170204e-05 -3.7201491670204874e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002147516768453708 -3.737220655849852e-05 -3.7048976818222367e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002067194193655212 -3.716742393948792e-05 -3.6807533023244285e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.001992396434788857 -3.688940814984794e-05 -3.650235841960991e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0019237929270720755 -3.656124360324924e-05 -3.615626505223288e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.001861806926575169 -3.6204346260697125e-05 -3.578962274894795e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0018066966557873407 -3.58381842837294e-05 -3.54203735479778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0017585872730437025 -3.548015215137123e-05 -3.5064110193234876e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.001717505097484141 -3.5145415893532845e-05 -3.473415650648596e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0016834157830890831 -3.4846713470150064e-05 -3.4441647380244516e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0016562533205116213 -3.459441432491512e-05 -3.4195681407199194e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0016359417451642406 -3.439673634618233e-05 -3.4003531301879695e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0016224110065471385 -3.426007486991565e-05 -3.387092897552858e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.00161560750854093 -3.418948390067063e-05 -3.380249455569414e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..800d4b5b7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0006573943792988745 -3.140760837270497e-07 -6.222607452965509e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0006637712577484452 -2.446539238741459e-07 -5.564292987712703e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0006765928164273125 -1.046552394567855e-07 -4.2352817921019477e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0006959934867447893 1.0887070094900696e-07 -2.2047425200167359e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0007221737248905291 4.004344020504196e-07 5.744502644044571e-08 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007553987419722869 7.758913918571025e-07 4.1637858986711884e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0007959961573930623 1.242200255911014e-06 8.636983657830755e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0008443519776989326 1.8071326467676923e-06 1.4077417455104843e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0009009040907217388 2.478916829126363e-06 2.05748801427133e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.000966132195493487 3.265798028351364e-06 2.8221501252781394e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0010405427549973216 4.1755028824737465e-06 3.7106636212155745e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.001124647142713511 5.214601263479685e-06 4.731058030655225e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0012189306619422335 6.38775011672266e-06 5.889684772003614e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0013238095021412479 7.696805929385364e-06 7.190274575223812e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0014395719542465294 9.139795815519762e-06 8.63279902497174e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.001566299313943833 1.070975371023016e-05 1.021212874504754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.001703760913507557 1.2393423878442098e-05 1.1916484399556557e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0018512766823069891 1.4169804170896336e-05 1.3725668552062838e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0020075395397762923 1.6008494832452953e-05 1.560910746560281e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0021703890206580053 1.786777096692475e-05 1.752377747830946e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0023365272121711003 1.969298234511901e-05 1.941234904399088e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0025011690592462764 2.1417939399010947e-05 2.120263125564473e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0026576223126161293 2.2965136917857675e-05 2.2807758175404827e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002796798319966615 2.4246491856986605e-05 2.4128216073081875e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0029066630115245785 2.5164571848976868e-05 2.5056585285859707e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0029717281275603424 2.5612872559266948e-05 2.5485209378224893e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.00297291901180176 2.5474622938078986e-05 2.531455712197206e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002893661305723237 2.4638269368037224e-05 2.4460939194430512e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027265611409637725 2.302730751537161e-05 2.286918364349324e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0024709098731925893 2.063725803893552e-05 2.0530121267606266e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0021338724926251345 1.7551475913070124e-05 1.7493688114877744e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0017265257170289362 1.388961332779212e-05 1.3859199517667487e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0012575236145201743 9.771675378968246e-06 9.759736929873768e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0007407597550888701 5.3458507666825835e-06 5.3537106353254045e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.00020194986279681055 7.923889501736287e-07 8.120920974631071e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0003290906384718016 -3.719861728177673e-06 -3.7014908357272976e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0008332017970642462 -8.060008865398444e-06 -8.047381954376352e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.001298573721028659 -1.2128731519547158e-05 -1.2118427855338347e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0017129966758153954 -1.5851823940311054e-05 -1.5841065989318884e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.002060687712877846 -1.918045319017859e-05 -1.9170456586465777e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0023300749883803287 -2.209144756100828e-05 -2.208535948958329e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0025217855176501583 -2.4584846476776446e-05 -2.458590132171048e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002648227049786999 -2.668015229380808e-05 -2.668992000775898e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002721682880842317 -2.8412042514671354e-05 -2.842803608808697e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0027531183619754433 -2.982395979117185e-05 -2.9837491900671616e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027516791406434864 -3.096145512237277e-05 -3.095773042816492e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002724844600548215 -3.1867395499489155e-05 -3.182767961036381e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002679009430549051 -3.25782505004268e-05 -3.2484048967211405e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002619572604084478 -3.3121641811726e-05 -3.296044697508123e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0025510283362653696 -3.35200168320077e-05 -3.3287872636318235e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0024772554593579556 -3.3793987808243744e-05 -3.349493383333481e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0024016924013622993 -3.396348237756299e-05 -3.360762363903796e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002326989925555739 -3.4047852671291675e-05 -3.364901488117621e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002255119928122554 -3.406558444526327e-05 -3.363905998097459e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002187522009297111 -3.403393692893703e-05 -3.359454987077843e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0021252248696903447 -3.396870961596365e-05 -3.3529243717207504e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0020689451841023965 -3.388419125794612e-05 -3.345410850619276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0020191669178406093 -3.379231922509735e-05 -3.3377451335428004e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.001976204385768399 -3.3702211117744845e-05 -3.330519628652797e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.001940251756883146 -3.3620373369572286e-05 -3.324132070780587e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.001911421240402869 -3.355117633490198e-05 -3.318832375371174e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0018897721161409244 -3.3497388932234984e-05 -3.314766428380607e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0018753321155383382 -3.346067446463541e-05 -3.312013990245618e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0018681110499048287 -3.3442007135775494e-05 -3.310619932867364e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..10a27b01d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005798738748063234 1.3400796485211798e-06 1.0510923466452559e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005855338034234288 1.3858765394493182e-06 1.0939283256300762e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005969158491041137 1.4789289592555548e-06 1.1810824484768415e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0006141443855970103 1.622134620954696e-06 1.3155276697145314e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0006374059535114372 1.819738047386226e-06 1.5016345190500632e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0006669489806128471 2.0771979581391343e-06 1.7450387679690685e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0007030829234517967 2.4009881875294663e-06 2.052468379489313e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0007461763744743196 2.798347472017112e-06 2.4315205634969395e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.000796653511499898 3.2769775012108635e-06 2.8903822361831394e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0008549880602836483 3.844676832934451e-06 3.437488171745859e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0009216936857299255 4.5089053575303654e-06 4.081108596104356e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.000997309411875265 5.276274166936779e-06 4.828857243940598e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.001082378284690866 6.15195556467091e-06 5.687109148324339e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0011774170228918749 7.139008646684142e-06 6.660316865673392e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0012828738430743507 8.23761694109144e-06 7.75021409984656e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.001399070994601771 9.44423733569689e-06 8.954898644971348e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0015261278109829862 1.0750659948234113e-05 1.0267789728499797e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0016638593122160147 1.214297068739942e-05 1.167645725301236e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0018116446421251311 1.360039358076517e-05 1.3161328505329169e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001968259028159152 1.5093953794094579e-05 1.469428697020356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0021316627289074295 1.658546033950029e-05 1.6237356958393657e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0022987409395433525 1.802866322942657e-05 1.7742148040890118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0024649903862723403 1.936915247417613e-05 1.9149331635780926e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0026241521892066723 2.0544550766443217e-05 2.0388737729173213e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0027677977124707497 2.1485169886571094e-05 2.1380436661703136e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002884886243474058 2.2115030198142578e-05 2.2037265095012093e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0029613296180673815 2.2350450065326e-05 2.2268868190266983e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029796706643066273 2.2096963887488912e-05 2.19877832128051e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029224770798977444 2.1255959878827744e-05 2.111671841185701e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0027810033051086573 1.9744861526651976e-05 1.95970541926209e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002552933833682221 1.752302412387663e-05 1.7401108149403368e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002243017687954956 1.4620487933037572e-05 1.4546820435424323e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0018620133686361362 1.1135263779056477e-05 1.1103594092106781e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0014181524852191357 7.187139655323514e-06 7.180414441984124e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0009221065791136955 2.9019471926174063e-06 2.9133971383777482e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.00039468149325981176 -1.5656099033639911e-06 -1.5422023628850293e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.00013527459746948568 -6.047481018112683e-06 -6.026658514084265e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0006444145199426463 -1.0401918506172573e-05 -1.0394440121460208e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0011200796126556866 -1.4524743730661057e-05 -1.4527374769282466e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0015514125373083617 -1.8337096495372206e-05 -1.8340100432516704e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.001923798272395325 -2.1782080037875933e-05 -2.1779270163107847e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0022236747077778443 -2.482582398140177e-05 -2.481759225070718e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002445123994558664 -2.745757160768373e-05 -2.74480327711658e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0025972391348213085 -2.9686567350052728e-05 -2.968136600807301e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026924622945384774 -3.1538325589362324e-05 -3.154220141064436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002742112801034011 -3.305062735536587e-05 -3.306442519725114e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002756042652413882 -3.426799121253812e-05 -3.428642556490236e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027422448779806366 -3.523574614656204e-05 -3.524740937327505e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002707477888275495 -3.599615964533593e-05 -3.59851437763252e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0026574981685827176 -3.6585916448271617e-05 -3.653466590847871e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002597135738463964 -3.7034135521745456e-05 -3.692757609985916e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002530404633145033 -3.736273006952158e-05 -3.7192065489641724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002460836042918638 -3.759022737526769e-05 -3.735354117194595e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0023913966888603195 -3.773369378281141e-05 -3.743479015159922e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002324326529916518 -3.780930168820651e-05 -3.745593687074624e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0022612828714269903 -3.783230389956433e-05 -3.743440008176061e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0022034702736018924 -3.7816846468431865e-05 -3.738491990856768e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0021517471055084525 -3.777571957558894e-05 -3.7319678866619365e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0021067115438248235 -3.7720153614835734e-05 -3.7248503673452893e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002068769929968776 -3.765970673411736e-05 -3.7179117890049994e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0020381902009752612 -3.760223189405937e-05 -3.71174159202215e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002015142787042901 -3.7553901393058784e-05 -3.706773130670716e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.001999730976710072 -3.7519254029333286e-05 -3.7033073874853394e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.001992012334985504 -3.75012269702245e-05 -3.701531351994541e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..f47cf171b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005556885706950719 2.2203773907024316e-06 1.964880525406959e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005610101055059186 2.2525438735887703e-06 1.99427762591036e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005717116345607183 2.3181586505581297e-06 2.054368740442565e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005879102027149095 2.4197582854651925e-06 2.1477319139887753e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0006097816095774789 2.5610624805417633e-06 2.2781596899374044e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0006375604514887433 2.7468672588184523e-06 2.4505601600364404e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006715397657133575 2.9828931949174035e-06 2.6708237825988824e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0007120698887209613 3.2755913355447824e-06 2.945651015119344e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0007595559976953898 3.631904125196117e-06 3.2823358100809226e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0008144536287493574 4.0589742525467655e-06 3.6884995737629615e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0008772612478620273 4.5637961306293865e-06 4.171768568346201e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.000948508681802885 5.152804530574086e-06 4.739386734955249e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0010287398864215439 5.83139486559862e-06 5.397754648179808e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0011184881295408535 6.6033702851314365e-06 6.151884675401607e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0012182411887856064 7.470312084762229e-06 7.004762496231633e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.001328393609991449 8.430872664210141e-06 7.956606924245112e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0014491824492474173 9.479992972738312e-06 9.004022832712938e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0015806022595258116 1.0608046605873013e-05 1.013904580437044e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001722294440527712 1.1799910937455896e-05 1.1348084974070254e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0018734055554773528 1.3033955612390882e-05 1.2610781145830873e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002032409012448128 1.4281188836456904e-05 1.3898884891683064e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.00219688489878945 1.550543288336556e-05 1.517549088668353e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0023632541838768694 1.666309908574916e-05 1.6394371286760403e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0025264666038949646 1.7703277739621425e-05 1.7499733372559983e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0026796471909616773 1.8568292200571867e-05 1.8426653338804193e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0028137157413162285 1.919470746641146e-05 1.910243934229526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0029170079185087314 1.951347827892805e-05 1.944893897080754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.00297494756629791 1.944954379064285e-05 1.938612532907339e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029700703018002363 1.8921993044607296e-05 1.8837638269355974e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002888273518066801 1.7847470989257442e-05 1.7737242335850856e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002723584063749613 1.6156400599204548e-05 1.6035792113417933e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0024757796516435776 1.381470924802583e-05 1.371132544309345e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.002151569427702062 1.0845930158269242e-05 1.0781190918255596e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0017612394719091786 7.336932337953826e-06 7.309530657157396e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0013123418892228636 3.401819330743974e-06 3.398478868872414e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0008163808636006968 -8.389974694236916e-07 -8.245333582312431e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.00029545095372222326 -5.241894627777446e-06 -5.214270352903683e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.00022280967458669163 -9.645058134516727e-06 -9.618940941891343e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0007184619391898704 -1.3908089771980808e-05 -1.389781121499251e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0011802046459274762 -1.7930041897834417e-05 -1.793499420115143e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0015976564340773568 -2.163760321747493e-05 -2.1645885507981526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0019564734446475608 -2.4976235089799196e-05 -2.4977532324243857e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0022441956149284676 -2.7911937325813274e-05 -2.7904187968563013e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002456261038287493 -3.0432809919013105e-05 -3.042010837924859e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026021666313050906 -3.254706879411353e-05 -3.253605552331365e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002693787107571219 -3.427910101959347e-05 -3.427631276702494e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.00274194161296216 -3.566540360865225e-05 -3.567469961209497e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027560654577470397 -3.675040910205282e-05 -3.67701160716418e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027438426979223434 -3.758068050153107e-05 -3.7602727325346384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002711781834031619 -3.820060472398985e-05 -3.821154859433118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0026654349088459845 -3.8649827842622885e-05 -3.863307809506439e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.00260946944109088 -3.896163540693718e-05 -3.8900583831540984e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0025477605736860076 -3.91617452000493e-05 -3.904377611560507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002483632251240763 -3.927033745258793e-05 -3.908920689182906e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002419937620450691 -3.930520841322768e-05 -3.906076095494864e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002358855387283829 -3.9282990993488944e-05 -3.89797511333252e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0023020051761811133 -3.921943820215331e-05 -3.88648941990206e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0022505715644158555 -3.9129274106480295e-05 -3.873230752381725e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0022054058374680724 -3.902591316838712e-05 -3.859556999178627e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002167107907927712 -3.8921194882798466e-05 -3.8465844083984e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.002136091004806356 -3.8825178660859614e-05 -3.835204007679833e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002112631596539191 -3.87460057181314e-05 -3.826099753285527e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002096906696902642 -3.8689816908968776e-05 -3.8197659714617814e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002089020305269083 -3.866070875315571e-05 -3.816521961707794e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..af32876f4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005341799191742056 2.528729395457259e-06 2.2843251590314188e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005392594264211114 2.5626813266381058e-06 2.3157144607034965e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005494746652647084 2.6315911364349903e-06 2.3795069700371724e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005649382790812176 2.737451135184968e-06 2.4777209746841693e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005858196462749343 2.883185065357291e-06 2.613328757344375e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0006123451658145842 3.072565879363372e-06 2.7901816884053807e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006447982716527849 3.3100974546552657e-06 3.0129088902330343e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006835188302995044 3.6008622423637284e-06 3.2867848101256906e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0007289014480886013 3.950331908349389e-06 3.617560979254643e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007813920570711525 4.364134110436746e-06 4.011256736440254e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0008414819528012676 4.8477699698347935e-06 4.473902173547854e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.000909698214673639 5.406276450776353e-06 5.011225550120251e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009865891405361137 6.043827679864423e-06 5.6282761893369055e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0010727029629680393 6.7632696833817e-06 6.328973165035695e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0011685576777258802 7.565584153303786e-06 7.1155699973020736e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0012745993024767031 8.4492792930247e-06 7.988026897721177e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0013911453019502683 9.409708586452817e-06 8.943284411945791e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0015183092851139947 1.0438319892131793e-05 9.974435705669425e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0016559024477615953 1.1521838346558353e-05 1.1069801763901811e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001803306687678845 1.2641382919946434e-05 1.2211923683776024e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0019593140098662903 1.3771700101258085e-05 1.3376552367002866e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.002121927009115305 1.4881137228858089e-05 1.4531881096123078e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0022881162408792347 1.5931341081587426e-05 1.5637847504909472e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0024535327187691328 1.6877228699573833e-05 1.6645761304312574e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002612178379463741 1.7667367626431828e-05 1.7498467503262208e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002756045151296605 1.824480044003447e-05 1.8131266004956533e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002874745490703179 1.8547496050854097e-05 1.847366172005185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002955175229632299 1.850871594819514e-05 1.845220938760739e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002981274389123195 1.8057979021895146e-05 1.7994818318265727e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029362065710581003 1.712137240631365e-05 1.7036326662395834e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002810975559057597 1.5628768002147053e-05 1.5524229384517334e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0026027477972221068 1.3530978456565972e-05 1.3425664693158388e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.002314894207841287 1.0819003115386993e-05 1.0737115099613657e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0019571944817724737 7.540771198621337e-06 7.494785934327264e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0015380810756086486 3.7934334405587924e-06 3.7768778551101084e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0010661948411799771 -3.107979858963243e-07 -3.076569880951395e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0005576303314330333 -4.650725768465112e-06 -4.629677718847978e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -3.811834485577763e-05 -9.078920471559183e-06 -9.046394071376231e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.00046715084076301384 -1.3440198662487907e-05 -1.3413703151906955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0009442450337607283 -1.7610033014718877e-05 -1.7602644967221068e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0013830941168828234 -2.150304147944736e-05 -2.1510558958128612e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0017719526405952655 -2.5056645287149295e-05 -2.5065332080262358e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002096724550288671 -2.822508206962096e-05 -2.82247457491685e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002347799124571942 -3.0981977849403894e-05 -3.09715581259567e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0025274306203842494 -3.332208504059983e-05 -3.3306451067743665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0026472330335020953 -3.525875367182979e-05 -3.524509406063409e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002718463763518788 -3.6819913619479286e-05 -3.681519227554453e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002751233973655458 -3.8044152246585514e-05 -3.805262982004621e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.00275409438214225 -3.897681368800042e-05 -3.899731548307118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027340597415644275 -3.9664662977938646e-05 -3.9689818538783065e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002697140704330497 -4.015200989941063e-05 -4.016929874613115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002648434437030802 -4.0478505752199866e-05 -4.047235351656056e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0025922045452599976 -4.067787732725365e-05 -4.0632428754583384e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002531986691550053 -4.07769935889819e-05 -4.0679536555661624e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0024708495192549283 -4.079691968243692e-05 -4.0640463626217696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002411323036018874 -4.0755979399736074e-05 -4.053927453648071e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0023553132518188773 -4.067111823578258e-05 -4.0397443323482226e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002304230723780349 -4.0558207194131176e-05 -4.023384134762345e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0022591025514275007 -4.043190135772524e-05 -4.0064721450547226e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0022206633254376806 -4.030535854197189e-05 -3.990374388319428e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0021894274440124504 -4.0189951653848414e-05 -3.976204743858949e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002165745227450868 -4.00950283261079e-05 -3.96483508532013e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0021498450305805464 -4.00277316233797e-05 -3.9569063854720414e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002141863187007643 -3.999287743955127e-05 -3.95283876704229e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz new file mode 100644 index 000000000..601357297 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005222083811403552 2.6830240201577335e-06 2.447934703956349e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005271413350370604 2.717336292692958e-06 2.4797990040568335e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005370619686279147 2.786808519838617e-06 2.5443801096347715e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.000552079964318251 2.893118135916574e-06 2.643372088112822e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005723603548236973 3.038727415073332e-06 2.779271012848862e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005981239391705474 3.226815388773008e-06 2.9553152162735608e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006296474979968376 3.461180678461379e-06 3.175403305706599e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006672634875947294 3.7461149513436617e-06 3.443985972075632e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0007113587733696075 4.086243607220592e-06 3.765927151881114e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007623718166216597 4.486327739556486e-06 4.146329355910423e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0008207875460143531 4.9510218735415045e-06 4.590316634802374e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008871289183032482 5.4845815494827e-06 5.102767596682506e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009619438927651459 6.0905146213547645e-06 5.687989751978106e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.001045786201308589 6.771170520798833e-06 6.3493257279677285e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0011391878839614935 7.527262824876623e-06 7.088681710813076e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0012426210733071047 8.357322736886398e-06 7.905969433275606e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0013564459550220753 9.257084110758073e-06 8.798455059826183e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014808412216955377 1.021880359995459e-05 9.760011712883262e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0016157127129574483 1.1230522917454305e-05 1.0780278917198076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0017605753721466307 1.2275281602885084e-05 1.1843741861642175e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0019144032799360523 1.3330402493554324e-05 1.2928788290634783e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0020754425631462473 1.4367241591295575e-05 1.4006907815487816e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0022409827561227663 1.5350823633658875e-05 1.5041959192679132e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0024070842073137845 1.6239716256457646e-05 1.5989699048169118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0025682630759221387 1.6986256959412163e-05 1.679775310238259e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0027171422901222765 1.753718552533667e-05 1.740623261410691e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0028440877030837084 1.7834212443074914e-05 1.7749121829612556e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002936864868750974 1.7814705001364243e-05 1.7756680485073005e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002980374480560669 1.7412892384332345e-05 1.7359155556498947e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029573352331963092 1.656054348100351e-05 1.6491720219258905e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0028562879335776153 1.5189441485559739e-05 1.5100077887098332e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0026729241523598046 1.3244740753815438e-05 1.3146190252917635e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0024086860287022816 1.0702522242941165e-05 1.0616368723506302e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0020718016029518133 7.587040906350614e-06 7.531160152431374e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0016718322565315465 3.977461032923577e-06 3.952450948676346e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0012164902724934872 -1.9338471098823118e-08 -2.2846590355943842e-08 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0007186157295741638 -4.289972926620369e-06 -4.2750145675432824e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.00020152983386637616 -8.700979551621902e-06 -8.66876798239749e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0003082002447052054 -1.3096945383433241e-05 -1.3061550524648615e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0007934218318175666 -1.7338945192524718e-05 -1.731894447012819e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.001243669147065049 -2.132786461197224e-05 -2.1328421489244392e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0016486979149528773 -2.4996744472106022e-05 -2.500641761769791e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0019944909254626065 -2.8294597787247787e-05 -2.8299477885546346e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0022697700761541316 -3.118763441423089e-05 -3.118153076491496e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0024717142675525047 -3.3662033672068366e-05 -3.3647246282214544e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0026103974092558636 -3.572384695096096e-05 -3.570684133887486e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002697287645736818 -3.73953087586162e-05 -3.7383690935217986e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027428164232704434 -3.871080666049193e-05 -3.871095116148062e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002756064336819952 -3.9713226920032106e-05 -3.9727610203828805e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027444401753899178 -4.044956435203612e-05 -4.0474703531557466e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027142327997152728 -4.09661101977067e-05 -4.0992718012800444e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0026708046320381585 -4.13055531125111e-05 -4.1320084439462405e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002618662906372297 -4.1505409207023935e-05 -4.149237590230654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002561548500621235 -4.159713610515156e-05 -4.154191598096561e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002502604954128216 -4.160556664174132e-05 -4.149761763630125e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024445453816704602 -4.1550867802280855e-05 -4.138533888865924e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0023894679767542002 -4.145101448745692e-05 -4.122824216595387e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023389363339109525 -4.1322646301287806e-05 -4.104684779849231e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0022940976489000376 -4.118114642999456e-05 -4.0859002264476546e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002255779263214009 -4.104041553844019e-05 -4.067985718893193e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022245657811436324 -4.09125635037272e-05 -4.0521886702526014e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022008591256843044 -4.080761895780723e-05 -4.039493936050051e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0021849237356505284 -4.0733294714533733e-05 -4.0306308689625026e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002176918771346905 -4.0694817464973067e-05 -4.0260803872231446e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz new file mode 100644 index 000000000..b72e77de5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005141374393608493 2.7629691984934267e-06 2.533236065422531e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005189750426139968 2.7979658722525624e-06 2.5658603114724373e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005287040139219999 2.8687036467743355e-06 2.6318560693850298e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005434321363129479 2.9766551669192192e-06 2.732707345943744e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005633216533563655 3.1239825361774977e-06 2.870601713023465e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005885897667518309 3.313478078981724e-06 3.0483796880238037e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006195089771908168 3.5484799031719e-06 3.2694645737053547e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0006564069636009654 3.83276104806179e-06 3.5377690840575863e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0006996655826867616 4.170388633494051e-06 3.8575744558738995e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0007497184306305841 4.5655474336939234e-06 4.233376903203288e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0008070462344112337 5.022322361175679e-06 4.669695011138328e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0008721691231923457 5.544433866521019e-06 5.1708305982377045e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0009456345617246765 6.134920043808879e-06 5.740574483902344e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.001027999398751883 6.7957595697745655e-06 6.381847855053336e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0011198040863016736 7.5274306572703745e-06 7.0962696959957855e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0012215366557895616 8.328403376612774e-06 7.883641520884867e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.001333583496171431 9.194565809095998e-06 8.741342519254384e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0014561633820014174 1.011858812283061e-05 9.663631572521648e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001589240579966057 1.1089233254267655e-05 1.064085883689629e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001732412289307778 1.2090626906656952e-05 1.1658598981867985e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018847652644850537 1.3101577408143594e-05 1.2696752007975937e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.002044696424604827 1.4095214655269755e-05 1.3728733323658187e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002209692882222161 1.503859098283293e-05 1.4720727683769519e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002376068584510884 1.5892497744844933e-05 1.5631166785752557e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0025386583095753376 1.6611597705878373e-05 1.641059428253173e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.00269047598643181 1.7144932237819035e-05 1.700210858242785e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002822354324119027 1.7436518885941e-05 1.7342534619761592e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029225978004712373 1.742616076877185e-05 1.73645561935675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002976702324791788 1.7050701366777103e-05 1.700006355019032e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029675305936859306 1.6244983444291747e-05 1.6184699309490723e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.00288196095702296 1.4942952683023848e-05 1.486330790301216e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002714683640268041 1.308771008280339e-05 1.299527673330801e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0024659585788384853 1.0648013629395595e-05 1.0561634007599463e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0021427478653679097 7.635336517137226e-06 7.574331150526892e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0017551844073643342 4.115101633069244e-06 4.084718257030562e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0013107273868722387 1.8897050115401721e-07 1.813825050968801e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0008206223608390761 -4.032719768235681e-06 -4.021931678953153e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0003062061311613247 -8.424988608780262e-06 -8.395006777302684e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0002058228104762058 -1.2836915957050432e-05 -1.2797765847804475e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0006958952564231907 -1.7121989243802167e-05 -1.7093682538374466e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.001153057331144704 -2.117111900281479e-05 -2.1164827999635607e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.00156756066126319 -2.4912681402505334e-05 -2.492073886915347e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0019260002907571612 -2.829340216470027e-05 -2.830082260535403e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0022162547540858306 -3.127558639562304e-05 -3.127278133451484e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0024328770845726336 -3.384024304346523e-05 -3.382710865985965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025840242689861726 -3.598852575314275e-05 -3.597056796551603e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026812839487587357 -3.773874518177743e-05 -3.7723565918169115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002735281805978919 -3.912233859093778e-05 -3.911715129073219e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002755392792131488 -4.0180076740446434e-05 -4.0189279722264067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002749334885137103 -4.095835004536972e-05 -4.098094452733649e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002723578424198285 -4.1504208912567226e-05 -4.1533230348508575e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0026836578832849494 -4.186190197118068e-05 -4.18855494111419e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002634239237318412 -4.2071001779665165e-05 -4.2074674529869505e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002579205579830223 -4.216543801830769e-05 -4.213425697635269e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002521778056556903 -4.2172887033292896e-05 -4.209459747460904e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024647457908851464 -4.21152211168035e-05 -4.1982713414004744e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024103337994446257 -4.201123785557918e-05 -4.18227829824631e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002360207480150757 -4.1878061322991994e-05 -4.1636292732958e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023155940748557174 -4.173145930270709e-05 -4.1442019997458036e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002277382849313454 -4.158570230298675e-05 -4.12559923500627e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.00224620534815149 -4.1453267415756806e-05 -4.1091474241824e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022224980381916723 -4.134452849354315e-05 -4.095898776940539e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022065495370183555 -4.126749237544906e-05 -4.086635654398032e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0021985343113196066 -4.122760095155585e-05 -4.081875626229774e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 b/drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 new file mode 100644 index 000000000..35f8223ca --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_00 b/drivers/py/pes/friction/frictionH/060K/inst.raw_00 new file mode 100644 index 000000000..b0611f6a3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_00 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 0 +{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} + #*EXTRAS*# Step: 1 Bead: 0 +{"friction": [[0.00013423764728277205, -2.348553637133703e-05, -2.3249318245248094e-05], [-2.348553637133703e-05, 0.00013443905315219606, -2.3370860165126848e-05], [-2.3249318245248094e-05, -2.3370860165126848e-05, 0.00013438946863385249]]} + #*EXTRAS*# Step: 2 Bead: 0 +{"friction": [[0.00013575229882282363, -1.5190825886546166e-05, -1.4688053747849838e-05], [-1.5190825886546166e-05, 0.00013584922333986188, -1.5052148480681862e-05], [-1.4688053747849838e-05, -1.5052148480681862e-05, 0.00013626830389509913]]} + #*EXTRAS*# Step: 3 Bead: 0 +{"friction": [[0.0001371461313605444, -7.6138455177672514e-06, -7.155165180438593e-06], [-7.6138455177672514e-06, 0.00013717564146078164, -7.509255010627289e-06], [-7.155165180438593e-06, -7.509255010627289e-06, 0.0001378738772975121]]} + #*EXTRAS*# Step: 4 Bead: 0 +{"friction": [[0.0001376909459037285, -5.029032704727686e-06, -4.673346570088041e-06], [-5.029032704727686e-06, 0.00013770983627563985, -4.947851967879184e-06], [-4.673346570088041e-06, -4.947851967879184e-06, 0.00013845751050799916]]} + #*EXTRAS*# Step: 5 Bead: 0 +{"friction": [[0.00013770582140571047, -4.961428005926094e-06, -4.609086083728716e-06], [-4.961428005926094e-06, 0.00013772453208725052, -4.88093750174026e-06], [-4.609086083728716e-06, -4.88093750174026e-06, 0.00013847316030156636]]} + #*EXTRAS*# Step: 6 Bead: 0 +{"friction": [[0.0001378382987707843, -4.365987040591944e-06, -4.044555358583953e-06], [-4.365987040591944e-06, 0.0001378556495428131, -4.291745681540963e-06], [-4.044555358583953e-06, -4.291745681540963e-06, 0.00013861192122795624]]} + #*EXTRAS*# Step: 7 Bead: 0 +{"friction": [[0.00013787999158690196, -4.181020414403456e-06, -3.869724738291976e-06], [-4.181020414403456e-06, 0.00013789700195002702, -4.108782178618286e-06], [-3.869724738291976e-06, -4.108782178618286e-06, 0.0001386553694775391]]} + #*EXTRAS*# Step: 8 Bead: 0 +{"friction": [[0.00013791721778029628, -4.0168349059974526e-06, -3.714749393673453e-06], [-4.0168349059974526e-06, 0.00013793395880981737, -3.946399244761727e-06], [-3.714749393673453e-06, -3.946399244761727e-06, 0.00013869407566294647]]} + #*EXTRAS*# Step: 9 Bead: 0 +{"friction": [[0.00013793799834706263, -3.9255752814151975e-06, -3.6286958232796008e-06], [-3.9255752814151975e-06, 0.00013795460306934335, -3.856151498891053e-06], [-3.6286958232796008e-06, -3.856151498891053e-06, 0.00013871564701568853]]} + #*EXTRAS*# Step: 10 Bead: 0 +{"friction": [[0.00013795203282752005, -3.8640998694949004e-06, -3.5707623591766514e-06], [-3.8640998694949004e-06, 0.0001379685511381923, -3.79536172394137e-06], [-3.5707623591766514e-06, -3.79536172394137e-06, 0.0001387302013603479]]} + #*EXTRAS*# Step: 11 Bead: 0 +{"friction": [[0.00013796080729782463, -3.825729501167846e-06, -3.53461701001706e-06], [-3.825729501167846e-06, 0.00013797727388437092, -3.757420933634416e-06], [-3.53461701001706e-06, -3.757420933634416e-06, 0.0001387392950688923]]} + #*EXTRAS*# Step: 12 Bead: 0 +{"friction": [[0.00013796647662811659, -3.800964119256224e-06, -3.511293554462288e-06], [-3.800964119256224e-06, 0.00013798291073333202, -3.732933480082611e-06], [-3.511293554462288e-06, -3.732933480082611e-06, 0.0001387451683062371]]} + #*EXTRAS*# Step: 13 Bead: 0 +{"friction": [[0.000137970088937315, -3.7851952101671225e-06, -3.496445150911942e-06], [-3.7851952101671225e-06, 0.000137986502729977, -3.7173418089810484e-06], [-3.496445150911942e-06, -3.7173418089810484e-06, 0.00013874890957506228]]} + #*EXTRAS*# Step: 14 Bead: 0 +{"friction": [[0.00013797240431558724, -3.7750922325792497e-06, -3.4869329072347104e-06], [-3.7750922325792497e-06, 0.00013798880524530167, -3.7073524972095786e-06], [-3.4869329072347104e-06, -3.7073524972095786e-06, 0.00013875130721878427]]} + #*EXTRAS*# Step: 15 Bead: 0 +{"friction": [[0.00013797388437386437, -3.7686359120512866e-06, -3.4808544950052107e-06], [-3.7686359120512866e-06, 0.00013799027714531302, -3.7009688604690436e-06], [-3.4808544950052107e-06, -3.7009688604690436e-06, 0.0001387528397026003]]} + #*EXTRAS*# Step: 16 Bead: 0 +{"friction": [[0.00013797483150163595, -3.7645050816462428e-06, -3.4769656180582017e-06], [-3.7645050816462428e-06, 0.00013799121907862047, -3.6968845526256393e-06], [-3.4769656180582017e-06, -3.6968845526256393e-06, 0.00013875382031300449]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_01 b/drivers/py/pes/friction/frictionH/060K/inst.raw_01 new file mode 100644 index 000000000..690a0ba47 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_01 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 1 +{"friction": [[0.0001318960708675288, -3.145359585337808e-05, -3.140499284046311e-05], [-3.145359585337808e-05, 0.00013214032682715794, -3.1420093958772926e-05], [-3.140499284046311e-05, -3.1420093958772926e-05, 0.00013167914079224472]]} + #*EXTRAS*# Step: 1 Bead: 1 +{"friction": [[0.00013421219818083975, -2.3605689047036214e-05, -2.3374290140305082e-05], [-2.3605689047036214e-05, 0.00013441500713185748, -2.3491833407910672e-05], [-2.3374290140305082e-05, -2.3491833407910672e-05, 0.00013435815019284246]]} + #*EXTRAS*# Step: 2 Bead: 1 +{"friction": [[0.00013573156450987525, -1.531122246133872e-05, -1.4810488159437588e-05], [-1.531122246133872e-05, 0.0001358299027784595, -1.5172430443879968e-05], [-1.4810488159437588e-05, -1.5172430443879968e-05, 0.00013624312450119847]]} + #*EXTRAS*# Step: 3 Bead: 1 +{"friction": [[0.00013712779840587168, -7.704633406618396e-06, -7.2432029676650376e-06], [-7.704633406618396e-06, 0.00013715781044139786, -7.5993272238622495e-06], [-7.2432029676650376e-06, -7.5993272238622495e-06, 0.00013785385777348626]]} + #*EXTRAS*# Step: 4 Bead: 1 +{"friction": [[0.00013767831127657328, -5.086572824476252e-06, -4.728066803940873e-06], [-5.086572824476252e-06, 0.00013769735862466465, -5.004807717050321e-06], [-4.728066803940873e-06, -5.004807717050321e-06, 0.00013844420710205075]]} + #*EXTRAS*# Step: 5 Bead: 1 +{"friction": [[0.00013769500088790595, -5.010588947814341e-06, -4.6558118404509825e-06], [-5.010588947814341e-06, 0.00013771384172842844, -4.929596127837761e-06], [-4.6558118404509825e-06, -4.929596127837761e-06, 0.0001384617779617171]]} + #*EXTRAS*# Step: 6 Bead: 1 +{"friction": [[0.00013782856683117385, -4.4093276387752435e-06, -4.085557628520318e-06], [-4.4093276387752435e-06, 0.0001378460030153187, -4.3346211515787955e-06], [-4.085557628520318e-06, -4.3346211515787955e-06, 0.00013860176447469952]]} + #*EXTRAS*# Step: 7 Bead: 1 +{"friction": [[0.00013787080283125152, -4.2216870213216404e-06, -3.908141071202103e-06], [-4.2216870213216404e-06, 0.00013788788468120576, -4.149005870458964e-06], [-3.908141071202103e-06, -4.149005870458964e-06, 0.00013864580277650641]]} + #*EXTRAS*# Step: 8 Bead: 1 +{"friction": [[0.00013790841378145038, -4.055583065666455e-06, -3.7513058560917236e-06], [-4.055583065666455e-06, 0.00013792521558389558, -3.984719917314708e-06], [-3.7513058560917236e-06, -3.984719917314708e-06, 0.00013868492901939597]]} + #*EXTRAS*# Step: 9 Bead: 1 +{"friction": [[0.0001379294302841245, -3.9631687121073085e-06, -3.6641371615835034e-06], [-3.9631687121073085e-06, 0.00013794608999531557, -3.893327236509839e-06], [-3.6641371615835034e-06, -3.893327236509839e-06, 0.00013870675595400254]]} + #*EXTRAS*# Step: 10 Bead: 1 +{"friction": [[0.0001379436183742693, -3.900942529069543e-06, -3.6054789210239987e-06], [-3.900942529069543e-06, 0.00013796018794874098, -3.83179308955976e-06], [-3.6054789210239987e-06, -3.83179308955976e-06, 0.00013872147658957804]]} + #*EXTRAS*# Step: 11 Bead: 1 +{"friction": [[0.0001379524904757413, -3.862097368035428e-06, -3.5688757070827457e-06], [-3.862097368035428e-06, 0.00013796900604495836, -3.7933816105998145e-06], [-3.5688757070827457e-06, -3.7933816105998145e-06, 0.00013873067576881967]]} + #*EXTRAS*# Step: 12 Bead: 1 +{"friction": [[0.0001379582225625487, -3.837027282171246e-06, -3.5452585150372925e-06], [-3.837027282171246e-06, 0.00013797470420217437, -3.7685920993052055e-06], [-3.5452585150372925e-06, -3.7685920993052055e-06, 0.00013873661675538375]]} + #*EXTRAS*# Step: 13 Bead: 1 +{"friction": [[0.00013796187499285674, -3.821063900763913e-06, -3.530222707167836e-06], [-3.821063900763913e-06, 0.00013797833540600532, -3.7528076527859285e-06], [-3.530222707167836e-06, -3.7528076527859285e-06, 0.00013874040130667877]]} + #*EXTRAS*# Step: 14 Bead: 1 +{"friction": [[0.0001379642160712024, -3.8108364518266074e-06, -3.5205905370555803e-06], [-3.8108364518266074e-06, 0.00013798066303964958, -3.742694958251714e-06], [-3.5205905370555803e-06, -3.742694958251714e-06, 0.0001387428266661096]]} + #*EXTRAS*# Step: 15 Bead: 1 +{"friction": [[0.00013796571257119976, -3.8043005508814134e-06, -3.514435460718382e-06], [-3.8043005508814134e-06, 0.00013798215101104406, -3.7362324383158968e-06], [-3.514435460718382e-06, -3.7362324383158968e-06, 0.00013874437687645187]]} + #*EXTRAS*# Step: 16 Bead: 1 +{"friction": [[0.00013796667022043812, -3.8001188130614423e-06, -3.5104975456983384e-06], [-3.8001188130614423e-06, 0.00013798310322949036, -3.7320976695151757e-06], [-3.5104975456983384e-06, -3.7320976695151757e-06, 0.0001387453688288128]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_02 b/drivers/py/pes/friction/frictionH/060K/inst.raw_02 new file mode 100644 index 000000000..29712b2f3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_02 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 2 +{"friction": [[0.00013182249801045433, -3.1627039924819494e-05, -3.157597998104187e-05], [-3.1627039924819494e-05, 0.00013206576277603182, -3.1595838794370805e-05], [-3.157597998104187e-05, -3.1595838794370805e-05, 0.0001315990850259919]]} + #*EXTRAS*# Step: 1 Bead: 2 +{"friction": [[0.00013416900800073794, -2.3807653696517653e-05, -2.358433734495794e-05], [-2.3807653696517653e-05, 0.00013437414992859416, -2.369520713456347e-05], [-2.358433734495794e-05, -2.369520713456347e-05, 0.00013430507960848526]]} + #*EXTRAS*# Step: 2 Bead: 2 +{"friction": [[0.00013569622167241053, -1.551660843299909e-05, -1.5019520532352334e-05], [-1.551660843299909e-05, 0.00013579698951373382, -1.537765223496821e-05], [-1.5019520532352334e-05, -1.537765223496821e-05, 0.0001362001284347798]]} + #*EXTRAS*# Step: 3 Bead: 2 +{"friction": [[0.00013709539583038705, -7.865718909077805e-06, -7.399551213118173e-06], [-7.865718909077805e-06, 0.000137126319254703, -7.759160858863718e-06], [-7.399551213118173e-06, -7.759160858863718e-06, 0.00013781840939080508]]} + #*EXTRAS*# Step: 4 Bead: 2 +{"friction": [[0.00013765352991564829, -5.199751249925924e-06, -4.835769581552853e-06], [-5.199751249925924e-06, 0.00013767289683673582, -5.116845052560431e-06], [-4.835769581552853e-06, -5.116845052560431e-06, 0.00013841808412039025]]} + #*EXTRAS*# Step: 5 Bead: 2 +{"friction": [[0.00013767327963907036, -5.109518353158603e-06, -4.7498946158095616e-06], [-5.109518353158603e-06, 0.0001376923906192341, -5.027521010267586e-06], [-4.7498946158095616e-06, -5.027521010267586e-06, 0.00013843890627086457]]} + #*EXTRAS*# Step: 6 Bead: 2 +{"friction": [[0.0001378090247068655, -4.496547804090528e-06, -4.1681142369068245e-06], [-4.496547804090528e-06, 0.00013782663926166817, -4.420910155772545e-06], [-4.1681142369068245e-06, -4.420910155772545e-06, 0.0001385813519303408]]} + #*EXTRAS*# Step: 7 Bead: 2 +{"friction": [[0.00013785235005580183, -4.30352138928369e-06, -3.9854843772290815e-06], [-4.30352138928369e-06, 0.00013786958149502337, -4.2299532371294874e-06], [-3.9854843772290815e-06, -4.2299532371294874e-06, 0.00013862657577925306]]} + #*EXTRAS*# Step: 8 Bead: 2 +{"friction": [[0.0001378907319832182, -4.133557019483402e-06, -3.824903255476108e-06], [-4.133557019483402e-06, 0.00013790766130770355, -4.0618375129126275e-06], [-3.824903255476108e-06, -4.0618375129126275e-06, 0.00013866654527912176]]} + #*EXTRAS*# Step: 9 Bead: 2 +{"friction": [[0.00013791222153992024, -4.038818162384249e-06, -3.7354878480972996e-06], [-4.038818162384249e-06, 0.00013792899683633502, -3.968139814694238e-06], [-3.7354878480972996e-06, -3.968139814694238e-06, 0.00013868888553103761]]} + #*EXTRAS*# Step: 10 Bead: 2 +{"friction": [[0.0001379267176097774, -3.975080823853663e-06, -3.6753695432488504e-06], [-3.975080823853663e-06, 0.00013794339508472038, -3.905107246632902e-06], [-3.6753695432488504e-06, -3.905107246632902e-06, 0.00013870394012607592]]} + #*EXTRAS*# Step: 11 Bead: 2 +{"friction": [[0.00013793578548403917, -3.935279935344475e-06, -3.637843911415166e-06], [-3.935279935344475e-06, 0.00013795240424567214, -3.865748210962321e-06], [-3.637843911415166e-06, -3.865748210962321e-06, 0.00013871335114125615]]} + #*EXTRAS*# Step: 12 Bead: 2 +{"friction": [[0.0001379416434151117, -3.9095965082902505e-06, -3.6136349684178526e-06], [-3.9095965082902505e-06, 0.00013795822525800537, -3.840350627646778e-06], [-3.6136349684178526e-06, -3.840350627646778e-06, 0.0001387194282015226]]} + #*EXTRAS*# Step: 13 Bead: 2 +{"friction": [[0.00013794537630303582, -3.893241665325648e-06, -3.5982216182689935e-06], [-3.893241665325648e-06, 0.0001379619350328975, -3.824178098975292e-06], [-3.5982216182689935e-06, -3.824178098975292e-06, 0.00013872329968787068]]} + #*EXTRAS*# Step: 14 Bead: 2 +{"friction": [[0.00013794776892036962, -3.882763662703983e-06, -3.5883478467009877e-06], [-3.882763662703983e-06, 0.0001379643130046078, -3.8138170188573057e-06], [-3.5883478467009877e-06, -3.8138170188573057e-06, 0.0001387257807161704]]} + #*EXTRAS*# Step: 15 Bead: 2 +{"friction": [[0.00013794929839317028, -3.8760675701452695e-06, -3.582038323916065e-06], [-3.8760675701452695e-06, 0.00013796583318427853, -3.807195696020668e-06], [-3.582038323916065e-06, -3.807195696020668e-06, 0.0001387273665318023]]} + #*EXTRAS*# Step: 16 Bead: 2 +{"friction": [[0.00013795027714269808, -3.871783357993848e-06, -3.5780016174998872e-06], [-3.871783357993848e-06, 0.00013796680601512723, -3.8029593421627264e-06], [-3.5780016174998872e-06, -3.8029593421627264e-06, 0.00013872838126558352]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_03 b/drivers/py/pes/friction/frictionH/060K/inst.raw_03 new file mode 100644 index 000000000..1b8a49453 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_03 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 3 +{"friction": [[0.00013171780647812666, -3.186828910318049e-05, -3.181299933918628e-05], [-3.186828910318049e-05, 0.0001319594795236481, -3.184031805657655e-05], [-3.181299933918628e-05, -3.184031805657655e-05, 0.00013148559226403892]]} + #*EXTRAS*# Step: 1 Bead: 3 +{"friction": [[0.0001341073054254621, -2.4091918826671486e-05, -2.38799248192029e-05], [-2.4091918826671486e-05, 0.0001343156734060211, -2.3981518631629152e-05], [-2.38799248192029e-05, -2.3981518631629152e-05, 0.00013422944390107609]]} + #*EXTRAS*# Step: 2 Bead: 3 +{"friction": [[0.0001356459621644533, -1.5808944485075542e-05, -1.5317410469091326e-05], [-1.5808944485075542e-05, 0.0001357502254732159, -1.5669822806364226e-05], [-1.5317410469091326e-05, -1.5669822806364226e-05, 0.00013613882449957463]]} + #*EXTRAS*# Step: 3 Bead: 3 +{"friction": [[0.00013704858835151458, -8.09982393646933e-06, -7.6270948629997415e-06], [-8.09982393646933e-06, 0.00013708088341545045, -7.991487566659908e-06], [-7.6270948629997415e-06, -7.991487566659908e-06, 0.00013776705416370654]]} + #*EXTRAS*# Step: 4 Bead: 3 +{"friction": [[0.00013761635512817485, -5.370331120688832e-06, -4.998274065256625e-06], [-5.370331120688832e-06, 0.00013763623069557024, -5.2857260077085855e-06], [-4.998274065256625e-06, -5.2857260077085855e-06, 0.00013837882178726406]]} + #*EXTRAS*# Step: 5 Bead: 3 +{"friction": [[0.00013764050036780585, -5.259428966355928e-06, -4.892597873339387e-06], [-5.259428966355928e-06, 0.0001376600415548423, -5.1759255393440015e-06], [-4.892597873339387e-06, -5.1759255393440015e-06, 0.00013840433318992323]]} + #*EXTRAS*# Step: 6 Bead: 3 +{"friction": [[0.00013777951704774323, -4.62873034737059e-06, -4.293336437723489e-06], [-4.62873034737059e-06, 0.0001377974184018706, -4.5516939579244145e-06], [-4.293336437723489e-06, -4.5516939579244145e-06, 0.0001385504856729999]]} + #*EXTRAS*# Step: 7 Bead: 3 +{"friction": [[0.00013782448357032125, -4.427530952936149e-06, -4.102782981314627e-06], [-4.427530952936149e-06, 0.00013784195626635742, -4.3526295890126455e-06], [-4.102782981314627e-06, -4.3526295890126455e-06, 0.00013859750126340328]]} + #*EXTRAS*# Step: 8 Bead: 3 +{"friction": [[0.00013786402545591187, -4.251717218417898e-06, -3.936517440200816e-06], [-4.251717218417898e-06, 0.00013788116131019357, -4.178709905316281e-06], [-3.936517440200816e-06, -4.178709905316281e-06, 0.00013863874341182728]]} + #*EXTRAS*# Step: 9 Bead: 3 +{"friction": [[0.00013788622745084406, -4.153453999202411e-06, -3.8436906893443965e-06], [-4.153453999202411e-06, 0.00013790319043292305, -4.0815168034275855e-06], [-3.8436906893443965e-06, -4.0815168034275855e-06, 0.0001386618589704395]]} + #*EXTRAS*# Step: 10 Bead: 3 +{"friction": [[0.00013790118732845096, -4.087425899284604e-06, -3.7813559390482727e-06], [-4.087425899284604e-06, 0.00013791804036488933, -4.016212405956493e-06], [-3.7813559390482727e-06, -4.016212405956493e-06, 0.00013867741791452715]]} + #*EXTRAS*# Step: 11 Bead: 3 +{"friction": [[0.0001379105500990275, -4.0461760643877775e-06, -3.7424299123029473e-06], [-4.0461760643877775e-06, 0.00013792733698882805, -3.9754165805040554e-06], [-3.7424299123029473e-06, -3.9754165805040554e-06, 0.00013868714889881485]]} + #*EXTRAS*# Step: 12 Bead: 3 +{"friction": [[0.0001379165975998007, -4.019562791819492e-06, -3.7173226174559855e-06], [-4.019562791819492e-06, 0.000137933342851277, -3.949096993389073e-06], [-3.7173226174559855e-06, -3.949096993389073e-06, 0.00013869343149434978]]} + #*EXTRAS*# Step: 13 Bead: 3 +{"friction": [[0.00013792045169693705, -4.002614463428573e-06, -3.7013360999725105e-06], [-4.002614463428573e-06, 0.00013793717085604587, -3.932336009932304e-06], [-3.7013360999725105e-06, -3.932336009932304e-06, 0.00013869743430006243]]} + #*EXTRAS*# Step: 14 Bead: 3 +{"friction": [[0.0001379229219598502, -3.991756602187793e-06, -3.69109554200351e-06], [-3.991756602187793e-06, 0.00013793962457667224, -3.921598299087858e-06], [-3.69109554200351e-06, -3.921598299087858e-06, 0.0001386999994198825]]} + #*EXTRAS*# Step: 15 Bead: 3 +{"friction": [[0.00013792450110888487, -3.984817644788738e-06, -3.684551545761487e-06], [-3.984817644788738e-06, 0.00013794119322504053, -3.914736179147696e-06], [-3.684551545761487e-06, -3.914736179147696e-06, 0.00013870163902059615]]} + #*EXTRAS*# Step: 16 Bead: 3 +{"friction": [[0.0001379255116481648, -3.980378072060427e-06, -3.680364858862378e-06], [-3.980378072060427e-06, 0.00013794219707502083, -3.910345788880799e-06], [-3.680364858862378e-06, -3.910345788880799e-06, 0.0001387026881680756]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_04 b/drivers/py/pes/friction/frictionH/060K/inst.raw_04 new file mode 100644 index 000000000..10a0c9b1f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_04 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 4 +{"friction": [[0.00013158007460812243, -3.217616690285429e-05, -3.2114038906784815e-05], [-3.217616690285429e-05, 0.000131819341634194, -3.215236678795705e-05], [-3.2114038906784815e-05, -3.215236678795705e-05, 0.00013133701434974246]]} + #*EXTRAS*# Step: 1 Bead: 4 +{"friction": [[0.00013402596589135048, -2.445897241083669e-05, -2.4261466286692028e-05], [-2.445897241083669e-05, 0.000134238391017754, -2.435132318714053e-05], [-2.4261466286692028e-05, -2.435132318714053e-05, 0.00013413007921958227]]} + #*EXTRAS*# Step: 2 Bead: 4 +{"friction": [[0.00013558035653235046, -1.619078144869508e-05, -1.5707129815061076e-05], [-1.619078144869508e-05, 0.00013568924777082483, -1.605156444346024e-05], [-1.5707129815061076e-05, -1.605156444346024e-05, 0.0001360585299848262]]} + #*EXTRAS*# Step: 3 Bead: 4 +{"friction": [[0.00013698693977136814, -8.410700532733241e-06, -7.929847247333982e-06], [-8.410700532733241e-06, 0.00013702114172870622, -8.300077941603389e-06], [-7.929847247333982e-06, -8.300077941603389e-06, 0.0001376991451454236]]} + #*EXTRAS*# Step: 4 Bead: 4 +{"friction": [[0.00013756644128827046, -5.600887075498122e-06, -5.218253396070243e-06], [-5.600887075498122e-06, 0.00013758705567076668, -5.514025724742836e-06], [-5.218253396070243e-06, -5.514025724742836e-06, 0.00013832596149248019]]} + #*EXTRAS*# Step: 5 Bead: 4 +{"friction": [[0.0001375964318955127, -5.462148054110503e-06, -5.085832442561333e-06], [-5.462148054110503e-06, 0.00013761659463747272, -5.37663889685109e-06], [-5.085832442561333e-06, -5.37663889685109e-06, 0.00013835774234699836]]} + #*EXTRAS*# Step: 6 Bead: 4 +{"friction": [[0.00013773981364965417, -4.807511949092367e-06, -4.462909265687072e-06], [-4.807511949092367e-06, 0.00013775813439169965, -4.728607587469339e-06], [-4.462909265687072e-06, -4.728607587469339e-06, 0.00013850886913433955]]} + #*EXTRAS*# Step: 7 Bead: 4 +{"friction": [[0.00013778698104651717, -4.595239363889967e-06, -4.261596771375986e-06], [-4.595239363889967e-06, 0.00013780480785947506, -4.5185559539245416e-06], [-4.261596771375986e-06, -4.5185559539245416e-06, 0.00013855829839521937]]} + #*EXTRAS*# Step: 8 Bead: 4 +{"friction": [[0.00013782807559174236, -4.4115170133151105e-06, -4.087629250445344e-06], [-4.4115170133151105e-06, 0.00013784551614732867, -4.336787072609965e-06], [-4.087629250445344e-06, -4.336787072609965e-06, 0.0001386012516397715]]} + #*EXTRAS*# Step: 9 Bead: 4 +{"friction": [[0.0001378512325592193, -4.308484486327402e-06, -3.990176698472619e-06], [-4.308484486327402e-06, 0.0001378684733169179, -4.234862723556853e-06], [-3.990176698472619e-06, -4.234862723556853e-06, 0.00013862541074022026]]} + #*EXTRAS*# Step: 10 Bead: 4 +{"friction": [[0.00013786681410085183, -4.2393572125690814e-06, -3.924837315878018e-06], [-4.2393572125690814e-06, 0.00013788392760278305, -4.16648404984495e-06], [-3.924837315878018e-06, -4.16648404984495e-06, 0.00013864164841749445]]} + #*EXTRAS*# Step: 11 Bead: 4 +{"friction": [[0.00013787657226515087, -4.19614679438362e-06, -3.884012669867443e-06], [-4.19614679438362e-06, 0.00013789360899737804, -4.123743646437485e-06], [-3.884012669867443e-06, -4.123743646437485e-06, 0.00013865181010203677]]} + #*EXTRAS*# Step: 12 Bead: 4 +{"friction": [[0.0001378828739546768, -4.168275375313441e-06, -3.857687470585437e-06], [-4.168275375313441e-06, 0.00013789986230344388, -4.096176241451027e-06], [-3.857687470585437e-06, -4.096176241451027e-06, 0.0001386583693657478]]} + #*EXTRAS*# Step: 13 Bead: 4 +{"friction": [[0.0001378868905953724, -4.150523987049385e-06, -3.840923883198975e-06], [-4.150523987049385e-06, 0.00013790384859256358, -4.078618826759461e-06], [-3.840923883198975e-06, -4.078618826759461e-06, 0.00013866254895104302]]} + #*EXTRAS*# Step: 14 Bead: 4 +{"friction": [[0.00013788946498655198, -4.139152128910127e-06, -3.830186058806337e-06], [-4.139152128910127e-06, 0.00013790640372980797, -4.067371373085801e-06], [-3.830186058806337e-06, -4.067371373085801e-06, 0.00013866522727545868]]} + #*EXTRAS*# Step: 15 Bead: 4 +{"friction": [[0.00013789111075756782, -4.131884540573933e-06, -3.823324175659879e-06], [-4.131884540573933e-06, 0.000137908037273583, -4.060183347700094e-06], [-3.823324175659879e-06, -4.060183347700094e-06, 0.00013866693928378968]]} + #*EXTRAS*# Step: 16 Bead: 4 +{"friction": [[0.00013789216393167466, -4.127234742082154e-06, -3.818934153074344e-06], [-4.127234742082154e-06, 0.00013790908265648577, -4.055584477207085e-06], [-3.818934153074344e-06, -4.055584477207085e-06, 0.0001386680347608504]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_05 b/drivers/py/pes/friction/frictionH/060K/inst.raw_05 new file mode 100644 index 000000000..af3427240 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_05 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 5 +{"friction": [[0.00013140687508940286, -3.2549089934313045e-05, -3.247646875118131e-05], [-3.2549089934313045e-05, 0.00013164265398424839, -3.25304116398176e-05], [-3.247646875118131e-05, -3.25304116398176e-05, 0.0001311512838181544]]} + #*EXTRAS*# Step: 1 Bead: 5 +{"friction": [[0.00013392341429703758, -2.4909337334287973e-05, -2.4729323817478538e-05], [-2.4909337334287973e-05, 0.00013414063220962155, -2.480522966465632e-05], [-2.4729323817478538e-05, -2.480522966465632e-05, 0.00013400538272629968]]} + #*EXTRAS*# Step: 2 Bead: 5 +{"friction": [[0.00013549881073491587, -1.6665278770724668e-05, -1.619238056838109e-05], [-1.6665278770724668e-05, 0.00013561354325466237, -1.6526134283560228e-05], [-1.619238056838109e-05, -1.6526134283560228e-05, 0.00013595832490855675]]} + #*EXTRAS*# Step: 3 Bead: 5 +{"friction": [[0.0001369099181112485, -8.803171711662813e-06, -8.313014401748177e-06], [-8.803171711662813e-06, 0.0001369466647782674, -8.689785841452845e-06], [-8.313014401748177e-06, -8.689785841452845e-06, 0.00013761386108267123]]} + #*EXTRAS*# Step: 4 Bead: 5 +{"friction": [[0.00013750335008310457, -5.89483311551549e-06, -5.499276464229538e-06], [-5.89483311551549e-06, 0.00013752499140817944, -5.805162054582552e-06], [-5.499276464229538e-06, -5.805162054582552e-06, 0.00013825890592898224]]} + #*EXTRAS*# Step: 5 Bead: 5 +{"friction": [[0.00013754077423236568, -5.720129883386304e-06, -5.332178089722472e-06], [-5.720129883386304e-06, 0.0001375617937617585, -5.6321196936610635e-06], [-5.332178089722472e-06, -5.6321196936610635e-06, 0.00013829871429053104]]} + #*EXTRAS*# Step: 6 Bead: 5 +{"friction": [[0.00013768961311797854, -5.0350972386330206e-06, -4.679112750825537e-06], [-5.0350972386330206e-06, 0.00013770851985974851, -4.953854776485155e-06], [-4.679112750825537e-06, -4.953854776485155e-06, 0.0001384561076582171]]} + #*EXTRAS*# Step: 7 Bead: 5 +{"friction": [[0.00013773955047169799, -4.80870058606456e-06, -4.464037466770495e-06], [-4.80870058606456e-06, 0.00013775787412287428, -4.729783897115178e-06], [-4.464037466770495e-06, -4.729783897115178e-06, 0.000138508592946185]]} + #*EXTRAS*# Step: 8 Bead: 5 +{"friction": [[0.00013778259454640327, -4.6149170597076255e-06, -4.280244472882557e-06], [-4.6149170597076255e-06, 0.00013780046500213393, -4.538026139233866e-06], [-4.280244472882557e-06, -4.538026139233866e-06, 0.0001385537073715922]]} + #*EXTRAS*# Step: 9 Bead: 5 +{"friction": [[0.000137806952748325, -4.505810295791428e-06, -4.176884782478642e-06], [-4.505810295791428e-06, 0.00013782458675378232, -4.4300741443607636e-06], [-4.176884782478642e-06, -4.4300741443607636e-06, 0.00013857918631933884]]} + #*EXTRAS*# Step: 10 Bead: 5 +{"friction": [[0.00013782331621288446, -4.432737112710233e-06, -4.107709894908343e-06], [-4.432737112710233e-06, 0.00013784079942074384, -4.357780066135241e-06], [-4.107709894908343e-06, -4.357780066135241e-06, 0.0001385962822740279]]} + #*EXTRAS*# Step: 11 Bead: 5 +{"friction": [[0.00013783357191172446, -4.387029955996895e-06, -4.064461220013463e-06], [-4.387029955996895e-06, 0.00013785096388599775, -4.312562564937565e-06], [-4.064461220013463e-06, -4.312562564937565e-06, 0.0001386069887507768]]} + #*EXTRAS*# Step: 12 Bead: 5 +{"friction": [[0.00013784019348067007, -4.35755638294656e-06, -4.036581172509351e-06], [-4.35755638294656e-06, 0.00013785752788706242, -4.283405688028381e-06], [-4.036581172509351e-06, -4.283405688028381e-06, 0.0001386138979783455]]} + #*EXTRAS*# Step: 13 Bead: 5 +{"friction": [[0.00013784441470022062, -4.338782304996927e-06, -4.0188254961769415e-06], [-4.338782304996927e-06, 0.00013786171295360308, -4.264833727072013e-06], [-4.0188254961769415e-06, -4.264833727072013e-06, 0.00013861830119638686]]} + #*EXTRAS*# Step: 14 Bead: 5 +{"friction": [[0.0001378471201553272, -4.326755874324704e-06, -4.007452813779088e-06], [-4.326755874324704e-06, 0.0001378643954609158, -4.252936928505525e-06], [-4.007452813779088e-06, -4.252936928505525e-06, 0.0001386211227325271]]} + #*EXTRAS*# Step: 15 Bead: 5 +{"friction": [[0.00013784884978623857, -4.319069769326809e-06, -4.000185081874505e-06], [-4.319069769326809e-06, 0.00013786611051234447, -4.245333736384734e-06], [-4.000185081874505e-06, -4.245333736384734e-06, 0.0001386229263444407]]} + #*EXTRAS*# Step: 16 Bead: 5 +{"friction": [[0.00013784995662798204, -4.31415224386569e-06, -3.995535458954869e-06], [-4.31415224386569e-06, 0.00013786720806160146, -4.240469284630536e-06], [-3.995535458954869e-06, -4.240469284630536e-06, 0.00013862408043431799]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_06 b/drivers/py/pes/friction/frictionH/060K/inst.raw_06 new file mode 100644 index 000000000..0a7becd4e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_06 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 6 +{"friction": [[0.0001311956103908458, -3.29848470674875e-05, -3.289701440835983e-05], [-3.29848470674875e-05, 0.00013142653940500336, -3.297224398384808e-05], [-3.289701440835983e-05, -3.297224398384808e-05, 0.00013092623268750358]]} + #*EXTRAS*# Step: 1 Bead: 6 +{"friction": [[0.00013379754738756933, -2.544336620256607e-05, -2.5283541235990818e-05], [-2.544336620256607e-05, 0.00013402015037169526, -2.5343693185848085e-05], [-2.5283541235990818e-05, -2.5343693185848085e-05, 0.0001338532609342757]]} + #*EXTRAS*# Step: 2 Bead: 6 +{"friction": [[0.0001354005408940594, -1.723598162677344e-05, -1.6777359961614436e-05], [-1.723598162677344e-05, 0.0001355224161928526, -1.7097205151167636e-05], [-1.6777359961614436e-05, -1.7097205151167636e-05, 0.00013583703505356534]]} + #*EXTRAS*# Step: 3 Bead: 6 +{"friction": [[0.00013681692943362544, -9.283028492345667e-06, -8.78292600373361e-06], [-9.283028492345667e-06, 0.00013685699186556386, -9.166451265365982e-06], [-8.78292600373361e-06, -9.166451265365982e-06, 0.0001375102298500599]]} + #*EXTRAS*# Step: 4 Bead: 6 +{"friction": [[0.00013742656368641927, -6.25643554302692e-06, -5.845841035678323e-06], [-6.25643554302692e-06, 0.00013744959784629403, -6.163411185282463e-06], [-5.845841035678323e-06, -6.163411185282463e-06, 0.00013817692418401675]]} + #*EXTRAS*# Step: 5 Bead: 6 +{"friction": [[0.00013747316574997005, -6.036469924334205e-06, -5.6349103574555905e-06], [-6.036469924334205e-06, 0.00013749533569004692, -5.945471831913888e-06], [-5.6349103574555905e-06, -5.945471831913888e-06, 0.0001382267284198196]]} + #*EXTRAS*# Step: 6 Bead: 6 +{"friction": [[0.00013762854824775383, -5.314275735928797e-06, -4.944848886793821e-06], [-5.314275735928797e-06, 0.00013764825309295193, -5.230226139709081e-06], [-4.944848886793821e-06, -5.230226139709081e-06, 0.00013839170958846754]]} + #*EXTRAS*# Step: 7 Bead: 6 +{"friction": [[0.0001376818345698643, -5.070516121837466e-06, -4.712794550557321e-06], [-5.070516121837466e-06, 0.00013770083774032905, -4.9889137970960025e-06], [-4.712794550557321e-06, -4.9889137970960025e-06, 0.00013844791792203725]]} + #*EXTRAS*# Step: 8 Bead: 6 +{"friction": [[0.0001377272289712876, -4.864403126914076e-06, -4.516919505127056e-06], [-4.864403126914076e-06, 0.00013774569073775813, -4.784910111662872e-06], [-4.516919505127056e-06, -4.784910111662872e-06, 0.00013849565745275368]]} + #*EXTRAS*# Step: 9 Bead: 6 +{"friction": [[0.0001377530385564088, -4.7478425622156085e-06, -4.406287137848918e-06], [-4.7478425622156085e-06, 0.00013777121530928057, -4.669558592185811e-06], [-4.406287137848918e-06, -4.669558592185811e-06, 0.0001385227422195074]]} + #*EXTRAS*# Step: 10 Bead: 6 +{"friction": [[0.00013777034671191228, -4.669929051115223e-06, -4.332392137920812e-06], [-4.669929051115223e-06, 0.00013778834150541543, -4.592459767670383e-06], [-4.332392137920812e-06, -4.592459767670383e-06, 0.00013854088217322562]]} + #*EXTRAS*# Step: 11 Bead: 6 +{"friction": [[0.00013778120383086624, -4.6211584672524236e-06, -4.28615978271252e-06], [-4.6211584672524236e-06, 0.0001377990882209774, -4.544201797664805e-06], [-4.28615978271252e-06, -4.544201797664805e-06, 0.0001385522515649031]]} + #*EXTRAS*# Step: 12 Bead: 6 +{"friction": [[0.00013778821211229674, -4.589719168563079e-06, -4.25636603499518e-06], [-4.589719168563079e-06, 0.00013780602676097844, -4.513094031348049e-06], [-4.25636603499518e-06, -4.513094031348049e-06, 0.0001385595866469089]]} + #*EXTRAS*# Step: 13 Bead: 6 +{"friction": [[0.0001377926806969983, -4.569690242231278e-06, -4.237389244134223e-06], [-4.569690242231278e-06, 0.00013781045150024568, -4.493276755678555e-06], [-4.237389244134223e-06, -4.493276755678555e-06, 0.0001385642620231786]]} + #*EXTRAS*# Step: 14 Bead: 6 +{"friction": [[0.00013779554463805383, -4.556860641450573e-06, -4.225235151000526e-06], [-4.556860641450573e-06, 0.0001378132875951081, -4.480582909396338e-06], [-4.225235151000526e-06, -4.480582909396338e-06, 0.0001385672578518146]]} + #*EXTRAS*# Step: 15 Bead: 6 +{"friction": [[0.00013779737568103969, -4.5486609997867384e-06, -4.217467876694222e-06], [-4.5486609997867384e-06, 0.00013781510093891964, -4.472470104998137e-06], [-4.217467876694222e-06, -4.472470104998137e-06, 0.00013856917295205308]]} + #*EXTRAS*# Step: 16 Bead: 6 +{"friction": [[0.00013779854742535517, -4.543414960688636e-06, -4.212498722243818e-06], [-4.543414960688636e-06, 0.00013781626139954025, -4.467279653674658e-06], [-4.212498722243818e-06, -4.467279653674658e-06, 0.0001385703983792827]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_07 b/drivers/py/pes/friction/frictionH/060K/inst.raw_07 new file mode 100644 index 000000000..d9330d9a7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_07 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 7 +{"friction": [[0.00013094354884002888, -3.34806356918497e-05, -3.337184485038292e-05], [-3.34806356918497e-05, 0.00013116798657021497, -3.347505294528034e-05], [-3.337184485038292e-05, -3.347505294528034e-05, 0.00013065962767836692]]} + #*EXTRAS*# Step: 1 Bead: 7 +{"friction": [[0.0001336455756449247, -2.6061221935753395e-05, -2.592375063293343e-05], [-2.6061221935753395e-05, 0.00013387394817920302, -2.5966994213336938e-05], [-2.592375063293343e-05, -2.5966994213336938e-05, 0.00013367099476153948]]} + #*EXTRAS*# Step: 2 Bead: 7 +{"friction": [[0.00013528448767963097, -1.790675287571595e-05, -1.7466671351673417e-05], [-1.790675287571595e-05, 0.00013541489436186326, -1.776880150731231e-05], [-1.7466671351673417e-05, -1.776880150731231e-05, 0.00013569315202618896]]} + #*EXTRAS*# Step: 3 Bead: 7 +{"friction": [[0.00013670732952222726, -9.857017672499874e-06, -9.347060015143981e-06], [-9.857017672499874e-06, 0.0001367516466341297, -9.736894693050155e-06], [-9.347060015143981e-06, -9.736894693050155e-06, 0.00013738712543597575]]} + #*EXTRAS*# Step: 4 Bead: 7 +{"friction": [[0.00013733549832113486, -6.690838581171217e-06, -6.263425019846885e-06], [-6.690838581171217e-06, 0.00013736039251903502, -6.593936768300574e-06], [-6.263425019846885e-06, -6.593936768300574e-06, 0.00013807915467407597]]} + #*EXTRAS*# Step: 5 Bead: 7 +{"friction": [[0.00013739319262262887, -6.414918658028865e-06, -5.9980309129128655e-06], [-6.414918658028865e-06, 0.0001374168818913002, -6.320460567413704e-06], [-5.9980309129128655e-06, -6.320460567413704e-06, 0.0001381411656655885]]} + #*EXTRAS*# Step: 6 Bead: 7 +{"friction": [[0.00013755619345895482, -5.648439958416892e-06, -5.2636730539858215e-06], [-5.648439958416892e-06, 0.00013757696753264188, -5.561118982686943e-06], [-5.2636730539858215e-06, -5.561118982686943e-06, 0.00013831508810924177]]} + #*EXTRAS*# Step: 7 Bead: 7 +{"friction": [[0.0001376134170444619, -5.3838539013022804e-06, -5.011165777057693e-06], [-5.3838539013022804e-06, 0.00013763333431951775, -5.299115182651091e-06], [-5.011165777057693e-06, -5.299115182651091e-06, 0.00013837571484746043]]} + #*EXTRAS*# Step: 8 Bead: 7 +{"friction": [[0.00013766156539978474, -5.1630059992353115e-06, -4.800791788156751e-06], [-5.1630059992353115e-06, 0.00013768082699694764, -5.080469063280605e-06], [-4.800791788156751e-06, -5.080469063280605e-06, 0.0001384265589860766]]} + #*EXTRAS*# Step: 9 Bead: 7 +{"friction": [[0.0001376890800326767, -5.037523262435468e-06, -4.681419498700208e-06], [-5.037523262435468e-06, 0.0001377079933345031, -4.956256116909054e-06], [-4.681419498700208e-06, -4.956256116909054e-06, 0.0001384555465169593]]} + #*EXTRAS*# Step: 10 Bead: 7 +{"friction": [[0.00013770749792156784, -4.953818264799446e-06, -4.601854879384859e-06], [-4.953818264799446e-06, 0.00013772618869801125, -4.873405701442467e-06], [-4.601854879384859e-06, -4.873405701442467e-06, 0.00013847492319747122]]} + #*EXTRAS*# Step: 11 Bead: 7 +{"friction": [[0.0001377190619769193, -4.901381191240156e-06, -4.552037804628818e-06], [-4.901381191240156e-06, 0.00013773761736102845, -4.821507057468019e-06], [-4.552037804628818e-06, -4.821507057468019e-06, 0.00013848707820845598]]} + #*EXTRAS*# Step: 12 Bead: 7 +{"friction": [[0.00013772652487945347, -4.8675892816448785e-06, -4.519945019813919e-06], [-4.8675892816448785e-06, 0.00013774499465173557, -4.788063381589297e-06], [-4.519945019813919e-06, -4.788063381589297e-06, 0.00013849491798617809]]} + #*EXTRAS*# Step: 13 Bead: 7 +{"friction": [[0.0001377312843289995, -4.8460584122878485e-06, -4.499501151868575e-06], [-4.8460584122878485e-06, 0.00013774970022335385, -4.766754905718086e-06], [-4.499501151868575e-06, -4.766754905718086e-06, 0.00013849991594923233]]} + #*EXTRAS*# Step: 14 Bead: 7 +{"friction": [[0.0001377343346417768, -4.832267479026501e-06, -4.486408258100472e-06], [-4.832267479026501e-06, 0.00013775271630067523, -4.753106629363754e-06], [-4.486408258100472e-06, -4.753106629363754e-06, 0.00013850311837328478]]} + #*EXTRAS*# Step: 15 Bead: 7 +{"friction": [[0.00013773628494961353, -4.823453158025755e-06, -4.478040815333197e-06], [-4.823453158025755e-06, 0.00013775464483957995, -4.74438357166544e-06], [-4.478040815333197e-06, -4.74438357166544e-06, 0.00013850516563086235]]} + #*EXTRAS*# Step: 16 Bead: 7 +{"friction": [[0.00013773753302509227, -4.817813900372436e-06, -4.472687763357605e-06], [-4.817813900372436e-06, 0.0001377558790335947, -4.738802737840148e-06], [-4.472687763357605e-06, -4.738802737840148e-06, 0.00013850647562253606]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_08 b/drivers/py/pes/friction/frictionH/060K/inst.raw_08 new file mode 100644 index 000000000..787a3153c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_08 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 8 +{"friction": [[0.00013064797267198423, -3.4032980337971224e-05, -3.389659333410311e-05], [-3.4032980337971224e-05, 0.00013086402099283612, -3.4035338460508096e-05], [-3.389659333410311e-05, -3.4035338460508096e-05, 0.00013034931536429637]]} + #*EXTRAS*# Step: 1 Bead: 8 +{"friction": [[0.00013346384001734014, -2.6762756873480406e-05, -2.6648948294302946e-05], [-2.6762756873480406e-05, 0.00013369807151647232, -2.6675114275945702e-05], [-2.6648948294302946e-05, -2.6675114275945702e-05, 0.0001334550924355645]]} + #*EXTRAS*# Step: 2 Bead: 8 +{"friction": [[0.00013514920402701955, -1.8681580580151673e-05, -1.826508808967502e-05], [-1.8681580580151673e-05, 0.0001352896022864443, -1.854511092233064e-05], [-1.826508808967502e-05, -1.854511092233064e-05, 0.00013552473729892632]]} + #*EXTRAS*# Step: 3 Bead: 8 +{"friction": [[0.00013658044132874373, -1.0532744637358344e-05, -1.001398748208733e-05], [-1.0532744637358344e-05, 0.00013663015757899678, -1.0408828553336886e-05], [-1.001398748208733e-05, -1.0408828553336886e-05, 0.0001372432705826552]]} + #*EXTRAS*# Step: 4 Bead: 8 +{"friction": [[0.00013722952262366984, -7.204076509686937e-06, -6.758531216928825e-06], [-7.204076509686937e-06, 0.00013725687333069318, -7.102806794648862e-06], [-6.758531216928825e-06, -7.102806794648862e-06, 0.00013796461047514]]} + #*EXTRAS*# Step: 5 Bead: 8 +{"friction": [[0.00013730040051261909, -6.8598921851358676e-06, -6.426298925429998e-06], [-6.8598921851358676e-06, 0.00013732607309241372, -6.761526085643723e-06], [-6.426298925429998e-06, -6.761526085643723e-06, 0.00013804131181483883]]} + #*EXTRAS*# Step: 6 Bead: 8 +{"friction": [[0.00013747207457939043, -6.0416023978654805e-06, -5.6398280324369435e-06], [-6.0416023978654805e-06, 0.00013749426408549885, -5.950556545899629e-06], [-5.6398280324369435e-06, -5.950556545899629e-06, 0.0001382255640113382]]} + #*EXTRAS*# Step: 7 Bead: 8 +{"friction": [[0.00013753383099074482, -5.752466842742327e-06, -5.36309068901538e-06], [-5.752466842742327e-06, 0.000137554963086956, -5.66414723153736e-06], [-5.36309068901538e-06, -5.66414723153736e-06, 0.0001382913359339186]]} + #*EXTRAS*# Step: 8 Bead: 8 +{"friction": [[0.00013758513766832362, -5.514321683465695e-06, -5.135613648294122e-06], [-5.514321683465695e-06, 0.00013760546775549277, -5.428302068898255e-06], [-5.135613648294122e-06, -5.428302068898255e-06, 0.00013834578097959036]]} + #*EXTRAS*# Step: 9 Bead: 8 +{"friction": [[0.00013761461352672832, -5.378346260640632e-06, -5.0059150005524146e-06], [-5.378346260640632e-06, 0.00013763451379032444, -5.293661938623747e-06], [-5.0059150005524146e-06, -5.293661938623747e-06, 0.00013837698016210353]]} + #*EXTRAS*# Step: 10 Bead: 8 +{"friction": [[0.0001376343078220217, -5.287833351761814e-06, -4.919655202714642e-06], [-5.287833351761814e-06, 0.00013765393334729879, -5.204046746590474e-06], [-4.919655202714642e-06, -5.204046746590474e-06, 0.0001383977939087055]]} + #*EXTRAS*# Step: 11 Bead: 8 +{"friction": [[0.00013764668558639042, -5.231084825035216e-06, -4.865603822136857e-06], [-5.231084825035216e-06, 0.0001376661435100691, -5.147864670666446e-06], [-4.865603822136857e-06, -5.147864670666446e-06, 0.00013841086223316892]]} + #*EXTRAS*# Step: 12 Bead: 8 +{"friction": [[0.00013765467186043745, -5.194526552278638e-06, -4.830795589589828e-06], [-5.194526552278638e-06, 0.00013767402371390466, -5.111672787978373e-06], [-4.830795589589828e-06, -5.111672787978373e-06, 0.00013841928876240687]]} + #*EXTRAS*# Step: 13 Bead: 8 +{"friction": [[0.00013765976624370983, -5.171229424021291e-06, -4.808618803774097e-06], [-5.171229424021291e-06, 0.00013767905128095215, -5.088609747720607e-06], [-4.808618803774097e-06, -5.088609747720607e-06, 0.00013842466181579523]]} + #*EXTRAS*# Step: 14 Bead: 8 +{"friction": [[0.00013766303118691395, -5.156307965124954e-06, -4.794416998497349e-06], [-5.156307965124954e-06, 0.00013768227374779852, -5.073838464879621e-06], [-4.794416998497349e-06, -5.073838464879621e-06, 0.0001384281044711423]]} + #*EXTRAS*# Step: 15 Bead: 8 +{"friction": [[0.00013766511885569956, -5.1467707596760025e-06, -4.7853406227169794e-06], [-5.1467707596760025e-06, 0.00013768433439768533, -5.064397346716989e-06], [-4.7853406227169794e-06, -5.064397346716989e-06, 0.0001384303054107221]]} + #*EXTRAS*# Step: 16 Bead: 8 +{"friction": [[0.00013766645484822597, -5.140669058414833e-06, -4.779534100527535e-06], [-5.140669058414833e-06, 0.00013768565315741487, -5.058357161248459e-06], [-4.779534100527535e-06, -5.058357161248459e-06, 0.00013843171374230943]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_09 b/drivers/py/pes/friction/frictionH/060K/inst.raw_09 new file mode 100644 index 000000000..a68c05505 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_09 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 9 +{"friction": [[0.00013030641560764987, -3.4637552590400345e-05, -3.4466313676195334e-05], [-3.4637552590400345e-05, 0.0001305119734329694, -3.464872341487375e-05], [-3.4466313676195334e-05, -3.464872341487375e-05, 0.00012999345633835313]]} + #*EXTRAS*# Step: 1 Bead: 9 +{"friction": [[0.00013324760201863632, -2.7547287952704127e-05, -2.745713276857384e-05], [-2.7547287952704127e-05, 0.00013348736991993047, -2.746750510471413e-05], [-2.745713276857384e-05, -2.746750510471413e-05, 0.00013320113079484775]]} + #*EXTRAS*# Step: 2 Bead: 9 +{"friction": [[0.00013499269979524978, -1.9564249321977466e-05, -1.9177145684223304e-05], [-1.9564249321977466e-05, 0.00013514458282816628, -1.9430158287639176e-05], [-1.9177145684223304e-05, -1.9430158287639176e-05, 0.00013532929865753293]]} + #*EXTRAS*# Step: 3 Bead: 9 +{"friction": [[0.00013643556922191414, -1.1318473549900948e-05, -1.0793214024115789e-05], [-1.1318473549900948e-05, 0.00013649207305291473, -1.1190668064869072e-05], [-1.0793214024115789e-05, -1.1190668064869072e-05, 0.00013707723845023654]]} + #*EXTRAS*# Step: 4 Bead: 9 +{"friction": [[0.00013710797974783413, -7.803064949085999e-06, -7.338718206841832e-06], [-7.803064949085999e-06, 0.00013713854553500042, -7.696991079250247e-06], [-7.338718206841832e-06, -7.696991079250247e-06, 0.00013783218606710094]]} + #*EXTRAS*# Step: 5 Bead: 9 +{"friction": [[0.00013719430807212504, -7.376475963856894e-06, -6.9252599735936125e-06], [-7.376475963856894e-06, 0.00013722254603283846, -7.273791055060373e-06], [-6.9252599735936125e-06, -7.273791055060373e-06, 0.00013792636103232087]]} + #*EXTRAS*# Step: 6 Bead: 9 +{"friction": [[0.0001373756810911033, -6.498408353307459e-06, -6.078277981379461e-06], [-6.498408353307459e-06, 0.00013739972634884792, -6.403203793821034e-06], [-6.078277981379461e-06, -6.403203793821034e-06, 0.00013812236940336864]]} + #*EXTRAS*# Step: 7 Bead: 9 +{"friction": [[0.0001374425697215263, -6.180708461795537e-06, -5.7731849416039865e-06], [-6.180708461795537e-06, 0.00013746530043454676, -6.088376919382487e-06], [-5.7731849416039865e-06, -6.088376919382487e-06, 0.00013819404726394068]]} + #*EXTRAS*# Step: 8 Bead: 9 +{"friction": [[0.00013749743669160108, -5.922529563874119e-06, -5.525787632280334e-06], [-5.922529563874119e-06, 0.00013751917966241053, -5.832597634657298e-06], [-5.525787632280334e-06, -5.832597634657298e-06, 0.00013825260701981403]]} + #*EXTRAS*# Step: 9 Bead: 9 +{"friction": [[0.00013752913076356418, -5.774376822291396e-06, -5.384039911486536e-06], [-5.774376822291396e-06, 0.0001375503397824534, -5.685848078008783e-06], [-5.384039911486536e-06, -5.685848078008783e-06, 0.00013828633929371977]]} + #*EXTRAS*# Step: 10 Bead: 9 +{"friction": [[0.00013755026866604022, -5.675966643942407e-06, -5.289972417306982e-06], [-5.675966643942407e-06, 0.00013757113631801473, -5.588380504064165e-06], [-5.289972417306982e-06, -5.588380504064165e-06, 0.00013830879842034076]]} + #*EXTRAS*# Step: 11 Bead: 9 +{"friction": [[0.00013756356749858068, -5.61421478950384e-06, -5.230981566374915e-06], [-5.61421478950384e-06, 0.00013758422638647817, -5.527224421170974e-06], [-5.230981566374915e-06, -5.527224421170974e-06, 0.00013832291299268937]]} + #*EXTRAS*# Step: 12 Bead: 9 +{"friction": [[0.0001375721463121495, -5.574446305635254e-06, -5.193005889289942e-06], [-5.574446305635254e-06, 0.00013759267298077914, -5.4878413679954094e-06], [-5.193005889289942e-06, -5.4878413679954094e-06, 0.00013833201170509828]]} + #*EXTRAS*# Step: 13 Bead: 9 +{"friction": [[0.00013757762000089017, -5.5490992991426455e-06, -5.1688075700327595e-06], [-5.5490992991426455e-06, 0.00013759806330873966, -5.462740736743647e-06], [-5.1688075700327595e-06, -5.462740736743647e-06, 0.00013833781453331202]]} + #*EXTRAS*# Step: 14 Bead: 9 +{"friction": [[0.00013758112803702956, -5.532865753261733e-06, -5.153312164969049e-06], [-5.532865753261733e-06, 0.00013760151832916973, -5.44666527497735e-06], [-5.153312164969049e-06, -5.44666527497735e-06, 0.00013834153245717722]]} + #*EXTRAS*# Step: 15 Bead: 9 +{"friction": [[0.00013758337129876158, -5.52248953757241e-06, -5.143408763920244e-06], [-5.52248953757241e-06, 0.00013760372785673723, -5.436390223703002e-06], [-5.143408763920244e-06, -5.436390223703002e-06, 0.00013834390950324366]]} + #*EXTRAS*# Step: 16 Bead: 9 +{"friction": [[0.0001375848068830465, -5.515851097540263e-06, -5.137073230801556e-06], [-5.515851097540263e-06, 0.00013760514192120597, -5.4298165550417216e-06], [-5.137073230801556e-06, -5.4298165550417216e-06, 0.0001383454305269793]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_10 b/drivers/py/pes/friction/frictionH/060K/inst.raw_10 new file mode 100644 index 000000000..669f0caf4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_10 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 10 +{"friction": [[0.00012991703273927124, -3.528883604745308e-05, -3.507531490942497e-05], [-3.528883604745308e-05, 0.00013010988907306278, -3.530960766886239e-05], [-3.507531490942497e-05, -3.530960766886239e-05, 0.00012959089167726413]]} + #*EXTRAS*# Step: 1 Bead: 10 +{"friction": [[0.00013299083465382724, -2.8413198796397015e-05, -2.8344731735154055e-05], [-2.8413198796397015e-05, 0.0001332352507916902, -2.8342680233595343e-05], [-2.8344731735154055e-05, -2.8342680233595343e-05, 0.0001329036171050276]]} + #*EXTRAS*# Step: 2 Bead: 10 +{"friction": [[0.00013481223629847953, -2.0557798063311087e-05, -2.0206465584359883e-05], [-2.0557798063311087e-05, 0.0001349770562483932, -2.042726365585097e-05], [-2.0206465584359883e-05, -2.042726365585097e-05, 0.00013510364139172312]]} + #*EXTRAS*# Step: 3 Bead: 10 +{"friction": [[0.00013627200230662074, -1.2222762327442306e-05, -1.1694844974630433e-05], [-1.2222762327442306e-05, 0.00013633696034209518, -1.2091178554884389e-05], [-1.1694844974630433e-05, -1.2091178554884389e-05, 0.00013688745084880982]]} + #*EXTRAS*# Step: 4 Bead: 10 +{"friction": [[0.00013697021159715477, -8.495555820507278e-06, -8.012601146556129e-06], [-8.495555820507278e-06, 0.00013700495083204594, -8.384324142458883e-06], [-8.012601146556129e-06, -8.384324142458883e-06, 0.00013768066443250852]]} + #*EXTRAS*# Step: 5 Bead: 10 +{"friction": [[0.00013707442109572556, -7.97041698272725e-06, -7.5012676133261295e-06], [-7.97041698272725e-06, 0.00013710595107870575, -7.86305760859994e-06], [-7.5012676133261295e-06, -7.86305760859994e-06, 0.00013779541851925584]]} + #*EXTRAS*# Step: 6 Bead: 10 +{"friction": [[0.00013726648057175482, -7.024140748206934e-06, -6.584738746274003e-06], [-7.024140748206934e-06, 0.00013729293841098045, -6.924376015250607e-06], [-6.584738746274003e-06, -6.924376015250607e-06, 0.00013800465206576057]]} + #*EXTRAS*# Step: 7 Bead: 10 +{"friction": [[0.00013733909998848447, -6.673542148475188e-06, -6.246772376578716e-06], [-6.673542148475188e-06, 0.00013736391626208833, -6.5767915650297055e-06], [-6.246772376578716e-06, -6.5767915650297055e-06, 0.00013808303290538214]]} + #*EXTRAS*# Step: 8 Bead: 10 +{"friction": [[0.0001373979227220545, -6.39240545217779e-06, -5.976400668664537e-06], [-6.39240545217779e-06, 0.00013742151728005463, -6.298149692159457e-06], [-5.976400668664537e-06, -6.298149692159457e-06, 0.0001381462390071276]]} + #*EXTRAS*# Step: 9 Bead: 10 +{"friction": [[0.00013743209040494888, -6.230266747617993e-06, -5.820728793536944e-06], [-6.230266747617993e-06, 0.00013745501900164686, -6.137481238296592e-06], [-5.820728793536944e-06, -6.137481238296592e-06, 0.00013818283865360513]]} + #*EXTRAS*# Step: 10 Bead: 10 +{"friction": [[0.00013745483807246566, -6.122790656775038e-06, -5.717643842149765e-06], [-6.122790656775038e-06, 0.00013747734089645318, -6.030992371351242e-06], [-5.717643842149765e-06, -6.030992371351242e-06, 0.00013820715958492993]]} + #*EXTRAS*# Step: 11 Bead: 10 +{"friction": [[0.00013746916494187673, -6.0552924797932334e-06, -5.652946104813637e-06], [-6.0552924797932334e-06, 0.0001374914067776091, -5.964119348832339e-06], [-5.652946104813637e-06, -5.964119348832339e-06, 0.00013822245867721222]]} + #*EXTRAS*# Step: 12 Bead: 10 +{"friction": [[0.00013747840525655695, -6.011837117120213e-06, -5.611311108823194e-06], [-6.011837117120213e-06, 0.00013750048169061733, -5.921068561281474e-06], [-5.611311108823194e-06, -5.921068561281474e-06, 0.0001382323184405087]]} + #*EXTRAS*# Step: 13 Bead: 10 +{"friction": [[0.00013748430253002385, -5.984135544403714e-06, -5.5847771048763575e-06], [-5.984135544403714e-06, 0.00013750627459894294, -5.893625752117605e-06], [-5.5847771048763575e-06, -5.893625752117605e-06, 0.0001382386079490778]]} + #*EXTRAS*# Step: 14 Bead: 10 +{"friction": [[0.00013748808207323946, -5.966394845710215e-06, -5.567787062994072e-06], [-5.966394845710215e-06, 0.00013750998774398324, -5.8760511222376265e-06], [-5.567787062994072e-06, -5.8760511222376265e-06, 0.00013824263760579982]]} + #*EXTRAS*# Step: 15 Bead: 10 +{"friction": [[0.00013749049913507904, -5.955054842834195e-06, -5.5569280810454855e-06], [-5.955054842834195e-06, 0.00013751236254346826, -5.864817415456545e-06], [-5.5569280810454855e-06, -5.864817415456545e-06, 0.0001382452140993823]]} + #*EXTRAS*# Step: 16 Bead: 10 +{"friction": [[0.00013749204597200926, -5.947799830199992e-06, -5.549981300857601e-06], [-5.947799830199992e-06, 0.00013751388241576928, -5.857630466758874e-06], [-5.549981300857601e-06, -5.857630466758874e-06, 0.00013824686275501727]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_11 b/drivers/py/pes/friction/frictionH/060K/inst.raw_11 new file mode 100644 index 000000000..12d639e0c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_11 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 11 +{"friction": [[0.00012947879542120336, -3.5980173125907095e-05, -3.571737595016751e-05], [-3.5980173125907095e-05, 0.00012965675992702663, -3.6011208770852356e-05], [-3.571737595016751e-05, -3.6011208770852356e-05, 0.00012914132189854633]]} + #*EXTRAS*# Step: 1 Bead: 11 +{"friction": [[0.0001326858520976646, -2.9357956137011075e-05, -2.930642017832087e-05], [-2.9357956137011075e-05, 0.00013293326919544825, -2.92982218670855e-05], [-2.930642017832087e-05, -2.92982218670855e-05, 0.00013255568217263044]]} + #*EXTRAS*# Step: 2 Bead: 11 +{"friction": [[0.00013460394736649993, -2.1664319528673927e-05, -2.135536679269862e-05], [-2.1664319528673927e-05, 0.00013478299754269792, -2.15388387882594e-05], [-2.135536679269862e-05, -2.15388387882594e-05, 0.00013484355234396088]]} + #*EXTRAS*# Step: 3 Bead: 11 +{"friction": [[0.00013608892090281343, -1.3254257681215665e-05, -1.2729382792127866e-05], [-1.3254257681215665e-05, 0.00013616430288727917, -1.311928225838203e-05], [-1.2729382792127866e-05, -1.311928225838203e-05, 0.00013667208286877606]]} + #*EXTRAS*# Step: 4 Bead: 11 +{"friction": [[0.000136815570715924, -9.290088717506661e-06, -8.789851562515098e-06], [-9.290088717506661e-06, 0.00013685568358874173, -9.17346607673873e-06], [-8.789851562515098e-06, -9.17346607673873e-06, 0.00013750871013063886]]} + #*EXTRAS*# Step: 5 Bead: 11 +{"friction": [[0.0001369402449167474, -8.648098453481923e-06, -8.16149087717138e-06], [-8.648098453481923e-06, 0.00013697596795511483, -8.535787979749678e-06], [-8.16149087717138e-06, -8.535787979749678e-06, 0.00013764750023824023]]} + #*EXTRAS*# Step: 6 Bead: 11 +{"friction": [[0.000137143934357179, -7.624712044871703e-06, -7.165699493726026e-06], [-7.624712044871703e-06, 0.00013717350408804185, -7.52003549338761e-06], [-7.165699493726026e-06, -7.52003549338761e-06, 0.00013787147956890924]]} + #*EXTRAS*# Step: 7 Bead: 11 +{"friction": [[0.0001372228770735339, -7.236539828419029e-06, -6.789910648009215e-06], [-7.236539828419029e-06, 0.00013725039248233846, -7.135001626003808e-06], [-6.789910648009215e-06, -7.135001626003808e-06, 0.00013795739945362967]]} + #*EXTRAS*# Step: 8 Bead: 11 +{"friction": [[0.00013728603983131002, -6.929325648036051e-06, -6.493253382771666e-06], [-6.929325648036051e-06, 0.00013731204088918858, -6.8303654061475505e-06], [-6.493253382771666e-06, -6.8303654061475505e-06, 0.00013802580166693225]]} + #*EXTRAS*# Step: 9 Bead: 11 +{"friction": [[0.00013732293196765604, -6.751261489442938e-06, -6.321615731965527e-06], [-6.751261489442938e-06, 0.00013734810088538053, -6.653833434196048e-06], [-6.321615731965527e-06, -6.653833434196048e-06, 0.00013806561592438098]]} + #*EXTRAS*# Step: 10 Bead: 11 +{"friction": [[0.00013734745254562742, -6.633467137415726e-06, -6.208197226582125e-06], [-6.633467137415726e-06, 0.00013737208949853724, -6.537067952831773e-06], [-6.208197226582125e-06, -6.537067952831773e-06, 0.00013809202318423272]]} + #*EXTRAS*# Step: 11 Bead: 11 +{"friction": [[0.00013736291277983805, -6.559425497954375e-06, -6.136956969676965e-06], [-6.559425497954375e-06, 0.00013738722293706062, -6.463679250480552e-06], [-6.136956969676965e-06, -6.463679250480552e-06, 0.00013810865039260854]]} + #*EXTRAS*# Step: 12 Bead: 11 +{"friction": [[0.00013737288254547688, -6.511771792876651e-06, -6.091127052678041e-06], [-6.511771792876651e-06, 0.00013739698547790563, -6.416448318977075e-06], [-6.091127052678041e-06, -6.416448318977075e-06, 0.00013811936349391986]]} + #*EXTRAS*# Step: 13 Bead: 11 +{"friction": [[0.00013737924707643223, -6.481388603373112e-06, -6.061915190669898e-06], [-6.481388603373112e-06, 0.0001374032191567493, -6.386335720161172e-06], [-6.061915190669898e-06, -6.386335720161172e-06, 0.00013812619879793476]]} + #*EXTRAS*# Step: 14 Bead: 11 +{"friction": [[0.00013738332616336198, -6.461931344663083e-06, -6.043211528026926e-06], [-6.461931344663083e-06, 0.00013740721496693594, -6.367052170714423e-06], [-6.043211528026926e-06, -6.367052170714423e-06, 0.0001381305780707983]]} + #*EXTRAS*# Step: 15 Bead: 11 +{"friction": [[0.000137385934997236, -6.449493586437809e-06, -6.031256920077626e-06], [-6.449493586437809e-06, 0.00013740977078042645, -6.35472562699983e-06], [-6.031256920077626e-06, -6.35472562699983e-06, 0.00013813337826409965]]} + #*EXTRAS*# Step: 16 Bead: 11 +{"friction": [[0.00013738760459928323, -6.4415362815611295e-06, -6.023609303523303e-06], [-6.4415362815611295e-06, 0.00013741140654880354, -6.346839544799323e-06], [-6.023609303523303e-06, -6.346839544799323e-06, 0.00013813517007536328]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_12 b/drivers/py/pes/friction/frictionH/060K/inst.raw_12 new file mode 100644 index 000000000..3a75aa25d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_12 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 12 +{"friction": [[0.0001289917032280999, -3.670377679754094e-05, -3.638593541360157e-05], [-3.670377679754094e-05, 0.00012915277647290737, -3.674556669422962e-05], [-3.638593541360157e-05, -3.674556669422962e-05, 0.0001286455046890979]]} + #*EXTRAS*# Step: 1 Bead: 12 +{"friction": [[0.00013232287205658676, -3.037809997386349e-05, -3.0334866679513425e-05], [-3.037809997386349e-05, 0.00013257064158619865, -3.0330758384483965e-05], [-3.0334866679513425e-05, -3.0330758384483965e-05, 0.000132148722318531]]} + #*EXTRAS*# Step: 2 Bead: 12 +{"friction": [[0.00013436232726476543, -2.2884678208415067e-05, -2.2624310793560876e-05], [-2.2884678208415067e-05, 0.00013455656320890215, -2.2766097704799904e-05], [-2.2624310793560876e-05, -2.2766097704799904e-05, 0.000134543381338873]]} + #*EXTRAS*# Step: 3 Bead: 12 +{"friction": [[0.00013588522181634324, -1.4421375973392095e-05, -1.3907367651037295e-05], [-1.4421375973392095e-05, 0.00013597330527119348, -1.4283751149908914e-05], [-1.3907367651037295e-05, -1.4283751149908914e-05, 0.0001364289022728591]]} + #*EXTRAS*# Step: 4 Bead: 12 +{"friction": [[0.00013664341688134792, -1.0195891508497838e-05, -9.681145611900458e-06], [-1.0195891508497838e-05, 0.0001366903897908657, -1.0073814654490859e-05], [-9.681145611900458e-06, -1.0073814654490859e-05, 0.0001373148476090624]]} + #*EXTRAS*# Step: 5 Bead: 12 +{"friction": [[0.00013679129061969057, -9.416489873956488e-06, -8.913898648827799e-06], [-9.416489873956488e-06, 0.00013683231458908, -9.299061754505972e-06], [-8.913898648827799e-06, -9.299061754505972e-06, 0.00013748152598926178]]} + #*EXTRAS*# Step: 6 Bead: 12 +{"friction": [[0.00013700751226063422, -8.30663720035087e-06, -7.828428872261193e-06], [-8.30663720035087e-06, 0.00013704106511602883, -8.196770327607462e-06], [-7.828428872261193e-06, -8.196770327607462e-06, 0.0001377218413135304]]} + #*EXTRAS*# Step: 7 Bead: 12 +{"friction": [[0.0001370933603432058, -7.875864667889367e-06, -7.409404682158363e-06], [-7.875864667889367e-06, 0.0001371243420577128, -7.769228540097764e-06], [-7.409404682158363e-06, -7.769228540097764e-06, 0.00013781617978741103]]} + #*EXTRAS*# Step: 8 Bead: 12 +{"friction": [[0.00013716123164710838, -7.539257142755845e-06, -7.0828795508629226e-06], [-7.539257142755845e-06, 0.00013719033572540828, -7.4352600661193795e-06], [-7.0828795508629226e-06, -7.4352600661193795e-06, 0.00013789034697978512]]} + #*EXTRAS*# Step: 9 Bead: 12 +{"friction": [[0.00013720109136185164, -7.34319468653344e-06, -6.893057034036405e-06], [-7.34319468653344e-06, 0.000137229155627522, -7.240780935884585e-06], [-6.893057034036405e-06, -7.240780935884585e-06, 0.00013793373632005226]]} + #*EXTRAS*# Step: 10 Bead: 12 +{"friction": [[0.00013722754282013912, -7.21374433164884e-06, -6.767875468082854e-06], [-7.21374433164884e-06, 0.00013725494246135818, -7.112394561952773e-06], [-6.767875468082854e-06, -7.112394561952773e-06, 0.0001379624625616038]]} + #*EXTRAS*# Step: 11 Bead: 12 +{"friction": [[0.00013724423869732126, -7.132306607236829e-06, -6.689184093436364e-06], [-7.132306607236829e-06, 0.00013727122919740797, -7.031633758745635e-06], [-6.689184093436364e-06, -7.031633758745635e-06, 0.00013798056678943055]]} + #*EXTRAS*# Step: 12 Bead: 12 +{"friction": [[0.00013725500393368492, -7.0799073913194e-06, -6.6385768380008965e-06], [-7.0799073913194e-06, 0.0001372817348588873, -6.979673179262425e-06], [-6.6385768380008965e-06, -6.979673179262425e-06, 0.0001379922289063694]]} + #*EXTRAS*# Step: 13 Bead: 12 +{"friction": [[0.00013726187819696902, -7.0464925520222154e-06, -6.606314913247175e-06], [-7.0464925520222154e-06, 0.00013728844509869548, -6.94653931885648e-06], [-6.606314913247175e-06, -6.94653931885648e-06, 0.00013799967130673983]]} + #*EXTRAS*# Step: 14 Bead: 12 +{"friction": [[0.0001372662841061676, -7.02509457645824e-06, -6.585659402858268e-06], [-7.02509457645824e-06, 0.00013729274658871903, -6.925321790575215e-06], [-6.585659402858268e-06, -6.925321790575215e-06, 0.0001380044394802936]]} + #*EXTRAS*# Step: 15 Bead: 12 +{"friction": [[0.0001372691022046474, -7.011415636302243e-06, -6.572456799803697e-06], [-7.011415636302243e-06, 0.00013729549818851318, -6.911758414730545e-06], [-6.572456799803697e-06, -6.911758414730545e-06, 0.00013800748852453142]]} + #*EXTRAS*# Step: 16 Bead: 12 +{"friction": [[0.00013727090577938476, -7.002664260661745e-06, -6.564010868639748e-06], [-7.002664260661745e-06, 0.00013729725932280548, -6.903081059975305e-06], [-6.564010868639748e-06, -6.903081059975305e-06, 0.0001380094395909746]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_13 b/drivers/py/pes/friction/frictionH/060K/inst.raw_13 new file mode 100644 index 000000000..a3853bef7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_13 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 13 +{"friction": [[0.00012845706441002837, -3.745063354531244e-05, -3.70741901275435e-05], [-3.745063354531244e-05, 0.00012859965202404274, -3.75034377235823e-05], [-3.70741901275435e-05, -3.75034377235823e-05, 0.00012810552361980438]]} + #*EXTRAS*# Step: 1 Bead: 13 +{"friction": [[0.00013188953554751334, -3.146913611374767e-05, -3.142033235991329e-05], [-3.146913611374767e-05, 0.00013213370780751463, -3.143583961717038e-05], [-3.142033235991329e-05, -3.143583961717038e-05, 0.00013167201947931348]]} + #*EXTRAS*# Step: 2 Bead: 13 +{"friction": [[0.0001340795657752404, -2.4218078198327182e-05, -2.4011082989593534e-05], [-2.4218078198327182e-05, 0.00013428934256581586, -2.4108609757907764e-05], [-2.4011082989593534e-05, -2.4108609757907764e-05, 0.00013419551247792358]]} + #*EXTRAS*# Step: 3 Bead: 13 +{"friction": [[0.0001356592199261579, -1.573180698268421e-05, -1.5238766453980848e-05], [-1.573180698268421e-05, 0.0001357625567552464, -1.559272118263123e-05], [-1.5238766453980848e-05, -1.559272118263123e-05, 0.00013615501362565133]]} + #*EXTRAS*# Step: 4 Bead: 13 +{"friction": [[0.00013645308234984263, -1.122270694403571e-05, -1.0698028670620889e-05], [-1.122270694403571e-05, 0.00013650873044093156, -1.1095345408784575e-05], [-1.0698028670620889e-05, -1.1095345408784575e-05, 0.00013709741208239604]]} + #*EXTRAS*# Step: 5 Bead: 13 +{"friction": [[0.00013662706755689782, -1.028306384127028e-05, -9.767208648942414e-06], [-1.028306384127028e-05, 0.0001366747405989479, -1.0160501163250383e-05], [-9.767208648942414e-06, -1.0160501163250383e-05, 0.0001372962996357886]]} + #*EXTRAS*# Step: 6 Bead: 13 +{"friction": [[0.0001368567022838553, -9.076980285850606e-06, -8.580956510835619e-06], [-9.076980285850606e-06, 0.00013689531367872985, -8.961748134081892e-06], [-8.580956510835619e-06, -8.961748134081892e-06, 0.0001375546451248301]]} + #*EXTRAS*# Step: 7 Bead: 13 +{"friction": [[0.0001369500264237354, -8.598231275519284e-06, -8.112800249274347e-06], [-8.598231275519284e-06, 0.00013698542531958286, -8.486271182738479e-06], [-8.112800249274347e-06, -8.486271182738479e-06, 0.00013765833367313773]]} + #*EXTRAS*# Step: 8 Bead: 13 +{"friction": [[0.00013702295620845897, -8.228727963830209e-06, -7.752548903146429e-06], [-8.228727963830209e-06, 0.00013705603019133444, -8.119433185803642e-06], [-7.752548903146429e-06, -8.119433185803642e-06, 0.0001377388567337728]]} + #*EXTRAS*# Step: 9 Bead: 13 +{"friction": [[0.0001370660162885877, -8.012464458304396e-06, -7.542139159816209e-06], [-8.012464458304396e-06, 0.00013709779300478467, -7.904786003904244e-06], [-7.542139159816209e-06, -7.904786003904244e-06, 0.00013778619593550408]]} + #*EXTRAS*# Step: 10 Bead: 13 +{"friction": [[0.00013709454949440767, -7.86993703602206e-06, -7.403647732388023e-06], [-7.86993703602206e-06, 0.00013712549714028425, -7.763346513758998e-06], [-7.403647732388023e-06, -7.763346513758998e-06, 0.00013781748238326873]]} + #*EXTRAS*# Step: 11 Bead: 13 +{"friction": [[0.00013711257892421396, -7.7801961148641e-06, -7.316520869611668e-06], [-7.7801961148641e-06, 0.00013714301517220765, -7.674299838413195e-06], [-7.316520869611668e-06, -7.674299838413195e-06, 0.00013783721803627507]]} + #*EXTRAS*# Step: 12 Bead: 13 +{"friction": [[0.00013712420284097142, -7.722469081966275e-06, -7.260505173686606e-06], [-7.722469081966275e-06, 0.00013715431447906866, -7.6170231588403715e-06], [-7.260505173686606e-06, -7.6170231588403715e-06, 0.00013784992832706103]]} + #*EXTRAS*# Step: 13 Bead: 13 +{"friction": [[0.0001371316275376846, -7.68564989148603e-06, -7.224789706086899e-06], [-7.68564989148603e-06, 0.00013716153391927921, -7.58049275161821e-06], [-7.224789706086899e-06, -7.58049275161821e-06, 0.00013785804135542183]]} + #*EXTRAS*# Step: 14 Bead: 13 +{"friction": [[0.0001371363864157451, -7.662072478711794e-06, -7.2019240667047715e-06], [-7.662072478711794e-06, 0.0001371661620911798, -7.557100893240508e-06], [-7.2019240667047715e-06, -7.557100893240508e-06, 0.00013786323913892487]]} + #*EXTRAS*# Step: 15 Bead: 13 +{"friction": [[0.00013713943055079818, -7.646999583043214e-06, -7.187308248875878e-06], [-7.646999583043214e-06, 0.000137169122966028, -7.54214687909083e-06], [-7.187308248875878e-06, -7.54214687909083e-06, 0.0001378665630972903]]} + #*EXTRAS*# Step: 16 Bead: 13 +{"friction": [[0.00013714137884570307, -7.637356367797478e-06, -7.177958296321102e-06], [-7.637356367797478e-06, 0.00013717101811597964, -7.5325798263279965e-06], [-7.177958296321102e-06, -7.5325798263279965e-06, 0.0001378686901017286]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_14 b/drivers/py/pes/friction/frictionH/060K/inst.raw_14 new file mode 100644 index 000000000..e243dedc2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_14 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 14 +{"friction": [[0.0001278780787535134, -3.82100307641886e-05, -3.7774858450361775e-05], [-3.82100307641886e-05, 0.00012800126167604204, -3.8273806917358165e-05], [-3.7774858450361775e-05, -3.8273806917358165e-05, 0.0001275253587009841]]} + #*EXTRAS*# Step: 1 Bead: 14 +{"friction": [[0.00013137078977257556, -3.2624940995155573e-05, -3.25498962909749e-05], [-3.2624940995155573e-05, 0.00013160578360822762, -3.260731339474759e-05], [-3.25498962909749e-05, -3.260731339474759e-05, 0.00013111273204259827]]} + #*EXTRAS*# Step: 2 Bead: 14 +{"friction": [[0.00013374478328643185, -2.5661182260503057e-05, -2.5509375856580467e-05], [-2.5661182260503057e-05, 0.00013396948007718206, -2.556339063378455e-05], [-2.5509375856580467e-05, -2.556339063378455e-05, 0.00013378980239580967]]} + #*EXTRAS*# Step: 3 Bead: 14 +{"friction": [[0.00013540819044204994, -1.7191626808076683e-05, -1.673184484825904e-05], [-1.7191626808076683e-05, 0.00013552950645998835, -1.7052810730826303e-05], [-1.673184484825904e-05, -1.7052810730826303e-05, 0.00013584649578752232]]} + #*EXTRAS*# Step: 4 Bead: 14 +{"friction": [[0.0001362437826395187, -1.2380497098284417e-05, -1.185263231695649e-05], [-1.2380497098284417e-05, 0.00013631028248581106, -1.2248331146973155e-05], [-1.185263231695649e-05, -1.2248331146973155e-05, 0.00013685445625756008]]} + #*EXTRAS*# Step: 5 Bead: 14 +{"friction": [[0.00013644705004819285, -1.1255669411550215e-05, -1.0730784511964865e-05], [-1.1255669411550215e-05, 0.00013650299180488024, -1.1128154125782506e-05], [-1.0730784511964865e-05, -1.1128154125782506e-05, 0.00013709046658308473]]} + #*EXTRAS*# Step: 6 Bead: 14 +{"friction": [[0.0001366910083365231, -9.943265960473648e-06, -9.432017545977411e-06], [-9.943265960473648e-06, 0.00013673599137623173, -9.822635849102834e-06], [-9.432017545977411e-06, -9.822635849102834e-06, 0.00013736870269931542]]} + #*EXTRAS*# Step: 7 Bead: 14 +{"friction": [[0.00013679237492042403, -9.410835526043185e-06, -8.908347306262705e-06], [-9.410835526043185e-06, 0.00013683335780874758, -9.293443131593616e-06], [-8.908347306262705e-06, -9.293443131593616e-06, 0.00013748274107063538]]} + #*EXTRAS*# Step: 8 Bead: 14 +{"friction": [[0.00013687069595131007, -9.004770389134832e-06, -8.510244157797807e-06], [-9.004770389134832e-06, 0.00013690880850569025, -8.890018629033262e-06], [-8.510244157797807e-06, -8.890018629033262e-06, 0.00013757023992532172]]} + #*EXTRAS*# Step: 9 Bead: 14 +{"friction": [[0.00013691717809970563, -8.765984582495752e-06, -8.276663494936957e-06], [-8.765984582495752e-06, 0.00013695367714590685, -8.652854637587062e-06], [-8.276663494936957e-06, -8.652854637587062e-06, 0.00013762192105447741]]} + #*EXTRAS*# Step: 10 Bead: 14 +{"friction": [[0.00013694793591004952, -8.60888280674614e-06, -8.123199036605814e-06], [-8.60888280674614e-06, 0.0001369834038359969, -8.496847686857384e-06], [-8.123199036605814e-06, -8.496847686857384e-06, 0.00013765601901106225]]} + #*EXTRAS*# Step: 11 Bead: 14 +{"friction": [[0.00013696739166711372, -8.509881214329787e-06, -8.026576679676384e-06], [-8.509881214329787e-06, 0.00013700222231173456, -8.398547342608335e-06], [-8.026576679676384e-06, -8.398547342608335e-06, 0.00013767754679049388]]} + #*EXTRAS*# Step: 12 Bead: 14 +{"friction": [[0.00013697993410570955, -8.446211474531963e-06, -7.964472737987686e-06], [-8.446211474531963e-06, 0.00013701436003617207, -8.335333206818991e-06], [-7.964472737987686e-06, -8.335333206818991e-06, 0.00013769140834012528]]} + #*EXTRAS*# Step: 13 Bead: 14 +{"friction": [[0.00013698794777866337, -8.405594136129314e-06, -7.924868892687207e-06], [-8.405594136129314e-06, 0.00013702211763241264, -8.295008403140615e-06], [-7.924868892687207e-06, -8.295008403140615e-06, 0.0001377002580193388]]} + #*EXTRAS*# Step: 14 Bead: 14 +{"friction": [[0.00013699308438334956, -8.379584990169755e-06, -7.899514716520752e-06], [-8.379584990169755e-06, 0.00013702709112258058, -8.269187352534887e-06], [-7.899514716520752e-06, -8.269187352534887e-06, 0.0001377059277036576]]} + #*EXTRAS*# Step: 15 Bead: 14 +{"friction": [[0.00013699637043761828, -8.362956640867231e-06, -7.883307556826771e-06], [-8.362956640867231e-06, 0.00013703027324691783, -8.252679573420974e-06], [-7.883307556826771e-06, -8.252679573420974e-06, 0.00013770955364770867]]} + #*EXTRAS*# Step: 16 Bead: 14 +{"friction": [[0.00013699847363036487, -8.352318221659146e-06, -7.872939607331777e-06], [-8.352318221659146e-06, 0.000137032310092565, -8.242118421293213e-06], [-7.872939607331777e-06, -8.242118421293213e-06, 0.00013771187391628344]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_15 b/drivers/py/pes/friction/frictionH/060K/inst.raw_15 new file mode 100644 index 000000000..99d24738b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_15 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 15 +{"friction": [[0.00012726027358761464, -3.896940372900226e-05, -3.8480234708173996e-05], [-3.896940372900226e-05, 0.00012736412762627062, -3.9043725441288e-05], [-3.8480234708173996e-05, -3.9043725441288e-05, 0.00012691129785582055]]} + #*EXTRAS*# Step: 1 Bead: 15 +{"friction": [[0.00013075563007134403, -3.383515887941949e-05, -3.370914581896609e-05], [-3.383515887941949e-05, 0.00013097481875553555, -3.3834659660389763e-05], [-3.370914581896609e-05, -3.3834659660389763e-05, 0.00013046207017740528]]} + #*EXTRAS*# Step: 2 Bead: 15 +{"friction": [[0.00013334304006582646, -2.7207533011997012e-05, -2.7107546612817397e-05], [-2.7207533011997012e-05, 0.0001335805527481861, -2.7124283004988266e-05], [-2.7107546612817397e-05, -2.7124283004988266e-05, 0.00013331282823855403]]} + #*EXTRAS*# Step: 3 Bead: 15 +{"friction": [[0.00013512758882667922, -1.880446315902926e-05, -1.8391909782546642e-05], [-1.880446315902926e-05, 0.00013526958137225612, -1.8668280572179135e-05], [-1.8391909782546642e-05, -1.8668280572179135e-05, 0.00013549777543054507]]} + #*EXTRAS*# Step: 4 Bead: 15 +{"friction": [[0.00013601441856726082, -1.3679059093255272e-05, -1.3157250691019724e-05], [-1.3679059093255272e-05, 0.00013609431801553487, -1.3542972891772954e-05], [-1.3157250691019724e-05, -1.3542972891772954e-05, 0.0001365835661920177]]} + #*EXTRAS*# Step: 5 Bead: 15 +{"friction": [[0.00013625059945418568, -1.2342350057704083e-05, -1.1814458709699892e-05], [-1.2342350057704083e-05, 0.00013631672464772593, -1.2210322803739529e-05], [-1.1814458709699892e-05, -1.2210322803739529e-05, 0.00013686243327888536]]} + #*EXTRAS*# Step: 6 Bead: 15 +{"friction": [[0.00013650992464440398, -1.0913345526217244e-05, -1.0390943830229813e-05], [-1.0913345526217244e-05, 0.0001365628618779277, -1.0787475263383961e-05], [-1.0390943830229813e-05, -1.0787475263383961e-05, 0.00013716269475026968]]} + #*EXTRAS*# Step: 7 Bead: 15 +{"friction": [[0.00013661991824969366, -1.0321244745951809e-05, -9.804919391385312e-06], [-1.0321244745951809e-05, 0.0001366679001097015, -1.0198471447139221e-05], [-9.804919391385312e-06, -1.0198471447139221e-05, 0.00013728818132706817]]} + #*EXTRAS*# Step: 8 Bead: 15 +{"friction": [[0.00013670395602328455, -9.874828404959758e-06, -9.364600153793568e-06], [-9.874828404959758e-06, 0.00013674841008933742, -9.754600149927545e-06], [-9.364600153793568e-06, -9.754600149927545e-06, 0.0001373833194979909]]} + #*EXTRAS*# Step: 9 Bead: 15 +{"friction": [[0.0001367540742158623, -9.61110235342023e-06, -9.105096780258365e-06], [-9.61110235342023e-06, 0.0001367965305508375, -9.49246217163632e-06], [-9.105096780258365e-06, -9.49246217163632e-06, 0.00013743975862121985]]} + #*EXTRAS*# Step: 10 Bead: 15 +{"friction": [[0.0001367871929118243, -9.43786639380244e-06, -8.93488769625713e-06], [-9.43786639380244e-06, 0.00013682837246411678, -9.320303474092856e-06], [-8.93488769625713e-06, -9.320303474092856e-06, 0.00013747693312111782]]} + #*EXTRAS*# Step: 11 Bead: 15 +{"friction": [[0.0001368081632097493, -9.328604529662604e-06, -8.827638651487792e-06], [-9.328604529662604e-06, 0.0001368485520917207, -9.211734930210104e-06], [-8.827638651487792e-06, -9.211734930210104e-06, 0.00013750042206048924]]} + #*EXTRAS*# Step: 12 Bead: 15 +{"friction": [[0.00013682168089355947, -9.258349772223948e-06, -8.75872064997521e-06], [-9.258349772223948e-06, 0.00013686156738582789, -9.141931638871224e-06], [-8.75872064997521e-06, -9.141931638871224e-06, 0.00013751554308142824]]} + #*EXTRAS*# Step: 13 Bead: 15 +{"friction": [[0.00013683032003667495, -9.213522622307818e-06, -8.714763868037366e-06], [-9.213522622307818e-06, 0.00013686988843783447, -9.097394869733063e-06], [-8.714763868037366e-06, -9.097394869733063e-06, 0.0001375251986497308]]} + #*EXTRAS*# Step: 14 Bead: 15 +{"friction": [[0.00013683585778763387, -9.18481791441584e-06, -8.686623633999523e-06], [-9.18481791441584e-06, 0.00013687522351332992, -9.068877051942377e-06], [-8.686623633999523e-06, -9.068877051942377e-06, 0.00013753138455388085]]} + #*EXTRAS*# Step: 15 Bead: 15 +{"friction": [[0.00013683940077880073, -9.166465184025984e-06, -8.668634731478581e-06], [-9.166465184025984e-06, 0.00013687863733586103, -9.050644199594586e-06], [-8.668634731478581e-06, -9.050644199594586e-06, 0.00013753534084219902]]} + #*EXTRAS*# Step: 16 Bead: 15 +{"friction": [[0.00013684166848964378, -9.154723425381994e-06, -8.657126940654715e-06], [-9.154723425381994e-06, 0.00013688082257664428, -9.038979295328312e-06], [-8.657126940654715e-06, -9.038979295328312e-06, 0.00013753787251985326]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_16 b/drivers/py/pes/friction/frictionH/060K/inst.raw_16 new file mode 100644 index 000000000..45b150085 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_16 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 16 +{"friction": [[0.00012661143308844656, -3.971479929521334e-05, -3.9182795101576245e-05], [-3.971479929521334e-05, 0.00012669737778386712, -3.979877417067022e-05], [-3.9182795101576245e-05, -3.979877417067022e-05, 0.00012627184388542937]]} + #*EXTRAS*# Step: 1 Bead: 16 +{"friction": [[0.0001300419988045457, -3.508387351803022e-05, -3.488413934101739e-05], [-3.508387351803022e-05, 0.0001302389999237797, -3.510161417158304e-05], [-3.488413934101739e-05, -3.510161417158304e-05, 0.00012971975066989813]]} + #*EXTRAS*# Step: 2 Bead: 16 +{"friction": [[0.00013285398820577342, -2.8847766639930128e-05, -2.8788060599403377e-05], [-2.8847766639930128e-05, 0.00013310007533029407, -2.8782123038680572e-05], [-2.8788060599403377e-05, -2.8782123038680572e-05, 0.00013274678793138373]]} + #*EXTRAS*# Step: 3 Bead: 16 +{"friction": [[0.00013480980842908326, -2.0570959032683117e-05, -2.0220116681172875e-05], [-2.0570959032683117e-05, 0.00013497479915151073, -2.0440477977134185e-05], [-2.0220116681172875e-05, -2.0440477977134185e-05, 0.000135100605970232]]} + #*EXTRAS*# Step: 4 Bead: 16 +{"friction": [[0.00013576320010202616, -1.5127558857927765e-05, -1.462374568036721e-05], [-1.5127558857927765e-05, 0.00013585938487788998, -1.4988947117862188e-05], [-1.462374568036721e-05, -1.4988947117862188e-05, 0.0001362815287202465]]} + #*EXTRAS*# Step: 5 Bead: 16 +{"friction": [[0.00013603681326419272, -1.3551092909970786e-05, -1.302825194582925e-05], [-1.3551092909970786e-05, 0.00013611533872728862, -1.341532370513671e-05], [-1.302825194582925e-05, -1.341532370513671e-05, 0.00013661022590483315]]} + #*EXTRAS*# Step: 6 Bead: 16 +{"friction": [[0.0001363128692689068, -1.1995205964190262e-05, -1.1467480360335515e-05], [-1.1995205964190262e-05, 0.00013637563749867743, -1.1864502369957449e-05], [-1.1467480360335515e-05, -1.1864502369957449e-05, 0.0001369351017299129]]} + #*EXTRAS*# Step: 7 Bead: 16 +{"friction": [[0.00013643214227161145, -1.1337237677561275e-05, -1.08118710681256e-05], [-1.1337237677561275e-05, 0.00013648881468102204, -1.1209346187837481e-05], [-1.08118710681256e-05, -1.1209346187837481e-05, 0.00013707328757969533]]} + #*EXTRAS*# Step: 8 Bead: 16 +{"friction": [[0.0001365222399869598, -1.0846619437280269e-05, -1.0324789107255714e-05], [-1.0846619437280269e-05, 0.00013657460334593835, -1.0721082255719091e-05], [-1.0324789107255714e-05, -1.0721082255719091e-05, 0.00013717679962937444]]} + #*EXTRAS*# Step: 9 Bead: 16 +{"friction": [[0.00013657621148275092, -1.0555473576486237e-05, -1.0036472438054398e-05], [-1.0555473576486237e-05, 0.00013662611649791558, -1.043143709688365e-05], [-1.0036472438054398e-05, -1.043143709688365e-05, 0.00013723845013589284]]} + #*EXTRAS*# Step: 10 Bead: 16 +{"friction": [[0.00013661182666341315, -1.0364503131152832e-05, -9.847656626998193e-06], [-1.0364503131152832e-05, 0.00013666015999732074, -1.024149279793435e-05], [-9.847656626998193e-06, -1.024149279793435e-05, 0.00013727898746005164]]} + #*EXTRAS*# Step: 11 Bead: 16 +{"friction": [[0.00013663439834091584, -1.024395277111157e-05, -9.728589107674408e-06], [-1.024395277111157e-05, 0.00013668175640740203, -1.0121607213874932e-05], [-9.728589107674408e-06, -1.0121607213874932e-05, 0.00013730461923487124]]} + #*EXTRAS*# Step: 12 Bead: 16 +{"friction": [[0.00013664894672125034, -1.0166451773594741e-05, -9.652091788315611e-06], [-1.0166451773594741e-05, 0.00013669568474029007, -1.004454054512357e-05], [-9.652091788315611e-06, -1.004454054512357e-05, 0.00013732111565967512]]} + #*EXTRAS*# Step: 13 Bead: 16 +{"friction": [[0.00013665824687450817, -1.0116990636080336e-05, -9.603291859512763e-06], [-1.0116990636080336e-05, 0.0001367045920348143, -9.995359437209905e-06], [-9.603291859512763e-06, -9.995359437209905e-06, 0.00013733165115639817]]} + #*EXTRAS*# Step: 14 Bead: 16 +{"friction": [[0.00013666420852162246, -1.0085318403106406e-05, -9.572051497443943e-06], [-1.0085318403106406e-05, 0.0001367103032886487, -9.963867682046814e-06], [-9.572051497443943e-06, -9.963867682046814e-06, 0.00013733840061471355]]} + #*EXTRAS*# Step: 15 Bead: 16 +{"friction": [[0.00013666802301626476, -1.0065067094900253e-05, -9.552079797660432e-06], [-1.0065067094900253e-05, 0.00013671395816178625, -9.943732247192215e-06], [-9.552079797660432e-06, -9.943732247192215e-06, 0.00013734271751280952]]} + #*EXTRAS*# Step: 16 Bead: 16 +{"friction": [[0.00013667046456739446, -1.0052110467045353e-05, -9.539303481494854e-06], [-1.0052110467045353e-05, 0.00013671629778523763, -9.930849948674365e-06], [-9.539303481494854e-06, -9.930849948674365e-06, 0.0001373454799552708]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_17 b/drivers/py/pes/friction/frictionH/060K/inst.raw_17 new file mode 100644 index 000000000..3fd949b34 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_17 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 17 +{"friction": [[0.00012594185509922254, -4.0430818480279955e-05, -3.987531491748839e-05], [-4.0430818480279955e-05, 0.0001260130421325445, -4.052299864131734e-05], [-3.987531491748839e-05, -4.052299864131734e-05, 0.00012561795751016416]]} + #*EXTRAS*# Step: 1 Bead: 17 +{"friction": [[0.0001292330233438706, -3.6350781754656434e-05, -3.606013317947199e-05], [-3.6350781754656434e-05, 0.00012940248479960308, -3.63873291496811e-05], [-3.606013317947199e-05, -3.63873291496811e-05, 0.0001288906648071318]]} + #*EXTRAS*# Step: 2 Bead: 17 +{"friction": [[0.00013225045162150537, -3.0569446914486834e-05, -3.052641201540585e-05], [-3.0569446914486834e-05, 0.00013249790819660405, -3.0524511681098596e-05], [-3.052641201540585e-05, -3.0524511681098596e-05, 0.00013206839277799757]]} + #*EXTRAS*# Step: 3 Bead: 17 +{"friction": [[0.0001344425002112759, -2.2487755759273258e-05, -2.2211465701507164e-05], [-2.2487755759273258e-05, 0.00013463187670572927, -2.2366779029739933e-05], [-2.2211465701507164e-05, -2.2366779029739933e-05, 0.00013464273433599105]]} + #*EXTRAS*# Step: 4 Bead: 17 +{"friction": [[0.00013548701775889643, -1.6733851523151897e-05, -1.6262592646678197e-05], [-1.6733851523151897e-05, 0.00013560260210227236, -1.6594735037362445e-05], [-1.6262592646678197e-05, -1.6594735037362445e-05, 0.00013594379888811497]]} + #*EXTRAS*# Step: 5 Bead: 17 +{"friction": [[0.0001358042596159704, -1.4889495312579095e-05, -1.438195090430603e-05], [-1.4889495312579095e-05, 0.00013589768090185644, -1.4751164215924579e-05], [-1.438195090430603e-05, -1.4751164215924579e-05, 0.0001363312549208322]]} + #*EXTRAS*# Step: 6 Bead: 17 +{"friction": [[0.00013609905040345982, -1.319670940479757e-05, -1.2671499127153465e-05], [-1.319670940479757e-05, 0.00013617383014264027, -1.306189732086529e-05], [-1.2671499127153465e-05, -1.306189732086529e-05, 0.00013668407907252997]]} + #*EXTRAS*# Step: 7 Bead: 17 +{"friction": [[0.00013622841752999648, -1.2466582571482739e-05, -1.1938810099540148e-05], [-1.2466582571482739e-05, 0.00013629576698105005, -1.233410854767926e-05], [-1.1938810099540148e-05, -1.233410854767926e-05, 0.00013683646025317427]]} + #*EXTRAS*# Step: 8 Bead: 17 +{"friction": [[0.00013632498607158152, -1.1927939212127352e-05, -1.140033121336755e-05], [-1.1927939212127352e-05, 0.0001363871148862876, -1.1797504907876863e-05], [-1.140033121336755e-05, -1.1797504907876863e-05, 0.0001369492001155031]]} + #*EXTRAS*# Step: 9 Bead: 17 +{"friction": [[0.0001363830555118439, -1.160688393634611e-05, -1.1080223546214069e-05], [-1.160688393634611e-05, 0.00013644218300017813, -1.1477792069853034e-05], [-1.1080223546214069e-05, -1.1477792069853034e-05, 0.00013701657701858082]]} + #*EXTRAS*# Step: 10 Bead: 17 +{"friction": [[0.0001364213157039717, -1.1396570770986937e-05, -1.087088019764848e-05], [-1.1396570770986937e-05, 0.0001364785231164496, -1.1268409446484133e-05], [-1.087088019764848e-05, -1.1268409446484133e-05, 0.00013706079868497462]]} + #*EXTRAS*# Step: 11 Bead: 17 +{"friction": [[0.0001364455819897545, -1.1263695155766039e-05, -1.0738760989940923e-05], [-1.1263695155766039e-05, 0.00013650159538798788, -1.1136142584743052e-05], [-1.0738760989940923e-05, -1.1136142584743052e-05, 0.0001370887757747922]]} + #*EXTRAS*# Step: 12 Bead: 17 +{"friction": [[0.00013646121990892591, -1.1178280483844804e-05, -1.0653891615211222e-05], [-1.1178280483844804e-05, 0.00013651647366126984, -1.1051127740505903e-05], [-1.0653891615211222e-05, -1.1051127740505903e-05, 0.00013710677622123465]]} + #*EXTRAS*# Step: 13 Bead: 17 +{"friction": [[0.0001364712185029339, -1.1123756690272338e-05, -1.0599740160709681e-05], [-1.1123756690272338e-05, 0.00013652599058962064, -1.099686265413028e-05], [-1.0599740160709681e-05, -1.099686265413028e-05, 0.0001371182735475757]]} + #*EXTRAS*# Step: 14 Bead: 17 +{"friction": [[0.0001364776278948441, -1.1088841933877804e-05, -1.0565073781948351e-05], [-1.1088841933877804e-05, 0.00013653209287796202, -1.0962114986733196e-05], [-1.0565073781948351e-05, -1.0962114986733196e-05, 0.00013712563882491393]]} + #*EXTRAS*# Step: 15 Bead: 17 +{"friction": [[0.00013648172911771728, -1.1066515827609075e-05, -1.054291057622375e-05], [-1.1066515827609075e-05, 0.00013653599827240264, -1.093989630736619e-05], [-1.054291057622375e-05, -1.093989630736619e-05, 0.0001371303497120099]]} + #*EXTRAS*# Step: 16 Bead: 17 +{"friction": [[0.0001364843542342276, -1.1052231476956996e-05, -1.0528732119685582e-05], [-1.1052231476956996e-05, 0.0001365384983214574, -1.092568092727965e-05], [-1.0528732119685582e-05, -1.092568092727965e-05, 0.00013713336425054732]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_18 b/drivers/py/pes/friction/frictionH/060K/inst.raw_18 new file mode 100644 index 000000000..190b14285 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_18 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 18 +{"friction": [[0.00012526486252094083, -4.1100303058221635e-05, -4.0550714905083066e-05], [-4.1100303058221635e-05, 0.00012532660471124878, -4.119858624384984e-05], [-4.0550714905083066e-05, -4.119858624384984e-05, 0.00012496354601260095]]} + #*EXTRAS*# Step: 1 Bead: 18 +{"friction": [[0.00012833823977072883, -3.7610486278497233e-05, -3.722149994422753e-05], [-3.7610486278497233e-05, 0.00012847677430923645, -3.766562462271395e-05], [-3.722149994422753e-05, -3.766562462271395e-05, 0.00012798607670308964]]} + #*EXTRAS*# Step: 2 Bead: 18 +{"friction": [[0.0001314971004449298, -3.235670417063397e-05, -3.228979458436936e-05], [-3.235670417063397e-05, 0.00013173475655464667, -3.2335374332141396e-05], [-3.228979458436936e-05, -3.2335374332141396e-05, 0.00013124789004719247]]} + #*EXTRAS*# Step: 3 Bead: 18 +{"friction": [[0.00013400635235862976, -2.45461752307615e-05, -2.4352083470184842e-05], [-2.45461752307615e-05, 0.00013421972209270273, -2.44391974920892e-05], [-2.4352083470184842e-05, -2.44391974920892e-05, 0.0001341061794138949]]} + #*EXTRAS*# Step: 4 Bead: 18 +{"friction": [[0.00013518042889920244, -1.8503582430742367e-05, -1.8081477138038666e-05], [-1.8503582430742367e-05, 0.0001353185217799309, -1.8366722230688185e-05], [-1.8081477138038666e-05, -1.8366722230688185e-05, 0.0001355636630167696]]} + #*EXTRAS*# Step: 5 Bead: 18 +{"friction": [[0.00013555053811370655, -1.6364334371615422e-05, -1.5884494878346004e-05], [-1.6364334371615422e-05, 0.0001356615547743042, -1.6225119326370997e-05], [-1.5884494878346004e-05, -1.6225119326370997e-05, 0.000136021938280242]]} + #*EXTRAS*# Step: 6 Bead: 18 +{"friction": [[0.00013586722726749166, -1.4525250231271924e-05, -1.4012574925462243e-05], [-1.4525250231271924e-05, 0.00013595648382141553, -1.4387451031634226e-05], [-1.4012574925462243e-05, -1.4387451031634226e-05, 0.00013640724655493165]]} + #*EXTRAS*# Step: 7 Bead: 18 +{"friction": [[0.00013600783152680447, -1.3716741248189751e-05, -1.3195254634843638e-05], [-1.3716741248189751e-05, 0.00013608813769597434, -1.3580564597696365e-05], [-1.3195254634843638e-05, -1.3580564597696365e-05, 0.00013657571614939703]]} + #*EXTRAS*# Step: 8 Bead: 18 +{"friction": [[0.00013611143899513702, -1.312639785310445e-05, -1.260080397603263e-05], [-1.312639785310445e-05, 0.00013618548613857618, -1.2991789494204778e-05], [-1.260080397603263e-05, -1.2991789494204778e-05, 0.0001366987379915751]]} + #*EXTRAS*# Step: 9 Bead: 18 +{"friction": [[0.00013617392363862667, -1.2773005107948865e-05, -1.2245922719739702e-05], [-1.2773005107948865e-05, 0.00013624434317366404, -1.2639489908652432e-05], [-1.2245922719739702e-05, -1.2639489908652432e-05, 0.0001367724596446654]]} + #*EXTRAS*# Step: 10 Bead: 18 +{"friction": [[0.00013621501645793776, -1.2541778311190603e-05, -1.2014123053782835e-05], [-1.2541778311190603e-05, 0.00013628311270093502, -1.2409040770321993e-05], [-1.2014123053782835e-05, -1.2409040770321993e-05, 0.00013682074673710993]]} + #*EXTRAS*# Step: 11 Bead: 18 +{"friction": [[0.00013624109224865164, -1.239556026665989e-05, -1.1867708403355572e-05], [-1.239556026665989e-05, 0.00013630774034510747, -1.2263339916604668e-05], [-1.1867708403355572e-05, -1.2263339916604668e-05, 0.00013685130678304364]]} + #*EXTRAS*# Step: 12 Bead: 18 +{"friction": [[0.00013625789124632667, -1.2301576091305348e-05, -1.1773666107220831e-05], [-1.2301576091305348e-05, 0.0001363236172377059, -1.216969856634114e-05], [-1.1773666107220831e-05, -1.216969856634114e-05, 0.00013687096134960822]]} + #*EXTRAS*# Step: 13 Bead: 18 +{"friction": [[0.00013626863334128072, -1.2241567760608181e-05, -1.171364873017892e-05], [-1.2241567760608181e-05, 0.00013633377417379553, -1.210991337809977e-05], [-1.171364873017892e-05, -1.210991337809977e-05, 0.0001368835157182638]]} + #*EXTRAS*# Step: 14 Bead: 18 +{"friction": [[0.00013627551901780537, -1.2203139627677653e-05, -1.167522632456817e-05], [-1.2203139627677653e-05, 0.00013634028660811245, -1.2071629880350777e-05], [-1.167522632456817e-05, -1.2071629880350777e-05, 0.00013689155743091302]]} + #*EXTRAS*# Step: 15 Bead: 18 +{"friction": [[0.00013627992511577595, -1.217856505453781e-05, -1.1650660137795105e-05], [-1.217856505453781e-05, 0.00013634445462846223, -1.2047148512240657e-05], [-1.1650660137795105e-05, -1.2047148512240657e-05, 0.00013689670096013034]]} + #*EXTRAS*# Step: 16 Bead: 18 +{"friction": [[0.0001362827453605403, -1.216284172368861e-05, -1.1634944108110554e-05], [-1.216284172368861e-05, 0.0001363471227957872, -1.2031485107121281e-05], [-1.1634944108110554e-05, -1.2031485107121281e-05, 0.00013689999227237663]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_19 b/drivers/py/pes/friction/frictionH/060K/inst.raw_19 new file mode 100644 index 000000000..4d5af75d6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_19 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 19 +{"friction": [[0.00012459632602131336, -4.170492542491858e-05, -4.120187097266213e-05], [-4.170492542491858e-05, 0.00012465628415804492, -4.1806390624578615e-05], [-4.120187097266213e-05, -4.1806390624578615e-05, 0.00012432488906652224]]} + #*EXTRAS*# Step: 1 Bead: 19 +{"friction": [[0.00012737514691066066, -3.8831975972658615e-05, -3.835200305068976e-05], [-3.8831975972658615e-05, 0.00012748245331564668, -3.890443226980349e-05], [-3.835200305068976e-05, -3.890443226980349e-05, 0.00012702509131795944]]} + #*EXTRAS*# Step: 2 Bead: 19 +{"friction": [[0.00013056371513976987, -3.418528092134356e-05, -3.404055026720772e-05], [-3.418528092134356e-05, 0.00013077724553918366, -3.4189848233424744e-05], [-3.404055026720772e-05, -3.4189848233424744e-05, 0.00013026127236826898]]} + #*EXTRAS*# Step: 3 Bead: 19 +{"friction": [[0.00013347229646797784, -2.6730988452118543e-05, -2.6616154827821612e-05], [-2.6730988452118543e-05, 0.0001337062801232049, -2.6643038523072606e-05], [-2.6616154827821612e-05, -2.6643038523072606e-05, 0.0001334650886812493]]} + #*EXTRAS*# Step: 4 Bead: 19 +{"friction": [[0.0001348340856662566, -2.0439096706516972e-05, -2.0083361277669606e-05], [-2.0439096706516972e-05, 0.0001349973643011436, -2.0308088471247244e-05], [-2.0083361277669606e-05, -2.0308088471247244e-05, 0.00013513096036123912]]} + #*EXTRAS*# Step: 5 Bead: 19 +{"friction": [[0.00013527158530635258, -1.7981026076545074e-05, -1.7543108291491857e-05], [-1.7981026076545074e-05, 0.00013540294423364493, -1.7843192178958153e-05], [-1.7543108291491857e-05, -1.7843192178958153e-05, 0.00013567711848954975]]} + #*EXTRAS*# Step: 6 Bead: 19 +{"friction": [[0.0001356153120108408, -1.5987317982323938e-05, -1.549937882263404e-05], [-1.5987317982323938e-05, 0.00013572172874288567, -1.5848134728436318e-05], [-1.549937882263404e-05, -1.5848134728436318e-05, 0.00013610134925392454]]} + #*EXTRAS*# Step: 7 Bead: 19 +{"friction": [[0.00013576890015841464, -1.5094487449900917e-05, -1.4590138313740641e-05], [-1.5094487449900917e-05, 0.0001358646991310732, -1.495591152587845e-05], [-1.4590138313740641e-05, -1.495591152587845e-05, 0.0001362884399744548]]} + #*EXTRAS*# Step: 8 Bead: 19 +{"friction": [[0.00013588042156139238, -1.4449075376273e-05, -1.3935416815000705e-05], [-1.4449075376273e-05, 0.00013596881719162962, -1.4311403069276172e-05], [-1.3935416815000705e-05, -1.4311403069276172e-05, 0.00013642312803424444]]} + #*EXTRAS*# Step: 9 Bead: 19 +{"friction": [[0.00013594778918990427, -1.4061073799854021e-05, -1.3542897672339578e-05], [-1.4061073799854021e-05, 0.0001360318557621689, -1.3924131752988994e-05], [-1.3542897672339578e-05, -1.3924131752988994e-05, 0.00013650398444447684]]} + #*EXTRAS*# Step: 10 Bead: 19 +{"friction": [[0.00013599198700427214, -1.3807460045783828e-05, -1.328678105927552e-05], [-1.3807460045783828e-05, 0.00013607327626730738, -1.3671071050449758e-05], [-1.328678105927552e-05, -1.3671071050449758e-05, 0.00013655681780615008]]} + #*EXTRAS*# Step: 11 Bead: 19 +{"friction": [[0.0001360200358910923, -1.3646939620791668e-05, -1.3124863289613076e-05], [-1.3646939620791668e-05, 0.00013609958941912208, -1.3510931556836012e-05], [-1.3124863289613076e-05, -1.3510931556836012e-05, 0.00013659025753077434]]} + #*EXTRAS*# Step: 12 Bead: 19 +{"friction": [[0.00013603809679509915, -1.3543765609822126e-05, -1.3020868346571515e-05], [-1.3543765609822126e-05, 0.0001361165439238566, -1.3408015016019237e-05], [-1.3020868346571515e-05, -1.3408015016019237e-05, 0.00013661175252142733]]} + #*EXTRAS*# Step: 13 Bead: 19 +{"friction": [[0.00013604964537260804, -1.3477872803273392e-05, -1.2954483054488914e-05], [-1.3477872803273392e-05, 0.00013612738972322374, -1.3342291811784259e-05], [-1.2954483054488914e-05, -1.3342291811784259e-05, 0.0001366254816129177]]} + #*EXTRAS*# Step: 14 Bead: 19 +{"friction": [[0.0001360570470305401, -1.3435674242518404e-05, -1.2911982174123592e-05], [-1.3435674242518404e-05, 0.0001361343428947732, -1.330020398116565e-05], [-1.2911982174123592e-05, -1.330020398116565e-05, 0.00013663427448905262]]} + #*EXTRAS*# Step: 15 Bead: 19 +{"friction": [[0.00013606178315754558, -1.3408686242505361e-05, -1.2884806191366222e-05], [-1.3408686242505361e-05, 0.00013613879284387083, -1.327328766381683e-05], [-1.2884806191366222e-05, -1.327328766381683e-05, 0.0001366398982304427]]} + #*EXTRAS*# Step: 16 Bead: 19 +{"friction": [[0.0001360648145243259, -1.339141820193649e-05, -1.286742007091546e-05], [-1.339141820193649e-05, 0.00013614164136930315, -1.3256065842931632e-05], [-1.286742007091546e-05, -1.3256065842931632e-05, 0.00013664349665439612]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_20 b/drivers/py/pes/friction/frictionH/060K/inst.raw_20 new file mode 100644 index 000000000..264c27391 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_20 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 20 +{"friction": [[0.0001239405986518248, -4.2236453288719934e-05, -4.1819804194371584e-05], [-4.2236453288719934e-05, 0.0001240048715323352, -4.2336200609474876e-05], [-4.1819804194371584e-05, -4.2336200609474876e-05, 0.00012370560188273736]]} + #*EXTRAS*# Step: 1 Bead: 20 +{"friction": [[0.0001263698903614625, -3.997924586102009e-05, -3.943597826949985e-05], [-3.997924586102009e-05, 0.00012645000382207543, -4.006640205237424e-05], [-3.943597826949985e-05, -4.006640205237424e-05, 0.00012603524116116342]]} + #*EXTRAS*# Step: 2 Bead: 20 +{"friction": [[0.00012945795216066054, -3.6012057900183475e-05, -3.57468985178587e-05], [-3.6012057900183475e-05, 0.00012963519840012352, -3.604356775499563e-05], [-3.57468985178587e-05, -3.604356775499563e-05, 0.00012912002488962534]]} + #*EXTRAS*# Step: 3 Bead: 20 +{"friction": [[0.0001327981173459688, -2.902012665669255e-05, -2.896344928765683e-05], [-2.902012665669255e-05, 0.00013304473296985516, -2.8956457237429775e-05], [-2.896344928765683e-05, -2.8956457237429775e-05, 0.00013268309392014144]]} + #*EXTRAS*# Step: 4 Bead: 20 +{"friction": [[0.00013443240368045766, -2.2538189056742836e-05, -2.2263918087254478e-05], [-2.2538189056742836e-05, 0.00013462240242744154, -2.2417508693865614e-05], [-2.2263918087254478e-05, -2.2417508693865614e-05, 0.00013463020735664493]]} + #*EXTRAS*# Step: 5 Bead: 20 +{"friction": [[0.0001349606159430793, -1.9742963745262314e-05, -1.9362101322306297e-05], [-1.9742963745262314e-05, 0.00013511482925796604, -1.9609443824807053e-05], [-1.9362101322306297e-05, -1.9609443824807053e-05, 0.00013528918749633549]]} + #*EXTRAS*# Step: 6 Bead: 20 +{"friction": [[0.00013533973999439592, -1.7587957090700136e-05, -1.7138835485650377e-05], [-1.7587957090700136e-05, 0.00013546607570201803, -1.744956064581296e-05], [-1.7138835485650377e-05, -1.744956064581296e-05, 0.00013576173267293968]]} + #*EXTRAS*# Step: 7 Bead: 20 +{"friction": [[0.00013550910109193037, -1.6605429866689432e-05, -1.6131118252914837e-05], [-1.6605429866689432e-05, 0.0001356230916804898, -1.6466264558273954e-05], [-1.6131118252914837e-05, -1.6466264558273954e-05, 0.0001359709931535253]]} + #*EXTRAS*# Step: 8 Bead: 20 +{"friction": [[0.0001356299564973054, -1.590208611816635e-05, -1.5412409963292034e-05], [-1.590208611816635e-05, 0.00013573534236607055, -1.5762928559838774e-05], [-1.5412409963292034e-05, -1.5762928559838774e-05, 0.00013611926304712442]]} + #*EXTRAS*# Step: 9 Bead: 20 +{"friction": [[0.0001357029519826426, -1.547748290593427e-05, -1.4979683966871741e-05], [-1.547748290593427e-05, 0.00013580325529201375, -1.5338554936065634e-05], [-1.4979683966871741e-05, -1.5338554936065634e-05, 0.00013620832346743136]]} + #*EXTRAS*# Step: 10 Bead: 20 +{"friction": [[0.00013575068673849844, -1.5200183818281656e-05, -1.469756741040556e-05], [-1.5200183818281656e-05, 0.00013584772085842943, -1.506149701772251e-05], [-1.469756741040556e-05, -1.506149701772251e-05, 0.00013626634741082744]]} + #*EXTRAS*# Step: 11 Bead: 20 +{"friction": [[0.00013578096569431814, -1.5024506822692827e-05, -1.4519042257684271e-05], [-1.5024506822692827e-05, 0.0001358759502995395, -1.4886010060460648e-05], [-1.4519042257684271e-05, -1.4886010060460648e-05, 0.0001363030607813231]]} + #*EXTRAS*# Step: 12 Bead: 20 +{"friction": [[0.00013580044618954738, -1.4911589004026887e-05, -1.4404378418090232e-05], [-1.4911589004026887e-05, 0.0001358941225902813, -1.4773229631179725e-05], [-1.4404378418090232e-05, -1.4773229631179725e-05, 0.00013632664228321317]]} + #*EXTRAS*# Step: 13 Bead: 20 +{"friction": [[0.00013581289932053535, -1.4839453336112244e-05, -1.433116231310426e-05], [-1.4839453336112244e-05, 0.00013590574381358973, -1.4701187971615155e-05], [-1.433116231310426e-05, -1.4701187971615155e-05, 0.00013634170094760405]]} + #*EXTRAS*# Step: 14 Bead: 20 +{"friction": [[0.00013582087862429757, -1.4793253604797753e-05, -1.4284285013225085e-05], [-1.4793253604797753e-05, 0.00013591319189937753, -1.4655051002895917e-05], [-1.4284285013225085e-05, -1.4655051002895917e-05, 0.00013635134309178837]]} + #*EXTRAS*# Step: 15 Bead: 20 +{"friction": [[0.00013582598378229413, -1.4763703906792923e-05, -1.425430785495804e-05], [-1.4763703906792923e-05, 0.00013591795793919928, -1.462554249389313e-05], [-1.425430785495804e-05, -1.462554249389313e-05, 0.0001363575093980782]]} + #*EXTRAS*# Step: 16 Bead: 20 +{"friction": [[0.00013582925104267015, -1.4744796052373444e-05, -1.4235128910728572e-05], [-1.4744796052373444e-05, 0.00013592100847783565, -1.4606661422838058e-05], [-1.4235128910728572e-05, -1.4606661422838058e-05, 0.00013636145466058098]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_21 b/drivers/py/pes/friction/frictionH/060K/inst.raw_21 new file mode 100644 index 000000000..139787118 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_21 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 21 +{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} + #*EXTRAS*# Step: 1 Bead: 21 +{"friction": [[0.00012535779220705377, -4.1011705964083915e-05, -4.045913785209357e-05], [-4.1011705964083915e-05, 0.00012542042648807614, -4.1109301544847376e-05], [-4.045913785209357e-05, -4.1109301544847376e-05, 0.00012505294416429144]]} + #*EXTRAS*# Step: 2 Bead: 21 +{"friction": [[0.00012820961979982722, -3.778113800426238e-05, -3.737883371333145e-05], [-3.778113800426238e-05, 0.00012834380280959926, -3.783875546898979e-05], [-3.737883371333145e-05, -3.783875546898979e-05, 0.0001278570069695347]]} + #*EXTRAS*# Step: 3 Bead: 21 +{"friction": [[0.0001319247670215818, -3.138504684079235e-05, -3.1337284489599855e-05], [-3.138504684079235e-05, 0.00013216938034488234, -3.135064069440188e-05], [-3.1337284489599855e-05, -3.135064069440188e-05, 0.00013171043363380117]]} + #*EXTRAS*# Step: 4 Bead: 21 +{"friction": [[0.0001339503267156999, -2.4792483301932613e-05, -2.4607966679358617e-05], [-2.4792483301932613e-05, 0.00013416632193940267, -2.468743920740109e-05], [-2.4607966679358617e-05, -2.468743920740109e-05, 0.0001340380423195001]]} + #*EXTRAS*# Step: 5 Bead: 21 +{"friction": [[0.00013460656103164655, -2.165073274032449e-05, -2.1341247370781026e-05], [-2.165073274032449e-05, 0.00013478543853515465, -2.1525182988457172e-05], [-2.1341247370781026e-05, -2.1525182988457172e-05, 0.00013484681025999564]]} + #*EXTRAS*# Step: 6 Bead: 21 +{"friction": [[0.0001350345139306028, -1.9330120117285333e-05, -1.8934981565640615e-05], [-1.9330120117285333e-05, 0.0001351833450817515, -1.919532648141686e-05], [-1.8934981565640615e-05, -1.919532648141686e-05, 0.0001353815576095785]]} + #*EXTRAS*# Step: 7 Bead: 21 +{"friction": [[0.00013522415397928224, -1.825343462577004e-05, -1.782363331079008e-05], [-1.825343462577004e-05, 0.00013535901632819277, -1.811607614732945e-05], [-1.782363331079008e-05, -1.811607614732945e-05, 0.0001356181209073743]]} + #*EXTRAS*# Step: 8 Bead: 21 +{"friction": [[0.00013535667258518093, -1.7490045019112235e-05, -1.70382291439126e-05], [-1.7490045019112235e-05, 0.00013548176368043008, -1.7351531126411512e-05], [-1.70382291439126e-05, -1.7351531126411512e-05, 0.00013578272207437475]]} + #*EXTRAS*# Step: 9 Bead: 21 +{"friction": [[0.00013543651448142844, -1.7027276732266403e-05, -1.6563269009400243e-05], [-1.7027276732266403e-05, 0.00013555576402235998, -1.688833008335975e-05], [-1.6563269009400243e-05, -1.688833008335975e-05, 0.00013588149875017335]]} + #*EXTRAS*# Step: 10 Bead: 21 +{"friction": [[0.00013548849463548713, -1.6725264882764618e-05, -1.6253799572278733e-05], [-1.6725264882764618e-05, 0.00013560397221306633, -1.6586144648180732e-05], [-1.6253799572278733e-05, -1.6586144648180732e-05, 0.0001359456184933696]]} + #*EXTRAS*# Step: 11 Bead: 21 +{"friction": [[0.00013552142431715202, -1.6533743380038443e-05, -1.6057760235320963e-05], [-1.6533743380038443e-05, 0.0001356345281304798, -1.639455756962692e-05], [-1.6057760235320963e-05, -1.639455756962692e-05, 0.0001359861554012421]]} + #*EXTRAS*# Step: 12 Bead: 21 +{"friction": [[0.00013554258247240394, -1.6410632673185766e-05, -1.5931833919573617e-05], [-1.6410632673185766e-05, 0.00013565416833545533, -1.6271422936645613e-05], [-1.5931833919573617e-05, -1.6271422936645613e-05, 0.00013601216564166192]]} + #*EXTRAS*# Step: 13 Bead: 21 +{"friction": [[0.00013555610049883945, -1.6331961835443716e-05, -1.5851400564242624e-05], [-1.6331961835443716e-05, 0.0001356667197099155, -1.619274427590195e-05], [-1.5851400564242624e-05, -1.619274427590195e-05, 0.0001360287686193702]]} + #*EXTRAS*# Step: 14 Bead: 21 +{"friction": [[0.00013556475822534394, -1.6281572152723717e-05, -1.579989713437438e-05], [-1.6281572152723717e-05, 0.00013567475968780286, -1.614235264038751e-05], [-1.579989713437438e-05, -1.614235264038751e-05, 0.000136039395849301]]} + #*EXTRAS*# Step: 15 Bead: 21 +{"friction": [[0.00013557029612614482, -1.624933916878676e-05, -1.576695795810795e-05], [-1.624933916878676e-05, 0.00013567990301344536, -1.611011965932404e-05], [-1.576695795810795e-05, -1.611011965932404e-05, 0.00013604619094143212]]} + #*EXTRAS*# Step: 16 Bead: 21 +{"friction": [[0.00013557383973637361, -1.6228713408330747e-05, -1.5745882871971713e-05], [-1.6228713408330747e-05, 0.00013568319437712455, -1.6089494413200116e-05], [-1.5745882871971713e-05, -1.6089494413200116e-05, 0.00013605053793653437]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_22 b/drivers/py/pes/friction/frictionH/060K/inst.raw_22 new file mode 100644 index 000000000..2e722c270 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_22 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 22 +{"friction": [[0.000122630467543474, -4.3096070467800976e-05, -4.2912418060752e-05], [-4.3096070467800976e-05, 0.00012269691709164998, -4.316425275719657e-05], [-4.2912418060752e-05, -4.316425275719657e-05, 0.00012247956068148197]]} + #*EXTRAS*# Step: 1 Bead: 22 +{"friction": [[0.00012438066833177133, -4.188685041013491e-05, -4.140824686814723e-05], [-4.188685041013491e-05, 0.0001244416138256371, -4.198843671953771e-05], [-4.140824686814723e-05, -4.198843671953771e-05, 0.0001241205156988537]]} + #*EXTRAS*# Step: 2 Bead: 22 +{"friction": [[0.00012686905064442495, -3.9425023755072084e-05, -3.8908010493452814e-05], [-3.9425023755072084e-05, 0.00012696174977762438, -3.950535181124683e-05], [-3.8908010493452814e-05, -3.950535181124683e-05, 0.00012652506317068984]]} + #*EXTRAS*# Step: 3 Bead: 22 +{"friction": [[0.00013078056797792792, -3.378880113611108e-05, -3.366514142378169e-05], [-3.378880113611108e-05, 0.00013100047094856323, -3.3787634404300685e-05], [-3.366514142378169e-05, -3.3787634404300685e-05, 0.00013048823189075026]]} + #*EXTRAS*# Step: 4 Bead: 22 +{"friction": [[0.0001333491115393587, -2.7185575838628054e-05, -2.708493144215687e-05], [-2.7185575838628054e-05, 0.0001335864707734607, -2.710210507303154e-05], [-2.708493144215687e-05, -2.710210507303154e-05, 0.00013331995486665608]]} + #*EXTRAS*# Step: 5 Bead: 22 +{"friction": [[0.00013419183654865186, -2.3701209472474907e-05, -2.3473636483654068e-05], [-2.3701209472474907e-05, 0.0001343957529658621, -2.3588015614735733e-05], [-2.3473636483654068e-05, -2.3588015614735733e-05, 0.00013433311773006625]]} + #*EXTRAS*# Step: 6 Bead: 22 +{"friction": [[0.00013468980515124834, -2.121392030493787e-05, -2.0887455876305765e-05], [-2.121392030493787e-05, 0.00013486309997083146, -2.1086243918513555e-05], [-2.0887455876305765e-05, -2.1086243918513555e-05, 0.00013495066333504713]]} + #*EXTRAS*# Step: 7 Bead: 22 +{"friction": [[0.00013490695375694607, -2.003994969036443e-05, -1.9669654628907933e-05], [-2.003994969036443e-05, 0.0001350650383180699, -1.9907445458335472e-05], [-1.9669654628907933e-05, -1.9907445458335472e-05, 0.00013522208426630024]]} + #*EXTRAS*# Step: 8 Bead: 22 +{"friction": [[0.00013505491129129927, -1.921543493090665e-05, -1.8816421438659548e-05], [-1.921543493090665e-05, 0.00013520224844931926, -1.9080316012487527e-05], [-1.8816421438659548e-05, -1.9080316012487527e-05, 0.00013540704094933145]]} + #*EXTRAS*# Step: 9 Bead: 22 +{"friction": [[0.00013514358574834282, -1.871354766151498e-05, -1.8298074913287735e-05], [-1.871354766151498e-05, 0.0001352843985487778, -1.8577151311092665e-05], [-1.8298074913287735e-05, -1.8577151311092665e-05, 0.00013551773048639716]]} + #*EXTRAS*# Step: 10 Bead: 22 +{"friction": [[0.00013520097189127875, -1.8386181646109514e-05, -1.7960436053193588e-05], [-1.8386181646109514e-05, 0.00013533754714220827, -1.8249080233328046e-05], [-1.7960436053193588e-05, -1.8249080233328046e-05, 0.00013558925634209526]]} + #*EXTRAS*# Step: 11 Bead: 22 +{"friction": [[0.00013523724280298694, -1.817836679968282e-05, -1.774630085752114e-05], [-1.817836679968282e-05, 0.0001353711380863948, -1.8040870316658815e-05], [-1.774630085752114e-05, -1.8040870316658815e-05, 0.00013563440984439053]]} + #*EXTRAS*# Step: 12 Bead: 22 +{"friction": [[0.00013526050298581655, -1.8044765505317703e-05, -1.760872157886197e-05], [-1.8044765505317703e-05, 0.00013539268016254038, -1.7907036570243968e-05], [-1.760872157886197e-05, -1.7907036570243968e-05, 0.00013566334137447722]]} + #*EXTRAS*# Step: 13 Bead: 22 +{"friction": [[0.0001352753497760747, -1.7959362906355993e-05, -1.7520811816198265e-05], [-1.7959362906355993e-05, 0.0001354064308243387, -1.7821494208303585e-05], [-1.7520811816198265e-05, -1.7821494208303585e-05, 0.00013568179722279935]]} + #*EXTRAS*# Step: 14 Bead: 22 +{"friction": [[0.0001352848518706819, -1.7904655389570143e-05, -1.746451307263769e-05], [-1.7904655389570143e-05, 0.0001354152316810853, -1.776670077937454e-05], [-1.746451307263769e-05, -1.776670077937454e-05, 0.00013569360450082387]]} + #*EXTRAS*# Step: 15 Bead: 22 +{"friction": [[0.00013529092745852755, -1.7869656313556854e-05, -1.742850213126348e-05], [-1.7869656313556854e-05, 0.000135420859043026, -1.7731648222905217e-05], [-1.742850213126348e-05, -1.7731648222905217e-05, 0.0001357011520603089]]} + #*EXTRAS*# Step: 16 Bead: 22 +{"friction": [[0.00013529481407190526, -1.7847259301157786e-05, -1.7405460113058365e-05], [-1.7847259301157786e-05, 0.00013542445898536044, -1.770921759333625e-05], [-1.7405460113058365e-05, -1.770921759333625e-05, 0.00013570597949811168]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_23 b/drivers/py/pes/friction/frictionH/060K/inst.raw_23 new file mode 100644 index 000000000..956271864 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_23 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 23 +{"friction": [[0.00012194919365104008, -4.3442200516587006e-05, -4.336434695504495e-05], [-4.3442200516587006e-05, 0.0001219973420398065, -4.3472479799487785e-05], [-4.336434695504495e-05, -4.3472479799487785e-05, 0.00012184015749727416]]} + #*EXTRAS*# Step: 1 Bead: 23 +{"friction": [[0.00012344247165202107, -4.259543523160764e-05, -4.2263448574749006e-05], [-4.259543523160764e-05, 0.00012351061675975453, -4.268858016658597e-05], [-4.2263448574749006e-05, -4.268858016658597e-05, 0.000123238586581904]]} + #*EXTRAS*# Step: 2 Bead: 23 +{"friction": [[0.00012550937283810728, -4.0864911331136064e-05, -4.030907443354633e-05], [-4.0864911331136064e-05, 0.00012557376009170282, -4.096127722178642e-05], [-4.030907443354633e-05, -4.096127722178642e-05, 0.0001251990690468549]]} + #*EXTRAS*# Step: 3 Bead: 23 +{"friction": [[0.00012936102026264154, -3.615921790662068e-05, -3.588306948599871e-05], [-3.615921790662068e-05, 0.00012953491835771648, -3.619291656938274e-05], [-3.588306948599871e-05, -3.619291656938274e-05, 0.00012902107986457372]]} + #*EXTRAS*# Step: 4 Bead: 23 +{"friction": [[0.0001325713399755933, -2.969130280920452e-05, -2.96437358116706e-05], [-2.969130280920452e-05, 0.00013281922767066282, -2.9635535185567243e-05], [-2.96437358116706e-05, -2.9635535185567243e-05, 0.00013242648944586426]]} + #*EXTRAS*# Step: 5 Bead: 23 +{"friction": [[0.0001336892708747946, -2.588654342790826e-05, -2.574287923014827e-05], [-2.588654342790826e-05, 0.0001339160663551512, -2.5790742294514604e-05], [-2.574287923014827e-05, -2.5790742294514604e-05, 0.00013372324054229396]]} + #*EXTRAS*# Step: 6 Bead: 23 +{"friction": [[0.00013428997807481575, -2.323580300454674e-05, -2.2989552108067756e-05], [-2.323580300454674e-05, 0.0001344884336871972, -2.3119463682552122e-05], [-2.2989552108067756e-05, -2.3119463682552122e-05, 0.00013445397504960142]]} + #*EXTRAS*# Step: 7 Bead: 23 +{"friction": [[0.00013454604775190685, -2.1963245492796887e-05, -2.1666070324207658e-05], [-2.1963245492796887e-05, 0.0001347288798037862, -2.1839326729325123e-05], [-2.1666070324207658e-05, -2.1839326729325123e-05, 0.00013477143215949789]]} + #*EXTRAS*# Step: 8 Bead: 23 +{"friction": [[0.0001347154337631298, -2.1077884172622977e-05, -2.0746195674178643e-05], [-2.1077884172622977e-05, 0.00013488697902497946, -2.0949582004102927e-05], [-2.0746195674178643e-05, -2.0949582004102927e-05, 0.00013498266729807968]]} + #*EXTRAS*# Step: 9 Bead: 23 +{"friction": [[0.00013481611865212025, -2.053674053534832e-05, -2.01846246551588e-05], [-2.053674053534832e-05, 0.0001349806653143807, -2.040612110386143e-05], [-2.01846246551588e-05, -2.040612110386143e-05, 0.00013510849536848895]]} + #*EXTRAS*# Step: 10 Bead: 23 +{"friction": [[0.0001348807778884315, -2.0183897772674578e-05, -1.981880815708119e-05], [-2.0183897772674578e-05, 0.0001350407372482183, -2.0051915754899918e-05], [-1.981880815708119e-05, -2.0051915754899918e-05, 0.00013518934935084786]]} + #*EXTRAS*# Step: 11 Bead: 23 +{"friction": [[0.0001349215048814425, -1.9959664346121504e-05, -1.9586489237769978e-05], [-1.9959664346121504e-05, 0.00013507854324242892, -1.9826877338041046e-05], [-1.9586489237769978e-05, -1.9826877338041046e-05, 0.0001352402812115684]]} + #*EXTRAS*# Step: 12 Bead: 23 +{"friction": [[0.00013494755391469843, -1.9815480195861314e-05, -1.9437175958492894e-05], [-1.9815480195861314e-05, 0.000135102712735021, -1.9682200606778163e-05], [-1.9437175958492894e-05, -1.9682200606778163e-05, 0.00013527285504668702]]} + #*EXTRAS*# Step: 13 Bead: 23 +{"friction": [[0.00013496415716432038, -1.9723279488697198e-05, -1.934172518666015e-05], [-1.9723279488697198e-05, 0.00013511811381395722, -1.958969518723911e-05], [-1.934172518666015e-05, -1.958969518723911e-05, 0.0001352936151525363]]} + #*EXTRAS*# Step: 14 Bead: 23 +{"friction": [[0.00013497477286834576, -1.9664209235413694e-05, -1.928058524167134e-05], [-1.9664209235413694e-05, 0.00013512795928148898, -1.9530433927742633e-05], [-1.928058524167134e-05, -1.9530433927742633e-05, 0.00013530688757860477]]} + #*EXTRAS*# Step: 15 Bead: 23 +{"friction": [[0.000134981556516536, -1.9626414162288698e-05, -1.924147112230769e-05], [-1.9626414162288698e-05, 0.00013513425010830033, -1.9492518369358335e-05], [-1.924147112230769e-05, -1.9492518369358335e-05, 0.0001353153684180537]]} + #*EXTRAS*# Step: 16 Bead: 23 +{"friction": [[0.00013498589438579357, -1.960222632853448e-05, -1.9216441287917022e-05], [-1.960222632853448e-05, 0.0001351382725902024, -1.946825413544425e-05], [-1.9216441287917022e-05, -1.946825413544425e-05, 0.00013532079134656762]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_24 b/drivers/py/pes/friction/frictionH/060K/inst.raw_24 new file mode 100644 index 000000000..52f4723db --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_24 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 24 +{"friction": [[0.0001212275207465149, -4.375126119893523e-05, -4.373820812440936e-05], [-4.375126119893523e-05, 0.00012123144588354693, -4.372279618309253e-05], [-4.373820812440936e-05, -4.372279618309253e-05, 0.00012115544091225404]]} + #*EXTRAS*# Step: 1 Bead: 24 +{"friction": [[0.0001225092445451383, -4.31622301792747e-05, -4.2999544165001186e-05], [-4.31622301792747e-05, 0.00012257383392490657, -4.322487922874107e-05], [-4.2999544165001186e-05, -4.322487922874107e-05, 0.00012236610993908312]]} + #*EXTRAS*# Step: 2 Bead: 24 +{"friction": [[0.00012421959614248118, -4.201824699380241e-05, -4.156057578201465e-05], [-4.201824699380241e-05, 0.00012428161237322603, -4.2119519875940854e-05], [-4.156057578201465e-05, -4.2119519875940854e-05, 0.00012396834099875703]]} + #*EXTRAS*# Step: 3 Bead: 24 +{"friction": [[0.0001277364830849899, -3.838854290242978e-05, -3.794007712512542e-05], [-3.838854290242978e-05, 0.0001278550843484508, -3.8454845303128744e-05], [-3.794007712512542e-05, -3.8454845303128744e-05, 0.00012738417166002197]]} + #*EXTRAS*# Step: 4 Bead: 24 +{"friction": [[0.0001315355094443387, -3.2273576088787664e-05, -3.220893847577936e-05], [-3.2273576088787664e-05, 0.00013177392556609088, -3.225110661921095e-05], [-3.220893847577936e-05, -3.225110661921095e-05, 0.00013128911141789795]]} + #*EXTRAS*# Step: 5 Bead: 24 +{"friction": [[0.00013305813843087736, -2.8192774754319324e-05, -2.8119290203796184e-05], [-2.8192774754319324e-05, 0.00013330153102134102, -2.811984047505774e-05], [-2.8119290203796184e-05, -2.811984047505774e-05, 0.00013298118525406424]]} + #*EXTRAS*# Step: 6 Bead: 24 +{"friction": [[0.00013381090181462853, -2.538767459171664e-05, -2.5225777699017188e-05], [-2.538767459171664e-05, 0.00013403295953355918, -2.5287527266207106e-05], [-2.5225777699017188e-05, -2.5287527266207106e-05, 0.00013386935155505091]]} + #*EXTRAS*# Step: 7 Bead: 24 +{"friction": [[0.0001341235421583582, -2.4017603061795224e-05, -2.380265632450398e-05], [-2.4017603061795224e-05, 0.00013433107352519145, -2.3906660775897728e-05], [-2.380265632450398e-05, -2.3906660775897728e-05, 0.00013424932581654057]]} + #*EXTRAS*# Step: 8 Bead: 24 +{"friction": [[0.0001343236190239994, -2.3073378337304825e-05, -2.282059672209276e-05], [-2.3073378337304825e-05, 0.00013452013259552072, -2.295598814215042e-05], [-2.282059672209276e-05, -2.295598814215042e-05, 0.00013449551596238137]]} + #*EXTRAS*# Step: 9 Bead: 24 +{"friction": [[0.00013444127464674107, -2.2493884404135924e-05, -2.2217839625658955e-05], [-2.2493884404135924e-05, 0.00013463072682802222, -2.2372943562996256e-05], [-2.2217839625658955e-05, -2.2372943562996256e-05, 0.00013464121353114902]]} + #*EXTRAS*# Step: 10 Bead: 24 +{"friction": [[0.0001345161360433974, -2.21161076101343e-05, -2.1824994087829502e-05], [-2.21161076101343e-05, 0.00013470088829719938, -2.199301982011484e-05], [-2.1824994087829502e-05, -2.199301982011484e-05, 0.00013473421564159542]]} + #*EXTRAS*# Step: 11 Bead: 24 +{"friction": [[0.00013456307515856528, -2.1875747758977706e-05, -2.1575114133610822e-05], [-2.1875747758977706e-05, 0.00013474480375997569, -2.175136315666072e-05], [-2.1575114133610822e-05, -2.175136315666072e-05, 0.00013479263101094294]]} + #*EXTRAS*# Step: 12 Bead: 24 +{"friction": [[0.00013459299757830956, -2.1721154081994953e-05, -2.1414432057755514e-05], [-2.1721154081994953e-05, 0.0001347727693551652, -2.15959638924929e-05], [-2.1414432057755514e-05, -2.15959638924929e-05, 0.00013482990558293448]]} + #*EXTRAS*# Step: 13 Bead: 24 +{"friction": [[0.0001346120337865254, -2.1622257690092793e-05, -2.1311656847119772e-05], [-2.1622257690092793e-05, 0.0001347905491981536, -2.1496563864720214e-05], [-2.1311656847119772e-05, -2.1496563864720214e-05, 0.0001348536326188236]]} + #*EXTRAS*# Step: 14 Bead: 24 +{"friction": [[0.00013462418942330193, -2.1558887449835894e-05, -2.1245808203806543e-05], [-2.1558887449835894e-05, 0.0001348018980296702, -2.143287571575068e-05], [-2.1245808203806543e-05, -2.143287571575068e-05, 0.0001348687887607984]]} + #*EXTRAS*# Step: 15 Bead: 24 +{"friction": [[0.00013463195109350565, -2.151833516559182e-05, -2.1203672931096517e-05], [-2.151833516559182e-05, 0.00013480914271076885, -2.139212196481093e-05], [-2.1203672931096517e-05, -2.139212196481093e-05, 0.0001348784683438238]]} + #*EXTRAS*# Step: 16 Bead: 24 +{"friction": [[0.00013463691182477878, -2.149238082187886e-05, -2.117670670324929e-05], [-2.149238082187886e-05, 0.00013481377228107368, -2.1366039485759367e-05], [-2.117670670324929e-05, -2.1366039485759367e-05, 0.00013488465567498782]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_25 b/drivers/py/pes/friction/frictionH/060K/inst.raw_25 new file mode 100644 index 000000000..5d6b1eaae --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_25 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 25 +{"friction": [[0.00012044952884396826, -4.403666137295798e-05, -4.402490059939584e-05], [-4.403666137295798e-05, 0.00012037593919233641, -4.3926210514548074e-05], [-4.402490059939584e-05, -4.3926210514548074e-05, 0.00012040610370999929]]} + #*EXTRAS*# Step: 1 Bead: 25 +{"friction": [[0.00012153653681983755, -4.362495949592709e-05, -4.359153976736546e-05], [-4.362495949592709e-05, 0.00012156286703430973, -4.362399569102738e-05], [-4.359153976736546e-05, -4.362399569102738e-05, 0.00012144980712419094]]} + #*EXTRAS*# Step: 2 Bead: 25 +{"friction": [[0.0001230023843048611, -4.287951327063969e-05, -4.262845271196275e-05], [-4.287951327063969e-05, 0.00012307156313931184, -4.296161280073764e-05], [-4.262845271196275e-05, -4.296161280073764e-05, 0.00012282721492859887]]} + #*EXTRAS*# Step: 3 Bead: 25 +{"friction": [[0.00012602369577714053, -4.034615929616824e-05, -3.9792156272290865e-05], [-4.034615929616824e-05, 0.00012609643562764048, -4.043744298933057e-05], [-3.9792156272290865e-05, -4.043744298933057e-05, 0.0001256975402721834]]} + #*EXTRAS*# Step: 4 Bead: 25 +{"friction": [[0.00013016662107639395, -3.487572542694021e-05, -3.46895518602407e-05], [-3.487572542694021e-05, 0.0001303676947248532, -3.4890396426973564e-05], [-3.46895518602407e-05, -3.4890396426973564e-05, 0.000129848568005846]]} + #*EXTRAS*# Step: 5 Bead: 25 +{"friction": [[0.0001322394569582092, -3.0598164498592625e-05, -3.0555118858507354e-05], [-3.0598164498592625e-05, 0.0001324868554692541, -3.055359256548341e-05], [-3.0555118858507354e-05, -3.055359256548341e-05, 0.0001320562214407449]]} + #*EXTRAS*# Step: 6 Bead: 25 +{"friction": [[0.00013321644297450768, -2.765605198415085e-05, -2.756889811727259e-05], [-2.765605198415085e-05, 0.0001334568840023085, -2.7577399272112362e-05], [-2.756889811727259e-05, -2.7577399272112362e-05, 0.00013316479560648034]]} + #*EXTRAS*# Step: 7 Bead: 25 +{"friction": [[0.00013361234079690477, -2.6192503130152418e-05, -2.6059612991407524e-05], [-2.6192503130152418e-05, 0.00013384186886587215, -2.609947540429443e-05], [-2.6059612991407524e-05, -2.609947540429443e-05, 0.0001336313432534449]]} + #*EXTRAS*# Step: 8 Bead: 25 +{"friction": [[0.0001338570523542825, -2.519345045794079e-05, -2.5024263702218505e-05], [-2.519345045794079e-05, 0.00013407717803182094, -2.5091670505977916e-05], [-2.5024263702218505e-05, -2.5091670505977916e-05, 0.00013392504878940623]]} + #*EXTRAS*# Step: 9 Bead: 25 +{"friction": [[0.00013399921338611034, -2.4577789811526045e-05, -2.4384932913257807e-05], [-2.4577789811526045e-05, 0.0001342129236687229, -2.4471057208106958e-05], [-2.4384932913257807e-05, -2.4471057208106958e-05, 0.0001340974862282814]]} + #*EXTRAS*# Step: 10 Bead: 25 +{"friction": [[0.00013408874595886063, -2.4176439392951697e-05, -2.396779636183741e-05], [-2.4176439392951697e-05, 0.00013429805938857637, -2.406666182960466e-05], [-2.396779636183741e-05, -2.406666182960466e-05, 0.00013420673672919246]]} + #*EXTRAS*# Step: 11 Bead: 25 +{"friction": [[0.0001341445873270174, -2.3920761071037604e-05, -2.3701958494061954e-05], [-2.3920761071037604e-05, 0.00013435102120982437, -2.3809119923672093e-05], [-2.3701958494061954e-05, -2.3809119923672093e-05, 0.0001342751183922475]]} + #*EXTRAS*# Step: 12 Bead: 25 +{"friction": [[0.00013418004849309693, -2.375626017091283e-05, -2.3530889599991965e-05], [-2.375626017091283e-05, 0.00013438459986888488, -2.3643451505679738e-05], [-2.3530889599991965e-05, -2.3643451505679738e-05, 0.0001343186359730924]]} + #*EXTRAS*# Step: 13 Bead: 25 +{"friction": [[0.00013420255821544136, -2.365097999729425e-05, -2.3421395803187722e-05], [-2.365097999729425e-05, 0.000134405893166766, -2.3537437100114013e-05], [-2.3421395803187722e-05, -2.3537437100114013e-05, 0.00013434629606047738]]} + #*EXTRAS*# Step: 14 Bead: 25 +{"friction": [[0.00013421691021698085, -2.3583506287114166e-05, -2.3351218164486548e-05], [-2.3583506287114166e-05, 0.00013441946095957042, -2.346949815762897e-05], [-2.3351218164486548e-05, -2.346949815762897e-05, 0.00013436394634996644]]} + #*EXTRAS*# Step: 15 Bead: 25 +{"friction": [[0.0001342260658730024, -2.354032100339811e-05, -2.3306301062616623e-05], [-2.354032100339811e-05, 0.00013442811285161477, -2.342601729999058e-05], [-2.3306301062616623e-05, -2.342601729999058e-05, 0.00013437521190632224]]} + #*EXTRAS*# Step: 16 Bead: 25 +{"friction": [[0.00013423191399738815, -2.351267905872793e-05, -2.3277550168717117e-05], [-2.351267905872793e-05, 0.0001344336377827095, -2.3398187062492438e-05], [-2.3277550168717117e-05, -2.3398187062492438e-05, 0.00013438241006312002]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_26 b/drivers/py/pes/friction/frictionH/060K/inst.raw_26 new file mode 100644 index 000000000..3d5d56cb7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_26 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 26 +{"friction": [[0.00011962164781834676, -4.428729526742142e-05, -4.422423780727485e-05], [-4.428729526742142e-05, 0.00011944812410604063, -4.4082117571065435e-05], [-4.422423780727485e-05, -4.4082117571065435e-05, 0.00011959886778569174]]} + #*EXTRAS*# Step: 1 Bead: 26 +{"friction": [[0.00012047581918875771, -4.402777868222472e-05, -4.4016928730177005e-05], [-4.402777868222472e-05, 0.00012040521060484018, -4.392029012564913e-05], [-4.4016928730177005e-05, -4.392029012564913e-05, 0.00012043159263550454]]} + #*EXTRAS*# Step: 2 Bead: 26 +{"friction": [[0.00012177105383005219, -4.352327908232164e-05, -4.346682783159071e-05], [-4.352327908232164e-05, 0.00012181087804981829, -4.354084631089246e-05], [-4.346682783159071e-05, -4.354084631089246e-05, 0.00012167199812647979]]} + #*EXTRAS*# Step: 3 Bead: 26 +{"friction": [[0.0001243839370599069, -4.188414373516916e-05, -4.140513822437185e-05], [-4.188414373516916e-05, 0.00012444486341466618, -4.1985732601397385e-05], [-4.140513822437185e-05, -4.1985732601397385e-05, 0.000124123607889392]]} + #*EXTRAS*# Step: 4 Bead: 26 +{"friction": [[0.0001285053984151157, -3.7384994647424015e-05, -3.701371310823259e-05], [-3.7384994647424015e-05, 0.0001286496425053405, -3.7436837407600435e-05], [-3.701371310823259e-05, -3.7436837407600435e-05, 0.00012815416822667874]]} + #*EXTRAS*# Step: 5 Bead: 26 +{"friction": [[0.00013115246117307954, -3.3071487635000564e-05, -3.298026587111625e-05], [-3.3071487635000564e-05, 0.00013138232921736616, -3.306010340155387e-05], [-3.298026587111625e-05, -3.306010340155387e-05, 0.0001308804536039917]]} + #*EXTRAS*# Step: 6 Bead: 26 +{"friction": [[0.00013245417768129836, -3.0021174353157708e-05, -2.9976367552237963e-05], [-3.0021174353157708e-05, 0.00013270219862420647, -2.9969411932142155e-05], [-2.9976367552237963e-05, -2.9969411932142155e-05, 0.00013229508539007955]]} + #*EXTRAS*# Step: 7 Bead: 26 +{"friction": [[0.00013297267741268454, -2.847189659807676e-05, -2.84047026966323e-05], [-2.847189659807676e-05, 0.0001332173466168814, -2.8402027839595697e-05], [-2.84047026966323e-05, -2.8402027839595697e-05, 0.00013288274046155922]]} + #*EXTRAS*# Step: 8 Bead: 26 +{"friction": [[0.00013328244370777945, -2.7424418924097923e-05, -2.7330786224643974e-05], [-2.7424418924097923e-05, 0.0001335214222906992, -2.73433711356701e-05], [-2.7330786224643974e-05, -2.73433711356701e-05, 0.0001332418373128221]]} + #*EXTRAS*# Step: 9 Bead: 26 +{"friction": [[0.0001334602352291442, -2.677627353424501e-05, -2.6662899631286075e-05], [-2.677627353424501e-05, 0.00013369457165078155, -2.668876195908431e-05], [-2.6662899631286075e-05, -2.668876195908431e-05, 0.00013345083275211219]]} + #*EXTRAS*# Step: 10 Bead: 26 +{"friction": [[0.0001335710630426156, -2.635367341754933e-05, -2.6226316065560635e-05], [-2.635367341754933e-05, 0.00013380197362180505, -2.626213931985757e-05], [-2.6226316065560635e-05, -2.626213931985757e-05, 0.0001335822008567369]]} + #*EXTRAS*# Step: 11 Bead: 26 +{"friction": [[0.00013363980964140873, -2.608409574216872e-05, -2.5947427277955544e-05], [-2.608409574216872e-05, 0.00013386838537225154, -2.5990076023978284e-05], [-2.5947427277955544e-05, -2.5990076023978284e-05, 0.00013366411012153662]]} + #*EXTRAS*# Step: 12 Bead: 26 +{"friction": [[0.00013368329310827035, -2.5910580684793436e-05, -2.5767775025209228e-05], [-2.5910580684793436e-05, 0.00013391030822681974, -2.5814994485704863e-05], [-2.5767775025209228e-05, -2.5814994485704863e-05, 0.0001337160853591214]]} + #*EXTRAS*# Step: 13 Bead: 26 +{"friction": [[0.00013371083066408774, -2.5799477984744106e-05, -2.5652687746447836e-05], [-2.5799477984744106e-05, 0.00013393682372613708, -2.5702902569321306e-05], [-2.5652687746447836e-05, -2.5702902569321306e-05, 0.00013374906697492502]]} + #*EXTRAS*# Step: 14 Bead: 26 +{"friction": [[0.00013372836053968066, -2.5728256735064985e-05, -2.5578890803771986e-05], [-2.5728256735064985e-05, 0.00013395368931745034, -2.563105288227006e-05], [-2.5578890803771986e-05, -2.563105288227006e-05, 0.000133770089134363]]} + #*EXTRAS*# Step: 15 Bead: 26 +{"friction": [[0.00013373953255663983, -2.5682664552630687e-05, -2.5531641301395925e-05], [-2.5682664552630687e-05, 0.0001339644324246853, -2.5585060744802952e-05], [-2.5531641301395925e-05, -2.5585060744802952e-05, 0.00013378349763865435]]} + #*EXTRAS*# Step: 16 Bead: 26 +{"friction": [[0.00013374666403789774, -2.5653479068278266e-05, -2.5501391491673066e-05], [-2.5653479068278266e-05, 0.00013397128785618215, -2.555562019172331e-05], [-2.5501391491673066e-05, -2.555562019172331e-05, 0.00013379206113878504]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_27 b/drivers/py/pes/friction/frictionH/060K/inst.raw_27 new file mode 100644 index 000000000..5c0aa4ee0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_27 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 27 +{"friction": [[0.00011875913034376447, -4.4483228394450665e-05, -4.434026563858943e-05], [-4.4483228394450665e-05, 0.00011848148125785116, -4.418642315217651e-05], [-4.434026563858943e-05, -4.418642315217651e-05, 0.0001187506872749722]]} + #*EXTRAS*# Step: 1 Bead: 27 +{"friction": [[0.0001193275220035658, -4.436202299442392e-05, -4.4273362244287376e-05], [-4.436202299442392e-05, 0.00011911761394086419, -4.41240760750693e-05], [-4.4273362244287376e-05, -4.41240760750693e-05, 0.0001193102997694]]} + #*EXTRAS*# Step: 2 Bead: 27 +{"friction": [[0.00012042263519450914, -4.4045691087736736e-05, -4.4032942263030244e-05], [-4.4045691087736736e-05, 0.00012034597742111694, -4.3932201964317e-05], [-4.4032942263030244e-05, -4.3932201964317e-05, 0.00012038001933624408]]} + #*EXTRAS*# Step: 3 Bead: 27 +{"friction": [[0.00012287166322537234, -4.2958020423255444e-05, -4.273101607003128e-05], [-4.2958020423255444e-05, 0.00012294034332972038, -4.3035737746281895e-05], [-4.273101607003128e-05, -4.3035737746281895e-05, 0.00012270506554498572]]} + #*EXTRAS*# Step: 4 Bead: 27 +{"friction": [[0.0001266702653750837, -3.9649329739638723e-05, -3.912049138286094e-05], [-3.9649329739638723e-05, 0.00012675770652759537, -3.973249430986833e-05], [-3.912049138286094e-05, -3.973249430986833e-05, 0.00012632959313286818]]} + #*EXTRAS*# Step: 5 Bead: 27 +{"friction": [[0.0001297540192518111, -3.5550819920972944e-05, -3.531909652361076e-05], [-3.5550819920972944e-05, 0.00012994139187567997, -3.5575475367560756e-05], [-3.531909652361076e-05, -3.5575475367560756e-05, 0.0001294232526113186]]} + #*EXTRAS*# Step: 6 Bead: 27 +{"friction": [[0.00013145084672000625, -3.245582648126374e-05, -3.2386052648890345e-05], [-3.245582648126374e-05, 0.00013168755615978095, -3.2435860364011944e-05], [-3.2386052648890345e-05, -3.2435860364011944e-05, 0.00013119832637238836]]} + #*EXTRAS*# Step: 7 Bead: 27 +{"friction": [[0.00013214802975001623, -3.0833661117443215e-05, -3.079011525676546e-05], [-3.0833661117443215e-05, 0.00013239483996974153, -3.079208927121242e-05], [-3.079011525676546e-05, -3.079208927121242e-05, 0.00013195525079814788]]} + #*EXTRAS*# Step: 8 Bead: 27 +{"friction": [[0.00013255191159500539, -2.9746771378047567e-05, -2.9699752160237765e-05], [-2.9746771378047567e-05, 0.00013279984535930747, -2.969167173267517e-05], [-2.9699752160237765e-05, -2.969167173267517e-05, 0.0001324046456583253]]} + #*EXTRAS*# Step: 9 Bead: 27 +{"friction": [[0.0001327812832165919, -2.9071500556477113e-05, -2.9015674147429855e-05], [-2.9071500556477113e-05, 0.00013302804100731147, -2.900842397367403e-05], [-2.9015674147429855e-05, -2.900842397367403e-05, 0.0001326639401069571]]} + #*EXTRAS*# Step: 10 Bead: 27 +{"friction": [[0.0001329229349671334, -2.863105948971545e-05, -2.85671793538337e-05], [-2.863105948971545e-05, 0.0001331682479542353, -2.856296639104107e-05], [-2.85671793538337e-05, -2.856296639104107e-05, 0.00013282565528619647]]} + #*EXTRAS*# Step: 11 Bead: 27 +{"friction": [[0.00013301036686760452, -2.834969391147519e-05, -2.827981918301931e-05], [-2.834969391147519e-05, 0.00013325449988645698, -2.827847540403538e-05], [-2.827981918301931e-05, -2.827847540403538e-05, 0.00013292609816023526]]} + #*EXTRAS*# Step: 12 Bead: 27 +{"friction": [[0.00013306546620426234, -2.8168501687399698e-05, -2.8094442390994245e-05], [-2.8168501687399698e-05, 0.00013330873914765558, -2.809530376269825e-05], [-2.8094442390994245e-05, -2.809530376269825e-05, 0.0001329896482101425]]} + #*EXTRAS*# Step: 13 Bead: 27 +{"friction": [[0.00013310028417274334, -2.8052421655014122e-05, -2.7975554780925855e-05], [-2.8052421655014122e-05, 0.00013334296634619333, -2.797796945882417e-05], [-2.7975554780925855e-05, -2.797796945882417e-05, 0.0001330299076810414]]} + #*EXTRAS*# Step: 14 Bead: 27 +{"friction": [[0.0001331224157106281, -2.7977990557434884e-05, -2.7899273101919326e-05], [-2.7977990557434884e-05, 0.00013336470312359713, -2.7902739835777912e-05], [-2.7899273101919326e-05, -2.7902739835777912e-05, 0.00013305553914640892]]} + #*EXTRAS*# Step: 15 Bead: 27 +{"friction": [[0.0001331365075002417, -2.793033385755404e-05, -2.7850411303995947e-05], [-2.793033385755404e-05, 0.00013337853570907, -2.785457421237243e-05], [-2.7850411303995947e-05, -2.785457421237243e-05, 0.00013307187616588096]]} + #*EXTRAS*# Step: 16 Bead: 27 +{"friction": [[0.00013314549733315804, -2.789982329085089e-05, -2.7819121048130398e-05], [-2.789982329085089e-05, 0.0001333873569787371, -2.7823738792861484e-05], [-2.7819121048130398e-05, -2.7823738792861484e-05, 0.00013308230515647184]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_28 b/drivers/py/pes/friction/frictionH/060K/inst.raw_28 new file mode 100644 index 000000000..bbccac632 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_28 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 28 +{"friction": [[0.00011787887860218989, -4.4603875439562205e-05, -4.437898686966099e-05], [-4.4603875439562205e-05, 0.00011751277754076018, -4.4235677964967273e-05], [-4.437898686966099e-05, -4.4235677964967273e-05, 0.00011788043866959533]]} + #*EXTRAS*# Step: 1 Bead: 28 +{"friction": [[0.00011813070470070375, -4.457834475821074e-05, -4.437540230734559e-05], [-4.457834475821074e-05, 0.00011778703080460533, -4.422741364903215e-05], [-4.437540230734559e-05, -4.422741364903215e-05, 0.00011812972976088878]]} + #*EXTRAS*# Step: 2 Bead: 28 +{"friction": [[0.00011894300132092769, -4.444749524652311e-05, -4.4322467903880206e-05], [-4.444749524652311e-05, 0.00011868668278726409, -4.416891074916062e-05], [-4.4322467903880206e-05, -4.416891074916062e-05, 0.00011893196649687474]]} + #*EXTRAS*# Step: 3 Bead: 28 +{"friction": [[0.00012132841601883246, -4.371089877270033e-05, -4.369251332339663e-05], [-4.371089877270033e-05, 0.00012134024783078066, -4.369179408863733e-05], [-4.369251332339663e-05, -4.369179408863733e-05, 0.00012125176394766864]]} + #*EXTRAS*# Step: 4 Bead: 28 +{"friction": [[0.0001248455065352969, -4.148650901814821e-05, -4.096076150309929e-05], [-4.148650901814821e-05, 0.00012490517198860806, -4.1587203346948567e-05], [-4.096076150309929e-05, -4.1587203346948567e-05, 0.00012456200080670756]]} + #*EXTRAS*# Step: 5 Bead: 28 +{"friction": [[0.00012810090271783315, -3.7923498463932324e-05, -3.751016979993151e-05], [-3.7923498463932324e-05, 0.0001282314412316355, -3.798317253830447e-05], [-3.751016979993151e-05, -3.798317253830447e-05, 0.0001277480888809426]]} + #*EXTRAS*# Step: 6 Bead: 28 +{"friction": [[0.00013014470900049582, -3.49126028318509e-05, -3.472406041183395e-05], [-3.49126028318509e-05, 0.00013034507140026593, -3.492781699614722e-05], [-3.472406041183395e-05, -3.492781699614722e-05, 0.0001298258951253752]]} + #*EXTRAS*# Step: 7 Bead: 28 +{"friction": [[0.00013106318014226658, -3.3248385372432774e-05, -3.314988027217958e-05], [-3.3248385372432774e-05, 0.000131290784649917, -3.323950040320252e-05], [-3.314988027217958e-05, -3.323950040320252e-05, 0.00013078591883416637]]} + #*EXTRAS*# Step: 8 Bead: 28 +{"friction": [[0.00013159884634417025, -3.213482090093772e-05, -3.2073707899698295e-05], [-3.213482090093772e-05, 0.00013183846151753234, -3.2110457560645584e-05], [-3.2073707899698295e-05, -3.2110457560645584e-05, 0.00013135721656993302]]} + #*EXTRAS*# Step: 9 Bead: 28 +{"friction": [[0.00013190196322288911, -3.143956191017395e-05, -3.139113694134558e-05], [-3.143956191017395e-05, 0.0001321462939139898, -3.1405874653996936e-05], [-3.139113694134558e-05, -3.1405874653996936e-05, 0.00013168556319627554]]} + #*EXTRAS*# Step: 10 Bead: 28 +{"friction": [[0.0001320877206626414, -3.098584672313091e-05, -3.094157508022235e-05], [-3.098584672313091e-05, 0.00013233404180755846, -3.094623313654997e-05], [-3.094157508022235e-05, -3.094623313654997e-05, 0.00013188887834846455]]} + #*EXTRAS*# Step: 11 Bead: 28 +{"friction": [[0.00013220192456721958, -3.069554922795803e-05, -3.0652386622206855e-05], [-3.069554922795803e-05, 0.0001324491042187683, -3.065221342677394e-05], [-3.0652386622206855e-05, -3.065221342677394e-05, 0.00013201471944518118]]} + #*EXTRAS*# Step: 12 Bead: 28 +{"friction": [[0.0001322736775728441, -3.050849591429529e-05, -3.046544844430937e-05], [-3.050849591429529e-05, 0.00013252124771713096, -3.046279145507286e-05], [-3.046544844430937e-05, -3.046279145507286e-05, 0.00013209412517286375]]} + #*EXTRAS*# Step: 13 Bead: 28 +{"friction": [[0.00013231893878343633, -3.0388591027140075e-05, -3.0345380591906997e-05], [-3.0388591027140075e-05, 0.0001325666944457183, -3.0341380721745423e-05], [-3.0345380591906997e-05, -3.0341380721745423e-05, 0.00013214435236303477]]} + #*EXTRAS*# Step: 14 Bead: 28 +{"friction": [[0.00013234767297370253, -3.0311684788507026e-05, -3.0268275124770536e-05], [-3.0311684788507026e-05, 0.00013259552156394153, -3.0263513850694503e-05], [-3.0268275124770536e-05, -3.0263513850694503e-05, 0.00013217629573733113]]} + #*EXTRAS*# Step: 15 Bead: 28 +{"friction": [[0.00013236595500697295, -3.0262432131024292e-05, -3.0218856688966543e-05], [-3.0262432131024292e-05, 0.00013261385256296487, -3.0213648134576503e-05], [-3.0218856688966543e-05, -3.0213648134576503e-05, 0.00013219664266735833]]} + #*EXTRAS*# Step: 16 Bead: 28 +{"friction": [[0.0001323776121296924, -3.023089572196217e-05, -3.0187198653826767e-05], [-3.023089572196217e-05, 0.0001326255367529502, -3.0181720072367504e-05], [-3.0187198653826767e-05, -3.0181720072367504e-05, 0.0001322096258448926]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_29 b/drivers/py/pes/friction/frictionH/060K/inst.raw_29 new file mode 100644 index 000000000..9b6fc6b6b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_29 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 29 +{"friction": [[0.0001169988017405095, -4.4628706812311107e-05, -4.434812841942771e-05], [-4.4628706812311107e-05, 0.00011658072617402499, -4.422718506529086e-05], [-4.434812841942771e-05, -4.422718506529086e-05, 0.00011700820795224204]]} + #*EXTRAS*# Step: 1 Bead: 29 +{"friction": [[0.00011692860364519255, -4.46259375021065e-05, -4.434289196062407e-05], [-4.46259375021065e-05, 0.00011650856832696371, -4.422393145283681e-05], [-4.434289196062407e-05, -4.422393145283681e-05, 0.00011693861572399676]]} + #*EXTRAS*# Step: 2 Bead: 29 +{"friction": [[0.00011741109028397437, -4.46302567917649e-05, -4.437074095211232e-05], [-4.46302567917649e-05, 0.00011701155113704522, -4.42385067268331e-05], [-4.437074095211232e-05, -4.42385067268331e-05, 0.00011741693477777579]]} + #*EXTRAS*# Step: 3 Bead: 29 +{"friction": [[0.00011958987907136912, -4.429574361634451e-05, -4.423005127666648e-05], [-4.429574361634451e-05, 0.00011941241292812724, -4.4086976099700915e-05], [-4.423005127666648e-05, -4.4086976099700915e-05, 0.00011956773791920831]]} + #*EXTRAS*# Step: 4 Bead: 29 +{"friction": [[0.0001231804793903084, -4.276826254224514e-05, -4.248423494921946e-05], [-4.276826254224514e-05, 0.00012324967530780533, -4.2855493764435625e-05], [-4.248423494921946e-05, -4.2855493764435625e-05, 0.0001229936287556039]]} + #*EXTRAS*# Step: 5 Bead: 29 +{"friction": [[0.00012631074897209233, -4.004293482285742e-05, -3.94973600091662e-05], [-4.004293482285742e-05, 0.0001263895163315975, -4.0130833179487585e-05], [-3.94973600091662e-05, -4.0130833179487585e-05, 0.00012597743155948622]]} + #*EXTRAS*# Step: 6 Bead: 29 +{"friction": [[0.00012857125803449962, -3.729497263484096e-05, -3.6930776004932744e-05], [-3.729497263484096e-05, 0.00012871776559630644, -3.734549430497054e-05], [-3.6930776004932744e-05, -3.734549430497054e-05, 0.00012822050510570942]]} + #*EXTRAS*# Step: 7 Bead: 29 +{"friction": [[0.0001296870560416613, -3.565674468209571e-05, -3.5417490532921645e-05], [-3.565674468209571e-05, 0.0001298721547498471, -3.5682972825625904e-05], [-3.5417490532921645e-05, -3.5682972825625904e-05, 0.00012935453273480406]]} + #*EXTRAS*# Step: 8 Bead: 29 +{"friction": [[0.00013035793578345487, -3.454847342907612e-05, -3.4382652575311744e-05], [-3.454847342907612e-05, 0.00013056512104841984, -3.45583389134542e-05], [-3.4382652575311744e-05, -3.45583389134542e-05, 0.00013004696109175518]]} + #*EXTRAS*# Step: 9 Bead: 29 +{"friction": [[0.00013074895196810835, -3.3847538320278155e-05, -3.3720891769966095e-05], [-3.3847538320278155e-05, 0.00013096794850799015, -3.384721749129757e-05], [-3.3720891769966095e-05, -3.384721749129757e-05, 0.00013045506714060666]]} + #*EXTRAS*# Step: 10 Bead: 29 +{"friction": [[0.0001309915798528324, -3.338802771436791e-05, -3.328343510278873e-05], [-3.338802771436791e-05, 0.00013121730654528223, -3.3381125461645546e-05], [-3.328343510278873e-05, -3.3381125461645546e-05, 0.00013071028172415318]]} + #*EXTRAS*# Step: 11 Bead: 29 +{"friction": [[0.00013114167698358492, -3.309302305732928e-05, -3.3000940588495514e-05], [-3.309302305732928e-05, 0.00013137127642437864, -3.308194232237275e-05], [-3.3000940588495514e-05, -3.308194232237275e-05, 0.00013086902150523936]]} + #*EXTRAS*# Step: 12 Bead: 29 +{"friction": [[0.0001312361934801847, -3.29026539689337e-05, -3.281792641748531e-05], [-3.29026539689337e-05, 0.00013146809969847564, -3.28888978679011e-05], [-3.281792641748531e-05, -3.28888978679011e-05, 0.00013096934492786113]]} + #*EXTRAS*# Step: 13 Bead: 29 +{"friction": [[0.00013129587871608286, -3.2780495148273824e-05, -3.2700181964125756e-05], [-3.2780495148273824e-05, 0.00013152918407720052, -3.276503138723642e-05], [-3.2700181964125756e-05, -3.276503138723642e-05, 0.00013103285050672828]]} + #*EXTRAS*# Step: 14 Bead: 29 +{"friction": [[0.00013133378456270414, -3.2702099911170686e-05, -3.262449171631374e-05], [-3.2702099911170686e-05, 0.00013156795399800637, -3.2685544119056665e-05], [-3.262449171631374e-05, -3.2685544119056665e-05, 0.00013107324657900575]]} + #*EXTRAS*# Step: 15 Bead: 29 +{"friction": [[0.0001313579064847583, -3.2651874856466496e-05, -3.257594651588804e-05], [-3.2651874856466496e-05, 0.00013159261549442453, -3.263462105099414e-05], [-3.257594651588804e-05, -3.263462105099414e-05, 0.00013109897967601683]]} + #*EXTRAS*# Step: 16 Bead: 29 +{"friction": [[0.00013137328823072003, -3.261970883460103e-05, -3.254483438683766e-05], [-3.261970883460103e-05, 0.00013160833702892388, -3.260200866362256e-05], [-3.254483438683766e-05, -3.260200866362256e-05, 0.00013111539973731335]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_30 b/drivers/py/pes/friction/frictionH/060K/inst.raw_30 new file mode 100644 index 000000000..cb15179e1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_30 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 30 +{"friction": [[0.00011613512964090057, -4.4542480960535e-05, -4.4255686347443705e-05], [-4.4542480960535e-05, 0.00011571790314066553, -4.415921694916118e-05], [-4.4255686347443705e-05, -4.415921694916118e-05, 0.00011615221676811073]]} + #*EXTRAS*# Step: 1 Bead: 30 +{"friction": [[0.00011575897154320233, -4.447060824352395e-05, -4.419592799146512e-05], [-4.447060824352395e-05, 0.00011535746416609618, -4.410997632419228e-05], [-4.419592799146512e-05, -4.410997632419228e-05, 0.00011577956674846523]]} + #*EXTRAS*# Step: 2 Bead: 30 +{"friction": [[0.00011591022236211386, -4.450192388528662e-05, -4.422140801901887e-05], [-4.450192388528662e-05, 0.00011550139345811448, -4.413125099549748e-05], [-4.422140801901887e-05, -4.413125099549748e-05, 0.00011592939462460905]]} + #*EXTRAS*# Step: 3 Bead: 30 +{"friction": [[0.00011772166257957501, -4.461588894119972e-05, -4.4378338351162186e-05], [-4.461588894119972e-05, 0.00011734303438162406, -4.4238456339390354e-05], [-4.4378338351162186e-05, -4.4238456339390354e-05, 0.00011772471239219435]]} + #*EXTRAS*# Step: 4 Bead: 30 +{"friction": [[0.0001215243377015859, -4.363010297646558e-05, -4.359770947492865e-05], [-4.363010297646558e-05, 0.00012154988450304211, -4.362811959777788e-05], [-4.359770947492865e-05, -4.362811959777788e-05, 0.00012143822186902066]]} + #*EXTRAS*# Step: 5 Bead: 30 +{"friction": [[0.00012456234417278531, -4.173403823322342e-05, -4.1234550432460786e-05], [-4.173403823322342e-05, 0.00012462241748754225, -4.183555942797928e-05], [-4.1234550432460786e-05, -4.183555942797928e-05, 0.00012429263525022885]]} + #*EXTRAS*# Step: 6 Bead: 30 +{"friction": [[0.00012682824825785758, -3.9471455772809754e-05, -3.8951878289022816e-05], [-3.9471455772809754e-05, 0.00012691984375003837, -3.955237825505439e-05], [-3.8951878289022816e-05, -3.955237825505439e-05, 0.00012648489811913755]]} + #*EXTRAS*# Step: 7 Bead: 30 +{"friction": [[0.00012807642286260374, -3.7955319539971494e-05, -3.753954005764631e-05], [-3.7955319539971494e-05, 0.00012820614544184922, -3.801545174554209e-05], [-3.753954005764631e-05, -3.801545174554209e-05, 0.00012772358621374394]]} + #*EXTRAS*# Step: 8 Bead: 30 +{"friction": [[0.000128852113824639, -3.690330587616891e-05, -3.6569892456550665e-05], [-3.690330587616891e-05, 0.00012900833620732593, -3.694805159710403e-05], [-3.6569892456550665e-05, -3.694805159710403e-05, 0.00012850410892393754]]} + #*EXTRAS*# Step: 9 Bead: 30 +{"friction": [[0.00012931721638910484, -3.6225124555209584e-05, -3.594401100915313e-05], [-3.6225124555209584e-05, 0.0001294895978219521, -3.625980344545412e-05], [-3.594401100915313e-05, -3.625980344545412e-05, 0.00012897641800064172]]} + #*EXTRAS*# Step: 10 Bead: 30 +{"friction": [[0.0001296105187152246, -3.577664703457526e-05, -3.5528757733220545e-05], [-3.577664703457526e-05, 0.0001297930055272022, -3.5804656652818016e-05], [-3.5528757733220545e-05, -3.5804656652818016e-05, 0.0001292760870351291]]} + #*EXTRAS*# Step: 11 Bead: 30 +{"friction": [[0.0001297941294827854, -3.5486906397888764e-05, -3.525968057820502e-05], [-3.5486906397888764e-05, 0.00012998285858892647, -3.551061350227416e-05], [-3.525968057820502e-05, -3.551061350227416e-05, 0.00012946445460721977]]} + #*EXTRAS*# Step: 12 Bead: 30 +{"friction": [[0.00012991060062556066, -3.5299286950114334e-05, -3.5085051823463605e-05], [-3.5299286950114334e-05, 0.000130103242139112, -3.5320213312376376e-05], [-3.5085051823463605e-05, -3.5320213312376376e-05, 0.00012958426746657558]]} + #*EXTRAS*# Step: 13 Bead: 30 +{"friction": [[0.0001299845171467507, -3.51786088826155e-05, -3.497255400665127e-05], [-3.51786088826155e-05, 0.00013017961878755135, -3.5197749539387014e-05], [-3.497255400665127e-05, -3.5197749539387014e-05, 0.00012966044008057504]]} + #*EXTRAS*# Step: 14 Bead: 30 +{"friction": [[0.00013003160918319376, -3.5101055090425746e-05, -3.4900181311631305e-05], [-3.5101055090425746e-05, 0.00013022826790833012, -3.511904952762073e-05], [-3.4900181311631305e-05, -3.511904952762073e-05, 0.00012970902559057826]]} + #*EXTRAS*# Step: 15 Bead: 30 +{"friction": [[0.00013006163887227976, -3.505132309967148e-05, -3.485373958505037e-05], [-3.505132309967148e-05, 0.00013025928608030045, -3.506858312037787e-05], [-3.485373958505037e-05, -3.506858312037787e-05, 0.00012974003080831178]]} + #*EXTRAS*# Step: 16 Bead: 30 +{"friction": [[0.0001300808129798318, -3.501945459538228e-05, -3.4823966058867656e-05], [-3.501945459538228e-05, 0.0001302790894584044, -3.503624425876368e-05], [-3.4823966058867656e-05, -3.503624425876368e-05, 0.00012975983733100308]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_31 b/drivers/py/pes/friction/frictionH/060K/inst.raw_31 new file mode 100644 index 000000000..718e44b5d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_31 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 31 +{"friction": [[0.00011529316548301044, -4.435439121512612e-05, -4.41050010482841e-05], [-4.435439121512612e-05, 0.00011492181793038626, -4.403170578939231e-05], [-4.41050010482841e-05, -4.403170578939231e-05, 0.00011531825069130156]]} + #*EXTRAS*# Step: 1 Bead: 31 +{"friction": [[0.00011463151720805868, -4.414077344111367e-05, -4.3942771043665696e-05], [-4.414077344111367e-05, 0.00011431917427686955, -4.388629439664982e-05], [-4.3942771043665696e-05, -4.388629439664982e-05, 0.00011466327320499583]]} + #*EXTRAS*# Step: 2 Bead: 31 +{"friction": [[0.00011447483125937992, -4.4082368427699694e-05, -4.3898541438228974e-05], [-4.4082368427699694e-05, 0.00011417857612750851, -4.384577650200786e-05], [-4.3898541438228974e-05, -4.384577650200786e-05, 0.00011450821969368034]]} + #*EXTRAS*# Step: 3 Bead: 31 +{"friction": [[0.00011587507685862038, -4.449493432711425e-05, -4.42156622996814e-05], [-4.449493432711425e-05, 0.00011546783275634489, -4.412648570925547e-05], [-4.42156622996814e-05, -4.412648570925547e-05, 0.00011589457826653105]]} + #*EXTRAS*# Step: 4 Bead: 31 +{"friction": [[0.00011965689825143423, -4.427781598137865e-05, -4.4217639448266493e-05], [-4.427781598137865e-05, 0.00011948774897856446, -4.407663287740825e-05], [-4.4217639448266493e-05, -4.407663287740825e-05, 0.00011963339775328734]]} + #*EXTRAS*# Step: 5 Bead: 31 +{"friction": [[0.0001229554558155162, -4.290800095914028e-05, -4.2665603166535156e-05], [-4.290800095914028e-05, 0.00012302450714339442, -4.298858879630991e-05], [-4.2665603166535156e-05, -4.298858879630991e-05, 0.00012278336601729254]]} + #*EXTRAS*# Step: 6 Bead: 31 +{"friction": [[0.00012507110543021115, -4.128155016028529e-05, -4.074075821614363e-05], [-4.128155016028529e-05, 0.00012513147234981362, -4.1381094907845826e-05], [-4.074075821614363e-05, -4.1381094907845826e-05, 0.0001247776269516911]]} + #*EXTRAS*# Step: 7 Bead: 31 +{"friction": [[0.00012634027613233793, -4.001118922605477e-05, -3.9466743184175846e-05], [-4.001118922605477e-05, 0.00012641971134178854, -4.0098718898431264e-05], [-3.9466743184175846e-05, -4.0098718898431264e-05, 0.0001260062877419076]]} + #*EXTRAS*# Step: 8 Bead: 31 +{"friction": [[0.00012716558596881212, -3.908142566512955e-05, -3.858500669211196e-05], [-3.908142566512955e-05, 0.00012726665108535372, -3.9157250910330746e-05], [-3.858500669211196e-05, -3.9157250910330746e-05, 0.0001268176315619704]]} + #*EXTRAS*# Step: 9 Bead: 31 +{"friction": [[0.00012767631510709806, -3.846357708898833e-05, -3.800961412246017e-05], [-3.846357708898833e-05, 0.0001277929940122162, -3.8530933687846757e-05], [-3.800961412246017e-05, -3.8530933687846757e-05, 0.00012732425870932407]]} + #*EXTRAS*# Step: 10 Bead: 31 +{"friction": [[0.00012800391826177265, -3.804906838500175e-05, -3.762610171551901e-05], [-3.804906838500175e-05, 0.00012813123508466592, -3.8110546720814236e-05], [-3.762610171551901e-05, -3.8110546720814236e-05, 0.00012765106216773518]]} + #*EXTRAS*# Step: 11 Bead: 31 +{"friction": [[0.0001282114584348212, -3.77787156630745e-05, -3.737659971522195e-05], [-3.77787156630745e-05, 0.00012834570335929835, -3.7836298038622585e-05], [-3.737659971522195e-05, -3.7836298038622585e-05, 0.0001278588504093753]]} + #*EXTRAS*# Step: 12 Bead: 31 +{"friction": [[0.0001283440561839969, -3.7602711120388415e-05, -3.721433362718197e-05], [-3.7602711120388415e-05, 0.00012848278842791851, -3.765773618481378e-05], [-3.721433362718197e-05, -3.765773618481378e-05, 0.00012799191893070935]]} + #*EXTRAS*# Step: 13 Bead: 31 +{"friction": [[0.00012842861116504027, -3.748910620892902e-05, -3.710963978946907e-05], [-3.748910620892902e-05, 0.00012857022565674613, -3.75424731287441e-05], [-3.710963978946907e-05, -3.75424731287441e-05, 0.0001280769031312665]]} + #*EXTRAS*# Step: 14 Bead: 31 +{"friction": [[0.00012848264215968805, -3.74159430875871e-05, -3.7042227168662206e-05], [-3.74159430875871e-05, 0.0001286261058405799, -3.746823935370866e-05], [-3.7042227168662206e-05, -3.746823935370866e-05, 0.00012813126157022088]]} + #*EXTRAS*# Step: 15 Bead: 31 +{"friction": [[0.0001285171639429838, -3.736896215164047e-05, -3.699894204757306e-05], [-3.736896215164047e-05, 0.0001286618118733782, -3.7420569840319866e-05], [-3.699894204757306e-05, -3.7420569840319866e-05, 0.00012816601443000185]]} + #*EXTRAS*# Step: 16 Bead: 31 +{"friction": [[0.00012853923347178381, -3.7338830749452425e-05, -3.697118186700052e-05], [-3.7338830749452425e-05, 0.0001286846395383567, -3.738999639779636e-05], [-3.697118186700052e-05, -3.738999639779636e-05, 0.00012818824065970237]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_32 b/drivers/py/pes/friction/frictionH/060K/inst.raw_32 new file mode 100644 index 000000000..be35432fd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_32 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 32 +{"friction": [[0.00011447442737646712, -4.4082214189905e-05, -4.389842451436581e-05], [-4.4082214189905e-05, 0.00011417821453784439, -4.384566898769395e-05], [-4.389842451436581e-05, -4.384566898769395e-05, 0.0001145078200454766]]} + #*EXTRAS*# Step: 1 Bead: 32 +{"friction": [[0.0001135481329710347, -4.368209209846083e-05, -4.3590141079231984e-05], [-4.368209209846083e-05, 0.00011335577591735126, -4.355637430108674e-05], [-4.3590141079231984e-05, -4.355637430108674e-05, 0.00011359161488625723]]} + #*EXTRAS*# Step: 2 Bead: 32 +{"friction": [[0.00011310710831811503, -4.3462412800855617e-05, -4.341459224960964e-05], [-4.3462412800855617e-05, 0.00011296494931577472, -4.338762039848684e-05], [-4.341459224960964e-05, -4.338762039848684e-05, 0.00011315567132622761]]} + #*EXTRAS*# Step: 3 Bead: 32 +{"friction": [[0.000114122877153058, -4.394099795227437e-05, -4.379091941852661e-05], [-4.394099795227437e-05, 0.00011386480169547532, -4.374601601157903e-05], [-4.379091941852661e-05, -4.374601601157903e-05, 0.00011416000910337057]]} + #*EXTRAS*# Step: 4 Bead: 32 +{"friction": [[0.00011763200489681337, -4.4621337869212946e-05, -4.4376997346763915e-05], [-4.4621337869212946e-05, 0.00011724679282003752, -4.423921571673185e-05], [-4.4376997346763915e-05, -4.423921571673185e-05, 0.0001176358788214876]]} + #*EXTRAS*# Step: 5 Bead: 32 +{"friction": [[0.00012132082880657961, -4.3713962128213234e-05, -4.369602309317331e-05], [-4.3713962128213234e-05, 0.00012133208615046775, -4.369416631119117e-05], [-4.369602309317331e-05, -4.369416631119117e-05, 0.00012124452785204513]]} + #*EXTRAS*# Step: 6 Bead: 32 +{"friction": [[0.00012345437106952876, -4.258732409351493e-05, -4.225319488811502e-05], [-4.258732409351493e-05, 0.0001235224450277167, -4.268069432189849e-05], [-4.225319488811502e-05, -4.268069432189849e-05, 0.00012324971993130806]]} + #*EXTRAS*# Step: 7 Bead: 32 +{"friction": [[0.00012464170503096077, -4.166579265106377e-05, -4.115814801075808e-05], [-4.166579265106377e-05, 0.00012470153560971867, -4.1767163340740546e-05], [-4.115814801075808e-05, -4.1767163340740546e-05, 0.00012436799060681683]]} + #*EXTRAS*# Step: 8 Bead: 32 +{"friction": [[0.0001254342205043844, -4.093804231702306e-05, -4.0383586714178126e-05], [-4.093804231702306e-05, 0.0001254976939228206, -4.103503425936176e-05], [-4.0383586714178126e-05, -4.103503425936176e-05, 0.00012512657507825578]]} + #*EXTRAS*# Step: 9 Bead: 32 +{"friction": [[0.0001259455844456809, -4.042697800963286e-05, -3.987153358714144e-05], [-4.042697800963286e-05, 0.0001260168405360671, -4.0519118008059904e-05], [-3.987153358714144e-05, -4.0519118008059904e-05, 0.00012562158184563062]]} + #*EXTRAS*# Step: 10 Bead: 32 +{"friction": [[0.00012628087356355476, -4.007494935818084e-05, -3.952828010700978e-05], [-4.007494935818084e-05, 0.00012635897387442273, -4.016321695775363e-05], [-3.952828010700978e-05, -4.016321695775363e-05, 0.00012594824739011338]]} + #*EXTRAS*# Step: 11 Bead: 32 +{"friction": [[0.00012649635739398886, -3.9841656459958326e-05, -3.930392839382861e-05], [-3.9841656459958326e-05, 0.0001265794593085403, -3.9927176587710945e-05], [-3.930392839382861e-05, -3.9927176587710945e-05, 0.00012615902224894456]]} + #*EXTRAS*# Step: 12 Bead: 32 +{"friction": [[0.00012663520501424768, -3.968839562929149e-05, -3.915765155976088e-05], [-3.968839562929149e-05, 0.00012672175094876083, -3.9772044725396426e-05], [-3.915765155976088e-05, -3.9772044725396426e-05, 0.00012629517256622174]]} + #*EXTRAS*# Step: 13 Bead: 32 +{"friction": [[0.00012672423711283668, -3.9588902280104446e-05, -3.906310552137704e-05], [-3.9588902280104446e-05, 0.00012681307569836883, -3.9671311633625135e-05], [-3.906310552137704e-05, -3.9671311633625135e-05, 0.00012638261234831555]]} + #*EXTRAS*# Step: 14 Bead: 32 +{"friction": [[0.0001267813244081198, -3.95246033561947e-05, -3.900216284258119e-05], [-3.95246033561947e-05, 0.00012687166594302024, -3.9606201714604153e-05], [-3.900216284258119e-05, -3.9606201714604153e-05, 0.00012643873472045246]]} + #*EXTRAS*# Step: 15 Bead: 32 +{"friction": [[0.00012681787984912844, -3.948322242945563e-05, -3.896300434769971e-05], [-3.948322242945563e-05, 0.00012690919684545048, -3.9564294969396635e-05], [-3.896300434769971e-05, -3.9564294969396635e-05, 0.00012647469520752735]]} + #*EXTRAS*# Step: 16 Bead: 32 +{"friction": [[0.00012684128214441426, -3.945664561631158e-05, -3.8937879768652084e-05], [-3.945664561631158e-05, 0.00012693322885614164, -3.953737889211204e-05], [-3.8937879768652084e-05, -3.953737889211204e-05, 0.00012649772600037464]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_33 b/drivers/py/pes/friction/frictionH/060K/inst.raw_33 new file mode 100644 index 000000000..2ebef6afb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_33 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 33 +{"friction": [[0.00011368019507082692, -4.37444711227787e-05, -4.363905558610621e-05], [-4.37444711227787e-05, 0.00011347259446525294, -4.36029403928641e-05], [-4.363905558610621e-05, -4.36029403928641e-05, 0.00011372219122617184]]} + #*EXTRAS*# Step: 1 Bead: 33 +{"friction": [[0.00011250999590699124, -4.314056579971767e-05, -4.314652498694465e-05], [-4.314056579971767e-05, 0.00011243006840844326, -4.312577384337824e-05], [-4.314652498694465e-05, -4.312577384337824e-05, 0.00011256574239802139]]} + #*EXTRAS*# Step: 2 Bead: 33 +{"friction": [[0.00011180733729136013, -4.273377403576957e-05, -4.2785381163104834e-05], [-4.273377403576957e-05, 0.00011178319237034686, -4.276670656431742e-05], [-4.2785381163104834e-05, -4.276670656431742e-05, 0.00011187195283205704]]} + #*EXTRAS*# Step: 3 Bead: 33 +{"friction": [[0.00011246767724056307, -4.311683723856096e-05, -4.3126181821144566e-05], [-4.311683723856096e-05, 0.00011239174134843541, -4.310572436716789e-05], [-4.3126181821144566e-05, -4.310572436716789e-05, 0.0001125239465761736]]} + #*EXTRAS*# Step: 4 Bead: 33 +{"friction": [[0.00011563858439807311, -4.4443402084246115e-05, -4.417423903404308e-05], [-4.4443402084246115e-05, 0.00011524381102366677, -4.409160553321496e-05], [-4.417423903404308e-05, -4.409160553321496e-05, 0.0001156603242930442]]} + #*EXTRAS*# Step: 5 Bead: 33 +{"friction": [[0.00011946692659731267, -4.432758660009099e-05, -4.42513794292664e-05], [-4.432758660009099e-05, 0.00011927421871130171, -4.4105030710393476e-05], [-4.42513794292664e-05, -4.4105030710393476e-05, 0.00011944716789083494]]} + #*EXTRAS*# Step: 6 Bead: 33 +{"friction": [[0.00012187677750786733, -4.347558343989079e-05, -4.340681129822877e-05], [-4.347558343989079e-05, 0.0001219217365920531, -4.350083732150723e-05], [-4.340681129822877e-05, -4.350083732150723e-05, 0.00012177185844485186]]} + #*EXTRAS*# Step: 7 Bead: 33 +{"friction": [[0.0001230810459790566, -4.283099131845855e-05, -4.2565373405784324e-05], [-4.283099131845855e-05, 0.0001231503188052962, -4.291547378564208e-05], [-4.2565373405784324e-05, -4.291547378564208e-05, 0.00012290071368178295]]} + #*EXTRAS*# Step: 8 Bead: 33 +{"friction": [[0.00012382236120977243, -4.2325251150378305e-05, -4.192756636132019e-05], [-4.2325251150378305e-05, 0.0001238876456558462, -4.2423920118493763e-05], [-4.192756636132019e-05, -4.2423920118493763e-05, 0.00012359453909308263]]} + #*EXTRAS*# Step: 9 Bead: 33 +{"friction": [[0.00012429227246151125, -4.195944325882244e-05, -4.149205889134215e-05], [-4.195944325882244e-05, 0.00012435377655076044, -4.206090425235662e-05], [-4.149205889134215e-05, -4.206090425235662e-05, 0.0001240369553433752]]} + #*EXTRAS*# Step: 10 Bead: 33 +{"friction": [[0.00012460200630023667, -4.170004298802925e-05, -4.1196403098802266e-05], [-4.170004298802925e-05, 0.00012466194680187353, -4.180149757641221e-05], [-4.1196403098802266e-05, -4.180149757641221e-05, 0.00012433028237054635]]} + #*EXTRAS*# Step: 11 Bead: 33 +{"friction": [[0.0001248033194611425, -4.1524088093217905e-05, -4.100174360125632e-05], [-4.1524088093217905e-05, 0.00012486296083457198, -4.162495372004358e-05], [-4.100174360125632e-05, -4.162495372004358e-05, 0.00012452178075950362]]} + #*EXTRAS*# Step: 12 Bead: 33 +{"friction": [[0.00012493425339288547, -4.140667760092328e-05, -4.0874373199493426e-05], [-4.140667760092328e-05, 0.00012499407669519099, -4.1506964136666044e-05], [-4.0874373199493426e-05, -4.1506964136666044e-05, 0.00012464671397942732]]} + #*EXTRAS*# Step: 13 Bead: 33 +{"friction": [[0.0001250188150401115, -4.132964666756911e-05, -4.079186563491397e-05], [-4.132964666756911e-05, 0.00012507893060230107, -4.1429490031334466e-05], [-4.079186563491397e-05, -4.1429490031334466e-05, 0.00012472756551744625]]} + #*EXTRAS*# Step: 14 Bead: 33 +{"friction": [[0.00012507329546785498, -4.1279528115967715e-05, -4.0738616190250885e-05], [-4.1279528115967715e-05, 0.0001251336740674384, -4.137905995765245e-05], [-4.0738616190250885e-05, -4.137905995765245e-05, 0.00012477972471041027]]} + #*EXTRAS*# Step: 15 Bead: 33 +{"friction": [[0.0001251082887021211, -4.1247136041264354e-05, -4.070437264215512e-05], [-4.1247136041264354e-05, 0.00012516886627938364, -4.134645737331276e-05], [-4.070437264215512e-05, -4.134645737331276e-05, 0.000124813255088454]]} + #*EXTRAS*# Step: 16 Bead: 33 +{"friction": [[0.00012513073411634388, -4.122627697552909e-05, -4.0682390309088815e-05], [-4.122627697552909e-05, 0.00012519145141838984, -4.13254590643392e-05], [-4.0682390309088815e-05, -4.13254590643392e-05, 0.00012483477362925055]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_34 b/drivers/py/pes/friction/frictionH/060K/inst.raw_34 new file mode 100644 index 000000000..331ad34ec --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_34 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 34 +{"friction": [[0.0001129115705507499, -4.335986330177095e-05, -4.33306885948054e-05], [-4.335986330177095e-05, 0.00011279080035366944, -4.3306160132593466e-05], [-4.33306885948054e-05, -4.3306160132593466e-05, 0.00011296244664467974]]} + #*EXTRAS*# Step: 1 Bead: 34 +{"friction": [[0.00011151765722836434, -4.2558407210384785e-05, -4.262200855089147e-05], [-4.2558407210384785e-05, 0.00011150975006612961, -4.2602649141142284e-05], [-4.262200855089147e-05, -4.2602649141142284e-05, 0.00011158582895218405]]} + #*EXTRAS*# Step: 2 Bead: 34 +{"friction": [[0.00011057367820025296, -4.19532183999747e-05, -4.203170760985738e-05], [-4.19532183999747e-05, 0.00011059517146040529, -4.200708393066487e-05], [-4.203170760985738e-05, -4.200708393066487e-05, 0.00011065024944335155]]} + #*EXTRAS*# Step: 3 Bead: 34 +{"friction": [[0.00011090694041565945, -4.2173023685135434e-05, -4.2250135662324524e-05], [-4.2173023685135434e-05, 0.00011092177597184436, -4.22276123837225e-05], [-4.2250135662324524e-05, -4.22276123837225e-05, 0.00011098134801952008]]} + #*EXTRAS*# Step: 4 Bead: 34 +{"friction": [[0.0001137573229235061, -4.378012991267756e-05, -4.3666851465123504e-05], [-4.378012991267756e-05, 0.00011354082947833922, -4.362930354461434e-05], [-4.3666851465123504e-05, -4.362930354461434e-05, 0.00011379845881205776]]} + #*EXTRAS*# Step: 5 Bead: 34 +{"friction": [[0.00011747661529656782, -4.462829330640185e-05, -4.4373030517934144e-05], [-4.462829330640185e-05, 0.00011708103171046958, -4.4239101948357973e-05], [-4.4373030517934144e-05, -4.4239101948357973e-05, 0.00011748188273735256]]} + #*EXTRAS*# Step: 6 Bead: 34 +{"friction": [[0.00012012772056300088, -4.4140886006680425e-05, -4.4113885223341186e-05], [-4.4140886006680425e-05, 0.00012001637274922009, -4.399370120722718e-05], [-4.4113885223341186e-05, -4.399370120722718e-05, 0.00012009331831320232]]} + #*EXTRAS*# Step: 7 Bead: 34 +{"friction": [[0.00012151123637534083, -4.363561158622147e-05, -4.36043005589357e-05], [-4.363561158622147e-05, 0.00012153593270085727, -4.3632527131394604e-05], [-4.36043005589357e-05, -4.3632527131394604e-05, 0.00012142577667267012]]} + #*EXTRAS*# Step: 8 Bead: 34 +{"friction": [[0.00012229132670658885, -4.327600323560484e-05, -4.3149015218213066e-05], [-4.327600323560484e-05, 0.00012235114744084229, -4.332740801574163e-05], [-4.3149015218213066e-05, -4.332740801574163e-05, 0.00012216187039123941]]} + #*EXTRAS*# Step: 9 Bead: 34 +{"friction": [[0.00012276004715921409, -4.3022985463058543e-05, -4.281626075376298e-05], [-4.3022985463058543e-05, 0.00012282792233844674, -4.309652936091371e-05], [-4.281626075376298e-05, -4.309652936091371e-05, 0.0001226007392740291]]} + #*EXTRAS*# Step: 10 Bead: 34 +{"friction": [[0.00012305904209468547, -4.284466196848289e-05, -4.258311892441312e-05], [-4.284466196848289e-05, 0.0001231283031273061, -4.292849668354219e-05], [-4.258311892441312e-05, -4.292849668354219e-05, 0.00012288015381646666]]} + #*EXTRAS*# Step: 11 Bead: 34 +{"friction": [[0.0001232498499550907, -4.2723570118396216e-05, -4.24267349452701e-05], [-4.2723570118396216e-05, 0.00012331887659546085, -4.2812550265495797e-05], [-4.24267349452701e-05, -4.2812550265495797e-05, 0.00012305846387599735]]} + #*EXTRAS*# Step: 12 Bead: 34 +{"friction": [[0.00012337254242579955, -4.2642641728854974e-05, -4.232332378266544e-05], [-4.2642641728854974e-05, 0.00012344106971552362, -4.273438891280345e-05], [-4.232332378266544e-05, -4.273438891280345e-05, 0.00012317317514245555]]} + #*EXTRAS*# Step: 13 Bead: 34 +{"friction": [[0.00012345124249542804, -4.258945886757766e-05, -4.225589257642031e-05], [-4.258945886757766e-05, 0.0001235193353223871, -4.268277021145665e-05], [-4.225589257642031e-05, -4.268277021145665e-05, 0.00012324679268980733]]} + #*EXTRAS*# Step: 14 Bead: 34 +{"friction": [[0.00012350173427886193, -4.255481348501487e-05, -4.221219917081433e-05], [-4.255481348501487e-05, 0.0001235695091029036, -4.264904502213783e-05], [-4.221219917081433e-05, -4.264904502213783e-05, 0.00012329404252320282]]} + #*EXTRAS*# Step: 15 Bead: 34 +{"friction": [[0.0001235340874641743, -4.253239833781201e-05, -4.2184030430361255e-05], [-4.253239833781201e-05, 0.00012360164440453886, -4.262718617259746e-05], [-4.2184030430361255e-05, -4.262718617259746e-05, 0.00012332432707631264]]} + #*EXTRAS*# Step: 16 Bead: 34 +{"friction": [[0.00012355480932809174, -4.25179531645733e-05, -4.21659196807797e-05], [-4.25179531645733e-05, 0.000123622221447886, -4.261308386919763e-05], [-4.21659196807797e-05, -4.261308386919763e-05, 0.00012334372780919368]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_35 b/drivers/py/pes/friction/frictionH/060K/inst.raw_35 new file mode 100644 index 000000000..b441dfea4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_35 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 35 +{"friction": [[0.00011216920631531552, -4.2946540772708485e-05, -4.2977592964064865e-05], [-4.2946540772708485e-05, 0.00011211926994815254, -4.2958595375337326e-05], [-4.2977592964064865e-05, -4.2958595375337326e-05, 0.0001122292163872923]]} + #*EXTRAS*# Step: 1 Bead: 35 +{"friction": [[0.00011057015670993158, -4.195085838223167e-05, -4.2029341823790465e-05], [-4.195085838223167e-05, 0.00011059170115053509, -4.200469638245758e-05], [-4.2029341823790465e-05, -4.200469638245758e-05, 0.00011064674459340928]]} + #*EXTRAS*# Step: 2 Bead: 35 +{"friction": [[0.00010940174233347514, -4.1121836384169986e-05, -4.117952266456567e-05], [-4.1121836384169986e-05, 0.00010942316879269038, -4.115174410249787e-05], [-4.117952266456567e-05, -4.115174410249787e-05, 0.00010947368459920659]]} + #*EXTRAS*# Step: 3 Bead: 35 +{"friction": [[0.00010943261189348166, -4.1144971472545974e-05, -4.1203597447430455e-05], [-4.1144971472545974e-05, 0.00010945437690505304, -4.117572459510217e-05], [-4.1203597447430455e-05, -4.117572459510217e-05, 0.00010950499715983993]]} + #*EXTRAS*# Step: 4 Bead: 35 +{"friction": [[0.00011198949914361116, -4.2841732516888345e-05, -4.2883791527133844e-05], [-4.2841732516888345e-05, 0.00011195316403229059, -4.28651398578202e-05], [-4.2883791527133844e-05, -4.28651398578202e-05, 0.00011205180007307474]]} + #*EXTRAS*# Step: 5 Bead: 35 +{"friction": [[0.0001155276566558337, -4.441657053733629e-05, -4.4153141526675066e-05], [-4.441657053733629e-05, 0.00011513976467012645, -4.407353880981911e-05], [-4.4153141526675066e-05, -4.407353880981911e-05, 0.00011555046093054683]]} + #*EXTRAS*# Step: 6 Bead: 35 +{"friction": [[0.00011819023895948003, -4.457121541182645e-05, -4.437370388154715e-05], [-4.457121541182645e-05, 0.00011785225155725546, -4.42247765925165e-05], [-4.437370388154715e-05, -4.42247765925165e-05, 0.00011818863281198347]]} + #*EXTRAS*# Step: 7 Bead: 35 +{"friction": [[0.00011974345853640291, -4.425407360770912e-05, -4.420076853583592e-05], [-4.425407360770912e-05, 0.00011958504311819264, -4.4062743986205514e-05], [-4.420076853583592e-05, -4.4062743986205514e-05, 0.00011971813588623074]]} + #*EXTRAS*# Step: 8 Bead: 35 +{"friction": [[0.00012064584181719867, -4.396901917772264e-05, -4.396266857166995e-05], [-4.396901917772264e-05, 0.0001205940314855708, -4.388046600168675e-05], [-4.396266857166995e-05, -4.388046600168675e-05, 0.00012059617737953079]]} + #*EXTRAS*# Step: 9 Bead: 35 +{"friction": [[0.00012117751436886447, -4.377097553710874e-05, -4.376007474097051e-05], [-4.377097553710874e-05, 0.00012117730549984323, -4.373773611637462e-05], [-4.376007474097051e-05, -4.373773611637462e-05, 0.00012110762184072035]]} + #*EXTRAS*# Step: 10 Bead: 35 +{"friction": [[0.0001215056424442684, -4.363795883451625e-05, -4.360710377107234e-05], [-4.363795883451625e-05, 0.00012152997275455754, -4.363440232577509e-05], [-4.360710377107234e-05, -4.363440232577509e-05, 0.00012142046189954146]]} + #*EXTRAS*# Step: 11 Bead: 35 +{"friction": [[0.00012171035539513513, -4.355012504158419e-05, -4.350021993485647e-05], [-4.355012504158419e-05, 0.00012174696898121557, -4.356309151738122e-05], [-4.350021993485647e-05, -4.356309151738122e-05, 0.00012161458272492721]]} + #*EXTRAS*# Step: 12 Bead: 35 +{"friction": [[0.00012184004545863179, -4.3492292262526974e-05, -4.342792987121958e-05], [-4.3492292262526974e-05, 0.00012188328561718875, -4.351492262576895e-05], [-4.342792987121958e-05, -4.351492262576895e-05, 0.00012173718385259607]]} + #*EXTRAS*# Step: 13 Bead: 35 +{"friction": [[0.00012192246399986323, -4.345459171550446e-05, -4.338014903407884e-05], [-4.345459171550446e-05, 0.00012196946573816056, -4.348303873047144e-05], [-4.338014903407884e-05, -4.348303873047144e-05, 0.00012181495673390722]]} + #*EXTRAS*# Step: 14 Bead: 35 +{"friction": [[0.00012197502472240629, -4.343014781409978e-05, -4.334893410736218e-05], [-4.343014781409978e-05, 0.00012202424760156631, -4.3462172590748284e-05], [-4.334893410736218e-05, -4.3462172590748284e-05, 0.00012186450107519755]]} + #*EXTRAS*# Step: 15 Bead: 35 +{"friction": [[0.00012200857595084499, -4.341437687488957e-05, -4.3328706885318586e-05], [-4.341437687488957e-05, 0.00012205914561195342, -4.344863191286281e-05], [-4.3328706885318586e-05, -4.344863191286281e-05, 0.00012189610588990062]]} + #*EXTRAS*# Step: 16 Bead: 35 +{"friction": [[0.00012203001278518469, -4.34042309055869e-05, -4.331566039141969e-05], [-4.34042309055869e-05, 0.00012208141432096457, -4.343988910834879e-05], [-4.331566039141969e-05, -4.343988910834879e-05, 0.00012191629079825389]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_36 b/drivers/py/pes/friction/frictionH/060K/inst.raw_36 new file mode 100644 index 000000000..ad81b03e5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_36 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 36 +{"friction": [[0.00011145322627121049, -4.2518769308164815e-05, -4.2584527045753256e-05], [-4.2518769308164815e-05, 0.00011144842873098494, -4.2564924963892915e-05], [-4.2584527045753256e-05, -4.2564924963892915e-05, 0.00011152215281971272]]} + #*EXTRAS*# Step: 1 Bead: 36 +{"friction": [[0.00010966559906378145, -4.131735318725655e-05, -4.138252285472593e-05], [-4.131735318725655e-05, 0.00010968947931368976, -4.135435050689565e-05], [-4.138252285472593e-05, -4.135435050689565e-05, 0.00010974068343260462]]} + #*EXTRAS*# Step: 2 Bead: 36 +{"friction": [[0.00010828689339154656, -4.0237840940055385e-05, -4.0254733125379006e-05], [-4.0237840940055385e-05, 0.00010829190381642513, -4.024227503398736e-05], [-4.0254733125379006e-05, -4.024227503398736e-05, 0.00010832673557097196]]} + #*EXTRAS*# Step: 3 Bead: 36 +{"friction": [[0.00010803472732303432, -4.0024257852909585e-05, -4.0031359426412444e-05], [-4.0024257852909585e-05, 0.00010803629384306061, -4.0026513221606095e-05], [-4.0031359426412444e-05, -4.0026513221606095e-05, 0.00010806221753441469]]} + #*EXTRAS*# Step: 4 Bead: 36 +{"friction": [[0.00011032997078026068, -4.178799936757539e-05, -4.186515869311822e-05], [-4.178799936757539e-05, 0.00011035413948864857, -4.183910767221489e-05], [-4.186515869311822e-05, -4.183910767221489e-05, 0.00011040733855906848]]} + #*EXTRAS*# Step: 5 Bead: 36 +{"friction": [[0.00011368826567761034, -4.374822944955434e-05, -4.364199072506649e-05], [-4.374822944955434e-05, 0.00011347973379239564, -4.3605727684323016e-05], [-4.364199072506649e-05, -4.3605727684323016e-05, 0.00011373017155881563]]} + #*EXTRAS*# Step: 6 Bead: 36 +{"friction": [[0.00011623555482830233, -4.455823131113455e-05, -4.4269610476642605e-05], [-4.455823131113455e-05, 0.00011581559190113467, -4.417030549148699e-05], [-4.4269610476642605e-05, -4.417030549148699e-05, 0.00011625172257426339]]} + #*EXTRAS*# Step: 7 Bead: 36 +{"friction": [[0.00011782271837924666, -4.460852121293309e-05, -4.437900630789932e-05], [-4.460852121293309e-05, 0.000117452004036985, -4.4236881368582285e-05], [-4.437900630789932e-05, -4.4236881368582285e-05, 0.00011782481777479668]]} + #*EXTRAS*# Step: 8 Bead: 36 +{"friction": [[0.00011879298485089414, -4.447690680741198e-05, -4.433725491481219e-05], [-4.447690680741198e-05, 0.00011851920941980702, -4.418338766201658e-05], [-4.433725491481219e-05, -4.418338766201658e-05, 0.00011878408056711673]]} + #*EXTRAS*# Step: 9 Bead: 36 +{"friction": [[0.00011938572449176385, -4.434786333972444e-05, -4.4264463858600315e-05], [-4.434786333972444e-05, 0.000119182982759469, -4.411630738322281e-05], [-4.4264463858600315e-05, -4.411630738322281e-05, 0.00011936746379674874]]} + #*EXTRAS*# Step: 10 Bead: 36 +{"friction": [[0.00011975893045365748, -4.424976068093299e-05, -4.419765179432589e-05], [-4.424976068093299e-05, 0.00011960243139869854, -4.40601981029783e-05], [-4.419765179432589e-05, -4.40601981029783e-05, 0.00011973327398987868]]} + #*EXTRAS*# Step: 11 Bead: 36 +{"friction": [[0.00011999385168303931, -4.418173846084318e-05, -4.414644315080138e-05], [-4.418173846084318e-05, 0.00011986627075315657, -4.401914511224472e-05], [-4.414644315080138e-05, -4.401914511224472e-05, 0.00011996280653739656]]} + #*EXTRAS*# Step: 12 Bead: 36 +{"friction": [[0.00012014299815472209, -4.413612899446036e-05, -4.41100080608449e-05], [-4.413612899446036e-05, 0.00012003348706705606, -4.39907009240829e-05], [-4.41100080608449e-05, -4.39907009240829e-05, 0.00012010819871109152]]} + #*EXTRAS*# Step: 13 Bead: 36 +{"friction": [[0.000120237805493007, -4.410617918255955e-05, -4.408519016286835e-05], [-4.410617918255955e-05, 0.00012013960625854008, -4.397163391395846e-05], [-4.408519016286835e-05, -4.397163391395846e-05, 0.00012020047415098786]]} + #*EXTRAS*# Step: 14 Bead: 36 +{"friction": [[0.00012029823891646707, -4.4086704944933534e-05, -4.406867775462716e-05], [-4.4086704944933534e-05, 0.0001202071639809128, -4.395907285700918e-05], [-4.406867775462716e-05, -4.395907285700918e-05, 0.0001202592316816196]]} + #*EXTRAS*# Step: 15 Bead: 36 +{"friction": [[0.00012033679683492273, -4.4074125313986054e-05, -4.4057855115324214e-05], [-4.4074125313986054e-05, 0.00012025022814948598, -4.3950891009001604e-05], [-4.4057855115324214e-05, -4.3950891009001604e-05, 0.00012029669432194084]]} + #*EXTRAS*# Step: 16 Bead: 36 +{"friction": [[0.00012036142226497382, -4.406602849599611e-05, -4.4050824498053083e-05], [-4.406602849599611e-05, 0.0001202777144657621, -4.39455967244352e-05], [-4.4050824498053083e-05, -4.39455967244352e-05, 0.00012032060941895086]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_37 b/drivers/py/pes/friction/frictionH/060K/inst.raw_37 new file mode 100644 index 000000000..25aaa0e4a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_37 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 37 +{"friction": [[0.00011076333879039023, -4.207916178846279e-05, -4.2157344930675944e-05], [-4.207916178846279e-05, 0.00011078149553564103, -4.213391549981982e-05], [-4.2157344930675944e-05, -4.213391549981982e-05, 0.0001108388141904826]]} + #*EXTRAS*# Step: 1 Bead: 37 +{"friction": [[0.0001088021687531608, -4.06583725598013e-05, -4.0695265468069316e-05], [-4.06583725598013e-05, 0.00010881522168647921, -4.067247013373706e-05], [-4.0695265468069316e-05, -4.067247013373706e-05, 0.00010886104307971991]]} + #*EXTRAS*# Step: 2 Bead: 37 +{"friction": [[0.00010722598132798967, -3.9303272232117253e-05, -3.9281920204113706e-05], [-3.9303272232117253e-05, 0.00010722150242766024, -3.93140767826227e-05], [-3.9281920204113706e-05, -3.93140767826227e-05, 0.0001071994543809502]]} + #*EXTRAS*# Step: 3 Bead: 37 +{"friction": [[0.0001067098610376435, -3.881285543032877e-05, -3.877627537420546e-05], [-3.881285543032877e-05, 0.00010670493533100018, -3.884000759832139e-05], [-3.877627537420546e-05, -3.884000759832139e-05, 0.00010663922189042249]]} + #*EXTRAS*# Step: 4 Bead: 37 +{"friction": [[0.00010876670474420533, -4.0630100214774646e-05, -4.066565084421107e-05], [-4.0630100214774646e-05, 0.00010877919784707635, -4.064336674173235e-05], [-4.066565084421107e-05, -4.064336674173235e-05, 0.00010882451701432759]]} + #*EXTRAS*# Step: 5 Bead: 37 +{"friction": [[0.00011196057559244039, -4.282470777202282e-05, -4.2868389530377934e-05], [-4.282470777202282e-05, 0.00011192628174474843, -4.284975805202977e-05], [-4.2868389530377934e-05, -4.284975805202977e-05, 0.00011202324565480105]]} + #*EXTRAS*# Step: 6 Bead: 37 +{"friction": [[0.00011437841948471593, -4.4045020199523975e-05, -4.387020325679274e-05], [-4.4045020199523975e-05, 0.00011409237010664695, -4.3819660336443154e-05], [-4.387020325679274e-05, -4.3819660336443154e-05, 0.00011441282274642562]]} + #*EXTRAS*# Step: 7 Bead: 37 +{"friction": [[0.00011591550582657196, -4.4502959517464244e-05, -4.422226264733018e-05], [-4.4502959517464244e-05, 0.00011550644488904984, -4.4131958076703863e-05], [-4.422226264733018e-05, -4.4131958076703863e-05, 0.00011593462868620167]]} + #*EXTRAS*# Step: 8 Bead: 37 +{"friction": [[0.000116871890663005, -4.462314372057326e-05, -4.433837100311939e-05], [-4.462314372057326e-05, 0.00011645054741314328, -4.422101553743704e-05], [-4.433837100311939e-05, -4.422101553743704e-05, 0.00011688239439623363]]} + #*EXTRAS*# Step: 9 Bead: 37 +{"friction": [[0.00011747506157882034, -4.462834660513471e-05, -4.43729804380026e-05], [-4.462834660513471e-05, 0.00011707938124914847, -4.423909160602527e-05], [-4.43729804380026e-05, -4.423909160602527e-05, 0.00011748034276590082]]} + #*EXTRAS*# Step: 10 Bead: 37 +{"friction": [[0.00011786255007506063, -4.460526637433737e-05, -4.437902148032213e-05], [-4.460526637433737e-05, 0.00011749509228808055, -4.423605197705671e-05], [-4.437902148032213e-05, -4.423605197705671e-05, 0.00011786426782669655]]} + #*EXTRAS*# Step: 11 Bead: 37 +{"friction": [[0.00011810987644041805, -4.458074184768974e-05, -4.437591877116652e-05], [-4.458074184768974e-05, 0.00011776424605024036, -4.422827462841242e-05], [-4.437591877116652e-05, -4.422827462841242e-05, 0.00011810911921989247]]} + #*EXTRAS*# Step: 12 Bead: 37 +{"friction": [[0.00011826823259110284, -4.4561259852990046e-05, -4.4370976541909915e-05], [-4.4561259852990046e-05, 0.00011793789829151705, -4.4220927351262865e-05], [-4.4370976541909915e-05, -4.4220927351262865e-05, 0.00011826577856976474]]} + #*EXTRAS*# Step: 13 Bead: 37 +{"friction": [[0.00011836946296301331, -4.454731377315063e-05, -4.43665761093658e-05], [-4.454731377315063e-05, 0.00011804938652313203, -4.421526430091897e-05], [-4.43665761093658e-05, -4.421526430091897e-05, 0.00011836587041163868]]} + #*EXTRAS*# Step: 14 Bead: 37 +{"friction": [[0.0001184342190448293, -4.453779559785145e-05, -4.436324448632558e-05], [-4.453779559785145e-05, 0.00011812088512322747, -4.421124653129016e-05], [-4.436324448632558e-05, -4.421124653129016e-05, 0.00011842987405313274]]} + #*EXTRAS*# Step: 15 Bead: 37 +{"friction": [[0.00011847563022713382, -4.4531467931360934e-05, -4.4360900091661085e-05], [-4.4531467931360934e-05, 0.00011816667797598816, -4.420851547812174e-05], [-4.4360900091661085e-05, -4.420851547812174e-05, 0.00011847079362375006]]} + #*EXTRAS*# Step: 16 Bead: 37 +{"friction": [[0.00011850211658024437, -4.452732313359407e-05, -4.43593124896401e-05], [-4.452732313359407e-05, 0.00011819599434756048, -4.420670253215203e-05], [-4.43593124896401e-05, -4.420670253215203e-05, 0.00011849696113129292]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_38 b/drivers/py/pes/friction/frictionH/060K/inst.raw_38 new file mode 100644 index 000000000..3e246a3dd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_38 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 38 +{"friction": [[0.0001100992324223387, -4.1627963427024275e-05, -4.170223714900381e-05], [-4.1627963427024275e-05, 0.00011012443903750724, -4.167507154046895e-05], [-4.170223714900381e-05, -4.167507154046895e-05, 0.00011017661577495691]]} + #*EXTRAS*# Step: 1 Bead: 38 +{"friction": [[0.00010797822166390719, -3.997568162025075e-05, -3.9980628777077524e-05], [-3.997568162025075e-05, 0.00010797910385895855, -3.9977746366189664e-05], [-3.9980628777077524e-05, -3.9977746366189664e-05, 0.00010800264805168079]]} + #*EXTRAS*# Step: 2 Bead: 38 +{"friction": [[0.00010622859141981498, -3.83324812312236e-05, -3.828398461329088e-05], [-3.83324812312236e-05, 0.00010622472848692704, -3.838058211843928e-05], [-3.828398461329088e-05, -3.838058211843928e-05, 0.00010611191730695247]]} + #*EXTRAS*# Step: 3 Bead: 38 +{"friction": [[0.00010548351053186661, -3.754017780683661e-05, -3.747813392072135e-05], [-3.754017780683661e-05, 0.00010548231634382465, -3.76278886277703e-05], [-3.747813392072135e-05, -3.76278886277703e-05, 0.00010528979557106851]]} + #*EXTRAS*# Step: 4 Bead: 38 +{"friction": [[0.00010728742340338263, -3.936003476884347e-05, -3.934065386538075e-05], [-3.936003476884347e-05, 0.00010728314717599636, -3.936939920149188e-05], [-3.934065386538075e-05, -3.936939920149188e-05, 0.00010726570448785635]]} + #*EXTRAS*# Step: 5 Bead: 38 +{"friction": [[0.00011034097396388683, -4.17955424405184e-05, -4.187280123383222e-05], [-4.17955424405184e-05, 0.00011036505836798214, -4.1846810199531155e-05], [-4.187280123383222e-05, -4.1846810199531155e-05, 0.00011041832215569864]]} + #*EXTRAS*# Step: 6 Bead: 38 +{"friction": [[0.00011262961662263497, -4.32070295902113e-05, -4.3203060223428444e-05], [-4.32070295902113e-05, 0.00011253805115451801, -4.31813679791116e-05], [-4.3203060223428444e-05, -4.31813679791116e-05, 0.00011268389518632202]]} + #*EXTRAS*# Step: 7 Bead: 38 +{"friction": [[0.00011410810425189925, -4.3934766689694895e-05, -4.3786149678760065e-05], [-4.3934766689694895e-05, 0.0001138516801823856, -4.374156047488538e-05], [-4.3786149678760065e-05, -4.374156047488538e-05, 0.00011414539569488173]]} + #*EXTRAS*# Step: 8 Bead: 38 +{"friction": [[0.00011502451382171189, -4.427428583840689e-05, -4.4043871265232925e-05], [-4.427428583840689e-05, 0.00011467514085032939, -4.397760212366534e-05], [-4.4043871265232925e-05, -4.397760212366534e-05, 0.0001150522650271121]]} + #*EXTRAS*# Step: 9 Bead: 38 +{"friction": [[0.00011560384196007536, -4.443517922072682e-05, -4.4167746428913496e-05], [-4.443517922072682e-05, 0.0001152111555195164, -4.408606507923345e-05], [-4.4167746428913496e-05, -4.408606507923345e-05, 0.0001156259142181165]]} + #*EXTRAS*# Step: 10 Bead: 38 +{"friction": [[0.00011597756401372726, -4.451482694870301e-05, -4.423212255570915e-05], [-4.451482694870301e-05, 0.0001155659006518599, -4.4140082017454705e-05], [-4.423212255570915e-05, -4.4140082017454705e-05, 0.00011599610811953288]]} + #*EXTRAS*# Step: 11 Bead: 38 +{"friction": [[0.00011621773787723707, -4.455554432454077e-05, -4.426720201222038e-05], [-4.455554432454077e-05, 0.00011579821331435508, -4.416840070287829e-05], [-4.426720201222038e-05, -4.416840070287829e-05, 0.00011623406821565399]]} + #*EXTRAS*# Step: 12 Bead: 38 +{"friction": [[0.0001163723032315263, -4.4577300928514994e-05, -4.4287211134747264e-05], [-4.4577300928514994e-05, 0.0001159496683780635, -4.418403353514908e-05], [-4.4287211134747264e-05, -4.418403353514908e-05, 0.0001163872304481187]]} + #*EXTRAS*# Step: 13 Bead: 38 +{"friction": [[0.00011647150236981029, -4.4589400500925694e-05, -4.429900388709965e-05], [-4.4589400500925694e-05, 0.0001160477147706412, -4.419301160653321e-05], [-4.429900388709965e-05, -4.419301160653321e-05, 0.00011648553780446082]]} + #*EXTRAS*# Step: 14 Bead: 38 +{"friction": [[0.00011653512716477239, -4.459638669450393e-05, -4.430613850714085e-05], [-4.459638669450393e-05, 0.00011611095741576162, -4.419833961411281e-05], [-4.430613850714085e-05, -4.419833961411281e-05, 0.0001165485941758242]]} + #*EXTRAS*# Step: 15 Bead: 38 +{"friction": [[0.00011657588867293869, -4.460054253623699e-05, -4.431053379630133e-05], [-4.460054253623699e-05, 0.00011615162342234644, -4.420157724561482e-05], [-4.431053379630133e-05, -4.420157724561482e-05, 0.00011658899296846508]]} + #*EXTRAS*# Step: 16 Bead: 38 +{"friction": [[0.00011660199015783915, -4.460307202014005e-05, -4.4313276486872935e-05], [-4.460307202014005e-05, 0.00011617772567912665, -4.420357861220157e-05], [-4.4313276486872935e-05, -4.420357861220157e-05, 0.00011661486278062103]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_39 b/drivers/py/pes/friction/frictionH/060K/inst.raw_39 new file mode 100644 index 000000000..397a8481e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_39 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 39 +{"friction": [[0.00010946055557351727, -4.116585373381819e-05, -4.12253165138265e-05], [-4.116585373381819e-05, 0.00010948261620819361, -4.119736995851763e-05], [-4.12253165138265e-05, -4.119736995851763e-05, 0.0001095333241093075]]} + #*EXTRAS*# Step: 1 Bead: 39 +{"friction": [[0.00010719340598664404, -3.927304106053979e-05, -3.925065727466137e-05], [-3.927304106053979e-05, 0.0001071888340924219, -3.92846561133398e-05], [-3.925065727466137e-05, -3.92846561133398e-05, 0.00010716428848098425]]} + #*EXTRAS*# Step: 2 Bead: 39 +{"friction": [[0.00010530918590558142, -3.734542380005795e-05, -3.7281169032834236e-05], [-3.734542380005795e-05, 0.00010530851926660373, -3.744310660569101e-05], [-3.7281169032834236e-05, -3.744310660569101e-05, 0.00010509697252065629]]} + #*EXTRAS*# Step: 3 Bead: 39 +{"friction": [[0.0001043821854071719, -3.62400394285289e-05, -3.617127184122493e-05], [-3.62400394285289e-05, 0.00010438095010775549, -3.638985100450957e-05], [-3.617127184122493e-05, -3.638985100450957e-05, 0.00010407385820863376]]} + #*EXTRAS*# Step: 4 Bead: 39 +{"friction": [[0.0001059057217959516, -3.799678369009613e-05, -3.7941640642720854e-05], [-3.799678369009613e-05, 0.0001059029928935373, -3.806124133204723e-05], [-3.7941640642720854e-05, -3.806124133204723e-05, 0.0001057562687940198]]} + #*EXTRAS*# Step: 5 Bead: 39 +{"friction": [[0.00010881867855981858, -4.067150106141546e-05, -4.0709015889772977e-05], [-4.067150106141546e-05, 0.000108831991094114, -4.068599176958625e-05], [-4.0709015889772977e-05, -4.068599176958625e-05, 0.00010887803552282529]]} + #*EXTRAS*# Step: 6 Bead: 39 +{"friction": [[0.00011098817269188965, -4.222555879447791e-05, -4.230172887734836e-05], [-4.222555879447791e-05, 0.0001110008089308484, -4.227970638068516e-05], [-4.230172887734836e-05, -4.227970638068516e-05, 0.00011106189594725799]]} + #*EXTRAS*# Step: 7 Bead: 39 +{"friction": [[0.00011240536802410847, -4.308170275724056e-05, -4.3095902280999684e-05], [-4.308170275724056e-05, 0.00011233518087368257, -4.307583901560464e-05], [-4.3095902280999684e-05, -4.307583901560464e-05, 0.0001124624105681048]]} + #*EXTRAS*# Step: 8 Bead: 39 +{"friction": [[0.00011328033011213197, -4.355069718115289e-05, -4.348579396742203e-05], [-4.355069718115289e-05, 0.00011311868387872016, -4.3456355773087645e-05], [-4.348579396742203e-05, -4.3456355773087645e-05, 0.00011332687521725808]]} + #*EXTRAS*# Step: 9 Bead: 39 +{"friction": [[0.00011383398482276485, -4.38149944633401e-05, -4.3693917991270466e-05], [-4.38149944633401e-05, 0.00011360867658996934, -4.365490307081331e-05], [-4.3693917991270466e-05, -4.365490307081331e-05, 0.00011387427103918016]]} + #*EXTRAS*# Step: 10 Bead: 39 +{"friction": [[0.00011419052764438923, -4.396923319718068e-05, -4.381250083623759e-05], [-4.396923319718068e-05, 0.00011392493274756484, -4.376614156051633e-05], [-4.381250083623759e-05, -4.376614156051633e-05, 0.00011422693167507453]]} + #*EXTRAS*# Step: 11 Bead: 39 +{"friction": [[0.00011441967797054733, -4.406113279609225e-05, -4.3882435379757424e-05], [-4.406113279609225e-05, 0.00011412923469623969, -4.3830947567750155e-05], [-4.3882435379757424e-05, -4.3830947567750155e-05, 0.00011445364597360604]]} + #*EXTRAS*# Step: 12 Bead: 39 +{"friction": [[0.00011456708747766047, -4.4117104768345696e-05, -4.392485638537705e-05], [-4.4117104768345696e-05, 0.00011426128023081793, -4.3869920545709195e-05], [-4.392485638537705e-05, -4.3869920545709195e-05, 0.00011459951223104197]]} + #*EXTRAS*# Step: 13 Bead: 39 +{"friction": [[0.00011466168778433507, -4.415168797387245e-05, -4.3951029423535894e-05], [-4.415168797387245e-05, 0.00011434632497052779, -4.389382452846589e-05], [-4.3951029423535894e-05, -4.389382452846589e-05, 0.0001146931318177965]]} + #*EXTRAS*# Step: 14 Bead: 39 +{"friction": [[0.0001147223548302546, -4.417330597662555e-05, -4.3967383991809684e-05], [-4.417330597662555e-05, 0.00011440100170718687, -4.390870213136895e-05], [-4.3967383991809684e-05, -4.390870213136895e-05, 0.00011475317386337059]]} + #*EXTRAS*# Step: 15 Bead: 39 +{"friction": [[0.00011476121959946372, -4.4186922344446486e-05, -4.3977685036565616e-05], [-4.4186922344446486e-05, 0.00011443608870623986, -4.391804838090831e-05], [-4.3977685036565616e-05, -4.391804838090831e-05, 0.00011479163984688846]]} + #*EXTRAS*# Step: 16 Bead: 39 +{"friction": [[0.00011478610531529539, -4.4195545026180146e-05, -4.398420888846979e-05], [-4.4195545026180146e-05, 0.00011445858081007543, -4.392395741939098e-05], [-4.398420888846979e-05, -4.392395741939098e-05, 0.0001148162708692408]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_40 b/drivers/py/pes/friction/frictionH/060K/inst.raw_40 new file mode 100644 index 000000000..e52a73d76 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_40 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 40 +{"friction": [[0.00010884671416050972, -4.069374642795891e-05, -4.0732312774585544e-05], [-4.069374642795891e-05, 0.00010886046575184648, -4.0708913362173936e-05], [-4.0732312774585544e-05, -4.0708913362173936e-05, 0.00010890687369275164]]} + #*EXTRAS*# Step: 1 Bead: 40 +{"friction": [[0.0001064529892925873, -3.855934644154066e-05, -3.851611816113914e-05], [-3.855934644154066e-05, 0.00010644850157988084, -3.859709529171976e-05], [-3.851611816113914e-05, -3.859709529171976e-05, 0.0001063582711399424]]} + #*EXTRAS*# Step: 2 Bead: 40 +{"friction": [[0.00010447704163414807, -3.635908381152948e-05, -3.629015678671782e-05], [-3.635908381152948e-05, 0.00010447626236277206, -3.6503893852748037e-05], [-3.629015678671782e-05, -3.6503893852748037e-05, 0.00010417811657219781]]} + #*EXTRAS*# Step: 3 Bead: 40 +{"friction": [[0.00010342222421027113, -3.494067862820951e-05, -3.488356133008459e-05], [-3.494067862820951e-05, 0.00010340696666247552, -3.5128716617487545e-05], [-3.488356133008459e-05, -3.5128716617487545e-05, 0.00010303231398545244]]} + #*EXTRAS*# Step: 4 Bead: 40 +{"friction": [[0.00010465862479116016, -3.658294386879851e-05, -3.651413503901892e-05], [-3.658294386879851e-05, 0.00010465840390752766, -3.6717850519508874e-05], [-3.651413503901892e-05, -3.6717850519508874e-05, 0.00010437808906171267]]} + #*EXTRAS*# Step: 5 Bead: 40 +{"friction": [[0.00010738192228649618, -3.9446683119442735e-05, -3.943039715577925e-05], [-3.9446683119442735e-05, 0.00010737803025674076, -3.945406491771937e-05], [-3.943039715577925e-05, -3.945406491771937e-05, 0.00010736739284848048]]} + #*EXTRAS*# Step: 6 Bead: 40 +{"friction": [[0.00010944638324781008, -4.1155269899330656e-05, -4.121430993655353e-05], [-4.1155269899330656e-05, 0.00010946829526130616, -4.118639939436827e-05], [-4.121430993655353e-05, -4.118639939436827e-05, 0.00010951895949279956]]} + #*EXTRAS*# Step: 7 Bead: 40 +{"friction": [[0.00011080553420440625, -4.210687425051959e-05, -4.218481976038426e-05], [-4.210687425051959e-05, 0.00011082278841265845, -4.216165807111229e-05], [-4.218481976038426e-05, -4.216165807111229e-05, 0.00011088071574599675]]} + #*EXTRAS*# Step: 8 Bead: 40 +{"friction": [[0.0001116395756547555, -4.263277610466597e-05, -4.269179451311441e-05], [-4.263277610466597e-05, 0.00011162529190943578, -4.267280996639046e-05], [-4.269179451311441e-05, -4.267280996639046e-05, 0.00011170627824325666]]} + #*EXTRAS*# Step: 9 Bead: 40 +{"friction": [[0.00011216748501401423, -4.294554471526128e-05, -4.2976709987115604e-05], [-4.294554471526128e-05, 0.00011211768654139926, -4.2957717600085096e-05], [-4.2976709987115604e-05, -4.2957717600085096e-05, 0.00011222751693184993]]} + #*EXTRAS*# Step: 10 Bead: 40 +{"friction": [[0.00011250674619214634, -4.313874755400084e-05, -4.314496915827705e-05], [-4.313874755400084e-05, 0.000112427127637154, -4.312424130425631e-05], [-4.314496915827705e-05, -4.312424130425631e-05, 0.0001125625327675532]]} + #*EXTRAS*# Step: 11 Bead: 40 +{"friction": [[0.00011272476686995288, -4.325922658917885e-05, -4.3247011997450526e-05], [-4.325922658917885e-05, 0.00011262360141098268, -4.322445733841386e-05], [-4.3247011997450526e-05, -4.322445733841386e-05, 0.00011277788824017996]]} + #*EXTRAS*# Step: 12 Bead: 40 +{"friction": [[0.00011286493953873556, -4.333497794594764e-05, -4.3310123941695696e-05], [-4.333497794594764e-05, 0.00011274914816633021, -4.3286122107271504e-05], [-4.3310123941695696e-05, -4.3286122107271504e-05, 0.00011291637283682106]]} + #*EXTRAS*# Step: 13 Bead: 40 +{"friction": [[0.00011295488251533501, -4.338283209233627e-05, -4.334959746090815e-05], [-4.338283209233627e-05, 0.00011282944242941347, -4.3324560169658516e-05], [-4.334959746090815e-05, -4.3324560169658516e-05, 0.00011300524300262928]]} + #*EXTRAS*# Step: 14 Bead: 40 +{"friction": [[0.0001130125519404606, -4.341319326958024e-05, -4.33744878424448e-05], [-4.341319326958024e-05, 0.00011288083095404138, -4.334874412594497e-05], [-4.33744878424448e-05, -4.334874412594497e-05, 0.0001130622287857531]]} + #*EXTRAS*# Step: 15 Bead: 40 +{"friction": [[0.00011304949336799923, -4.3432506447188e-05, -4.339026023960931e-05], [-4.3432506447188e-05, 0.00011291371395547994, -4.33640469273406e-05], [-4.339026023960931e-05, -4.33640469273406e-05, 0.0001130987340138238]]} + #*EXTRAS*# Step: 16 Bead: 40 +{"friction": [[0.00011307314587264887, -4.344481576736545e-05, -4.340028854369348e-05], [-4.344481576736545e-05, 0.00011293475455543487, -4.3373767657457024e-05], [-4.340028854369348e-05, -4.3373767657457024e-05, 0.00011312210793653401]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_41 b/drivers/py/pes/friction/frictionH/060K/inst.raw_41 new file mode 100644 index 000000000..ef8be5f4a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_41 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 41 +{"friction": [[0.00010825727003808276, -4.0213019041528475e-05, -4.022875126678125e-05], [-4.0213019041528475e-05, 0.00010826184840136975, -4.021709341324004e-05], [-4.022875126678125e-05, -4.021709341324004e-05, 0.00010829577020577766]]} + #*EXTRAS*# Step: 1 Bead: 41 +{"friction": [[0.00010576244829180019, -3.784415088796962e-05, -3.778643010616481e-05], [-3.784415088796962e-05, 0.00010576025688793631, -3.791630905540916e-05], [-3.778643010616481e-05, -3.791630905540916e-05, 0.00010559810766842389]]} + #*EXTRAS*# Step: 2 Bead: 41 +{"friction": [[0.00010373690972140701, -3.53874920437074e-05, -3.532433155323708e-05], [-3.53874920437074e-05, 0.00010372855849355927, -3.556627464511633e-05], [-3.532433155323708e-05, -3.556627464511633e-05, 0.0001033702398576833]]} + #*EXTRAS*# Step: 3 Bead: 41 +{"friction": [[0.00010260692703305216, -3.366471893474104e-05, -3.363511965732257e-05], [-3.366471893474104e-05, 0.00010255924938797093, -3.385215496716889e-05], [-3.363511965732257e-05, -3.385215496716889e-05, 0.00010218376499650189]]} + #*EXTRAS*# Step: 4 Bead: 41 +{"friction": [[0.00010357177601257707, -3.5155860672921846e-05, -3.50955675807967e-05], [-3.5155860672921846e-05, 0.00010356014705772904, -3.534002037040894e-05], [-3.50955675807967e-05, -3.534002037040894e-05, 0.00010319236378584369]]} + #*EXTRAS*# Step: 5 Bead: 41 +{"friction": [[0.00010604060845050878, -3.81383958599492e-05, -3.808589143124808e-05], [-3.81383958599492e-05, 0.00010603738424364503, -3.819583502497252e-05], [-3.808589143124808e-05, -3.819583502497252e-05, 0.00010590499612553794]]} + #*EXTRAS*# Step: 6 Bead: 41 +{"friction": [[0.00010799314680998776, -3.998853798979155e-05, -3.9994052291265675e-05], [-3.998853798979155e-05, 0.00010799420609947005, -3.999064163362388e-05], [-3.9994052291265675e-05, -3.999064163362388e-05, 0.00010801839327319492]]} + #*EXTRAS*# Step: 7 Bead: 41 +{"friction": [[0.00010930064846867448, -4.104558191043698e-05, -4.110008399710328e-05], [-4.104558191043698e-05, 0.00010932088410464479, -4.107271281574979e-05], [-4.110008399710328e-05, -4.107271281574979e-05, 0.00010937099266932653]]} + #*EXTRAS*# Step: 8 Bead: 41 +{"friction": [[0.00011009756399414933, -4.162679320162019e-05, -4.1701040713433146e-05], [-4.162679320162019e-05, 0.00011012277327551824, -4.1673868208897034e-05], [-4.1701040713433146e-05, -4.1673868208897034e-05, 0.00011017494457401959]]} + #*EXTRAS*# Step: 9 Bead: 41 +{"friction": [[0.00011060166944230142, -4.197194926907198e-05, -4.205046978525749e-05], [-4.197194926907198e-05, 0.00011062274225490577, -4.2026019862116116e-05], [-4.205046978525749e-05, -4.2026019862116116e-05, 0.00011067810340821175]]} + #*EXTRAS*# Step: 10 Bead: 41 +{"friction": [[0.00011092460484360461, -4.218448195682597e-05, -4.2261410136464234e-05], [-4.218448195682597e-05, 0.00011093898226179493, -4.223899677857198e-05], [-4.2261410136464234e-05, -4.223899677857198e-05, 0.00011099886832025922]]} + #*EXTRAS*# Step: 11 Bead: 41 +{"friction": [[0.00011113197331631678, -4.2317582064888355e-05, -4.239146554543009e-05], [-4.2317582064888355e-05, 0.00011114012173676864, -4.237028921079027e-05], [-4.239146554543009e-05, -4.237028921079027e-05, 0.00011120435917065584]]} + #*EXTRAS*# Step: 12 Bead: 41 +{"friction": [[0.00011126516936910068, -4.2401724204231824e-05, -4.24727577830298e-05], [-4.2401724204231824e-05, 0.00011126845445297173, -4.245229805255483e-05], [-4.24727577830298e-05, -4.245229805255483e-05, 0.00011133619075373824]]} + #*EXTRAS*# Step: 13 Bead: 41 +{"friction": [[0.00011135060351966278, -4.2455149530904036e-05, -4.252397160150355e-05], [-4.2455149530904036e-05, 0.00011135039714576412, -4.25039268384625e-05], [-4.252397160150355e-05, -4.25039268384625e-05, 0.00011142069512743773]]} + #*EXTRAS*# Step: 14 Bead: 41 +{"friction": [[0.00011140536388070902, -4.2489172336330806e-05, -4.255641532659432e-05], [-4.2489172336330806e-05, 0.00011140276232526135, -4.253661492078083e-05], [-4.255641532659432e-05, -4.253661492078083e-05, 0.00011147483987107472]]} + #*EXTRAS*# Step: 15 Bead: 41 +{"friction": [[0.00011144043602766423, -4.251087286229722e-05, -4.257703717402473e-05], [-4.251087286229722e-05, 0.00011143623476370413, -4.255738354859973e-05], [-4.257703717402473e-05, -4.255738354859973e-05, 0.00011150951038936989]]} + #*EXTRAS*# Step: 16 Bead: 41 +{"friction": [[0.00011146288890995997, -4.252472868856512e-05, -4.259017457187387e-05], [-4.252472868856512e-05, 0.00011145763630833868, -4.257061070720722e-05], [-4.259017457187387e-05, -4.257061070720722e-05, 0.00011153170332934535]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_42 b/drivers/py/pes/friction/frictionH/060K/inst.raw_42 new file mode 100644 index 000000000..5121478a7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_42 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 42 +{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} + #*EXTRAS*# Step: 1 Bead: 42 +{"friction": [[0.00010512525477911151, -3.7135737823050746e-05, -3.7069583722332596e-05], [-3.7135737823050746e-05, 0.00010512500570699283, -3.724403625503903e-05], [-3.7069583722332596e-05, -3.724403625503903e-05, 0.00010489351986399696]]} + #*EXTRAS*# Step: 2 Bead: 42 +{"friction": [[0.00010308970498390537, -3.444189887962235e-05, -3.439401392092446e-05], [-3.444189887962235e-05, 0.00010306373801166513, -3.4634420691001086e-05], [-3.439401392092446e-05, -3.4634420691001086e-05, 0.00010268078163841328]]} + #*EXTRAS*# Step: 3 Bead: 42 +{"friction": [[0.00010190643611943269, -3.242880957354569e-05, -3.243083335772634e-05], [-3.242880957354569e-05, 0.00010182050307135832, -3.258331868672591e-05], [-3.243083335772634e-05, -3.258331868672591e-05, 0.0001014998664790337]]} + #*EXTRAS*# Step: 4 Bead: 42 +{"friction": [[0.00010265544969555167, -3.3745673745378135e-05, -3.371402943050202e-05], [-3.3745673745378135e-05, 0.00010261021964570684, -3.393426439550907e-05], [-3.371402943050202e-05, -3.393426439550907e-05, 0.00010223288988134378]]} + #*EXTRAS*# Step: 5 Bead: 42 +{"friction": [[0.00010482754159787259, -3.678665849557969e-05, -3.6718434435205e-05], [-3.678665849557969e-05, 0.00010482752163159551, -3.691206435794058e-05], [-3.6718434435205e-05, -3.691206435794058e-05, 0.00010456447511975183]]} + #*EXTRAS*# Step: 6 Bead: 42 +{"friction": [[0.00010662474601485302, -3.872957026119587e-05, -3.869071619469362e-05], [-3.872957026119587e-05, 0.00010661992626704087, -3.876007224645631e-05], [-3.869071619469362e-05, -3.876007224645631e-05, 0.00010654626564864374]]} + #*EXTRAS*# Step: 7 Bead: 42 +{"friction": [[0.00010788067319534115, -3.989119898473427e-05, -3.989247790730107e-05], [-3.989119898473427e-05, 0.00010788046772664443, -3.9893219939555594e-05], [-3.989247790730107e-05, -3.9893219939555594e-05, 0.00010789954600711859]]} + #*EXTRAS*# Step: 8 Bead: 42 +{"friction": [[0.00010864482605491693, -4.0532188574956354e-05, -4.056306899693271e-05], [-4.0532188574956354e-05, 0.00010865538210675202, -4.05427541595167e-05], [-4.056306899693271e-05, -4.05427541595167e-05, 0.00010869871970741264]]} + #*EXTRAS*# Step: 9 Bead: 42 +{"friction": [[0.00010912805614874166, -4.091364372109721e-05, -4.0962368097479816e-05], [-4.091364372109721e-05, 0.00010914600808188657, -4.093606875448982e-05], [-4.0962368097479816e-05, -4.093606875448982e-05, 0.00010919512841512947]]} + #*EXTRAS*# Step: 10 Bead: 42 +{"friction": [[0.0001094366330552407, -4.1147979989278066e-05, -4.120672719997032e-05], [-4.1147979989278066e-05, 0.00010945844125144178, -4.1178843066000676e-05], [-4.120672719997032e-05, -4.1178843066000676e-05, 0.00010950907450837129]]} + #*EXTRAS*# Step: 11 Bead: 42 +{"friction": [[0.00010963459640974025, -4.1294640325747335e-05, -4.1358998767564434e-05], [-4.1294640325747335e-05, 0.00010965824398008219, -4.133082701483083e-05], [-4.1358998767564434e-05, -4.133082701483083e-05, 0.0001097093850409799]]} + #*EXTRAS*# Step: 12 Bead: 42 +{"friction": [[0.00010976160254658929, -4.138725284604769e-05, -4.1454808798477465e-05], [-4.138725284604769e-05, 0.00010978609751232352, -4.1426703592978584e-05], [-4.1454808798477465e-05, -4.1426703592978584e-05, 0.00010983748530503766]]} + #*EXTRAS*# Step: 13 Bead: 42 +{"friction": [[0.00010984302270309117, -4.144602480344348e-05, -4.1515448213877815e-05], [-4.144602480344348e-05, 0.00010986790563436933, -4.148747612824945e-05], [-4.1515448213877815e-05, -4.148747612824945e-05, 0.00010991944803329967]]} + #*EXTRAS*# Step: 14 Bead: 42 +{"friction": [[0.00010989518672371805, -4.148343489192419e-05, -4.155397546368845e-05], [-4.148343489192419e-05, 0.00010992024965284082, -4.152612247372378e-05], [-4.155397546368845e-05, -4.152612247372378e-05, 0.00010997189717817723]]} + #*EXTRAS*# Step: 15 Bead: 42 +{"friction": [[0.00010992858778644207, -4.150728954258721e-05, -4.157851178586154e-05], [-4.150728954258721e-05, 0.00010995373659854462, -4.155074804863291e-05], [-4.157851178586154e-05, -4.155074804863291e-05, 0.00011000545589522337]]} + #*EXTRAS*# Step: 16 Bead: 42 +{"friction": [[0.00010994996704775725, -4.1522517817380933e-05, -4.1594162293228696e-05], [-4.1522517817380933e-05, 0.00010997515846926766, -4.156646078191022e-05], [-4.1594162293228696e-05, -4.156646078191022e-05, 0.00011002692604575515]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_43 b/drivers/py/pes/friction/frictionH/060K/inst.raw_43 new file mode 100644 index 000000000..44496073e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_43 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 43 +{"friction": [[0.00010715217792801399, -3.923464312552263e-05, -3.921096682771662e-05], [-3.923464312552263e-05, 0.00010714750227249788, -3.92473297219389e-05], [-3.921096682771662e-05, -3.92473297219389e-05, 0.00010711974146902487]]} + #*EXTRAS*# Step: 1 Bead: 43 +{"friction": [[0.00010454305074822383, -3.644106269991503e-05, -3.637211548779993e-05], [-3.644106269991503e-05, 0.00010454251974005566, -3.658231785418943e-05], [-3.637211548779993e-05, -3.658231785418943e-05, 0.00010425075591069191]]} + #*EXTRAS*# Step: 2 Bead: 43 +{"friction": [[0.00010252745815866934, -3.353077923102774e-05, -3.3504604696066525e-05], [-3.353077923102774e-05, 0.00010247567332776365, -3.371600898606345e-05], [-3.3504604696066525e-05, -3.371600898606345e-05, 0.00010210375207214395]]} + #*EXTRAS*# Step: 3 Bead: 43 +{"friction": [[0.00010128586477060097, -3.124502290066867e-05, -3.127087033212352e-05], [-3.124502290066867e-05, 0.00010117053659333839, -3.134626497387675e-05], [-3.127087033212352e-05, -3.134626497387675e-05, 0.00010094159022058502]]} + #*EXTRAS*# Step: 4 Bead: 43 +{"friction": [[0.0001018772219533189, -3.237472242993008e-05, -3.2378048404515545e-05], [-3.237472242993008e-05, 0.00010178969822026577, -3.252720733188819e-05], [-3.2378048404515545e-05, -3.252720733188819e-05, 0.00010147249633129714]]} + #*EXTRAS*# Step: 5 Bead: 43 +{"friction": [[0.00010376528363084542, -3.542669263365644e-05, -3.536310348320248e-05], [-3.542669263365644e-05, 0.00010375742542476681, -3.560444835897472e-05], [-3.536310348320248e-05, -3.560444835897472e-05, 0.0001034009121849032]]} + #*EXTRAS*# Step: 6 Bead: 43 +{"friction": [[0.00010536908071083201, -3.7412765730816286e-05, -3.734922651303697e-05], [-3.7412765730816286e-05, 0.00010536824484283737, -3.750700779629536e-05], [-3.734922651303697e-05, -3.750700779629536e-05, 0.00010516322809194156]]} + #*EXTRAS*# Step: 7 Bead: 43 +{"friction": [[0.00010654456571406692, -3.865046819832964e-05, -3.860953604032163e-05], [-3.865046819832964e-05, 0.00010653988261999253, -3.868427487339966e-05], [-3.860953604032163e-05, -3.868427487339966e-05, 0.00010645857151382234]]} + #*EXTRAS*# Step: 8 Bead: 43 +{"friction": [[0.0001072726553803448, -3.934642219886736e-05, -3.9326564543261994e-05], [-3.934642219886736e-05, 0.00010726832712766751, -3.935612207760564e-05], [-3.9326564543261994e-05, -3.935612207760564e-05, 0.00010724979026488522]]} + #*EXTRAS*# Step: 9 Bead: 43 +{"friction": [[0.0001077370818054769, -3.9765393695025754e-05, -3.9761408185633054e-05], [-3.9765393695025754e-05, 0.00010773550488568549, -3.976802600199203e-05], [-3.9761408185633054e-05, -3.976802600199203e-05, 0.00010774717108245793]]} + #*EXTRAS*# Step: 10 Bead: 43 +{"friction": [[0.0001080332501436496, -4.00229913243921e-05, -4.003003633534549e-05], [-4.00229913243921e-05, 0.00010803479830441766, -4.002524022521354e-05], [-4.003003633534549e-05, -4.002524022521354e-05, 0.00010806066167116464]]} + #*EXTRAS*# Step: 11 Bead: 43 +{"friction": [[0.00010822310121314715, -4.018429992719905e-05, -4.019869630732803e-05], [-4.018429992719905e-05, 0.00010822718907203007, -4.0187991751868996e-05], [-4.019869630732803e-05, -4.0187991751868996e-05, 0.0001082600180271449]]} + #*EXTRAS*# Step: 12 Bead: 43 +{"friction": [[0.00010834476050372291, -4.028612385237115e-05, -4.0305285116106215e-05], [-4.028612385237115e-05, 0.00010835063132599846, -4.029133292410121e-05], [-4.0305285116106215e-05, -4.029133292410121e-05, 0.00010838714288628579]]} + #*EXTRAS*# Step: 13 Bead: 43 +{"friction": [[0.00010842271133516437, -4.035073748880891e-05, -4.037295716957075e-05], [-4.035073748880891e-05, 0.00010842977021850981, -4.0357133422498276e-05], [-4.037295716957075e-05, -4.0357133422498276e-05, 0.00010846834819175399]]} + #*EXTRAS*# Step: 14 Bead: 43 +{"friction": [[0.00010847262979347391, -4.0391859051456496e-05, -4.0416035130034516e-05], [-4.0391859051456496e-05, 0.00010848046346990081, -4.0399095626228064e-05], [-4.0416035130034516e-05, -4.0399095626228064e-05, 0.00010852025170218044]]} + #*EXTRAS*# Step: 15 Bead: 43 +{"friction": [[0.00010850458502692974, -4.041807849422016e-05, -4.044350492549152e-05], [-4.041807849422016e-05, 0.00010851291917174239, -4.042588427726886e-05], [-4.044350492549152e-05, -4.042588427726886e-05, 0.00010855343770837245]]} + #*EXTRAS*# Step: 16 Bead: 43 +{"friction": [[0.00010852503512470026, -4.043481523591691e-05, -4.046104071154139e-05], [-4.043481523591691e-05, 0.00010853369106173592, -4.0442997504852044e-05], [-4.046104071154139e-05, -4.0442997504852044e-05, 0.00010857465925562761]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_44 b/drivers/py/pes/friction/frictionH/060K/inst.raw_44 new file mode 100644 index 000000000..4d2bca79e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_44 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 44 +{"friction": [[0.00010664017028987908, -3.874471502576407e-05, -3.8706267883039e-05], [-3.874471502576407e-05, 0.00010663532824109419, -3.87745976441682e-05], [-3.8706267883039e-05, -3.87745976441682e-05, 0.00010656312142689027]]} + #*EXTRAS*# Step: 1 Bead: 44 +{"friction": [[0.00010401580066799551, -3.5765637172837496e-05, -3.569902664303221e-05], [-3.5765637172837496e-05, 0.00010401150363935715, -3.5933204405707024e-05], [-3.569902664303221e-05, -3.5933204405707024e-05, 0.00010367292263721634]]} + #*EXTRAS*# Step: 2 Bead: 44 +{"friction": [[0.00010203244773026804, -3.2659936801569464e-05, -3.265625263154466e-05], [-3.2659936801569464e-05, 0.00010195347220665959, -3.282259276303486e-05], [-3.265625263154466e-05, -3.282259276303486e-05, 0.00010161906373979083]]} + #*EXTRAS*# Step: 3 Bead: 44 +{"friction": [[0.0001007193685986567, -3.0121828356291172e-05, -3.0156049379748463e-05], [-3.0121828356291172e-05, 0.00010059299323697395, -3.015866971634974e-05], [-3.0156049379748463e-05, -3.015866971634974e-05, 0.00010047784616868131]]} + #*EXTRAS*# Step: 4 Bead: 44 +{"friction": [[0.0001011911564115652, -3.1059111909536e-05, -3.108750847774247e-05], [-3.1059111909536e-05, 0.0001010726141211161, -3.115048916461377e-05], [-3.108750847774247e-05, -3.115048916461377e-05, 0.00010086090415968688]]} + #*EXTRAS*# Step: 5 Bead: 44 +{"friction": [[0.00010286428343291861, -3.408686211238272e-05, -3.404689674694679e-05], [-3.408686211238272e-05, 0.00010282896792987195, -3.4278768596348275e-05], [-3.404689674694679e-05, -3.4278768596348275e-05, 0.00010244651734377347]]} + #*EXTRAS*# Step: 6 Bead: 44 +{"friction": [[0.00010425314152897805, -3.607566503211241e-05, -3.600737003609811e-05], [-3.607566503211241e-05, 0.0001042510796271058, -3.6232043874797995e-05], [-3.600737003609811e-05, -3.6232043874797995e-05, 0.00010393229537995276]]} + #*EXTRAS*# Step: 7 Bead: 44 +{"friction": [[0.00010532057524236721, -3.7358264208957125e-05, -3.729414190251846e-05], [-3.7358264208957125e-05, 0.00010531987752197044, -3.7455291818281894e-05], [-3.729414190251846e-05, -3.7455291818281894e-05, 0.00010510957155262027]]} + #*EXTRAS*# Step: 8 Bead: 44 +{"friction": [[0.00010599423016176674, -3.808992973610056e-05, -3.803649531452608e-05], [-3.808992973610056e-05, 0.00010599117391760137, -3.814975443479213e-05], [-3.803649531452608e-05, -3.814975443479213e-05, 0.00010585388044321263]]} + #*EXTRAS*# Step: 9 Bead: 44 +{"friction": [[0.0001064308859571348, -3.853722740483751e-05, -3.84934574347232e-05], [-3.853722740483751e-05, 0.00010642645114497857, -3.857595345362364e-05], [-3.84934574347232e-05, -3.857595345362364e-05, 0.00010633404050660571]]} + #*EXTRAS*# Step: 10 Bead: 44 +{"friction": [[0.00010671132023561743, -3.881427715858746e-05, -3.877773669201445e-05], [-3.881427715858746e-05, 0.00010670639308641367, -3.884137336640162e-05], [-3.877773669201445e-05, -3.884137336640162e-05, 0.00010664081425850258]]} + #*EXTRAS*# Step: 11 Bead: 44 +{"friction": [[0.00010689201391623618, -3.8988763413707155e-05, -3.895728019385685e-05], [-3.8988763413707155e-05, 0.00010688701503139892, -3.900933238940677e-05], [-3.895728019385685e-05, -3.900933238940677e-05, 0.00010683765160625773]]} + #*EXTRAS*# Step: 12 Bead: 44 +{"friction": [[0.00010700804418603533, -3.9099191823997367e-05, -3.907111511901329e-05], [-3.9099191823997367e-05, 0.00010700312200996536, -3.911601327351304e-05], [-3.907111511901329e-05, -3.911601327351304e-05, 0.00010696366337719108]]} + #*EXTRAS*# Step: 13 Bead: 44 +{"friction": [[0.00010708248513904225, -3.916938498234261e-05, -3.9143557860862764e-05], [-3.916938498234261e-05, 0.00010707766831867975, -3.918399670005289e-05], [-3.9143557860862764e-05, -3.918399670005289e-05, 0.00010704433827821563]]} + #*EXTRAS*# Step: 14 Bead: 44 +{"friction": [[0.00010713018481130852, -3.9214097013371214e-05, -3.918973733589378e-05], [-3.9214097013371214e-05, 0.00010712546003174798, -3.922737583494331e-05], [-3.918973733589378e-05, -3.922737583494331e-05, 0.00010709595973224419]]} + #*EXTRAS*# Step: 15 Bead: 44 +{"friction": [[0.00010716073160240975, -3.924262221981833e-05, -3.92192128559515e-05], [-3.924262221981833e-05, 0.00010715607621375361, -3.925508233892538e-05], [-3.92192128559515e-05, -3.925508233892538e-05, 0.00010712898739512425]]} + #*EXTRAS*# Step: 16 Bead: 44 +{"friction": [[0.00010718028442916238, -3.92608368417243e-05, -3.923804007465337e-05], [-3.92608368417243e-05, 0.00010717567783990247, -3.927278742423065e-05], [-3.923804007465337e-05, -3.927278742423065e-05, 0.00010715011545478958]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_45 b/drivers/py/pes/friction/frictionH/060K/inst.raw_45 new file mode 100644 index 000000000..4e86cdc1e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_45 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 45 +{"friction": [[0.00010615791386994777, -3.8259948801847704e-05, -3.820990102880373e-05], [-3.8259948801847704e-05, 0.0001061542815691971, -3.831149517488624e-05], [-3.820990102880373e-05, -3.831149517488624e-05, 0.000106034172149726]]} + #*EXTRAS*# Step: 1 Bead: 45 +{"friction": [[0.00010354235205419792, -3.5113942340354194e-05, -3.505422924962381e-05], [-3.5113942340354194e-05, 0.00010353006137209655, -3.529894437889325e-05], [-3.505422924962381e-05, -3.529894437889325e-05, 0.00010316079131783398]]} + #*EXTRAS*# Step: 2 Bead: 45 +{"friction": [[0.00010158990977297511, -3.183349868368006e-05, -3.184890188488018e-05], [-3.183349868368006e-05, 0.00010148756142177106, -3.196344802653723e-05], [-3.184890188488018e-05, -3.196344802653723e-05, 0.00010120888762491]]} + #*EXTRAS*# Step: 3 Bead: 45 +{"friction": [[0.00010018875038753532, -2.906480857843254e-05, -2.9087730765034423e-05], [-2.906480857843254e-05, 0.00010007495713085022, -2.90329353894439e-05], [-2.9087730765034423e-05, -2.90329353894439e-05, 0.00010008454506624207]]} + #*EXTRAS*# Step: 4 Bead: 45 +{"friction": [[0.00010056345598044818, -2.9810340194121033e-05, -2.984343632542387e-05], [-2.9810340194121033e-05, 0.00010043813945351654, -2.9827580530622198e-05], [-2.984343632542387e-05, -2.9827580530622198e-05, 0.00010035821848160144]]} + #*EXTRAS*# Step: 5 Bead: 45 +{"friction": [[0.00010210335332488943, -3.278838636502624e-05, -3.2781448099931364e-05], [-3.278838636502624e-05, 0.00010202833385707311, -3.295520415596575e-05], [-3.2781448099931364e-05, -3.295520415596575e-05, 0.00010168692594433275]]} + #*EXTRAS*# Step: 6 Bead: 45 +{"friction": [[0.00010329218497155537, -3.474909417223701e-05, -3.469521898716443e-05], [-3.474909417223701e-05, 0.0001032731977375933, -3.493961903860623e-05], [-3.469521898716443e-05, -3.493961903860623e-05, 0.00010289406993994924]]} + #*EXTRAS*# Step: 7 Bead: 45 +{"friction": [[0.00010423354886509322, -3.605045682101098e-05, -3.5982260127764844e-05], [-3.605045682101098e-05, 0.00010423133906345728, -3.620780585065814e-05], [-3.5982260127764844e-05, -3.620780585065814e-05, 0.0001039108323727449]]} + #*EXTRAS*# Step: 8 Bead: 45 +{"friction": [[0.00010483908489127552, -3.680042620323891e-05, -3.673225815676051e-05], [-3.680042620323891e-05, 0.00010483906886802344, -3.6925175375952574e-05], [-3.673225815676051e-05, -3.6925175375952574e-05, 0.00010457722230730651]]} + #*EXTRAS*# Step: 9 Bead: 45 +{"friction": [[0.00010523795215181045, -3.726473786750674e-05, -3.719969350865754e-05], [-3.726473786750674e-05, 0.00010523746707756129, -3.736652614721553e-05], [-3.719969350865754e-05, -3.736652614721553e-05, 0.0001050181732771548]]} + #*EXTRAS*# Step: 10 Bead: 45 +{"friction": [[0.00010549588701365738, -3.7553861896376296e-05, -3.749198966564414e-05], [-3.7553861896376296e-05, 0.00010549465173017284, -3.7640870454003506e-05], [-3.749198966564414e-05, -3.7640870454003506e-05, 0.00010530348288856685]]} + #*EXTRAS*# Step: 11 Bead: 45 +{"friction": [[0.00010566300454966081, -3.77368330641816e-05, -3.767746352403932e-05], [-3.77368330641816e-05, 0.00010566118173486096, -3.781446206860914e-05], [-3.767746352403932e-05, -3.781446206860914e-05, 0.0001054882399366176]]} + #*EXTRAS*# Step: 12 Bead: 45 +{"friction": [[0.00010577062338650553, -3.785292258213887e-05, -3.779534251587365e-05], [-3.785292258213887e-05, 0.00010576840136734514, -3.7924635294822145e-05], [-3.779534251587365e-05, -3.7924635294822145e-05, 0.0001056071366862492]]} + #*EXTRAS*# Step: 13 Bead: 45 +{"friction": [[0.00010583981063831308, -3.792685434052792e-05, -3.787049620061222e-05], [-3.792685434052792e-05, 0.00010583732881175195, -3.799482561345527e-05], [-3.787049620061222e-05, -3.799482561345527e-05, 0.00010568353015737393]]} + #*EXTRAS*# Step: 14 Bead: 45 +{"friction": [[0.00010588419671747183, -3.797399975994023e-05, -3.791845446565284e-05], [-3.797399975994023e-05, 0.00010588154832309794, -3.8039599168880295e-05], [-3.791845446565284e-05, -3.8039599168880295e-05, 0.00010573251830536752]]} + #*EXTRAS*# Step: 15 Bead: 45 +{"friction": [[0.00010591264448771072, -3.80041002905466e-05, -3.7949087721920757e-05], [-3.80041002905466e-05, 0.00010590988974815205, -3.806819193957951e-05], [-3.7949087721920757e-05, -3.806819193957951e-05, 0.00010576390628262574]]} + #*EXTRAS*# Step: 16 Bead: 45 +{"friction": [[0.00010593086271246113, -3.802332976375978e-05, -3.796866314843513e-05], [-3.802332976375978e-05, 0.00010592804013250864, -3.8086461111016226e-05], [-3.796866314843513e-05, -3.8086461111016226e-05, 0.0001057840034278351]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_46 b/drivers/py/pes/friction/frictionH/060K/inst.raw_46 new file mode 100644 index 000000000..1a0887ef8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_46 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 46 +{"friction": [[0.00010570677276922272, -3.778420803142114e-05, -3.7725549753719546e-05], [-3.778420803142114e-05, 0.0001057047887977086, -3.7859417660977375e-05], [-3.7725549753719546e-05, -3.7859417660977375e-05, 0.00010553660403377729]]} + #*EXTRAS*# Step: 1 Bead: 46 +{"friction": [[0.00010312068182388208, -3.448961136841816e-05, -3.444073715784168e-05], [-3.448961136841816e-05, 0.0001030958742800372, -3.468198192095972e-05], [-3.444073715784168e-05, -3.468198192095972e-05, 0.00010271324538096658]]} + #*EXTRAS*# Step: 2 Bead: 46 +{"friction": [[0.00010118870594557712, -3.105428811993952e-05, -3.108274541285152e-05], [-3.105428811993952e-05, 0.00010107008668698186, -3.114540474587346e-05], [-3.108274541285152e-05, -3.114540474587346e-05, 0.00010085883309608546]]} + #*EXTRAS*# Step: 3 Bead: 46 +{"friction": [[9.968233045865866e-05, -2.80771184889227e-05, -2.8067641990699267e-05], [-2.80771184889227e-05, 9.960661181690746e-05, -2.797709423026835e-05], [-2.8067641990699267e-05, -2.797709423026835e-05, 9.974359299421726e-05]]} + #*EXTRAS*# Step: 4 Bead: 46 +{"friction": [[9.99707557669177e-05, -2.8636054547941205e-05, -2.8647743653415935e-05], [-2.8636054547941205e-05, 9.987007008668562e-05, -2.8574889668780047e-05], [-2.8647743653415935e-05, -2.8574889668780047e-05, 9.993393659420326e-05]]} + #*EXTRAS*# Step: 5 Bead: 46 +{"friction": [[0.00010144063187069611, -3.1546332675361663e-05, -3.156724661264432e-05], [-3.1546332675361663e-05, 0.00010133146204474885, -3.166277638729108e-05], [-3.156724661264432e-05, -3.166277638729108e-05, 0.00010107610013894785]]} + #*EXTRAS*# Step: 6 Bead: 46 +{"friction": [[0.00010248419750378064, -3.345716411469634e-05, -3.3432888834879214e-05], [-3.345716411469634e-05, 0.0001024301307513911, -3.3641027859179616e-05], [-3.3432888834879214e-05, -3.3641027859179616e-05, 0.0001020604329771546]]} + #*EXTRAS*# Step: 7 Bead: 46 +{"friction": [[0.00010329714723657551, -3.475648491672512e-05, -3.470247742075372e-05], [-3.475648491672512e-05, 0.00010327831287759902, -3.494693137309133e-05], [-3.470247742075372e-05, -3.494693137309133e-05, 0.0001028993281705598]]} + #*EXTRAS*# Step: 8 Bead: 46 +{"friction": [[0.00010382635102082632, -3.551048701421213e-05, -3.5446036589264305e-05], [-3.551048701421213e-05, 0.00010381948879483968, -3.568593893862973e-05], [-3.5446036589264305e-05, -3.568593893862973e-05, 0.00010346702609829425]]} + #*EXTRAS*# Step: 9 Bead: 46 +{"friction": [[0.00010418086841561535, -3.59823408719403e-05, -3.591444408854958e-05], [-3.59823408719403e-05, 0.00010417822984372442, -3.614225991259169e-05], [-3.591444408854958e-05, -3.614225991259169e-05, 0.00010385316609913986]]} + #*EXTRAS*# Step: 10 Bead: 46 +{"friction": [[0.00010441175575530671, -3.6277309248118946e-05, -3.62084751995981e-05], [-3.6277309248118946e-05, 0.0001044106757169697, -3.642557619933238e-05], [-3.62084751995981e-05, -3.642557619933238e-05, 0.0001041063426659083]]} + #*EXTRAS*# Step: 11 Bead: 46 +{"friction": [[0.00010456219513787276, -3.6464708935239637e-05, -3.6395769512193725e-05], [-3.6464708935239637e-05, 0.00010456172614029575, -3.6604922819226556e-05], [-3.6395769512193725e-05, -3.6604922819226556e-05, 0.00010427183551520427]]} + #*EXTRAS*# Step: 12 Bead: 46 +{"friction": [[0.00010465935201701016, -3.6583830088930845e-05, -3.651502281566863e-05], [-3.6583830088930845e-05, 0.00010465913261351188, -3.6718696350295903e-05], [-3.651502281566863e-05, -3.6718696350295903e-05, 0.00010437889082790067]]} + #*EXTRAS*# Step: 13 Bead: 46 +{"friction": [[0.00010472194341555205, -3.66598052225658e-05, -3.659116341596077e-05], [-3.66598052225658e-05, 0.00010472183069211772, -3.6791177087529916e-05], [-3.659116341596077e-05, -3.6791177087529916e-05, 0.00010444792095636778]]} + #*EXTRAS*# Step: 14 Bead: 46 +{"friction": [[0.00010476214583505724, -3.670829375493973e-05, -3.6639790702226404e-05], [-3.670829375493973e-05, 0.00010476208083853802, -3.6837403793541606e-05], [-3.6639790702226404e-05, -3.6837403793541606e-05, 0.00010449228158515653]]} + #*EXTRAS*# Step: 15 Bead: 46 +{"friction": [[0.0001047879330882239, -3.6739269910907394e-05, -3.667086904645554e-05], [-3.6739269910907394e-05, 0.00010478789054841851, -3.686692275226453e-05], [-3.667086904645554e-05, -3.686692275226453e-05, 0.00010452074461239907]]} + #*EXTRAS*# Step: 16 Bead: 46 +{"friction": [[0.00010480445560189681, -3.675906570134224e-05, -3.6690735680612935e-05], [-3.675906570134224e-05, 0.0001048044242047548, -3.688578246046996e-05], [-3.6690735680612935e-05, -3.688578246046996e-05, 0.0001045389848744415]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_47 b/drivers/py/pes/friction/frictionH/060K/inst.raw_47 new file mode 100644 index 000000000..0c9897a5f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_47 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 47 +{"friction": [[0.00010528762108165504, -3.73210662070218e-05, -3.725656530783905e-05], [-3.73210662070218e-05, 0.0001052870117955876, -3.741999059478165e-05], [-3.725656530783905e-05, -3.741999059478165e-05, 0.00010507311718896647]]} + #*EXTRAS*# Step: 1 Bead: 47 +{"friction": [[0.00010274627639563953, -3.389551065734809e-05, -3.3860145084141096e-05], [-3.389551065734809e-05, 0.00010270548969082022, -3.408587195571511e-05], [-3.3860145084141096e-05, -3.408587195571511e-05, 0.00010232537340242907]]} + #*EXTRAS*# Step: 2 Bead: 47 +{"friction": [[0.00010082068108630414, -3.032409503989544e-05, -3.035816602401009e-05], [-3.032409503989544e-05, 0.00010069467353867162, -3.037330952175579e-05], [-3.035816602401009e-05, -3.037330952175579e-05, 0.0001005574317751368]]} + #*EXTRAS*# Step: 3 Bead: 47 +{"friction": [[9.920504068560729e-05, -2.7156468071478975e-05, -2.7098878774828026e-05], [-2.7156468071478975e-05, 9.918686903680222e-05, -2.6992935136534412e-05], [-2.7098878774828026e-05, -2.6992935136534412e-05, 9.944576956092008e-05]]} + #*EXTRAS*# Step: 4 Bead: 47 +{"friction": [[9.940277498268246e-05, -2.7539329161750653e-05, -2.7503362054672305e-05], [-2.7539329161750653e-05, 9.93586132212277e-05, -2.74019193440054e-05], [-2.7503362054672305e-05, -2.74019193440054e-05, 9.956703224640248e-05]]} + #*EXTRAS*# Step: 5 Bead: 47 +{"friction": [[0.00010084439524941145, -3.0371395580612684e-05, -3.0405336869925727e-05], [-3.0371395580612684e-05, 0.00010071858696790643, -3.0423459846632693e-05], [-3.0405336869925727e-05, -3.0423459846632693e-05, 0.00010057627179970382]]} + #*EXTRAS*# Step: 6 Bead: 47 +{"friction": [[0.00010179269519783546, -3.221720579593893e-05, -3.2224237484325155e-05], [-3.221720579593893e-05, 0.00010170063727123359, -3.236355131338419e-05], [-3.2224237484325155e-05, -3.236355131338419e-05, 0.00010139388097483068]]} + #*EXTRAS*# Step: 7 Bead: 47 +{"friction": [[0.00010250897479811667, -3.349938703688066e-05, -3.347402118425864e-05], [-3.349938703688066e-05, 0.00010245621870450947, -3.36840474013729e-05], [-3.347402118425864e-05, -3.36840474013729e-05, 0.00010208522289680759]]} + #*EXTRAS*# Step: 8 Bead: 47 +{"friction": [[0.00010296450019051039, -3.424640363274644e-05, -3.4202767202460804e-05], [-3.424640363274644e-05, 0.00010293353115209994, -3.443895896357693e-05], [-3.4202767202460804e-05, -3.443895896357693e-05, 0.00010255022262549286]]} + #*EXTRAS*# Step: 9 Bead: 47 +{"friction": [[0.00010327149167487319, -3.471820367841357e-05, -3.466488779131122e-05], [-3.471820367841357e-05, 0.00010325185753543282, -3.490904073470429e-05], [-3.466488779131122e-05, -3.490904073470429e-05, 0.00010287215775947507]]} + #*EXTRAS*# Step: 10 Bead: 47 +{"friction": [[0.00010347275029095793, -3.501397636629875e-05, -3.495572195041159e-05], [-3.501397636629875e-05, 0.0001034587939298016, -3.520081889515659e-05], [-3.495572195041159e-05, -3.520081889515659e-05, 0.00010308626669746085]]} + #*EXTRAS*# Step: 11 Bead: 47 +{"friction": [[0.000103604679432416, -3.520250007715493e-05, -3.514158365435959e-05], [-3.520250007715493e-05, 0.0001035937616309445, -3.538567451297996e-05], [-3.514158365435959e-05, -3.538567451297996e-05, 0.00010322771529658312]]} + #*EXTRAS*# Step: 12 Bead: 47 +{"friction": [[0.00010369014355731514, -3.532250434420895e-05, -3.526009061898425e-05], [-3.532250434420895e-05, 0.00010368093625296378, -3.550291622394546e-05], [-3.526009061898425e-05, -3.550291622394546e-05, 0.00010331975252030344]]} + #*EXTRAS*# Step: 13 Bead: 47 +{"friction": [[0.00010374532369365785, -3.5399134420000404e-05, -3.533584490757743e-05], [-3.5399134420000404e-05, 0.00010373712071270386, -3.5577615476804445e-05], [-3.533584490757743e-05, -3.5577615476804445e-05, 0.0001033793322506754]]} + #*EXTRAS*# Step: 14 Bead: 47 +{"friction": [[0.00010378081052701893, -3.5448071985329125e-05, -3.538425596341766e-05], [-3.5448071985329125e-05, 0.00010377321388698839, -3.562525389563364e-05], [-3.538425596341766e-05, -3.562525389563364e-05, 0.00010341770946960422]]} + #*EXTRAS*# Step: 15 Bead: 47 +{"friction": [[0.00010380359248853033, -3.5479349472316954e-05, -3.541521033617155e-05], [-3.5479349472316954e-05, 0.00010379636928860843, -3.565567458542703e-05], [-3.541521033617155e-05, -3.565567458542703e-05, 0.00010344237125116261]]} + #*EXTRAS*# Step: 16 Bead: 47 +{"friction": [[0.00010381819699915873, -3.549934324545063e-05, -3.543500303696491e-05], [-3.549934324545063e-05, 0.00010381120681602313, -3.5675109977851966e-05], [-3.543500303696491e-05, -3.5675109977851966e-05, 0.00010345819056574255]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_48 b/drivers/py/pes/friction/frictionH/060K/inst.raw_48 new file mode 100644 index 000000000..0723fdb46 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_48 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 48 +{"friction": [[0.00010490062451440705, -3.687350091212312e-05, -3.6805665261342465e-05], [-3.687350091212312e-05, 0.00010490061033065456, -3.69947368229772e-05], [-3.6805665261342465e-05, -3.69947368229772e-05, 0.0001046451982602587]]} + #*EXTRAS*# Step: 1 Bead: 48 +{"friction": [[0.00010241218749187014, -3.333354022513325e-05, -3.331247262865845e-05], [-3.333354022513325e-05, 0.00010235426035805363, -3.35148718125976e-05], [-3.331247262865845e-05, -3.35148718125976e-05, 0.00010198870964078345]]} + #*EXTRAS*# Step: 2 Bead: 48 +{"friction": [[0.00010047994921406065, -2.96436278916192e-05, -2.967540235593756e-05], [-2.96436278916192e-05, 0.0001003560631094302, -2.9650132463857295e-05], [-2.967540235593756e-05, -2.9650132463857295e-05, 0.00010029555401847941]]} + #*EXTRAS*# Step: 3 Bead: 48 +{"friction": [[9.877353267481574e-05, -2.6296523145280043e-05, -2.618522439671099e-05], [-2.6296523145280043e-05, 9.882088027899617e-05, -2.6077497201697387e-05], [-2.618522439671099e-05, -2.6077497201697387e-05, 9.918846004428267e-05]]} + #*EXTRAS*# Step: 4 Bead: 48 +{"friction": [[9.888003440097208e-05, -2.6513293046411083e-05, -2.641596744529621e-05], [-2.6513293046411083e-05, 9.891019458323802e-05, -2.630771999392694e-05], [-2.641596744529621e-05, -2.630771999392694e-05, 9.925124835351527e-05]]} + #*EXTRAS*# Step: 5 Bead: 48 +{"friction": [[0.0001002926078955002, -2.927063199407184e-05, -2.9297493818048076e-05], [-2.927063199407184e-05, 0.00010017427283758008, -2.925258204666208e-05], [-2.9297493818048076e-05, -2.925258204666208e-05, 0.0001001584833375123]]} + #*EXTRAS*# Step: 6 Bead: 48 +{"friction": [[0.00010118228218269887, -3.1041639755543175e-05, -3.1070254933904884e-05], [-3.1041639755543175e-05, 0.00010106346269848581, -3.1132071894849516e-05], [-3.1070254933904884e-05, -3.1132071894849516e-05, 0.00010085340790604885]]} + #*EXTRAS*# Step: 7 Bead: 48 +{"friction": [[0.00010183475213105653, -3.229576704591551e-05, -3.2300967415999325e-05], [-3.229576704591551e-05, 0.00010174493637136346, -3.2445219489107416e-05], [-3.2300967415999325e-05, -3.2445219489107416e-05, 0.00010143288877148483]]} + #*EXTRAS*# Step: 8 Bead: 48 +{"friction": [[0.00010223747837220154, -3.302806479858911e-05, -3.301495058421632e-05], [-3.302806479858911e-05, 0.00010216994705051909, -3.320191163011509e-05], [-3.301495058421632e-05, -3.320191163011509e-05, 0.00010181678529110152]]} + #*EXTRAS*# Step: 9 Bead: 48 +{"friction": [[0.000102505976416638, -3.34942860893554e-05, -3.346905182061658e-05], [-3.34942860893554e-05, 0.00010245306223493712, -3.367885208384535e-05], [-3.346905182061658e-05, -3.367885208384535e-05, 0.000102082220004412]]} + #*EXTRAS*# Step: 10 Bead: 48 +{"friction": [[0.00010268041444454005, -3.378707911292343e-05, -3.3754397561468144e-05], [-3.378707911292343e-05, 0.00010263642429977745, -3.3976207104015986e-05], [-3.3754397561468144e-05, -3.3976207104015986e-05, 0.00010225824213166934]]} + #*EXTRAS*# Step: 11 Bead: 48 +{"friction": [[0.00010279451974116389, -3.397419367701251e-05, -3.3936913599664164e-05], [-3.397419367701251e-05, 0.00010275601329657256, -3.416528939484107e-05], [-3.3936913599664164e-05, -3.416528939484107e-05, 0.00010237476816998179]]} + #*EXTRAS*# Step: 12 Bead: 48 +{"friction": [[0.00010286836803173804, -3.409341788894801e-05, -3.405329849590342e-05], [-3.409341788894801e-05, 0.0001028332352806251, -3.428536267494743e-05], [-3.405329849590342e-05, -3.428536267494743e-05, 0.00010245072966523856]]} + #*EXTRAS*# Step: 13 Bead: 48 +{"friction": [[0.00010291605558731851, -3.416962166570133e-05, -3.412773126579041e-05], [-3.416962166570133e-05, 0.00010288302176043987, -3.4361938932081395e-05], [-3.412773126579041e-05, -3.4361938932081395e-05, 0.00010250000015075995]]} + #*EXTRAS*# Step: 14 Bead: 48 +{"friction": [[0.00010294672807677494, -3.421830976625893e-05, -3.4175307510870735e-05], [-3.421830976625893e-05, 0.00010291500963698059, -3.441079413412964e-05], [-3.4175307510870735e-05, -3.441079413412964e-05, 0.00010253177871532054]]} + #*EXTRAS*# Step: 15 Bead: 48 +{"friction": [[0.0001029664236126996, -3.424943900930914e-05, -3.4205734392960515e-05], [-3.424943900930914e-05, 0.00010293553511074273, -3.44420008849487e-05], [-3.4205734392960515e-05, -3.44420008849487e-05, 0.00010255222010134212]]} + #*EXTRAS*# Step: 16 Bead: 48 +{"friction": [[0.00010297905134956256, -3.426934207992203e-05, -3.422519200204534e-05], [-3.426934207992203e-05, 0.00010294868880536898, -3.446194142502017e-05], [-3.422519200204534e-05, -3.446194142502017e-05, 0.00010256534051166263]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_49 b/drivers/py/pes/friction/frictionH/060K/inst.raw_49 new file mode 100644 index 000000000..3c2e0d031 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_49 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 49 +{"friction": [[0.00010454547171753977, -3.6444056165635773e-05, -3.637510960233212e-05], [-3.6444056165635773e-05, 0.00010454494879362924, -3.658517988655125e-05], [-3.637510960233212e-05, -3.658517988655125e-05, 0.00010425342130998133]]} + #*EXTRAS*# Step: 1 Bead: 49 +{"friction": [[0.00010211257595627723, -3.280500640034903e-05, -3.279764370768853e-05], [-3.280500640034903e-05, 0.00010203807193065473, -3.2972342949772675e-05], [-3.279764370768853e-05, -3.2972342949772675e-05, 0.00010169579348202292]]} + #*EXTRAS*# Step: 2 Bead: 49 +{"friction": [[0.00010016246114352229, -2.901284968861217e-05, -2.903463240241026e-05], [-2.901284968861217e-05, 0.00010004998899101943, -2.8977460124696344e-05], [-2.903463240241026e-05, -2.8977460124696344e-05, 0.00010006605631440637]]} + #*EXTRAS*# Step: 3 Bead: 49 +{"friction": [[9.839747190985914e-05, -2.54928134013641e-05, -2.532928934037445e-05], [-2.54928134013641e-05, 9.851013654734162e-05, -2.5228106623200587e-05], [-2.532928934037445e-05, -2.5228106623200587e-05, 9.896871658520104e-05]]} + #*EXTRAS*# Step: 4 Bead: 49 +{"friction": [[9.842337451690667e-05, -2.555061232986489e-05, -2.5390804429279854e-05], [-2.555061232986489e-05, 9.853132640214412e-05, -2.528894076132812e-05], [-2.5390804429279854e-05, -2.528894076132812e-05, 9.898381122857562e-05]]} + #*EXTRAS*# Step: 5 Bead: 49 +{"friction": [[9.977103840718073e-05, -2.8248143600011888e-05, -2.8245911679802298e-05], [-2.8248143600011888e-05, 9.968674672345859e-05, -2.8160053934878053e-05], [-2.8245911679802298e-05, -2.8160053934878053e-05, 9.980114032200482e-05]]} + #*EXTRAS*# Step: 6 Bead: 49 +{"friction": [[0.00010062787645744466, -2.9939035220358906e-05, -2.997280282306848e-05], [-2.9939035220358906e-05, 0.00010050187449722171, -2.9964449721743494e-05], [-2.997280282306848e-05, -2.9964449721743494e-05, 0.00010040722963255531]]} + #*EXTRAS*# Step: 7 Bead: 49 +{"friction": [[0.00010124123564694494, -3.115754762659955e-05, -3.1184644419997235e-05], [-3.115754762659955e-05, 0.00010112433593662723, -3.1254192283173354e-05], [-3.1184644419997235e-05, -3.1254192283173354e-05, 0.00010090341338396506]]} + #*EXTRAS*# Step: 8 Bead: 49 +{"friction": [[0.00010160885132825532, -3.186966587590332e-05, -3.188432554349781e-05], [-3.186966587590332e-05, 0.00010150742003995001, -3.2001243783857183e-05], [-3.188432554349781e-05, -3.2001243783857183e-05, 0.0001012259457437926]]} + #*EXTRAS*# Step: 9 Bead: 49 +{"friction": [[0.00010185120563935048, -3.232640113578066e-05, -3.2330878135532325e-05], [-3.232640113578066e-05, 0.00010176227476055784, -3.2477040976626464e-05], [-3.2330878135532325e-05, -3.2477040976626464e-05, 0.00010144820770670582]]} + #*EXTRAS*# Step: 10 Bead: 49 +{"friction": [[0.00010200702044850023, -3.261358844049192e-05, -3.261106554561141e-05], [-3.261358844049192e-05, 0.00010192663134453903, -3.2774677474388934e-05], [-3.261106554561141e-05, -3.2774677474388934e-05, 0.00010159486482971633]]} + #*EXTRAS*# Step: 11 Bead: 49 +{"friction": [[0.00010210842953887038, -3.2797536682337295e-05, -3.279036483114311e-05], [-3.2797536682337295e-05, 0.00010203369376291654, -3.296464064700175e-05], [-3.279036483114311e-05, -3.296464064700175e-05, 0.00010169180556268276]]} + #*EXTRAS*# Step: 12 Bead: 49 +{"friction": [[0.00010217380299432583, -3.291482487003572e-05, -3.290464179215675e-05], [-3.291482487003572e-05, 0.00010210272101878258, -3.3085472927280954e-05], [-3.290464179215675e-05, -3.3085472927280954e-05, 0.00010175489651475224]]} + #*EXTRAS*# Step: 13 Bead: 49 +{"friction": [[0.00010221592597788603, -3.298984806160176e-05, -3.297772511918078e-05], [-3.298984806160176e-05, 0.00010214719453104758, -3.316264025642074e-05], [-3.297772511918078e-05, -3.316264025642074e-05, 0.00010179579010919835]]} + #*EXTRAS*# Step: 14 Bead: 49 +{"friction": [[0.00010224297790625268, -3.303779811532473e-05, -3.302443116030994e-05], [-3.303779811532473e-05, 0.0001021757524675101, -3.321190945308088e-05], [-3.302443116030994e-05, -3.321190945308088e-05, 0.00010182215034787974]]} + #*EXTRAS*# Step: 15 Bead: 49 +{"friction": [[0.00010226033271521992, -3.306846398410719e-05, -3.3054300109170756e-05], [-3.306846398410719e-05, 0.00010219407147145082, -3.3243397730321056e-05], [-3.3054300109170756e-05, -3.3243397730321056e-05, 0.00010183910120187115]]} + #*EXTRAS*# Step: 16 Bead: 49 +{"friction": [[0.00010227145290240907, -3.308807371704193e-05, -3.3073399797377163e-05], [-3.308807371704193e-05, 0.0001022058085320992, -3.326352460775726e-05], [-3.3073399797377163e-05, -3.326352460775726e-05, 0.00010184997876775155]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_50 b/drivers/py/pes/friction/frictionH/060K/inst.raw_50 new file mode 100644 index 000000000..d7a70a6b7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_50 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 50 +{"friction": [[0.00010422157793290393, -3.6035021611147086e-05, -3.5966888494172815e-05], [-3.6035021611147086e-05, 0.00010421927471690661, -3.619295965410192e-05], [-3.5966888494172815e-05, -3.619295965410192e-05, 0.00010389772288898436]]} + #*EXTRAS*# Step: 1 Bead: 50 +{"friction": [[0.00010184286409641186, -3.231087751270343e-05, -3.231572170477077e-05], [-3.231087751270343e-05, 0.0001017534840941216, -3.246091735319335e-05], [-3.231572170477077e-05, -3.246091735319335e-05, 0.00010144043728980299]]} + #*EXTRAS*# Step: 2 Bead: 50 +{"friction": [[9.986564096886184e-05, -2.8431282856047567e-05, -2.843607677563736e-05], [-2.8431282856047567e-05, 9.97730610010615e-05, -2.835594198424407e-05], [-2.843607677563736e-05, -2.835594198424407e-05, 9.986345311413552e-05]]} + #*EXTRAS*# Step: 3 Bead: 50 +{"friction": [[9.808044547478142e-05, -2.474260497040455e-05, -2.4532701810930088e-05], [-2.474260497040455e-05, 9.825305387157817e-05, -2.4442611092722866e-05], [-2.4532701810930088e-05, -2.4442611092722866e-05, 9.878314938907566e-05]]} + #*EXTRAS*# Step: 4 Bead: 50 +{"friction": [[9.804282580830414e-05, -2.4647016299492422e-05, -2.4431544083885696e-05], [-2.4647016299492422e-05, 9.822280472410111e-05, -2.434311526444534e-05], [-2.4431544083885696e-05, -2.434311526444534e-05, 9.876090997698144e-05]]} + #*EXTRAS*# Step: 5 Bead: 50 +{"friction": [[9.928046578102524e-05, -2.7302998692466298e-05, -2.725391000581015e-05], [-2.7302998692466298e-05, 9.92520513363811e-05, -2.714939082438386e-05], [-2.725391000581015e-05, -2.714939082438386e-05, 9.949171995819893e-05]]} + #*EXTRAS*# Step: 6 Bead: 50 +{"friction": [[0.00010011276245628187, -2.8914798496965835e-05, -2.8934267561954046e-05], [-2.8914798496965835e-05, 0.00010000298017630164, -2.887274624923963e-05], [-2.8934267561954046e-05, -2.887274624923963e-05, 0.00010003135135167634]]} + #*EXTRAS*# Step: 7 Bead: 50 +{"friction": [[0.00010070493408416996, -3.0092993496150513e-05, -3.012718098213182e-05], [-3.0092993496150513e-05, 0.0001005785720822103, -3.012804724590641e-05], [-3.012718098213182e-05, -3.012804724590641e-05, 0.00010046662618761619]]} + #*EXTRAS*# Step: 8 Bead: 50 +{"friction": [[0.00010105054520866393, -3.078135380745269e-05, -3.0812770659302374e-05], [-3.078135380745269e-05, 0.00010092813737237016, -3.085735882247448e-05], [-3.0812770659302374e-05, -3.085735882247448e-05, 0.00010074342977187761]]} + #*EXTRAS*# Step: 9 Bead: 50 +{"friction": [[0.00010127610226880505, -3.122590875650482e-05, -3.125203657541698e-05], [-3.122590875650482e-05, 0.00010116042194024815, -3.132615308405544e-05], [-3.125203657541698e-05, -3.132615308405544e-05, 0.00010093321556631456]]} + #*EXTRAS*# Step: 10 Bead: 50 +{"friction": [[0.00010141963783795289, -3.150566076041346e-05, -3.152729444047112e-05], [-3.150566076041346e-05, 0.00010130957324371036, -3.162011204809938e-05], [-3.152729444047112e-05, -3.162011204809938e-05, 0.00010105766317638271]]} + #*EXTRAS*# Step: 11 Bead: 50 +{"friction": [[0.00010151258620180548, -3.168520990542833e-05, -3.170354932455329e-05], [-3.168520990542833e-05, 0.00010140660913335766, -3.1808310292156957e-05], [-3.170354932455329e-05, -3.1808310292156957e-05, 0.00010113973809477499]]} + #*EXTRAS*# Step: 12 Bead: 50 +{"friction": [[0.00010157226592221296, -3.179975230053877e-05, -3.181583982149026e-05], [-3.179975230053877e-05, 0.00010146907291930396, -3.19281671075682e-05], [-3.181583982149026e-05, -3.19281671075682e-05, 0.0001011930400636229]]} + #*EXTRAS*# Step: 13 Bead: 50 +{"friction": [[0.00010161063428735534, -3.1873066974763386e-05, -3.188765619188124e-05], [-3.1873066974763386e-05, 0.00010150928985614295, -3.200479716966899e-05], [-3.188765619188124e-05, -3.200479716966899e-05, 0.00010122755380597295]]} + #*EXTRAS*# Step: 14 Bead: 50 +{"friction": [[0.00010163523603689656, -3.191993753760366e-05, -3.193354678327291e-05], [-3.191993753760366e-05, 0.000101535099179572, -3.205375120705757e-05], [-3.193354678327291e-05, -3.205375120705757e-05, 0.00010124978409963043]]} + #*EXTRAS*# Step: 15 Bead: 50 +{"friction": [[0.00010165100401287871, -3.1949920006789815e-05, -3.196289365375916e-05], [-3.1949920006789815e-05, 0.00010155164977982365, -3.208505147312827e-05], [-3.196289365375916e-05, -3.208505147312827e-05, 0.00010126407299685324]]} + #*EXTRAS*# Step: 16 Bead: 50 +{"friction": [[0.00010166110101526962, -3.196909502854489e-05, -3.19816586977276e-05], [-3.196909502854489e-05, 0.00010156225135565583, -3.210506309768043e-05], [-3.19816586977276e-05, -3.210506309768043e-05, 0.0001012732395590608]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_51 b/drivers/py/pes/friction/frictionH/060K/inst.raw_51 new file mode 100644 index 000000000..c3afa918b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_51 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 51 +{"friction": [[0.00010392810737404057, -3.564841585082599e-05, -3.5582711172999606e-05], [-3.564841585082599e-05, 0.0001039227172200635, -3.581976330672245e-05], [-3.5582711172999606e-05, -3.581976330672245e-05, 0.00010357747568088037]]} + #*EXTRAS*# Step: 1 Bead: 51 +{"friction": [[0.00010159950057720748, -3.185181944597111e-05, -3.186684729834325e-05], [-3.185181944597111e-05, 0.00010149761526160896, -3.1982595836817304e-05], [-3.186684729834325e-05, -3.1982595836817304e-05, 0.00010121751897000925]]} + #*EXTRAS*# Step: 2 Bead: 51 +{"friction": [[9.958909900009009e-05, -2.789777900535259e-05, -2.7880055002417155e-05], [-2.789777900535259e-05, 9.95231709371138e-05, -2.7785242086469034e-05], [-2.7880055002417155e-05, -2.7785242086469034e-05, 9.968395042460206e-05]]} + #*EXTRAS*# Step: 3 Bead: 51 +{"friction": [[9.78217089870107e-05, -2.404439877699718e-05, -2.3796302601172432e-05], [-2.404439877699718e-05, 9.804596309933551e-05, -2.3719233805716925e-05], [-2.3796302601172432e-05, -2.3719233805716925e-05, 9.862816350421207e-05]]} + #*EXTRAS*# Step: 4 Bead: 51 +{"friction": [[9.77405278754854e-05, -2.3800480966068397e-05, -2.354060447958986e-05], [-2.3800480966068397e-05, 9.798139686344618e-05, -2.3468444709559176e-05], [-2.354060447958986e-05, -2.3468444709559176e-05, 9.857812122444582e-05]]} + #*EXTRAS*# Step: 5 Bead: 51 +{"friction": [[9.883832725990797e-05, -2.6428843222474272e-05, -2.632609563401284e-05], [-2.6428843222474272e-05, 9.887514396599439e-05, -2.6217979705177336e-05], [-2.632609563401284e-05, -2.6217979705177336e-05, 9.922661537357304e-05]]} + #*EXTRAS*# Step: 6 Bead: 51 +{"friction": [[9.962749822488106e-05, -2.797161357889566e-05, -2.7957362021950412e-05], [-2.797161357889566e-05, 9.955744415964286e-05, -2.7864225829908813e-05], [-2.7957362021950412e-05, -2.7864225829908813e-05, 9.97084161708547e-05]]} + #*EXTRAS*# Step: 7 Bead: 51 +{"friction": [[0.00010021026592541625, -2.9107377345657472e-05, -2.9131189007792164e-05], [-2.9107377345657472e-05, 0.0001000954434032451, -2.9078377307351963e-05], [-2.9131189007792164e-05, -2.9078377307351963e-05, 0.00010009974440916409]]} + #*EXTRAS*# Step: 8 Bead: 51 +{"friction": [[0.00010054324161118794, -2.9769969204196133e-05, -2.9802792775049977e-05], [-2.9769969204196133e-05, 0.00010041821443323132, -2.9784624560543882e-05], [-2.9802792775049977e-05, -2.9784624560543882e-05, 0.00010034295979970767]]} + #*EXTRAS*# Step: 9 Bead: 51 +{"friction": [[0.00010075884608004766, -3.020067281117671e-05, -3.023491470121282e-05], [-3.020067281117671e-05, 0.00010063251906437104, -3.0242372436843226e-05], [-3.023491470121282e-05, -3.0242372436843226e-05, 0.00010050868356586719]]} + #*EXTRAS*# Step: 10 Bead: 51 +{"friction": [[0.00010089478789587937, -3.0471831879516735e-05, -3.050538313122385e-05], [-3.0471831879516735e-05, 0.00010076953984804766, -3.052988965326851e-05], [-3.050538313122385e-05, -3.052988965326851e-05, 0.0001006165734466744]]} + #*EXTRAS*# Step: 11 Bead: 51 +{"friction": [[0.00010098242631406213, -3.0646185011996586e-05, -3.067870174926936e-05], [-3.0646185011996586e-05, 0.0001008585779062183, -3.071445308804897e-05], [-3.067870174926936e-05, -3.071445308804897e-05, 0.00010068752545999048]]} + #*EXTRAS*# Step: 12 Bead: 51 +{"friction": [[0.0001010384879813515, -3.0757454157938243e-05, -3.078908378337422e-05], [-3.0757454157938243e-05, 0.00010091580361460243, -3.083210294493325e-05], [-3.078908378337422e-05, -3.083210294493325e-05, 0.00010073348655127778]]} + #*EXTRAS*# Step: 13 Bead: 51 +{"friction": [[0.00010107445596722977, -3.0828714177130266e-05, -3.085968668264369e-05], [-3.0828714177130266e-05, 0.00010095262316917772, -3.090739147342865e-05], [-3.085968668264369e-05, -3.090739147342865e-05, 0.00010076320919101726]]} + #*EXTRAS*# Step: 14 Bead: 51 +{"friction": [[0.00010109748442467893, -3.087428067454206e-05, -3.09047975909096e-05], [-3.087428067454206e-05, 0.00010097623831993084, -3.095550960872202e-05], [-3.09047975909096e-05, -3.095550960872202e-05, 0.00010078233526043724]]} + #*EXTRAS*# Step: 15 Bead: 51 +{"friction": [[0.00010111223094094355, -3.09034346906858e-05, -3.093364589690335e-05], [-3.09034346906858e-05, 0.00010099137713648245, -3.098628605532633e-05], [-3.093364589690335e-05, -3.098628605532633e-05, 0.00010079462220181947]]} + #*EXTRAS*# Step: 16 Bead: 51 +{"friction": [[0.0001011216682043396, -3.0922081677912555e-05, -3.095209160352582e-05], [-3.0922081677912555e-05, 0.00010100107215592385, -3.1005966558795484e-05], [-3.095209160352582e-05, -3.1005966558795484e-05, 0.00010080250152601363]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_52 b/drivers/py/pes/friction/frictionH/060K/inst.raw_52 new file mode 100644 index 000000000..0248cce00 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_52 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 52 +{"friction": [[0.00010366394327696455, -3.5285887569447394e-05, -3.522391444163986e-05], [-3.5285887569447394e-05, 0.00010365423205589712, -3.546717661556058e-05], [-3.522391444163986e-05, -3.546717661556058e-05, 0.00010329150520581095]]} + #*EXTRAS*# Step: 1 Bead: 52 +{"friction": [[0.00010137971738935573, -3.142814232946037e-05, -3.1451102768022846e-05], [-3.142814232946037e-05, 0.00010126800048912262, -3.153874370928429e-05], [-3.1451102768022846e-05, -3.153874370928429e-05, 0.00010102276928021121]]} + #*EXTRAS*# Step: 2 Bead: 52 +{"friction": [[9.93357944929949e-05, -2.7410070684412604e-05, -2.7367022899696978e-05], [-2.7410070684412604e-05, 9.930012079475498e-05, -2.7263775530006035e-05], [-2.7367022899696978e-05, -2.7263775530006035e-05, 9.952566022934459e-05]]} + #*EXTRAS*# Step: 3 Bead: 52 +{"friction": [[9.76175609700588e-05, -2.339749617873421e-05, -2.3120269406814896e-05], [-2.339749617873421e-05, 9.788387628951507e-05, -2.3056419767073376e-05], [-2.3120269406814896e-05, -2.3056419767073376e-05, 9.850012939991969e-05]]} + #*EXTRAS*# Step: 4 Bead: 52 +{"friction": [[9.751310161398863e-05, -2.3010564504919607e-05, -2.271942471523731e-05], [-2.3010564504919607e-05, 9.78011940029252e-05, -2.266361612288356e-05], [-2.271942471523731e-05, -2.266361612288356e-05, 9.843074074152643e-05]]} + #*EXTRAS*# Step: 5 Bead: 52 +{"friction": [[9.845527157098916e-05, -2.5621203741735716e-05, -2.5465951589750378e-05], [-2.5621203741735716e-05, 9.855746116242544e-05, -2.5363295791254894e-05], [-2.5465951589750378e-05, -2.5363295791254894e-05, 9.900239852764618e-05]]} + #*EXTRAS*# Step: 6 Bead: 52 +{"friction": [[9.917947608893624e-05, -2.7106626277552036e-05, -2.704608909068944e-05], [-2.7106626277552036e-05, 9.916486415593332e-05, -2.6939741752433517e-05], [-2.704608909068944e-05, -2.6939741752433517e-05, 9.94302733137955e-05]]} + #*EXTRAS*# Step: 7 Bead: 52 +{"friction": [[9.974794192495288e-05, -2.8203561701117104e-05, -2.8199502682521546e-05], [-2.8203561701117104e-05, 9.966580991354183e-05, -2.8112362456318632e-05], [-2.8199502682521546e-05, -2.8112362456318632e-05, 9.97860779479665e-05]]} + #*EXTRAS*# Step: 8 Bead: 52 +{"friction": [[0.000100074609905375, -2.883969265807147e-05, -2.885724271284861e-05], [-2.883969265807147e-05, 9.996706493717237e-05, -2.8792514408181942e-05], [-2.885724271284861e-05, -2.8792514408181942e-05, 0.00010000492651330525]]} + #*EXTRAS*# Step: 9 Bead: 52 +{"friction": [[0.00010028509410508422, -2.9255714081329458e-05, -2.9282320625274606e-05], [-2.9255714081329458e-05, 0.00010016705179855776, -2.9236668256038294e-05], [-2.9282320625274606e-05, -2.9236668256038294e-05, 0.00010015308564307156]]} + #*EXTRAS*# Step: 10 Bead: 52 +{"friction": [[0.00010041678575204521, -2.9517676715400762e-05, -2.9548101913287456e-05], [-2.9517676715400762e-05, 0.00010029440176976114, -2.9515968091117742e-05], [-2.9548101913287456e-05, -2.9515968091117742e-05, 0.00010024880062220468]]} + #*EXTRAS*# Step: 11 Bead: 52 +{"friction": [[0.00010050138174843617, -2.9686398054083988e-05, -2.9718561311985332e-05], [-2.9686398054083988e-05, 0.00010037706894539806, -2.9695672046773143e-05], [-2.9718561311985332e-05, -2.9695672046773143e-05, 0.00010031154424875213]]} + #*EXTRAS*# Step: 12 Bead: 52 +{"friction": [[0.00010055532515753637, -2.9794100854285308e-05, -2.9827090948770028e-05], [-2.9794100854285308e-05, 0.00010043012069783228, -2.9810302540792204e-05], [-2.9827090948770028e-05, -2.9810302540792204e-05, 0.00010035207408527163]]} + #*EXTRAS*# Step: 13 Bead: 52 +{"friction": [[0.00010058987415596834, -2.986311123372257e-05, -2.9896518747464187e-05], [-2.986311123372257e-05, 0.00010046423330558181, -2.9883715750335325e-05], [-2.9896518747464187e-05, -2.9883715750335325e-05, 0.00010037824667439686]]} + #*EXTRAS*# Step: 14 Bead: 52 +{"friction": [[0.00010061196581559928, -2.9907246340476335e-05, -2.9940875688919423e-05], [-2.9907246340476335e-05, 0.00010048610003506689, -2.9930651337553902e-05], [-2.9940875688919423e-05, -2.9930651337553902e-05, 0.00010039507035450281]]} + #*EXTRAS*# Step: 15 Bead: 52 +{"friction": [[0.00010062610170894928, -2.9935489271865783e-05, -2.9969242340033936e-05], [-2.9935489271865783e-05, 0.00010050011387458556, -2.99606799374882e-05], [-2.9969242340033936e-05, -2.99606799374882e-05, 0.00010040587155585479]]} + #*EXTRAS*# Step: 16 Bead: 52 +{"friction": [[0.00010063514351186697, -2.9953554921195183e-05, -2.9987379724816192e-05], [-2.9953554921195183e-05, 0.0001005090864862577, -2.9979885130413363e-05], [-2.9987379724816192e-05, -2.9979885130413363e-05, 0.00010041279518989028]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_53 b/drivers/py/pes/friction/frictionH/060K/inst.raw_53 new file mode 100644 index 000000000..805db799b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_53 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 53 +{"friction": [[0.00010342777205096691, -3.4948757364551355e-05, -3.48915119324289e-05], [-3.4948757364551355e-05, 0.00010341266127600232, -3.513667008856002e-05], [-3.48915119324289e-05, -3.513667008856002e-05, 0.0001030382318154365]]} + #*EXTRAS*# Step: 1 Bead: 53 +{"friction": [[0.0001011813874026259, -3.103987758716177e-05, -3.106851460775509e-05], [-3.103987758716177e-05, 0.0001010625402063414, -3.1130214238216904e-05], [-3.106851460775509e-05, -3.1130214238216904e-05, 0.00010085265267792885]]} + #*EXTRAS*# Step: 2 Bead: 53 +{"friction": [[9.91077096966672e-05, -2.6966143797481686e-05, -2.6897158817365743e-05], [-2.6966143797481686e-05, 9.910332108243037e-05, -2.6789887068105478e-05], [-2.6897158817365743e-05, -2.6789887068105478e-05, 9.938696841104092e-05]]} + #*EXTRAS*# Step: 3 Bead: 53 +{"friction": [[9.746244084800881e-05, -2.280172363673665e-05, -2.250428829831513e-05], [-2.280172363673665e-05, 9.776109648330735e-05, -2.2452781647492403e-05], [-2.250428829831513e-05, -2.2452781647492403e-05, 9.839552195165435e-05]]} + #*EXTRAS*# Step: 4 Bead: 53 +{"friction": [[9.735351943597568e-05, -2.2277895572195278e-05, -2.196870413396373e-05], [-2.2277895572195278e-05, 9.767466362736363e-05, -2.19276699660718e-05], [-2.196870413396373e-05, -2.19276699660718e-05, 9.831403133197474e-05]]} + #*EXTRAS*# Step: 5 Bead: 53 +{"friction": [[9.81347367182115e-05, -2.4877699996399277e-05, -2.467582229520593e-05], [-2.4877699996399277e-05, 9.829679905251022e-05, -2.4583465319669316e-05], [-2.467582229520593e-05, -2.4583465319669316e-05, 9.881512723082247e-05]]} + #*EXTRAS*# Step: 6 Bead: 53 +{"friction": [[9.878242950944426e-05, -2.6314777341568135e-05, -2.620466166171737e-05], [-2.6314777341568135e-05, 9.88283177016945e-05, -2.6096867910619694e-05], [-2.620466166171737e-05, -2.6096867910619694e-05, 9.919369149345864e-05]]} + #*EXTRAS*# Step: 7 Bead: 53 +{"friction": [[9.93204540590546e-05, -2.7380414417328086e-05, -2.7335708757746688e-05], [-2.7380414417328086e-05, 9.928677098115145e-05, -2.723208918345071e-05], [-2.7335708757746688e-05, -2.723208918345071e-05, 9.951622931633544e-05]]} + #*EXTRAS*# Step: 8 Bead: 53 +{"friction": [[9.96383248324306e-05, -2.7992437136421535e-05, -2.7979145739026198e-05], [-2.7992437136421535e-05, 9.956713088189292e-05, -2.788650235556343e-05], [-2.7979145739026198e-05, -2.788650235556343e-05, 9.971533899833806e-05]]} + #*EXTRAS*# Step: 9 Bead: 53 +{"friction": [[9.984632909987637e-05, -2.8393817432207427e-05, -2.8397238634744963e-05], [-2.8393817432207427e-05, 9.975536638045886e-05, -2.831587279434574e-05], [-2.8397238634744963e-05, -2.831587279434574e-05, 9.985064940508807e-05]]} + #*EXTRAS*# Step: 10 Bead: 53 +{"friction": [[9.997606095476824e-05, -2.8646426581457288e-05, -2.8658437869997936e-05], [-2.8646426581457288e-05, 9.98749973670603e-05, -2.858597696217655e-05], [-2.8658437869997936e-05, -2.858597696217655e-05, 9.993753005572131e-05]]} + #*EXTRAS*# Step: 11 Bead: 53 +{"friction": [[0.00010005918563976601, -2.88093721761132e-05, -2.8826110918522215e-05], [-2.88093721761132e-05, 9.995258800364756e-05, -2.8760119317182374e-05], [-2.8826110918522215e-05, -2.8760119317182374e-05, 9.999429663397172e-05]]} + #*EXTRAS*# Step: 12 Bead: 53 +{"friction": [[0.00010011205539527252, -2.8913405253643664e-05, -2.8932839887582476e-05], [-2.8913405253643664e-05, 0.00010000231321127458, -2.887125808931785e-05], [-2.8932839887582476e-05, -2.887125808931785e-05, 0.00010003085992437336]]} + #*EXTRAS*# Step: 13 Bead: 53 +{"friction": [[0.00010014587144142404, -2.898009355403116e-05, -2.9001127242790966e-05], [-2.898009355403116e-05, 0.00010003426910031352, -2.8942482011824316e-05], [-2.9001127242790966e-05, -2.8942482011824316e-05, 0.00010005443576820379]]} + #*EXTRAS*# Step: 14 Bead: 53 +{"friction": [[0.00010016747216024213, -2.9022748847299035e-05, -2.9044753240503206e-05], [-2.9022748847299035e-05, 0.00010005474278479738, -2.8988030003948203e-05], [-2.9044753240503206e-05, -2.8988030003948203e-05, 0.00010006957346143275]]} + #*EXTRAS*# Step: 15 Bead: 53 +{"friction": [[0.00010018128561645675, -2.905004873529288e-05, -2.9072653272828257e-05], [-2.905004873529288e-05, 0.00010006786036849015, -2.901717769874478e-05], [-2.9072653272828257e-05, -2.901717769874478e-05, 0.00010007928597779758]]} + #*EXTRAS*# Step: 16 Bead: 53 +{"friction": [[0.0001001901174952087, -2.9067512241049058e-05, -2.9090492096433183e-05], [-2.9067512241049058e-05, 0.00010007625745083602, -2.9035821743975355e-05], [-2.9090492096433183e-05, -2.9035821743975355e-05, 0.00010008550901884418]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_54 b/drivers/py/pes/friction/frictionH/060K/inst.raw_54 new file mode 100644 index 000000000..e2b77013c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_54 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 54 +{"friction": [[0.00010321820672526034, -3.463813479007007e-05, -3.4586315531130965e-05], [-3.463813479007007e-05, 0.00010319683609987853, -3.482966366715975e-05], [-3.4586315531130965e-05, -3.482966366715975e-05, 0.00010281585060269033]]} + #*EXTRAS*# Step: 1 Bead: 54 +{"friction": [[0.00010100293567762007, -3.068691770322139e-05, -3.0719129690069354e-05], [-3.068691770322139e-05, 0.00010087948954331636, -3.0757534154374416e-05], [-3.0719129690069354e-05, -3.0757534154374416e-05, 0.00010070428783763487]]} + #*EXTRAS*# Step: 2 Bead: 54 +{"friction": [[9.89054368569124e-05, -2.6564472436869192e-05, -2.6470416303354777e-05], [-2.6564472436869192e-05, 9.893159069408707e-05, -2.6362134844251836e-05], [-2.6470416303354777e-05, -2.6362134844251836e-05, 9.9266282221234e-05]]} + #*EXTRAS*# Step: 3 Bead: 54 +{"friction": [[9.7349769683163e-05, -2.225726771520433e-05, -2.194773654784395e-05], [-2.225726771520433e-05, 9.767167625067085e-05, -2.190710179615841e-05], [-2.194773654784395e-05, -2.190710179615841e-05, 9.83110215890771e-05]]} + #*EXTRAS*# Step: 4 Bead: 54 +{"friction": [[9.725254777708447e-05, -2.1603787155989207e-05, -2.1288605311021518e-05], [-2.1603787155989207e-05, 9.759344859381441e-05, -2.1259905436648432e-05], [-2.1288605311021518e-05, -2.1259905436648432e-05, 9.822340151739657e-05]]} + #*EXTRAS*# Step: 5 Bead: 54 +{"friction": [[9.787514979784292e-05, -2.4197436276884823e-05, -2.3957178174738958e-05], [-2.4197436276884823e-05, 9.80885638897034e-05, -2.3877104078358055e-05], [-2.3957178174738958e-05, -2.3877104078358055e-05, 9.866064932568723e-05]]} + #*EXTRAS*# Step: 6 Bead: 54 +{"friction": [[9.844256406611393e-05, -2.5593156048475405e-05, -2.5436091701303044e-05], [-2.5593156048475405e-05, 9.85470438258813e-05, -2.5333745340788826e-05], [-2.5436091701303044e-05, -2.5333745340788826e-05, 9.899499340564813e-05]]} + #*EXTRAS*# Step: 7 Bead: 54 +{"friction": [[9.893988721591826e-05, -2.6633589787725847e-05, -2.6543926629403237e-05], [-2.6633589787725847e-05, 9.896066673603342e-05, -2.643565535636988e-05], [-2.6543926629403237e-05, -2.643565535636988e-05, 9.92867105201158e-05]]} + #*EXTRAS*# Step: 8 Bead: 54 +{"friction": [[9.924072929634912e-05, -2.7225892392284503e-05, -2.717236252856746e-05], [-2.7225892392284503e-05, 9.921766216880017e-05, -2.706704905497217e-05], [-2.717236252856746e-05, -2.706704905497217e-05, 9.946746773445723e-05]]} + #*EXTRAS*# Step: 9 Bead: 54 +{"friction": [[9.944203473577762e-05, -2.761495307620058e-05, -2.7583012756389918e-05], [-2.761495307620058e-05, 9.93930557306191e-05, -2.7482766393362044e-05], [-2.7583012756389918e-05, -2.7482766393362044e-05, 9.959143536552707e-05]]} + #*EXTRAS*# Step: 10 Bead: 54 +{"friction": [[9.956898741348012e-05, -2.7859115965655727e-05, -2.7839532336628075e-05], [-2.7859115965655727e-05, 9.950527126021748e-05, -2.7743884916492312e-05], [-2.7839532336628075e-05, -2.7743884916492312e-05, 9.967118986858504e-05]]} + #*EXTRAS*# Step: 11 Bead: 54 +{"friction": [[9.9650892798636e-05, -2.8016614499937413e-05, -2.80044270950423e-05], [-2.8016614499937413e-05, 9.957838874082374e-05, -2.7912366989520265e-05], [-2.80044270950423e-05, -2.7912366989520265e-05, 9.972338923549824e-05]]} + #*EXTRAS*# Step: 12 Bead: 54 +{"friction": [[9.970309803356987e-05, -2.8117112643708406e-05, -2.8109386559800592e-05], [-2.8117112643708406e-05, 9.962530562815277e-05, -2.8019880210604488e-05], [-2.8109386559800592e-05, -2.8019880210604488e-05, 9.975699300565576e-05]]} + #*EXTRAS*# Step: 13 Bead: 54 +{"friction": [[9.973652476294535e-05, -2.8181539003617753e-05, -2.8176561191974045e-05], [-2.8181539003617753e-05, 9.96554794244346e-05, -2.8088803150377343e-05], [-2.8176561191974045e-05, -2.8088803150377343e-05, 9.977865317046678e-05]]} + #*EXTRAS*# Step: 14 Bead: 54 +{"friction": [[9.975788257376503e-05, -2.8222744348316703e-05, -2.821947691993967e-05], [-2.8222744348316703e-05, 9.967481467578284e-05, -2.8132883284981958e-05], [-2.821947691993967e-05, -2.8132883284981958e-05, 9.979255374857505e-05]]} + #*EXTRAS*# Step: 15 Bead: 54 +{"friction": [[9.977154248059024e-05, -2.8249117075170078e-05, -2.824692455472971e-05], [-2.8249117075170078e-05, 9.968720424423933e-05, -2.816109529086259e-05], [-2.824692455472971e-05, -2.816109529086259e-05, 9.980146969277388e-05]]} + #*EXTRAS*# Step: 16 Bead: 54 +{"friction": [[9.978027627349094e-05, -2.826598742816015e-05, -2.826447430646709e-05], [-2.826598742816015e-05, 9.969513542261014e-05, -2.8179141874100764e-05], [-2.826447430646709e-05, -2.8179141874100764e-05, 9.980718089499678e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_55 b/drivers/py/pes/friction/frictionH/060K/inst.raw_55 new file mode 100644 index 000000000..32c056864 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_55 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 55 +{"friction": [[0.0001030336955245592, -3.435497053307799e-05, -3.430893758166685e-05], [-3.435497053307799e-05, 0.00010300555227581691, -3.4547622358950575e-05], [-3.430893758166685e-05, -3.4547622358950575e-05, 0.00010262224478354004]]} + #*EXTRAS*# Step: 1 Bead: 55 +{"friction": [[0.00010084323851698672, -3.0369088844643668e-05, -3.0403037269591273e-05], [-3.0369088844643668e-05, 0.00010071741954785476, -3.0421014530895674e-05], [-3.0403037269591273e-05, -3.0421014530895674e-05, 0.00010057535095624512]]} + #*EXTRAS*# Step: 2 Bead: 55 +{"friction": [[9.872861954109439e-05, -2.620392956771059e-05, -2.6086616622463943e-05], [-2.620392956771059e-05, 9.878339862040572e-05, -2.5979288915981047e-05], [-2.6086616622463943e-05, -2.5979288915981047e-05, 9.916208422109301e-05]]} + #*EXTRAS*# Step: 3 Bead: 55 +{"friction": [[9.727256038123935e-05, -2.176454047024342e-05, -2.144981033296398e-05], [-2.176454047024342e-05, 9.7609738580856e-05, -2.141831872937291e-05], [-2.144981033296398e-05, -2.141831872937291e-05, 9.824357424802705e-05]]} + #*EXTRAS*# Step: 4 Bead: 55 +{"friction": [[9.719944207474689e-05, -2.0990124963094387e-05, -2.067892925219908e-05], [-2.0990124963094387e-05, 9.75486946250711e-05, -2.0659860191048528e-05], [-2.067892925219908e-05, -2.0659860191048528e-05, 9.815452394978559e-05]]} + #*EXTRAS*# Step: 5 Bead: 55 +{"friction": [[9.767165463135103e-05, -2.3580525836210872e-05, -2.3310836462196283e-05], [-2.3580525836210872e-05, 9.792674090528685e-05, -2.3243192121646128e-05], [-2.3310836462196283e-05, -2.3243192121646128e-05, 9.85348279938594e-05]]} + #*EXTRAS*# Step: 6 Bead: 55 +{"friction": [[9.816041453990958e-05, -2.494050461095045e-05, -2.474241525327793e-05], [-2.494050461095045e-05, 9.831752737060797e-05, -2.4649040101068896e-05], [-2.474241525327793e-05, -2.4649040101068896e-05, 9.883021070134415e-05]]} + #*EXTRAS*# Step: 7 Bead: 55 +{"friction": [[9.861233182845656e-05, -2.5960412067907193e-05, -2.58272218024581e-05], [-2.5960412067907193e-05, 9.868683484524019e-05, -2.572141525955759e-05], [-2.58272218024581e-05, -2.572141525955759e-05, 9.90940135238982e-05]]} + #*EXTRAS*# Step: 8 Bead: 55 +{"friction": [[9.889153371173634e-05, -2.6536484450618504e-05, -2.644064202299371e-05], [-2.6536484450618504e-05, 9.89198757448243e-05, -2.6332374831793928e-05], [-2.644064202299371e-05, -2.6332374831793928e-05, 9.925805097775005e-05]]} + #*EXTRAS*# Step: 9 Bead: 55 +{"friction": [[9.908202991662435e-05, -2.6915651277525225e-05, -2.684358375312845e-05], [-2.6915651277525225e-05, 9.908138004180094e-05, -2.6736054835089458e-05], [-2.684358375312845e-05, -2.6736054835089458e-05, 9.937153979536133e-05]]} + #*EXTRAS*# Step: 10 Bead: 55 +{"friction": [[9.920326821346101e-05, -2.715301550097698e-05, -2.709522288511609e-05], [-2.715301550097698e-05, 9.918534195466327e-05, -2.698924997929247e-05], [-2.709522288511609e-05, -2.698924997929247e-05, 9.944469392068833e-05]]} + #*EXTRAS*# Step: 11 Bead: 55 +{"friction": [[9.928207092943393e-05, -2.7306109484565944e-05, -2.7257198420527072e-05], [-2.7306109484565944e-05, 9.925344280585467e-05, -2.7152713399492733e-05], [-2.7257198420527072e-05, -2.7152713399492733e-05, 9.949270174441089e-05]]} + #*EXTRAS*# Step: 12 Bead: 55 +{"friction": [[9.933250359838599e-05, -2.740371052926841e-05, -2.7360308205932366e-05], [-2.740371052926841e-05, 9.929725549394364e-05, -2.7256979713061154e-05], [-2.7360308205932366e-05, -2.7256979713061154e-05, 9.952363571003751e-05]]} + #*EXTRAS*# Step: 13 Bead: 55 +{"friction": [[9.936489120277991e-05, -2.7466263775532264e-05, -2.7426323845516763e-05], [-2.7466263775532264e-05, 9.932548917846205e-05, -2.7323824281930674e-05], [-2.7426323845516763e-05, -2.7323824281930674e-05, 9.954359303700285e-05]]} + #*EXTRAS*# Step: 14 Bead: 55 +{"friction": [[9.938562156934706e-05, -2.750625837114144e-05, -2.746850285644841e-05], [-2.750625837114144e-05, 9.93436015864439e-05, -2.7366569854952853e-05], [-2.746850285644841e-05, -2.7366569854952853e-05, 9.95564062442568e-05]]} + #*EXTRAS*# Step: 15 Bead: 55 +{"friction": [[9.939889605917562e-05, -2.7531852517328048e-05, -2.7495482521910943e-05], [-2.7531852517328048e-05, 9.935521666883056e-05, -2.7393927228830775e-05], [-2.7495482521910943e-05, -2.7393927228830775e-05, 9.956462747629897e-05]]} + #*EXTRAS*# Step: 16 Bead: 55 +{"friction": [[9.940738970819511e-05, -2.754822283368826e-05, -2.7512733871010748e-05], [-2.754822283368826e-05, 9.936265556631575e-05, -2.7411426407049646e-05], [-2.7512733871010748e-05, -2.7411426407049646e-05, 9.956989463941387e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_56 b/drivers/py/pes/friction/frictionH/060K/inst.raw_56 new file mode 100644 index 000000000..33611fa66 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_56 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 56 +{"friction": [[0.00010287248283727404, -3.41000175745236e-05, -3.4059743381936934e-05], [-3.41000175745236e-05, 0.00010283753372188608, -3.4291999923335146e-05], [-3.4059743381936934e-05, -3.4291999923335146e-05, 0.00010245497440254835]]} + #*EXTRAS*# Step: 1 Bead: 56 +{"friction": [[0.00010070149523632192, -3.0086123566959233e-05, -3.0120300993066578e-05], [-3.0086123566959233e-05, 0.00010057513889767838, -3.0120750573944634e-05], [-3.0120300993066578e-05, -3.0120750573944634e-05, 0.00010046395753331524]]} + #*EXTRAS*# Step: 2 Bead: 56 +{"friction": [[9.857626175405478e-05, -2.5883644892532035e-05, -2.574544667487532e-05], [-2.5883644892532035e-05, 9.865701952424236e-05, -2.564025302704883e-05], [-2.574544667487532e-05, -2.564025302704883e-05, 9.907294993945184e-05]]} + #*EXTRAS*# Step: 3 Bead: 56 +{"friction": [[9.722384452567074e-05, -2.1324044072463934e-05, -2.1009581669045634e-05], [-2.1324044072463934e-05, 9.756969048652943e-05, -2.0985476697449218e-05], [-2.1009581669045634e-05, -2.0985476697449218e-05, 9.819042056527153e-05]]} + #*EXTRAS*# Step: 4 Bead: 56 +{"friction": [[9.718055360277684e-05, -2.0440150386777664e-05, -2.013930975013855e-05], [-2.0440150386777664e-05, 9.753000320802163e-05, -2.0127540932950795e-05], [-2.013930975013855e-05, -2.0127540932950795e-05, 9.810338986309521e-05]]} + #*EXTRAS*# Step: 5 Bead: 56 +{"friction": [[9.751744479232603e-05, -2.3027725844187386e-05, -2.2737142259634234e-05], [-2.3027725844187386e-05, 9.780463085269791e-05, -2.2680978271728978e-05], [-2.2737142259634234e-05, -2.2680978271728978e-05, 9.843370432262026e-05]]} + #*EXTRAS*# Step: 6 Bead: 56 +{"friction": [[9.793275622083307e-05, -2.4356692774141935e-05, -2.4124929574380776e-05], [-2.4356692774141935e-05, 9.81345806792338e-05, -2.4041805969323683e-05], [-2.4124929574380776e-05, -2.4041805969323683e-05, 9.869534349758338e-05]]} + #*EXTRAS*# Step: 7 Bead: 56 +{"friction": [[9.833858804108849e-05, -2.5359735933573093e-05, -2.5187712770459785e-05], [-2.5359735933573093e-05, 9.846207509253663e-05, -2.5088203728540942e-05], [-2.5187712770459785e-05, -2.5088203728540942e-05, 9.893439057787623e-05]]} + #*EXTRAS*# Step: 8 Bead: 56 +{"friction": [[9.859441227516191e-05, -2.592235262444642e-05, -2.5786679073994624e-05], [-2.592235262444642e-05, 9.867201473136579e-05, -2.5681168724372422e-05], [-2.5786679073994624e-05, -2.5681168724372422e-05, 9.9083546767601e-05]]} + #*EXTRAS*# Step: 9 Bead: 56 +{"friction": [[9.87720702939819e-05, -2.6293519980471082e-05, -2.618202650387136e-05], [-2.6293519980471082e-05, 9.881965818752925e-05, -2.6074310648085636e-05], [-2.618202650387136e-05, -2.6074310648085636e-05, 9.918760036530422e-05]]} + #*EXTRAS*# Step: 10 Bead: 56 +{"friction": [[9.888602724874971e-05, -2.6525384068906894e-05, -2.642883206452779e-05], [-2.6525384068906894e-05, 9.891523897219836e-05, -2.6320573430616378e-05], [-2.642883206452779e-05, -2.6320573430616378e-05, 9.925479292249318e-05]]} + #*EXTRAS*# Step: 11 Bead: 56 +{"friction": [[9.896057272749836e-05, -2.6674937759617008e-05, -2.6587889100994513e-05], [-2.6674937759617008e-05, 9.897815838595836e-05, -2.6479655343789376e-05], [-2.6587889100994513e-05, -2.6479655343789376e-05, 9.929899957041641e-05]]} + #*EXTRAS*# Step: 12 Bead: 56 +{"friction": [[9.90084423196623e-05, -2.6770211420316332e-05, -2.6689144241545206e-05], [-2.6770211420316332e-05, 9.901873393352248e-05, -2.658108864512741e-05], [-2.6689144241545206e-05, -2.658108864512741e-05, 9.932750853576191e-05]]} + #*EXTRAS*# Step: 13 Bead: 56 +{"friction": [[9.90392602006085e-05, -2.6831262588544717e-05, -2.6753993844055985e-05], [-2.6831262588544717e-05, 9.904492902241295e-05, -2.664612119277719e-05], [-2.6753993844055985e-05, -2.664612119277719e-05, 9.934591690475344e-05]]} + #*EXTRAS*# Step: 14 Bead: 56 +{"friction": [[9.905901438514627e-05, -2.687028670419652e-05, -2.6795430566358988e-05], [-2.687028670419652e-05, 9.906175063967452e-05, -2.6687703619589283e-05], [-2.6795430566358988e-05, -2.6687703619589283e-05, 9.935774027581842e-05]]} + #*EXTRAS*# Step: 15 Bead: 56 +{"friction": [[9.907167628278578e-05, -2.6895257128670826e-05, -2.6821938132112364e-05], [-2.6895257128670826e-05, 9.90725455734403e-05, -2.6714316350255218e-05], [-2.6821938132112364e-05, -2.6714316350255218e-05, 9.93653287572673e-05]]} + #*EXTRAS*# Step: 16 Bead: 56 +{"friction": [[9.907978286939224e-05, -2.691122695772488e-05, -2.6838888245421934e-05], [-2.691122695772488e-05, 9.907946212699842e-05, -2.673133864661661e-05], [-2.6838888245421934e-05, -2.673133864661661e-05, 9.937019135667063e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_57 b/drivers/py/pes/friction/frictionH/060K/inst.raw_57 new file mode 100644 index 000000000..4d508a891 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_57 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 57 +{"friction": [[0.00010273307889993032, -3.387387660981356e-05, -3.383904253920663e-05], [-3.387387660981356e-05, 0.00010269165843199864, -3.406401214784578e-05], [-3.383904253920663e-05, -3.406401214784578e-05, 0.00010231189325852699]]} + #*EXTRAS*# Step: 1 Bead: 57 +{"friction": [[0.00010057715283536595, -2.9837698800403484e-05, -2.987096267704469e-05], [-2.9837698800403484e-05, 0.00010045166058892498, -2.985668537607142e-05], [-2.987096267704469e-05, -2.985668537607142e-05, 0.00010036859010096835]]} + #*EXTRAS*# Step: 2 Bead: 57 +{"friction": [[9.84469934341226e-05, -2.5602943619572132e-05, -2.5446511359930904e-05], [-2.5602943619572132e-05, 9.855067409837872e-05, -2.5344056217313763e-05], [-2.5446511359930904e-05, -2.5344056217313763e-05, 9.899757452818374e-05]]} + #*EXTRAS*# Step: 3 Bead: 57 +{"friction": [[9.719647288011471e-05, -2.093653628092836e-05, -2.0626090525615262e-05], [-2.093653628092836e-05, 9.754603179474513e-05, -2.0607785870569423e-05], [-2.0626090525615262e-05, -2.0607785870569423e-05, 9.81491085450342e-05]]} + #*EXTRAS*# Step: 4 Bead: 57 +{"friction": [[9.718356603935949e-05, -1.995664594534006e-05, -1.9669202298824862e-05], [-1.995664594534006e-05, 9.752818305548077e-05, -1.966290994207454e-05], [-1.9669202298824862e-05, -1.966290994207454e-05, 9.806640547093446e-05]]} + #*EXTRAS*# Step: 5 Bead: 57 +{"friction": [[9.740477582270654e-05, -2.2540160820586433e-05, -2.223611398202304e-05], [-2.2540160820586433e-05, 9.771540011534829e-05, -2.218990765202684e-05], [-2.223611398202304e-05, -2.218990765202684e-05, 9.835361127801993e-05]]} + #*EXTRAS*# Step: 6 Bead: 57 +{"friction": [[9.775409475685224e-05, -2.3842310227339477e-05, -2.358438885599657e-05], [-2.3842310227339477e-05, 9.799217557271071e-05, -2.351137862435719e-05], [-2.358438885599657e-05, -2.351137862435719e-05, 9.858655120530738e-05]]} + #*EXTRAS*# Step: 7 Bead: 57 +{"friction": [[9.811600216410788e-05, -2.483144567093975e-05, -2.462680067720907e-05], [-2.483144567093975e-05, 9.828169134819201e-05, -2.453520823860693e-05], [-2.462680067720907e-05, -2.453520823860693e-05, 9.880410660468447e-05]]} + #*EXTRAS*# Step: 8 Bead: 57 +{"friction": [[9.834875329666405e-05, -2.5382883432002616e-05, -2.521233230578152e-05], [-2.5382883432002616e-05, 9.847036138100085e-05, -2.5112521858724128e-05], [-2.521233230578152e-05, -2.5112521858724128e-05, 9.894031817530737e-05]]} + #*EXTRAS*# Step: 9 Bead: 57 +{"friction": [[9.851306405341418e-05, -2.574756285756342e-05, -2.560050360722155e-05], [-2.574756285756342e-05, 9.860493116648378e-05, -2.5496543224931544e-05], [-2.560050360722155e-05, -2.5496543224931544e-05, 9.903608394059837e-05]]} + #*EXTRAS*# Step: 10 Bead: 57 +{"friction": [[9.86192026335455e-05, -2.59749649119851e-05, -2.5842724316680504e-05], [-2.59749649119851e-05, 9.869252142140992e-05, -2.5736808556720074e-05], [-2.5842724316680504e-05, -2.5736808556720074e-05, 9.909802809928472e-05]]} + #*EXTRAS*# Step: 11 Bead: 57 +{"friction": [[9.868902983892818e-05, -2.6121665400185526e-05, -2.5998995060479605e-05], [-2.6121665400185526e-05, 9.875044681332458e-05, -2.5892106801708074e-05], [-2.5998995060479605e-05, -2.5892106801708074e-05, 9.913887734078048e-05]]} + #*EXTRAS*# Step: 12 Bead: 57 +{"friction": [[9.873400127404555e-05, -2.6215064649492156e-05, -2.6098475977837022e-05], [-2.6215064649492156e-05, 9.878788428260245e-05, -2.5991094832723575e-05], [-2.6098475977837022e-05, -2.5991094832723575e-05, 9.91652418789754e-05]]} + #*EXTRAS*# Step: 13 Bead: 57 +{"friction": [[9.876301580509413e-05, -2.627490836435924e-05, -2.6162207547267327e-05], [-2.627490836435924e-05, 9.8812094010301e-05, -2.60545644059837e-05], [-2.6162207547267327e-05, -2.60545644059837e-05, 9.918227892455216e-05]]} + #*EXTRAS*# Step: 14 Bead: 57 +{"friction": [[9.878163715401484e-05, -2.6313152756798784e-05, -2.6202931825496593e-05], [-2.6313152756798784e-05, 9.88276551502925e-05, -2.60951438325028e-05], [-2.6202931825496593e-05, -2.60951438325028e-05, 9.919322548500318e-05]]} + #*EXTRAS*# Step: 15 Bead: 57 +{"friction": [[9.879358307869977e-05, -2.6337622362568198e-05, -2.6228985889703894e-05], [-2.6337622362568198e-05, 9.883764766401769e-05, -2.6121114605317304e-05], [-2.6228985889703894e-05, -2.6121114605317304e-05, 9.92002532239501e-05]]} + #*EXTRAS*# Step: 16 Bead: 57 +{"friction": [[9.880123523234854e-05, -2.635327070261222e-05, -2.6245646504778955e-05], [-2.635327070261222e-05, 9.884405256686616e-05, -2.6137725835217763e-05], [-2.6245646504778955e-05, -2.6137725835217763e-05, 9.920475721263539e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_58 b/drivers/py/pes/friction/frictionH/060K/inst.raw_58 new file mode 100644 index 000000000..45e85d06f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_58 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 58 +{"friction": [[0.00010261428366339391, -3.367703313457375e-05, -3.3647121432587244e-05], [-3.367703313457375e-05, 0.00010256698019056102, -3.3864653594504656e-05], [-3.3647121432587244e-05, -3.3864653594504656e-05, 0.00010219119996151315]]} + #*EXTRAS*# Step: 1 Bead: 58 +{"friction": [[0.00010046984925679088, -2.9623477882043044e-05, -2.965505709417293e-05], [-2.9623477882043044e-05, 0.00010034617869781209, -2.9628674208501218e-05], [-2.965505709417293e-05, -2.9628674208501218e-05, 0.00010028804089026298]]} + #*EXTRAS*# Step: 2 Bead: 58 +{"friction": [[9.833927812561367e-05, -2.536130971066541e-05, -2.5189386539940574e-05], [-2.536130971066541e-05, 9.846263748100797e-05, -2.50898568718136e-05], [-2.5189386539940574e-05, -2.50898568718136e-05, 9.893479301334817e-05]]} + #*EXTRAS*# Step: 3 Bead: 58 +{"friction": [[9.718354023267677e-05, -2.0602896865951697e-05, -2.0298403929499415e-05], [-2.0602896865951697e-05, 9.753359435908528e-05, -2.0284598088998606e-05], [-2.0298403929499415e-05, -2.0284598088998606e-05, 9.811750319503003e-05]]} + #*EXTRAS*# Step: 4 Bead: 58 +{"friction": [[9.719922753395536e-05, -1.9541231139559056e-05, -1.926792514905672e-05], [-1.9541231139559056e-05, 9.753634014543658e-05, -1.926568947530301e-05], [-1.926792514905672e-05, -1.926568947530301e-05, 9.804043811660889e-05]]} + #*EXTRAS*# Step: 5 Bead: 58 +{"friction": [[9.732572311801129e-05, -2.211911844276661e-05, -2.1807561018920152e-05], [-2.211911844276661e-05, 9.765248517509604e-05, -2.1769569750227396e-05], [-2.1807561018920152e-05, -2.1769569750227396e-05, 9.829125156219944e-05]]} + #*EXTRAS*# Step: 6 Bead: 58 +{"friction": [[9.761780824629172e-05, -2.3398356336237852e-05, -2.3121163598890848e-05], [-2.3398356336237852e-05, 9.788407213280974e-05, -2.3057296080704394e-05], [-2.3121163598890848e-05, -2.3057296080704394e-05, 9.850028964880448e-05]]} + #*EXTRAS*# Step: 7 Bead: 58 +{"friction": [[9.793990035782005e-05, -2.4376066663578447e-05, -2.414535923761304e-05], [-2.4376066663578447e-05, 9.814029474527465e-05, -2.406187078957339e-05], [-2.414535923761304e-05, -2.406187078957339e-05, 9.869962576669298e-05]]} + #*EXTRAS*# Step: 8 Bead: 58 +{"friction": [[9.815129172013007e-05, -2.4918268108949004e-05, -2.4718833483943216e-05], [-2.4918268108949004e-05, 9.831016014092594e-05, -2.4625816148137668e-05], [-2.4718833483943216e-05, -2.4625816148137668e-05, 9.882485454836931e-05]]} + #*EXTRAS*# Step: 9 Bead: 58 +{"friction": [[9.830283003533844e-05, -2.52777025891553e-05, -2.510048646158218e-05], [-2.52777025891553e-05, 9.843296144374219e-05, -2.5002079093499052e-05], [-2.510048646158218e-05, -2.5002079093499052e-05, 9.89135302877234e-05]]} + #*EXTRAS*# Step: 10 Bead: 58 +{"friction": [[9.840135115152406e-05, -2.550149735789909e-05, -2.533853075320843e-05], [-2.550149735789909e-05, 9.85133081086695e-05, -2.5237243904949205e-05], [-2.533853075320843e-05, -2.5237243904949205e-05, 9.897097730320971e-05]]} + #*EXTRAS*# Step: 11 Bead: 58 +{"friction": [[9.846649996800344e-05, -2.5645905704020973e-05, -2.5492251678417157e-05], [-2.5645905704020973e-05, 9.856667204241357e-05, -2.5389329229511722e-05], [-2.5492251678417157e-05, -2.5389329229511722e-05, 9.900894202600237e-05]]} + #*EXTRAS*# Step: 12 Bead: 58 +{"friction": [[9.85085678396616e-05, -2.5737800262846334e-05, -2.5590106582853007e-05], [-2.5737800262846334e-05, 9.860123250271538e-05, -2.5486241648056924e-05], [-2.5590106582853007e-05, -2.5486241648056924e-05, 9.903346254219312e-05]]} + #*EXTRAS*# Step: 13 Bead: 58 +{"friction": [[9.853576088812997e-05, -2.5796676486847458e-05, -2.5652811856403554e-05], [-2.5796676486847458e-05, 9.862361642352616e-05, -2.5548385264148824e-05], [-2.5652811856403554e-05, -2.5548385264148824e-05, 9.904931928252995e-05]]} + #*EXTRAS*# Step: 14 Bead: 58 +{"friction": [[9.855323227405618e-05, -2.5834296448738123e-05, -2.569288168276351e-05], [-2.5834296448738123e-05, 9.86380163613488e-05, -2.5588113985872325e-05], [-2.569288168276351e-05, -2.5588113985872325e-05, 9.905951084516148e-05]]} + #*EXTRAS*# Step: 15 Bead: 58 +{"friction": [[9.856444884320471e-05, -2.5858365224805103e-05, -2.5718518912159505e-05], [-2.5858365224805103e-05, 9.864726872762261e-05, -2.5613540389031283e-05], [-2.5718518912159505e-05, -2.5613540389031283e-05, 9.906605557898674e-05]]} + #*EXTRAS*# Step: 16 Bead: 58 +{"friction": [[9.857163705017485e-05, -2.5873756329799365e-05, -2.5734913351675844e-05], [-2.5873756329799365e-05, 9.865320133027265e-05, -2.562980307922321e-05], [-2.5734913351675844e-05, -2.562980307922321e-05, 9.907025061433366e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_59 b/drivers/py/pes/friction/frictionH/060K/inst.raw_59 new file mode 100644 index 000000000..80e4b4bf1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_59 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 59 +{"friction": [[0.00010251514085647045, -3.350986950112593e-05, -3.3484233397662335e-05], [-3.350986950112593e-05, 0.0001024627094050115, -3.369472217637789e-05], [-3.3484233397662335e-05, -3.369472217637789e-05, 0.00010209140079979171]]} + #*EXTRAS*# Step: 1 Bead: 59 +{"friction": [[0.00010037935865733542, -2.9443127531236544e-05, -2.9472607460003528e-05], [-2.9443127531236544e-05, 0.00010025804007922309, -2.9436518778351414e-05], [-2.9472607460003528e-05, -2.9436518778351414e-05, 0.00010022135715849928]]} + #*EXTRAS*# Step: 2 Bead: 59 +{"friction": [[9.825156322495388e-05, -2.5158344641308105e-05, -2.4973646352311754e-05], [-2.5158344641308105e-05, 9.839131353113851e-05, -2.4876931339995305e-05], [-2.4973646352311754e-05, -2.4876931339995305e-05, 9.888358954759786e-05]]} + #*EXTRAS*# Step: 3 Bead: 59 +{"friction": [[9.717968876776888e-05, -2.0323567344601568e-05, -2.002562150918368e-05], [-2.0323567344601568e-05, 9.752838005223056e-05, -2.0015250696461092e-05], [-2.002562150918368e-05, -2.0015250696461092e-05, 9.809379861566223e-05]]} + #*EXTRAS*# Step: 4 Bead: 59 +{"friction": [[9.722067865142672e-05, -1.9194728086477996e-05, -1.8934752509729627e-05], [-1.9194728086477996e-05, 9.754937046620953e-05, -1.8935471101597535e-05], [-1.8934752509729627e-05, -1.8935471101597535e-05, 9.802281954235908e-05]]} + #*EXTRAS*# Step: 5 Bead: 59 +{"friction": [[9.72727407106999e-05, -2.1765901177572855e-05, -2.1451177525339022e-05], [-2.1765901177572855e-05, 9.760988469766427e-05, -2.1419661850770163e-05], [-2.1451177525339022e-05, -2.1419661850770163e-05, 9.824374882612662e-05]]} + #*EXTRAS*# Step: 6 Bead: 59 +{"friction": [[9.751700884830694e-05, -2.30260081247189e-05, -2.2735368606543846e-05], [-2.30260081247189e-05, 9.780428588246839e-05, -2.2679240201096193e-05], [-2.2735368606543846e-05, -2.2679240201096193e-05, 9.843340721484104e-05]]} + #*EXTRAS*# Step: 7 Bead: 59 +{"friction": [[9.780468786863167e-05, -2.3994469695012272e-05, -2.3743888961589212e-05], [-2.3994469695012272e-05, 9.803241141047216e-05, -2.3667814288760632e-05], [-2.3743888961589212e-05, -2.3667814288760632e-05, 9.861774629299982e-05]]} + #*EXTRAS*# Step: 8 Bead: 59 +{"friction": [[9.799737324253508e-05, -2.4529162323707588e-05, -2.4306958950579498e-05], [-2.4529162323707588e-05, 9.81863236536516e-05, -2.4220639837419018e-05], [-2.4306958950579498e-05, -2.4220639837419018e-05, 9.873393391796848e-05]]} + #*EXTRAS*# Step: 9 Bead: 59 +{"friction": [[9.813746772487275e-05, -2.4884411793309146e-05, -2.468293727100296e-05], [-2.4884411793309146e-05, 9.829900245930342e-05, -2.459047037640573e-05], [-2.468293727100296e-05, -2.459047037640573e-05, 9.881673260395983e-05]]} + #*EXTRAS*# Step: 10 Bead: 59 +{"friction": [[9.822908807208024e-05, -2.5105328595214404e-05, -2.4917337901636612e-05], [-2.5105328595214404e-05, 9.837308901581875e-05, -2.4821406913389253e-05], [-2.4917337901636612e-05, -2.4821406913389253e-05, 9.887044756863591e-05]]} + #*EXTRAS*# Step: 11 Bead: 59 +{"friction": [[9.828995178564207e-05, -2.524791855936654e-05, -2.506882681132987e-05], [-2.524791855936654e-05, 9.842248927939609e-05, -2.4970832037013967e-05], [-2.506882681132987e-05, -2.4970832037013967e-05, 9.89060133091731e-05]]} + #*EXTRAS*# Step: 12 Bead: 59 +{"friction": [[9.832934383837228e-05, -2.5338620321198715e-05, -2.5165256843632497e-05], [-2.5338620321198715e-05, 9.84545434254939e-05, -2.506602642136082e-05], [-2.5165256843632497e-05, -2.506602642136082e-05, 9.892899918040389e-05]]} + #*EXTRAS*# Step: 13 Bead: 59 +{"friction": [[9.835485009581442e-05, -2.5396730906633058e-05, -2.522706172790782e-05], [-2.5396730906633058e-05, 9.847533335457675e-05, -2.512707300640674e-05], [-2.522706172790782e-05, -2.512707300640674e-05, 9.894387291848124e-05]]} + #*EXTRAS*# Step: 14 Bead: 59 +{"friction": [[9.837125345346259e-05, -2.5433856969923737e-05, -2.526655709503163e-05], [-2.5433856969923737e-05, 9.848871832089122e-05, -2.5166098026024688e-05], [-2.526655709503163e-05, -2.5166098026024688e-05, 9.89534354853721e-05]]} + #*EXTRAS*# Step: 15 Bead: 59 +{"friction": [[9.838179124347716e-05, -2.5457608886525703e-05, -2.5291828282217243e-05], [-2.5457608886525703e-05, 9.849732318786211e-05, -2.5191074203160543e-05], [-2.5291828282217243e-05, -2.5191074203160543e-05, 9.895957771496338e-05]]} + #*EXTRAS*# Step: 16 Bead: 59 +{"friction": [[9.838854712750694e-05, -2.547279669631829e-05, -2.530798892731227e-05], [-2.547279669631829e-05, 9.850284239821027e-05, -2.520704865548808e-05], [-2.530798892731227e-05, -2.520704865548808e-05, 9.896351525200723e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_60 b/drivers/py/pes/friction/frictionH/060K/inst.raw_60 new file mode 100644 index 000000000..f7ff86fbf --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_60 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 60 +{"friction": [[0.00010243489413890537, -3.337266793205423e-05, -3.3350583183048474e-05], [-3.337266793205423e-05, 0.00010237819197671717, -3.355483283288116e-05], [-3.3350583183048474e-05, -3.355483283288116e-05, 0.00010201127331709875]]} + #*EXTRAS*# Step: 1 Bead: 60 +{"friction": [[0.00010030554386096575, -2.92963241292448e-05, -2.9323614712425175e-05], [-2.92963241292448e-05, 0.00010018671772734519, -2.9279986997115343e-05], [-2.9323614712425175e-05, -2.9279986997115343e-05, 0.000100167794024414]]} + #*EXTRAS*# Step: 2 Bead: 60 +{"friction": [[9.8182389441973e-05, -2.499373027515611e-05, -2.4798878087874322e-05], [-2.499373027515611e-05, 9.833528655743751e-05, -2.470465870608873e-05], [-2.4798878087874322e-05, -2.470465870608873e-05, 9.884310115457009e-05]]} + #*EXTRAS*# Step: 3 Bead: 60 +{"friction": [[9.7180908939243e-05, -2.0098659836044432e-05, -1.9806912509833764e-05], [-2.0098659836044432e-05, 9.752739895146938e-05, -1.9799098402679313e-05], [-1.9806912509833764e-05, -1.9799098402679313e-05, 9.807650775274657e-05]]} + #*EXTRAS*# Step: 4 Bead: 60 +{"friction": [[9.724291436829919e-05, -1.8917447617868385e-05, -1.866898504856869e-05], [-1.8917447617868385e-05, 9.75635553123535e-05, -1.8671800519933502e-05], [-1.866898504856869e-05, -1.8671800519933502e-05, 9.801134224729761e-05]]} + #*EXTRAS*# Step: 5 Bead: 60 +{"friction": [[9.723906648158019e-05, -2.1481719118558802e-05, -2.1166614804225257e-05], [-2.1481719118558802e-05, 9.7582366411545e-05, -2.1139962632404197e-05], [-2.1166614804225257e-05, -2.1139962632404197e-05, 9.820867972523337e-05]]} + #*EXTRAS*# Step: 6 Bead: 60 +{"friction": [[9.74451819842229e-05, -2.2726449748644298e-05, -2.2426964001285947e-05], [-2.2726449748644298e-05, 9.774742875711584e-05, -2.2376994505044336e-05], [-2.2426964001285947e-05, -2.2376994505044336e-05, 9.838321047901973e-05]]} + #*EXTRAS*# Step: 7 Bead: 60 +{"friction": [[9.770467661692687e-05, -2.3687650118301826e-05, -2.3422640001075604e-05], [-2.3687650118301826e-05, 9.795293378835016e-05, -2.335278847314381e-05], [-2.3422640001075604e-05, -2.335278847314381e-05, 9.855569566910974e-05]]} + #*EXTRAS*# Step: 8 Bead: 60 +{"friction": [[9.788191433043101e-05, -2.421642974038673e-05, -2.3977167117058714e-05], [-2.421642974038673e-05, 9.809396223106949e-05, -2.3896724869112565e-05], [-2.3977167117058714e-05, -2.3896724869112565e-05, 9.866473954955063e-05]]} + #*EXTRAS*# Step: 9 Bead: 60 +{"friction": [[9.801240338053946e-05, -2.4568433282431695e-05, -2.4348455659959415e-05], [-2.4568433282431695e-05, 9.819837923384216e-05, -2.4261426465855103e-05], [-2.4348455659959415e-05, -2.4261426465855103e-05, 9.874286827274087e-05]]} + #*EXTRAS*# Step: 10 Bead: 60 +{"friction": [[9.809819039411136e-05, -2.478711832135308e-05, -2.457984016929087e-05], [-2.478711832135308e-05, 9.826733988707809e-05, -2.4488991670490208e-05], [-2.457984016929087e-05, -2.4488991670490208e-05, 9.879361534773418e-05]]} + #*EXTRAS*# Step: 11 Bead: 60 +{"friction": [[9.815540521946722e-05, -2.4928304933050536e-05, -2.4729476985744752e-05], [-2.4928304933050536e-05, 9.831348164748491e-05, -2.4636297775665538e-05], [-2.4729476985744752e-05, -2.4636297775665538e-05, 9.882727000679762e-05]]} + #*EXTRAS*# Step: 12 Bead: 60 +{"friction": [[9.81925098947162e-05, -2.501808676709059e-05, -2.482472375447456e-05], [-2.501808676709059e-05, 9.834347177169294e-05, -2.4730123939354733e-05], [-2.482472375447456e-05, -2.4730123939354733e-05, 9.884903274866809e-05]]} + #*EXTRAS*# Step: 13 Bead: 60 +{"friction": [[9.821656971701218e-05, -2.5075607735100318e-05, -2.4885780295205246e-05], [-2.5075607735100318e-05, 9.83629469800449e-05, -2.4790297172275877e-05], [-2.4885780295205246e-05, -2.4790297172275877e-05, 9.886312257264868e-05]]} + #*EXTRAS*# Step: 14 Bead: 60 +{"friction": [[9.823205556020426e-05, -2.5112353621403843e-05, -2.4924798031565134e-05], [-2.5112353621403843e-05, 9.837549411179429e-05, -2.4828762049907244e-05], [-2.4924798031565134e-05, -2.4828762049907244e-05, 9.887218341119737e-05]]} + #*EXTRAS*# Step: 15 Bead: 60 +{"friction": [[9.824200947294337e-05, -2.5135861757294544e-05, -2.4949764781276185e-05], [-2.5135861757294544e-05, 9.838356415833861e-05, -2.4853379897647883e-05], [-2.4949764781276185e-05, -2.4853379897647883e-05, 9.887800451008932e-05]]} + #*EXTRAS*# Step: 16 Bead: 60 +{"friction": [[9.824839318294628e-05, -2.515089319378181e-05, -2.4965730947475086e-05], [-2.515089319378181e-05, 9.838874179355621e-05, -2.4869124960547818e-05], [-2.4965730947475086e-05, -2.4869124960547818e-05, 9.888173658419655e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_61 b/drivers/py/pes/friction/frictionH/060K/inst.raw_61 new file mode 100644 index 000000000..5e9c9aa13 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_61 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 61 +{"friction": [[0.00010237295826707656, -3.326562672264948e-05, -3.3246327268270765e-05], [-3.326562672264948e-05, 0.00010231289990664679, -3.3445442976744176e-05], [-3.3246327268270765e-05, -3.3445442976744176e-05, 0.0001019498435873969]]} + #*EXTRAS*# Step: 1 Bead: 61 +{"friction": [[0.0001002483250804849, -2.9182770965635303e-05, -2.9208061790821546e-05], [-2.9182770965635303e-05, 0.00010013179546908187, -2.915884176089963e-05], [-2.9208061790821546e-05, -2.915884176089963e-05, 0.00010012678129875834]]} + #*EXTRAS*# Step: 2 Bead: 61 +{"friction": [[9.813047548664374e-05, -2.4867211927167853e-05, -2.4664705023587918e-05], [-2.4867211927167853e-05, 9.829336160387571e-05, -2.45725203331877e-05], [-2.4664705023587918e-05, -2.45725203331877e-05, 9.881262177279298e-05]]} + #*EXTRAS*# Step: 3 Bead: 61 +{"friction": [[9.718427109561252e-05, -1.9928097196371617e-05, -1.9641553139821118e-05], [-1.9928097196371617e-05, 9.752846776829738e-05, -1.9635558226475252e-05], [-1.9641553139821118e-05, -1.9635558226475252e-05, 9.806445038796342e-05]]} + #*EXTRAS*# Step: 4 Bead: 61 +{"friction": [[9.726237259838942e-05, -1.870940538330825e-05, -1.847000303882603e-05], [-1.870940538330825e-05, 9.7576251869166e-05, -1.8474241856364478e-05], [-1.847000303882603e-05, -1.8474241856364478e-05, 9.800425251668492e-05]]} + #*EXTRAS*# Step: 5 Bead: 61 +{"friction": [[9.721898759670856e-05, -2.1267624347541838e-05, -2.0953536692540057e-05], [-2.1267624347541838e-05, 9.756559521814638e-05, -2.093031631413689e-05], [-2.0953536692540057e-05, -2.093031631413689e-05, 9.818409262140034e-05]]} + #*EXTRAS*# Step: 6 Bead: 61 +{"friction": [[9.739665128349606e-05, -2.2500749633865177e-05, -2.219583321778112e-05], [-2.2500749633865177e-05, 9.770895291997266e-05, -2.215041435568899e-05], [-2.219583321778112e-05, -2.215041435568899e-05, 9.834750767104676e-05]]} + #*EXTRAS*# Step: 7 Bead: 61 +{"friction": [[9.763469532250692e-05, -2.34565664201695e-05, -2.3181707735824556e-05], [-2.34565664201695e-05, 9.789744877579584e-05, -2.3116631077548038e-05], [-2.3181707735824556e-05, -2.3116631077548038e-05, 9.851119614864806e-05]]} + #*EXTRAS*# Step: 8 Bead: 61 +{"friction": [[9.780011539977943e-05, -2.398095306160085e-05, -2.3729706047420906e-05], [-2.398095306160085e-05, 9.802877228321592e-05, -2.365390154207851e-05], [-2.3729706047420906e-05, -2.365390154207851e-05, 9.861494155104444e-05]]} + #*EXTRAS*# Step: 9 Bead: 61 +{"friction": [[9.792317089661862e-05, -2.4330572893376855e-05, -2.409739380650449e-05], [-2.4330572893376855e-05, 9.812691664037869e-05, -2.401476428944014e-05], [-2.409739380650449e-05, -2.401476428944014e-05, 9.868959128600054e-05]]} + #*EXTRAS*# Step: 10 Bead: 61 +{"friction": [[9.800442280271126e-05, -2.454761930999833e-05, -2.4326459836574892e-05], [-2.454761930999833e-05, 9.819197710212993e-05, -2.4239806134395202e-05], [-2.4326459836574892e-05, -2.4239806134395202e-05, 9.873812618600461e-05]]} + #*EXTRAS*# Step: 11 Bead: 61 +{"friction": [[9.80587867600228e-05, -2.4687779425829518e-05, -2.4474670501189994e-05], [-2.4687779425829518e-05, 9.823563240247355e-05, -2.4385527347163866e-05], [-2.4474670501189994e-05, -2.4385527347163866e-05, 9.877035449281477e-05]]} + #*EXTRAS*# Step: 12 Bead: 61 +{"friction": [[9.809409984218466e-05, -2.477688874855366e-05, -2.4569005620520547e-05], [-2.477688874855366e-05, 9.826404566038217e-05, -2.4478330328987564e-05], [-2.4569005620520547e-05, -2.4478330328987564e-05, 9.879120402288565e-05]]} + #*EXTRAS*# Step: 13 Bead: 61 +{"friction": [[9.811702441204518e-05, -2.4833979187469834e-05, -2.462948525462925e-05], [-2.4833979187469834e-05, 9.828251535956562e-05, -2.453785062556591e-05], [-2.462948525462925e-05, -2.453785062556591e-05, 9.880470830772303e-05]]} + #*EXTRAS*# Step: 14 Bead: 61 +{"friction": [[9.813178928598965e-05, -2.4870447578644046e-05, -2.4668134682137145e-05], [-2.4870447578644046e-05, 9.829442134623774e-05, -2.4575896772734333e-05], [-2.4668134682137145e-05, -2.4575896772734333e-05, 9.881339431641726e-05]]} + #*EXTRAS*# Step: 15 Bead: 61 +{"friction": [[9.814128401020497e-05, -2.48937778478064e-05, -2.4692866624024347e-05], [-2.48937778478064e-05, 9.830208195249244e-05, -2.4600246780182208e-05], [-2.4692866624024347e-05, -2.4600246780182208e-05, 9.881897546848938e-05]]} + #*EXTRAS*# Step: 16 Bead: 61 +{"friction": [[9.814737487556166e-05, -2.4908695212416572e-05, -2.47086827742527e-05], [-2.4908695212416572e-05, 9.830699802495711e-05, -2.461582039012096e-05], [-2.47086827742527e-05, -2.461582039012096e-05, 9.882255400957526e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_62 b/drivers/py/pes/friction/frictionH/060K/inst.raw_62 new file mode 100644 index 000000000..e0e5cc25b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_62 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 62 +{"friction": [[0.00010232890466352831, -3.318888996525138e-05, -3.3171590289423344e-05], [-3.318888996525138e-05, 0.00010226643313891227, -3.33668903313071e-05], [-3.3171590289423344e-05, -3.33668903313071e-05, 0.00010190637620575303]]} + #*EXTRAS*# Step: 1 Bead: 62 +{"friction": [[0.00010020766388117925, -2.910222708904941e-05, -2.9125933233193048e-05], [-2.910222708904941e-05, 0.00010009296336100789, -2.9072879816209882e-05], [-2.9125933233193048e-05, -2.9072879816209882e-05, 0.00010009790297454793]]} + #*EXTRAS*# Step: 2 Bead: 62 +{"friction": [[9.80947837457584e-05, -2.4778600348563297e-05, -2.4570818373286747e-05], [-2.4778600348563297e-05, 9.826459638283224e-05, -2.448011406158536e-05], [-2.4570818373286747e-05, -2.448011406158536e-05, 9.879160722727227e-05]]} + #*EXTRAS*# Step: 3 Bead: 62 +{"friction": [[9.718772391202257e-05, -1.9811724841075762e-05, -1.952896214322264e-05], [-1.9811724841075762e-05, 9.753005858980748e-05, -1.952415079919637e-05], [-1.952896214322264e-05, -1.952415079919637e-05, 9.8056742244321e-05]]} + #*EXTRAS*# Step: 4 Bead: 62 +{"friction": [[9.727662818786011e-05, -1.8570481189546894e-05, -1.833730581359854e-05], [-1.8570481189546894e-05, 9.758566318478211e-05, -1.834242554119328e-05], [-1.833730581359854e-05, -1.834242554119328e-05, 9.800024243373918e-05]]} + #*EXTRAS*# Step: 5 Bead: 62 +{"friction": [[9.720801797885828e-05, -2.112446851566223e-05, -2.081166036072837e-05], [-2.112446851566223e-05, 9.755621496858423e-05, -2.079062243614572e-05], [-2.081166036072837e-05, -2.079062243614572e-05, 9.81685177842783e-05]]} + #*EXTRAS*# Step: 6 Bead: 62 +{"friction": [[9.736690767929569e-05, -2.2349774325247834e-05, -2.2041841350492772e-05], [-2.2349774325247834e-05, 9.768532040623553e-05, -2.199940646114245e-05], [-2.2041841350492772e-05, -2.199940646114245e-05, 9.832463646016201e-05]]} + #*EXTRAS*# Step: 7 Bead: 62 +{"friction": [[9.75905265976065e-05, -2.3302025519827016e-05, -2.3021104722003003e-05], [-2.3302025519827016e-05, 9.786246962441761e-05, -2.2959240737777208e-05], [-2.3021104722003003e-05, -2.2959240737777208e-05, 9.848250846652532e-05]]} + #*EXTRAS*# Step: 8 Bead: 62 +{"friction": [[9.774797512847753e-05, -2.3823498856457437e-05, -2.3564694811457992e-05], [-2.3823498856457437e-05, 9.798731306659037e-05, -2.3492066661894563e-05], [-2.3564694811457992e-05, -2.3492066661894563e-05, 9.85827523130476e-05]]} + #*EXTRAS*# Step: 9 Bead: 62 +{"friction": [[9.786597723002635e-05, -2.4171550645961008e-05, -2.3929943755029567e-05], [-2.4171550645961008e-05, 9.80812460237367e-05, -2.385037321143824e-05], [-2.3929943755029567e-05, -2.385037321143824e-05, 9.865509563096739e-05]]} + #*EXTRAS*# Step: 10 Bead: 62 +{"friction": [[9.794413727536207e-05, -2.4387519325032636e-05, -2.415743821706036e-05], [-2.4387519325032636e-05, 9.814368431488002e-05, -2.4073734764479703e-05], [-2.415743821706036e-05, -2.4073734764479703e-05, 9.870216346176393e-05]]} + #*EXTRAS*# Step: 11 Bead: 62 +{"friction": [[9.799655137183377e-05, -2.4527006128274284e-05, -2.430468105849995e-05], [-2.4527006128274284e-05, 9.818566465805331e-05, -2.4218401130951047e-05], [-2.430468105849995e-05, -2.4218401130951047e-05, 9.873344495240476e-05]]} + #*EXTRAS*# Step: 12 Bead: 62 +{"friction": [[9.803063716876702e-05, -2.4615674513122582e-05, -2.4398397275643036e-05], [-2.4615674513122582e-05, 9.821301486783601e-05, -2.4310523191521105e-05], [-2.4398397275643036e-05, -2.4310523191521105e-05, 9.875368814880108e-05]]} + #*EXTRAS*# Step: 13 Bead: 62 +{"friction": [[9.805278304377655e-05, -2.4672482913934752e-05, -2.4458485103095604e-05], [-2.4672482913934752e-05, 9.82308062080085e-05, -2.4369609042797243e-05], [-2.4458485103095604e-05, -2.4369609042797243e-05, 9.876680354253288e-05]]} + #*EXTRAS*# Step: 14 Bead: 62 +{"friction": [[9.806705302446392e-05, -2.4708769569168385e-05, -2.449688434883552e-05], [-2.4708769569168385e-05, 9.824227949104283e-05, -2.440737659831884e-05], [-2.449688434883552e-05, -2.440737659831884e-05, 9.877524057408884e-05]]} + #*EXTRAS*# Step: 15 Bead: 62 +{"friction": [[9.807623238122439e-05, -2.4731983384694714e-05, -2.4521456769266448e-05], [-2.4731983384694714e-05, 9.824966369148244e-05, -2.443154841724145e-05], [-2.4521456769266448e-05, -2.443154841724145e-05, 9.878066232652847e-05]]} + #*EXTRAS*# Step: 16 Bead: 62 +{"friction": [[9.80821220585243e-05, -2.4746826073737677e-05, -2.4537170995180064e-05], [-2.4746826073737677e-05, 9.825440315903343e-05, -2.444700796707389e-05], [-2.4537170995180064e-05, -2.444700796707389e-05, 9.878413886807257e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_63 b/drivers/py/pes/friction/frictionH/060K/inst.raw_63 new file mode 100644 index 000000000..4b5eb6449 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst.raw_63 @@ -0,0 +1,34 @@ + #*EXTRAS*# Step: 0 Bead: 63 +{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} + #*EXTRAS*# Step: 1 Bead: 63 +{"friction": [[0.00010018351870518526, -2.905446363591528e-05, -2.907716368803539e-05], [-2.905446363591528e-05, 0.00010006998277680341, -2.9021891158709383e-05], [-2.907716368803539e-05, -2.9021891158709383e-05, 0.00010008085846559029]]} + #*EXTRAS*# Step: 2 Bead: 63 +{"friction": [[9.807454252214828e-05, -2.4727717298074652e-05, -2.4516940596123586e-05], [-2.4727717298074652e-05, 9.824830408082602e-05, -2.44271056555307e-05], [-2.4516940596123586e-05, -2.44271056555307e-05, 9.877966453080054e-05]]} + #*EXTRAS*# Step: 3 Bead: 63 +{"friction": [[9.718995101344479e-05, -1.9749353309399745e-05, -1.9468690627591005e-05], [-1.9749353309399745e-05, 9.753119101376992e-05, -1.9464494746457783e-05], [-1.9468690627591005e-05, -1.9464494746457783e-05, 9.805278319385623e-05]]} + #*EXTRAS*# Step: 4 Bead: 63 +{"friction": [[9.728417694592658e-05, -1.850052555422473e-05, -1.8270534522998274e-05], [-1.850052555422473e-05, 9.75906758202262e-05, -1.8276077139052005e-05], [-1.8270534522998274e-05, -1.8276077139052005e-05, 9.799844237156387e-05]]} + #*EXTRAS*# Step: 5 Bead: 63 +{"friction": [[9.72032379249192e-05, -2.105277374985194e-05, -2.0740777801210474e-05], [-2.105277374985194e-05, 9.755204985851789e-05, -2.0720800011274557e-05], [-2.0740777801210474e-05, -2.0720800011274557e-05, 9.816097519124181e-05]]} + #*EXTRAS*# Step: 6 Bead: 63 +{"friction": [[9.735283198113455e-05, -2.227413073424113e-05, -2.1964876575809726e-05], [-2.227413073424113e-05, 9.767411603398189e-05, -2.1923915393552286e-05], [-2.1964876575809726e-05, -2.1923915393552286e-05, 9.831348089540015e-05]]} + #*EXTRAS*# Step: 7 Bead: 63 +{"friction": [[9.756920561901278e-05, -2.3224604970750704e-05, -2.2940811986814074e-05], [-2.3224604970750704e-05, 9.78455924485955e-05, -2.288055891288173e-05], [-2.2940811986814074e-05, -2.288055891288173e-05, 9.846845972521893e-05]]} + #*EXTRAS*# Step: 8 Bead: 63 +{"friction": [[9.772264383112357e-05, -2.374462536902469e-05, -2.348218170215389e-05], [-2.374462536902469e-05, 9.796719476811822e-05, -2.3411162188619685e-05], [-2.348218170215389e-05, -2.3411162188619685e-05, 9.856696251033694e-05]]} + #*EXTRAS*# Step: 9 Bead: 63 +{"friction": [[9.783809220176591e-05, -2.4091898866849364e-05, -2.3846200037384157e-05], [-2.4091898866849364e-05, 9.805901444636406e-05, -2.3768191412213577e-05], [-2.3846200037384157e-05, -2.3768191412213577e-05, 9.863815682857016e-05]]} + #*EXTRAS*# Step: 10 Bead: 63 +{"friction": [[9.791468731038645e-05, -2.430733267141808e-05, -2.4072901127049373e-05], [-2.430733267141808e-05, 9.812013592439068e-05, -2.399071330615677e-05], [-2.4072901127049373e-05, -2.399071330615677e-05, 9.86844936673206e-05]]} + #*EXTRAS*# Step: 11 Bead: 63 +{"friction": [[9.79661126948285e-05, -2.4446485854474863e-05, -2.4219655060252935e-05], [-2.4446485854474863e-05, 9.816127417500086e-05, -2.4134852709008207e-05], [-2.4219655060252935e-05, -2.4134852709008207e-05, 9.871530312614261e-05]]} + #*EXTRAS*# Step: 12 Bead: 63 +{"friction": [[9.799957563719973e-05, -2.4534935814705664e-05, -2.431305856288476e-05], [-2.4534935814705664e-05, 9.818808969936377e-05, -2.4226634625778833e-05], [-2.431305856288476e-05, -2.4226634625778833e-05, 9.873524399661502e-05]]} + #*EXTRAS*# Step: 13 Bead: 63 +{"friction": [[9.802132603040287e-05, -2.4591604576429815e-05, -2.4372948376028818e-05], [-2.4591604576429815e-05, 9.820553969992723e-05, -2.4285503479951573e-05], [-2.4372948376028818e-05, -2.4285503479951573e-05, 9.874816544921708e-05]]} + #*EXTRAS*# Step: 14 Bead: 63 +{"friction": [[9.80353445634791e-05, -2.462780126803823e-05, -2.441122117001879e-05], [-2.462780126803823e-05, 9.8216795207593e-05, -2.4323131890002328e-05], [-2.441122117001879e-05, -2.4323131890002328e-05, 9.87564783062955e-05]]} + #*EXTRAS*# Step: 15 Bead: 63 +{"friction": [[9.804436363951555e-05, -2.4650957446469668e-05, -2.4435712955289474e-05], [-2.4650957446469668e-05, 9.822404027333466e-05, -2.4347214714399244e-05], [-2.4435712955289474e-05, -2.4347214714399244e-05, 9.876182055492795e-05]]} + #*EXTRAS*# Step: 16 Bead: 63 +{"friction": [[9.80501510479367e-05, -2.4665763178915614e-05, -2.4451375658037263e-05], [-2.4665763178915614e-05, 9.822869083489756e-05, -2.4362617299172843e-05], [-2.4451375658037263e-05, -2.4362617299172843e-05, 9.876524622047617e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst1D.dat b/drivers/py/pes/friction/frictionH/060K/inst1D.dat new file mode 100644 index 000000000..c5b29658d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/inst1D.dat @@ -0,0 +1,64 @@ +1.8946271398760188 0.04188996657777692 +1.894899109419571 0.041900863526889834 +1.895446775546507 0.041923123290036494 +1.8962776582522902 0.04195770050408234 +1.8974032022448168 0.0420060855131063 +1.8988389743444964 0.04207037759868062 +1.9006049261077105 0.042153387961075615 +1.9027257208707462 0.04225877714797312 +1.90523112379517 0.04239123290766601 +1.9081564525570596 0.042556695720057956 +1.911543084944227 0.04276264043735885 +1.9154390176656064 0.043018423378940955 +1.9198994679528358 0.043335704593480864 +1.9249875058165546 0.04372895439217363 +1.9307746998326776 0.044216051019865206 +1.9373417527292698 0.04481897152736948 +1.944779094420871 0.04556456922968684 +1.953187389015454 0.04648541682458694 +1.9626778981716309 0.04762067205218661 +1.9733726254423485 0.04901688998007385 +1.985404144367682 0.05072865960581607 +1.9989149866301472 0.05281887968573434 +2.014056435407754 0.05535840789837423 +2.0309865334809216 0.058424719865035474 +2.0498670769172844 0.06209910701146486 +2.070859325905254 0.066461841209792 +2.094118129360892 0.07158467096788483 +2.1197841372029558 0.07752004091605551 +2.1479737758413475 0.08428662141762541 +2.178766705931564 0.09185113866674895 +2.212190608326317 0.10009593976347193 +2.2482067670047514 0.10877697963014449 +2.2867031902053014 0.11751915734160046 +2.3274929122114663 0.12581135530799012 +2.3703181182985524 0.13307220508135698 +2.4148594137053774 0.13895092600109205 +2.4607429171896102 0.1432150762092829 +2.507548727689012 0.1456581628459286 +2.554827002764131 0.14610963278888334 +2.6021216915269947 0.14458378473150957 +2.648991957297969 0.14143639238751873 +2.6950236423421674 0.13709530919860483 +2.73983806768427 0.1317981110496677 +2.7831028413206846 0.1255805307751963 +2.8245439522388858 0.11851733915702649 +2.8639534578924675 0.1108844393473955 +2.9011861646946615 0.10306701924110809 +2.936149039492901 0.09537350522366975 +2.968791143171844 0.08803268331193705 +2.999094611103431 0.08118650169152661 +3.0270670057098226 0.07490294300227612 +3.052735015597897 0.06921489462993596 +3.076139066907417 0.06412983710469453 +3.097328765727429 0.05963651004553192 +3.116359097484316 0.05571064347467451 +3.133287296790556 0.05231629164973843 +3.1481702244493515 0.049410067695638174 +3.161062173004411 0.04695241828952321 +3.1720131988989606 0.044908869850933196 +3.1810678866287674 0.04325007570479916 +3.1882644479839457 0.041951779568970234 +3.1936340784233743 0.04099473574992911 +3.1972005095141953 0.040364615621776574 +3.1989797112554377 0.040051921394414956 diff --git a/drivers/py/pes/friction/frictionH/060K/z_friction.dat b/drivers/py/pes/friction/frictionH/060K/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/060K/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/080K/RESTART b/drivers/py/pes/friction/frictionH/080K/RESTART new file mode 100644 index 000000000..2dd6bdb46 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/RESTART @@ -0,0 +1,612 @@ + + + [ step, potential{electronvolt} ] + extras + extras + + 8 + 50 + + + + + + [ friction ] + + + + 2.53345216e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 1.87125253e-03, 1.94415705e-03, 2.11485323e-03, 2.43333383e-03, 2.96417915e-03, + 3.73894991e-03, 4.62473097e-03, 5.24531366e-03, 5.33474337e-03, 4.92758778e-03, + 4.24486200e-03, 3.47030406e-03, 2.81905209e-03, 2.35304891e-03, 2.06372948e-03, + 1.92715839e-03 ] + + + [ -1.85101715e-03, 1.78054446e-05, 1.72347097e-05, -1.99935349e-03, 1.87715891e-05, + 1.82552250e-05, -2.27916672e-03, 2.04242136e-05, 2.00299537e-05, -2.63635485e-03, + 2.21550416e-05, 2.19414412e-05, -2.93491219e-03, 2.29794467e-05, 2.29137533e-05, + -2.89739482e-03, 2.15580367e-05, 2.14545521e-05, -2.25370048e-03, 1.62445756e-05, + 1.61023873e-05, -1.05469771e-03, 6.43464786e-06, 6.41458842e-06, 4.02628281e-04, + -5.86683778e-06, -5.84993412e-06, 1.65907654e-03, -1.78251631e-05, -1.78386211e-05, + 2.43915345e-03, -2.74463257e-05, -2.74344677e-05, 2.72472822e-03, -3.40805857e-05, + -3.40689424e-05, 2.74382201e-03, -3.81045174e-05, -3.81325991e-05, 2.65724093e-03, + -4.03253940e-05, -4.03618379e-05, 2.55902302e-03, -4.14460535e-05, -4.14371939e-05, + 2.49940959e-03, -4.19041578e-05, -4.18476427e-05 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00 ] + + True + + [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, + 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, + 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, + 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, + 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, + 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, + 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, + 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, + 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, + 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, + 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, + 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, + 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, + 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, + 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, + 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, + 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, + 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, + 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, + 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, + 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, + 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, + 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, + 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, + 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, + 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, + 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, + 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, + 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, + 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, + 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, + 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, + 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, + 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, + 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, + 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, + 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, + 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, + 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, + 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, + 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, + 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, + 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, + 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, + 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, + 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, + 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, + 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, + 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, + 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, + 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, + 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, + 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, + 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, + 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, + 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, + 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, + 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, + 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, + 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, + 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, + 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, + 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, + 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, + 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, + 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, + 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, + 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, + 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, + 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, + 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, + 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, + 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, + 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, + 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, + 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, + 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, + 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, + 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, + 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, + 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, + 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, + 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, + 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, + 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, + 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, + 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, + 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, + 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, + 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, + 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, + 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, + 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, + 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, + 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, + 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, + 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, + 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, + 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, + 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, + 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, + 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, + 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, + 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, + 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, + 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, + 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, + 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, + 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, + 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, + 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, + 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, + 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, + 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, + 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, + 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, + 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, + 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, + 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, + 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, + 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, + 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, + 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, + 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, + 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, + 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, + 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, + 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, + 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, + 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, + 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, + 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, + 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, + 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, + 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, + 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, + 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, + 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, + 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, + 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, + 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, + 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, + 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, + 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, + 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, + 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, + 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, + 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, + 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, + 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, + 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, + 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, + 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, + 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, + 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, + 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, + 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, + 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, + 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, + 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, + 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, + 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, + 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, + 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, + 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, + 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, + 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, + 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, + 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, + 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, + 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, + 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, + 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, + 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, + 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, + 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, + 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, + 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, + 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, + 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, + 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, + 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, + 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, + 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, + 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, + 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, + 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, + 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, + 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, + 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, + 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, + 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, + 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, + 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, + 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, + 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, + 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, + 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, + 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, + 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, + 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, + 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, + 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, + 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, + 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, + 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, + 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, + 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, + 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, + 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, + 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, + 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, + 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, + 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, + 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, + 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, + 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, + 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, + 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, + 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, + 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, + 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, + 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, + 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, + 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, + 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, + 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, + 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, + 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, + 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, + 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, + 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, + 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, + 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, + 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, + 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, + 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, + 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, + 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, + 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, + 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, + 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, + 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, + 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, + 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, + 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, + 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, + 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, + 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, + 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, + 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, + 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, + 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, + 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, + 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, + 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, + 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, + 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, + 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, + 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, + 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, + 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, + 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, + 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, + 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, + 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, + 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, + 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, + 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, + 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, + 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, + 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, + 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, + 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, + 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, + 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, + 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, + 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, + 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, + 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, + 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, + 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, + 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, + 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, + 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, + 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, + 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, + 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, + 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, + 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, + 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, + 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, + 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, + 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, + 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, + 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, + 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, + 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, + 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, + 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, + 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, + 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, + 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, + 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, + 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, + 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, + 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, + 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, + 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, + 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, + 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, + 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, + 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, + 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, + 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, + 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, + 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, + 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, + 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, + 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, + 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, + 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, + 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, + 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, + 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, + 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, + 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, + 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, + 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, + 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, + 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, + 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, + 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, + 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, + 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, + 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, + 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, + 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, + 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, + 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, + 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, + 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, + 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, + 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, + 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, + 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, + 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, + 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, + 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, + 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, + 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, + 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, + 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, + 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, + 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, + 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, + 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, + 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, + 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, + 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, + 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, + 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, + 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, + 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, + 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, + 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, + 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, + 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, + 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, + 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, + 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, + 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, + 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, + 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, + 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, + 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, + 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, + 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, + 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, + 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, + 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, + 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, + 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, + 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, + 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, + 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, + 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, + 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, + 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, + 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, + 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, + 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, + 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, + 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, + 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, + 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, + 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, + 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, + 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, + 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] + + + [ 1.21172076e-02, 1.33987082e-04, 1.36080893e-04, 1.13463014e-02, 1.26926930e-04, + 1.29740772e-04, 9.68973888e-03, 1.13407995e-04, 1.17089937e-04, 6.90881613e-03, + 9.47721243e-05, 9.83732453e-05, 2.63412953e-03, 7.33099879e-05, 7.45531034e-05, + -3.21521752e-03, 5.08542413e-05, 4.83341232e-05, -7.97977335e-03, 2.22445852e-05, + 2.28629884e-05, -1.06083078e-02, 5.93668383e-06, 5.74605447e-06, -1.04273577e-02, + 3.93573554e-06, 3.61536359e-06, -8.38045235e-03, 1.40836676e-05, 1.40973166e-05, + -4.54031070e-03, 2.89910424e-05, 2.92975625e-05, -1.36089546e-03, 4.53413577e-05, + 4.48852482e-05, 7.57470041e-04, 5.88513284e-05, 5.81954661e-05, 2.15165782e-03, + 6.78512307e-05, 6.85411407e-05, 2.98889580e-03, 7.31959302e-05, 7.57688979e-05, + 3.36916454e-03, 7.60546386e-05, 7.95919396e-05, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, 5.51152161e-01, + 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, + 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] + + + [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] + + True + + + + + [ 1.98668503e+00, -3.23058601e-05, -3.12703295e-05, 1.99943789e+00, -3.40588143e-05, + -3.31219331e-05, 2.02627213e+00, -3.70573047e-05, -3.63419672e-05, 2.06970175e+00, + -4.01976861e-05, -3.98101337e-05, 2.13297153e+00, -4.16934710e-05, -4.15742783e-05, + 2.21892113e+00, -3.91144919e-05, -3.89267314e-05, 2.32767375e+00, -2.94738490e-05, + -2.92158654e-05, 2.45437017e+00, -1.16749027e-05, -1.16385073e-05, 2.58955300e+00, + 1.06446789e-05, 1.06140092e-05, 2.72160968e+00, 3.23416370e-05, 3.23660548e-05, + 2.84056578e+00, 4.97980914e-05, 4.97765764e-05, 2.94036115e+00, 6.18351666e-05, + 6.18140413e-05, 3.01899058e+00, 6.91361117e-05, 6.91870627e-05, 3.07660539e+00, + 7.31656280e-05, 7.32317512e-05, 3.11416743e+00, 7.51989314e-05, 7.51828567e-05, + 3.13265872e+00, 7.60301071e-05, 7.59275671e-05 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/frictionH/080K/clean.sh b/drivers/py/pes/friction/frictionH/080K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/frictionH/080K/get1D.sh b/drivers/py/pes/friction/frictionH/080K/get1D.sh new file mode 100755 index 000000000..5cd175503 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/get1D.sh @@ -0,0 +1,6 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 +xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/frictionH/080K/init.xyz b/drivers/py/pes/friction/frictionH/080K/init.xyz new file mode 100644 index 000000000..223399063 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/frictionH/080K/input.xml b/drivers/py/pes/friction/frictionH/080K/input.xml new file mode 100644 index 000000000..fd619e24e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/input.xml @@ -0,0 +1,45 @@ + + + [ step, potential{electronvolt}] + extras + extras + + 50 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + ['friction'] + + + + 80 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + + z_friction.dat + true + true + none + 0.1 + + + +
diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_00 b/drivers/py/pes/friction/frictionH/080K/inst.fric_00 new file mode 100644 index 000000000..637fd6134 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_00 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 0 + 0.00013194 -0.00003135 -0.00003130 + -0.00003135 0.00013218 -0.00003131 + -0.00003130 -0.00003131 0.00013173 + #*EXTRAS*# Step: 1 Bead: 0 + 0.00013433 -0.00002303 -0.00002278 + -0.00002303 0.00013453 -0.00002291 + -0.00002278 -0.00002291 0.00013451 + #*EXTRAS*# Step: 2 Bead: 0 + 0.00013622 -0.00001252 -0.00001199 + -0.00001252 0.00013629 -0.00001239 + -0.00001199 -0.00001239 0.00013683 + #*EXTRAS*# Step: 3 Bead: 0 + 0.00013549 -0.00001671 -0.00001624 + -0.00001671 0.00013561 -0.00001658 + -0.00001624 -0.00001658 0.00013595 + #*EXTRAS*# Step: 4 Bead: 0 + 0.00013579 -0.00001498 -0.00001447 + -0.00001498 0.00013588 -0.00001484 + -0.00001447 -0.00001484 0.00013631 + #*EXTRAS*# Step: 5 Bead: 0 + 0.00013578 -0.00001505 -0.00001454 + -0.00001505 0.00013587 -0.00001491 + -0.00001454 -0.00001491 0.00013630 + #*EXTRAS*# Step: 6 Bead: 0 + 0.00013580 -0.00001492 -0.00001441 + -0.00001492 0.00013589 -0.00001478 + -0.00001441 -0.00001478 0.00013632 + #*EXTRAS*# Step: 7 Bead: 0 + 0.00013580 -0.00001490 -0.00001440 + -0.00001490 0.00013590 -0.00001477 + -0.00001440 -0.00001477 0.00013633 + #*EXTRAS*# Step: 8 Bead: 0 + 0.00013580 -0.00001489 -0.00001438 + -0.00001489 0.00013590 -0.00001475 + -0.00001438 -0.00001475 0.00013633 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_01 b/drivers/py/pes/friction/frictionH/080K/inst.fric_01 new file mode 100644 index 000000000..097f5a008 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_01 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 1 + 0.00013155 -0.00003225 -0.00003218 + -0.00003225 0.00013179 -0.00003222 + -0.00003218 -0.00003222 0.00013130 + #*EXTRAS*# Step: 1 Bead: 1 + 0.00013405 -0.00002436 -0.00002416 + -0.00002436 0.00013426 -0.00002425 + -0.00002416 -0.00002425 0.00013416 + #*EXTRAS*# Step: 2 Bead: 1 + 0.00013592 -0.00001423 -0.00001372 + -0.00001423 0.00013600 -0.00001410 + -0.00001372 -0.00001410 0.00013647 + #*EXTRAS*# Step: 3 Bead: 1 + 0.00013525 -0.00001812 -0.00001769 + -0.00001812 0.00013538 -0.00001799 + -0.00001769 -0.00001799 0.00013565 + #*EXTRAS*# Step: 4 Bead: 1 + 0.00013555 -0.00001640 -0.00001592 + -0.00001640 0.00013566 -0.00001626 + -0.00001592 -0.00001626 0.00013602 + #*EXTRAS*# Step: 5 Bead: 1 + 0.00013554 -0.00001645 -0.00001598 + -0.00001645 0.00013565 -0.00001631 + -0.00001598 -0.00001631 0.00013600 + #*EXTRAS*# Step: 6 Bead: 1 + 0.00013556 -0.00001632 -0.00001584 + -0.00001632 0.00013567 -0.00001618 + -0.00001584 -0.00001618 0.00013603 + #*EXTRAS*# Step: 7 Bead: 1 + 0.00013556 -0.00001630 -0.00001582 + -0.00001630 0.00013567 -0.00001616 + -0.00001582 -0.00001616 0.00013603 + #*EXTRAS*# Step: 8 Bead: 1 + 0.00013556 -0.00001629 -0.00001580 + -0.00001629 0.00013567 -0.00001615 + -0.00001580 -0.00001615 0.00013604 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_02 b/drivers/py/pes/friction/frictionH/080K/inst.fric_02 new file mode 100644 index 000000000..04c999e47 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_02 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 2 + 0.00013052 -0.00003427 -0.00003412 + -0.00003427 0.00013073 -0.00003427 + -0.00003412 -0.00003427 0.00013021 + #*EXTRAS*# Step: 1 Bead: 2 + 0.00013334 -0.00002721 -0.00002711 + -0.00002721 0.00013358 -0.00002713 + -0.00002711 -0.00002713 0.00013331 + #*EXTRAS*# Step: 2 Bead: 2 + 0.00013531 -0.00001773 -0.00001729 + -0.00001773 0.00013544 -0.00001759 + -0.00001729 -0.00001759 0.00013573 + #*EXTRAS*# Step: 3 Bead: 2 + 0.00013474 -0.00002097 -0.00002063 + -0.00002097 0.00013491 -0.00002084 + -0.00002063 -0.00002084 0.00013501 + #*EXTRAS*# Step: 4 Bead: 2 + 0.00013504 -0.00001927 -0.00001887 + -0.00001927 0.00013519 -0.00001914 + -0.00001887 -0.00001914 0.00013539 + #*EXTRAS*# Step: 5 Bead: 2 + 0.00013504 -0.00001930 -0.00001891 + -0.00001930 0.00013519 -0.00001917 + -0.00001891 -0.00001917 0.00013539 + #*EXTRAS*# Step: 6 Bead: 2 + 0.00013506 -0.00001916 -0.00001876 + -0.00001916 0.00013521 -0.00001903 + -0.00001876 -0.00001903 0.00013542 + #*EXTRAS*# Step: 7 Bead: 2 + 0.00013507 -0.00001914 -0.00001874 + -0.00001914 0.00013521 -0.00001900 + -0.00001874 -0.00001900 0.00013542 + #*EXTRAS*# Step: 8 Bead: 2 + 0.00013507 -0.00001912 -0.00001872 + -0.00001912 0.00013522 -0.00001898 + -0.00001872 -0.00001898 0.00013543 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_03 b/drivers/py/pes/friction/frictionH/080K/inst.fric_03 new file mode 100644 index 000000000..0fb9794c2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_03 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 3 + 0.00012868 -0.00003715 -0.00003680 + -0.00003715 0.00012883 -0.00003720 + -0.00003680 -0.00003720 0.00012833 + #*EXTRAS*# Step: 1 Bead: 3 + 0.00013192 -0.00003140 -0.00003135 + -0.00003140 0.00013216 -0.00003136 + -0.00003135 -0.00003136 0.00013170 + #*EXTRAS*# Step: 2 Bead: 3 + 0.00013434 -0.00002299 -0.00002274 + -0.00002299 0.00013454 -0.00002288 + -0.00002274 -0.00002288 0.00013452 + #*EXTRAS*# Step: 3 Bead: 3 + 0.00013385 -0.00002523 -0.00002507 + -0.00002523 0.00013407 -0.00002513 + -0.00002507 -0.00002513 0.00013391 + #*EXTRAS*# Step: 4 Bead: 3 + 0.00013421 -0.00002361 -0.00002338 + -0.00002361 0.00013441 -0.00002350 + -0.00002338 -0.00002350 0.00013436 + #*EXTRAS*# Step: 5 Bead: 3 + 0.00013421 -0.00002361 -0.00002338 + -0.00002361 0.00013441 -0.00002350 + -0.00002338 -0.00002350 0.00013436 + #*EXTRAS*# Step: 6 Bead: 3 + 0.00013424 -0.00002346 -0.00002322 + -0.00002346 0.00013444 -0.00002334 + -0.00002322 -0.00002334 0.00013440 + #*EXTRAS*# Step: 7 Bead: 3 + 0.00013425 -0.00002343 -0.00002319 + -0.00002343 0.00013445 -0.00002331 + -0.00002319 -0.00002331 0.00013440 + #*EXTRAS*# Step: 8 Bead: 3 + 0.00013425 -0.00002340 -0.00002316 + -0.00002340 0.00013446 -0.00002329 + -0.00002316 -0.00002329 0.00013441 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_04 b/drivers/py/pes/friction/frictionH/080K/inst.fric_04 new file mode 100644 index 000000000..0adcaaaa0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_04 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 4 + 0.00012608 -0.00004029 -0.00003974 + -0.00004029 0.00012615 -0.00004038 + -0.00003974 -0.00004038 0.00012575 + #*EXTRAS*# Step: 1 Bead: 4 + 0.00012916 -0.00003646 -0.00003616 + -0.00003646 0.00012933 -0.00003650 + -0.00003616 -0.00003650 0.00012882 + #*EXTRAS*# Step: 2 Bead: 4 + 0.00013255 -0.00002975 -0.00002970 + -0.00002975 0.00013280 -0.00002969 + -0.00002970 -0.00002969 0.00013240 + #*EXTRAS*# Step: 3 Bead: 4 + 0.00013218 -0.00003075 -0.00003070 + -0.00003075 0.00013243 -0.00003070 + -0.00003070 -0.00003070 0.00013199 + #*EXTRAS*# Step: 4 Bead: 4 + 0.00013271 -0.00002928 -0.00002923 + -0.00002928 0.00013296 -0.00002922 + -0.00002923 -0.00002922 0.00013258 + #*EXTRAS*# Step: 5 Bead: 4 + 0.00013273 -0.00002923 -0.00002918 + -0.00002923 0.00013298 -0.00002917 + -0.00002918 -0.00002917 0.00013260 + #*EXTRAS*# Step: 6 Bead: 4 + 0.00013278 -0.00002907 -0.00002902 + -0.00002907 0.00013303 -0.00002901 + -0.00002902 -0.00002901 0.00013266 + #*EXTRAS*# Step: 7 Bead: 4 + 0.00013279 -0.00002903 -0.00002898 + -0.00002903 0.00013304 -0.00002897 + -0.00002898 -0.00002897 0.00013268 + #*EXTRAS*# Step: 8 Bead: 4 + 0.00013280 -0.00002901 -0.00002895 + -0.00002901 0.00013305 -0.00002894 + -0.00002895 -0.00002894 0.00013269 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_05 b/drivers/py/pes/friction/frictionH/080K/inst.fric_05 new file mode 100644 index 000000000..43b9cff95 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_05 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 5 + 0.00012329 -0.00004270 -0.00004239 + -0.00004270 0.00012336 -0.00004279 + -0.00004239 -0.00004279 0.00012310 + #*EXTRAS*# Step: 1 Bead: 5 + 0.00012524 -0.00004112 -0.00004057 + -0.00004112 0.00012530 -0.00004122 + -0.00004057 -0.00004122 0.00012494 + #*EXTRAS*# Step: 2 Bead: 5 + 0.00012869 -0.00003713 -0.00003678 + -0.00003713 0.00012884 -0.00003717 + -0.00003678 -0.00003717 0.00012834 + #*EXTRAS*# Step: 3 Bead: 5 + 0.00012881 -0.00003696 -0.00003663 + -0.00003696 0.00012896 -0.00003701 + -0.00003663 -0.00003701 0.00012846 + #*EXTRAS*# Step: 4 Bead: 5 + 0.00012960 -0.00003580 -0.00003555 + -0.00003580 0.00012978 -0.00003582 + -0.00003555 -0.00003582 0.00012926 + #*EXTRAS*# Step: 5 Bead: 5 + 0.00012966 -0.00003569 -0.00003545 + -0.00003569 0.00012985 -0.00003572 + -0.00003545 -0.00003572 0.00012933 + #*EXTRAS*# Step: 6 Bead: 5 + 0.00012976 -0.00003554 -0.00003531 + -0.00003554 0.00012995 -0.00003557 + -0.00003531 -0.00003557 0.00012943 + #*EXTRAS*# Step: 7 Bead: 5 + 0.00012979 -0.00003550 -0.00003527 + -0.00003550 0.00012997 -0.00003552 + -0.00003527 -0.00003552 0.00012946 + #*EXTRAS*# Step: 8 Bead: 5 + 0.00012980 -0.00003548 -0.00003525 + -0.00003548 0.00012999 -0.00003550 + -0.00003525 -0.00003550 0.00012947 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_06 b/drivers/py/pes/friction/frictionH/080K/inst.fric_06 new file mode 100644 index 000000000..d3b2f7b0c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_06 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 6 + 0.00012029 -0.00004409 -0.00004407 + -0.00004409 0.00012020 -0.00004396 + -0.00004407 -0.00004396 0.00012025 + #*EXTRAS*# Step: 1 Bead: 6 + 0.00012145 -0.00004366 -0.00004363 + -0.00004366 0.00012147 -0.00004365 + -0.00004363 -0.00004365 0.00012137 + #*EXTRAS*# Step: 2 Bead: 6 + 0.00012354 -0.00004252 -0.00004217 + -0.00004252 0.00012361 -0.00004262 + -0.00004217 -0.00004262 0.00012333 + #*EXTRAS*# Step: 3 Bead: 6 + 0.00012421 -0.00004202 -0.00004157 + -0.00004202 0.00012427 -0.00004213 + -0.00004157 -0.00004213 0.00012396 + #*EXTRAS*# Step: 4 Bead: 6 + 0.00012487 -0.00004147 -0.00004094 + -0.00004147 0.00012493 -0.00004157 + -0.00004094 -0.00004157 0.00012458 + #*EXTRAS*# Step: 5 Bead: 6 + 0.00012498 -0.00004137 -0.00004083 + -0.00004137 0.00012504 -0.00004147 + -0.00004083 -0.00004147 0.00012469 + #*EXTRAS*# Step: 6 Bead: 6 + 0.00012507 -0.00004128 -0.00004074 + -0.00004128 0.00012514 -0.00004138 + -0.00004074 -0.00004138 0.00012478 + #*EXTRAS*# Step: 7 Bead: 6 + 0.00012511 -0.00004125 -0.00004071 + -0.00004125 0.00012517 -0.00004135 + -0.00004071 -0.00004135 0.00012481 + #*EXTRAS*# Step: 8 Bead: 6 + 0.00012512 -0.00004123 -0.00004069 + -0.00004123 0.00012518 -0.00004133 + -0.00004069 -0.00004133 0.00012483 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_07 b/drivers/py/pes/friction/frictionH/080K/inst.fric_07 new file mode 100644 index 000000000..72dea0f1a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_07 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 7 + 0.00011665 -0.00004461 -0.00004432 + -0.00004461 0.00011623 -0.00004421 + -0.00004432 -0.00004421 0.00011666 + #*EXTRAS*# Step: 1 Bead: 7 + 0.00011691 -0.00004462 -0.00004434 + -0.00004462 0.00011649 -0.00004422 + -0.00004434 -0.00004422 0.00011692 + #*EXTRAS*# Step: 2 Bead: 7 + 0.00011833 -0.00004455 -0.00004437 + -0.00004455 0.00011801 -0.00004422 + -0.00004437 -0.00004422 0.00011833 + #*EXTRAS*# Step: 3 Bead: 7 + 0.00011968 -0.00004427 -0.00004421 + -0.00004427 0.00011951 -0.00004407 + -0.00004421 -0.00004407 0.00011965 + #*EXTRAS*# Step: 4 Bead: 7 + 0.00012029 -0.00004409 -0.00004407 + -0.00004409 0.00012020 -0.00004396 + -0.00004407 -0.00004396 0.00012025 + #*EXTRAS*# Step: 5 Bead: 7 + 0.00012045 -0.00004404 -0.00004402 + -0.00004404 0.00012038 -0.00004393 + -0.00004402 -0.00004393 0.00012041 + #*EXTRAS*# Step: 6 Bead: 7 + 0.00012055 -0.00004400 -0.00004399 + -0.00004400 0.00012049 -0.00004390 + -0.00004399 -0.00004390 0.00012050 + #*EXTRAS*# Step: 7 Bead: 7 + 0.00012059 -0.00004399 -0.00004398 + -0.00004399 0.00012053 -0.00004389 + -0.00004398 -0.00004389 0.00012054 + #*EXTRAS*# Step: 8 Bead: 7 + 0.00012060 -0.00004398 -0.00004398 + -0.00004398 0.00012055 -0.00004389 + -0.00004398 -0.00004389 0.00012056 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_08 b/drivers/py/pes/friction/frictionH/080K/inst.fric_08 new file mode 100644 index 000000000..8911c1063 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_08 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 8 + 0.00011322 -0.00004352 -0.00004346 + -0.00004352 0.00011306 -0.00004343 + -0.00004346 -0.00004343 0.00011326 + #*EXTRAS*# Step: 1 Bead: 8 + 0.00011255 -0.00004316 -0.00004317 + -0.00004316 0.00011247 -0.00004314 + -0.00004317 -0.00004314 0.00011260 + #*EXTRAS*# Step: 2 Bead: 8 + 0.00011281 -0.00004330 -0.00004328 + -0.00004330 0.00011270 -0.00004326 + -0.00004328 -0.00004326 0.00011286 + #*EXTRAS*# Step: 3 Bead: 8 + 0.00011444 -0.00004407 -0.00004389 + -0.00004407 0.00011415 -0.00004384 + -0.00004389 -0.00004384 0.00011447 + #*EXTRAS*# Step: 4 Bead: 8 + 0.00011491 -0.00004424 -0.00004402 + -0.00004424 0.00011457 -0.00004395 + -0.00004402 -0.00004395 0.00011494 + #*EXTRAS*# Step: 5 Bead: 8 + 0.00011511 -0.00004430 -0.00004406 + -0.00004430 0.00011475 -0.00004399 + -0.00004406 -0.00004399 0.00011513 + #*EXTRAS*# Step: 6 Bead: 8 + 0.00011520 -0.00004433 -0.00004409 + -0.00004433 0.00011484 -0.00004401 + -0.00004409 -0.00004401 0.00011523 + #*EXTRAS*# Step: 7 Bead: 8 + 0.00011524 -0.00004434 -0.00004409 + -0.00004434 0.00011487 -0.00004402 + -0.00004409 -0.00004402 0.00011527 + #*EXTRAS*# Step: 8 Bead: 8 + 0.00011526 -0.00004434 -0.00004410 + -0.00004434 0.00011489 -0.00004403 + -0.00004410 -0.00004403 0.00011529 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_09 b/drivers/py/pes/friction/frictionH/080K/inst.fric_09 new file mode 100644 index 000000000..a9a573430 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_09 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 9 + 0.00011023 -0.00004172 -0.00004180 + -0.00004172 0.00011025 -0.00004177 + -0.00004180 -0.00004177 0.00011031 + #*EXTRAS*# Step: 1 Bead: 9 + 0.00010885 -0.00004070 -0.00004074 + -0.00004070 0.00010887 -0.00004071 + -0.00004074 -0.00004071 0.00010891 + #*EXTRAS*# Step: 2 Bead: 9 + 0.00010821 -0.00004017 -0.00004019 + -0.00004017 0.00010821 -0.00004018 + -0.00004019 -0.00004018 0.00010824 + #*EXTRAS*# Step: 3 Bead: 9 + 0.00010994 -0.00004152 -0.00004159 + -0.00004152 0.00010996 -0.00004156 + -0.00004159 -0.00004156 0.00011002 + #*EXTRAS*# Step: 4 Bead: 9 + 0.00011023 -0.00004172 -0.00004180 + -0.00004172 0.00011026 -0.00004177 + -0.00004180 -0.00004177 0.00011031 + #*EXTRAS*# Step: 5 Bead: 9 + 0.00011043 -0.00004186 -0.00004194 + -0.00004186 0.00011046 -0.00004191 + -0.00004194 -0.00004191 0.00011051 + #*EXTRAS*# Step: 6 Bead: 9 + 0.00011051 -0.00004191 -0.00004199 + -0.00004191 0.00011053 -0.00004196 + -0.00004199 -0.00004196 0.00011059 + #*EXTRAS*# Step: 7 Bead: 9 + 0.00011054 -0.00004193 -0.00004201 + -0.00004193 0.00011057 -0.00004199 + -0.00004201 -0.00004199 0.00011062 + #*EXTRAS*# Step: 8 Bead: 9 + 0.00011056 -0.00004194 -0.00004202 + -0.00004194 0.00011058 -0.00004200 + -0.00004202 -0.00004200 0.00011064 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_10 b/drivers/py/pes/friction/frictionH/080K/inst.fric_10 new file mode 100644 index 000000000..2467ff17a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_10 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 10 + 0.00010769 -0.00003973 -0.00003972 + -0.00003973 0.00010769 -0.00003973 + -0.00003972 -0.00003973 0.00010770 + #*EXTRAS*# Step: 1 Bead: 10 + 0.00010577 -0.00003785 -0.00003780 + -0.00003785 0.00010577 -0.00003793 + -0.00003780 -0.00003793 0.00010561 + #*EXTRAS*# Step: 2 Bead: 10 + 0.00010449 -0.00003638 -0.00003631 + -0.00003638 0.00010449 -0.00003652 + -0.00003631 -0.00003652 0.00010419 + #*EXTRAS*# Step: 3 Bead: 10 + 0.00010621 -0.00003832 -0.00003827 + -0.00003832 0.00010621 -0.00003837 + -0.00003827 -0.00003837 0.00010610 + #*EXTRAS*# Step: 4 Bead: 10 + 0.00010636 -0.00003846 -0.00003842 + -0.00003846 0.00010635 -0.00003851 + -0.00003842 -0.00003851 0.00010626 + #*EXTRAS*# Step: 5 Bead: 10 + 0.00010656 -0.00003867 -0.00003863 + -0.00003867 0.00010656 -0.00003870 + -0.00003863 -0.00003870 0.00010648 + #*EXTRAS*# Step: 6 Bead: 10 + 0.00010662 -0.00003873 -0.00003869 + -0.00003873 0.00010662 -0.00003876 + -0.00003869 -0.00003876 0.00010654 + #*EXTRAS*# Step: 7 Bead: 10 + 0.00010665 -0.00003876 -0.00003872 + -0.00003876 0.00010665 -0.00003879 + -0.00003872 -0.00003879 0.00010658 + #*EXTRAS*# Step: 8 Bead: 10 + 0.00010667 -0.00003877 -0.00003873 + -0.00003877 0.00010666 -0.00003880 + -0.00003873 -0.00003880 0.00010659 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_11 b/drivers/py/pes/friction/frictionH/080K/inst.fric_11 new file mode 100644 index 000000000..dbe3db5f8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_11 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 11 + 0.00010562 -0.00003769 -0.00003763 + -0.00003769 0.00010562 -0.00003777 + -0.00003763 -0.00003777 0.00010544 + #*EXTRAS*# Step: 1 Bead: 11 + 0.00010349 -0.00003504 -0.00003498 + -0.00003504 0.00010347 -0.00003522 + -0.00003498 -0.00003522 0.00010310 + #*EXTRAS*# Step: 2 Bead: 11 + 0.00010203 -0.00003265 -0.00003265 + -0.00003265 0.00010195 -0.00003282 + -0.00003265 -0.00003282 0.00010162 + #*EXTRAS*# Step: 3 Bead: 11 + 0.00010344 -0.00003496 -0.00003490 + -0.00003496 0.00010342 -0.00003515 + -0.00003490 -0.00003515 0.00010305 + #*EXTRAS*# Step: 4 Bead: 11 + 0.00010346 -0.00003499 -0.00003494 + -0.00003499 0.00010345 -0.00003518 + -0.00003494 -0.00003518 0.00010307 + #*EXTRAS*# Step: 5 Bead: 11 + 0.00010363 -0.00003524 -0.00003518 + -0.00003524 0.00010362 -0.00003542 + -0.00003518 -0.00003542 0.00010326 + #*EXTRAS*# Step: 6 Bead: 11 + 0.00010367 -0.00003529 -0.00003523 + -0.00003529 0.00010366 -0.00003548 + -0.00003523 -0.00003548 0.00010330 + #*EXTRAS*# Step: 7 Bead: 11 + 0.00010370 -0.00003533 -0.00003527 + -0.00003533 0.00010369 -0.00003551 + -0.00003527 -0.00003551 0.00010333 + #*EXTRAS*# Step: 8 Bead: 11 + 0.00010371 -0.00003534 -0.00003528 + -0.00003534 0.00010370 -0.00003552 + -0.00003528 -0.00003552 0.00010334 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_12 b/drivers/py/pes/friction/frictionH/080K/inst.fric_12 new file mode 100644 index 000000000..2f6598a56 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_12 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 12 + 0.00010410 -0.00003588 -0.00003581 + -0.00003588 0.00010410 -0.00003604 + -0.00003581 -0.00003604 0.00010377 + #*EXTRAS*# Step: 1 Bead: 12 + 0.00010201 -0.00003262 -0.00003262 + -0.00003262 0.00010193 -0.00003278 + -0.00003262 -0.00003278 0.00010160 + #*EXTRAS*# Step: 2 Bead: 12 + 0.00010043 -0.00002954 -0.00002957 + -0.00002954 0.00010030 -0.00002953 + -0.00002957 -0.00002953 0.00010026 + #*EXTRAS*# Step: 3 Bead: 12 + 0.00010169 -0.00003203 -0.00003204 + -0.00003203 0.00010159 -0.00003216 + -0.00003204 -0.00003216 0.00010130 + #*EXTRAS*# Step: 4 Bead: 12 + 0.00010164 -0.00003194 -0.00003195 + -0.00003194 0.00010154 -0.00003207 + -0.00003195 -0.00003207 0.00010126 + #*EXTRAS*# Step: 5 Bead: 12 + 0.00010178 -0.00003220 -0.00003221 + -0.00003220 0.00010169 -0.00003235 + -0.00003221 -0.00003235 0.00010139 + #*EXTRAS*# Step: 6 Bead: 12 + 0.00010181 -0.00003225 -0.00003225 + -0.00003225 0.00010172 -0.00003239 + -0.00003225 -0.00003239 0.00010141 + #*EXTRAS*# Step: 7 Bead: 12 + 0.00010183 -0.00003228 -0.00003229 + -0.00003228 0.00010174 -0.00003243 + -0.00003229 -0.00003243 0.00010143 + #*EXTRAS*# Step: 8 Bead: 12 + 0.00010183 -0.00003229 -0.00003230 + -0.00003229 0.00010174 -0.00003244 + -0.00003230 -0.00003244 0.00010143 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_13 b/drivers/py/pes/friction/frictionH/080K/inst.fric_13 new file mode 100644 index 000000000..5d0e45ed8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_13 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 13 + 0.00010310 -0.00003446 -0.00003442 + -0.00003446 0.00010308 -0.00003466 + -0.00003442 -0.00003466 0.00010270 + #*EXTRAS*# Step: 1 Bead: 13 + 0.00010106 -0.00003079 -0.00003082 + -0.00003079 0.00010093 -0.00003087 + -0.00003082 -0.00003087 0.00010075 + #*EXTRAS*# Step: 2 Bead: 13 + 0.00009923 -0.00002720 -0.00002715 + -0.00002720 0.00009921 -0.00002704 + -0.00002715 -0.00002704 0.00009946 + #*EXTRAS*# Step: 3 Bead: 13 + 0.00010054 -0.00002977 -0.00002980 + -0.00002977 0.00010042 -0.00002978 + -0.00002980 -0.00002978 0.00010034 + #*EXTRAS*# Step: 4 Bead: 13 + 0.00010045 -0.00002958 -0.00002961 + -0.00002958 0.00010033 -0.00002958 + -0.00002961 -0.00002958 0.00010027 + #*EXTRAS*# Step: 5 Bead: 13 + 0.00010058 -0.00002985 -0.00002989 + -0.00002985 0.00010046 -0.00002987 + -0.00002989 -0.00002987 0.00010037 + #*EXTRAS*# Step: 6 Bead: 13 + 0.00010060 -0.00002989 -0.00002992 + -0.00002989 0.00010048 -0.00002991 + -0.00002992 -0.00002991 0.00010039 + #*EXTRAS*# Step: 7 Bead: 13 + 0.00010062 -0.00002992 -0.00002996 + -0.00002992 0.00010049 -0.00002995 + -0.00002996 -0.00002995 0.00010040 + #*EXTRAS*# Step: 8 Bead: 13 + 0.00010063 -0.00002993 -0.00002997 + -0.00002993 0.00010050 -0.00002996 + -0.00002997 -0.00002996 0.00010041 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_14 b/drivers/py/pes/friction/frictionH/080K/inst.fric_14 new file mode 100644 index 000000000..e7c39bd7e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_14 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 14 + 0.00010253 -0.00003354 -0.00003351 + -0.00003354 0.00010248 -0.00003373 + -0.00003351 -0.00003373 0.00010211 + #*EXTRAS*# Step: 1 Bead: 14 + 0.00010046 -0.00002960 -0.00002963 + -0.00002960 0.00010033 -0.00002960 + -0.00002963 -0.00002960 0.00010028 + #*EXTRAS*# Step: 2 Bead: 14 + 0.00009847 -0.00002565 -0.00002549 + -0.00002565 0.00009857 -0.00002539 + -0.00002549 -0.00002539 0.00009901 + #*EXTRAS*# Step: 3 Bead: 14 + 0.00009978 -0.00002826 -0.00002826 + -0.00002826 0.00009969 -0.00002818 + -0.00002826 -0.00002818 0.00009981 + #*EXTRAS*# Step: 4 Bead: 14 + 0.00009965 -0.00002801 -0.00002800 + -0.00002801 0.00009958 -0.00002791 + -0.00002800 -0.00002791 0.00009972 + #*EXTRAS*# Step: 5 Bead: 14 + 0.00009979 -0.00002829 -0.00002828 + -0.00002829 0.00009970 -0.00002820 + -0.00002828 -0.00002820 0.00009981 + #*EXTRAS*# Step: 6 Bead: 14 + 0.00009981 -0.00002831 -0.00002831 + -0.00002831 0.00009972 -0.00002823 + -0.00002831 -0.00002823 0.00009982 + #*EXTRAS*# Step: 7 Bead: 14 + 0.00009982 -0.00002835 -0.00002835 + -0.00002835 0.00009973 -0.00002827 + -0.00002835 -0.00002827 0.00009984 + #*EXTRAS*# Step: 8 Bead: 14 + 0.00009983 -0.00002836 -0.00002836 + -0.00002836 0.00009974 -0.00002828 + -0.00002836 -0.00002828 0.00009984 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_15 b/drivers/py/pes/friction/frictionH/080K/inst.fric_15 new file mode 100644 index 000000000..f9ea2019f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.fric_15 @@ -0,0 +1,36 @@ + #*EXTRAS*# Step: 0 Bead: 15 + 0.00010230 -0.00003314 -0.00003313 + -0.00003314 0.00010224 -0.00003332 + -0.00003313 -0.00003332 0.00010188 + #*EXTRAS*# Step: 1 Bead: 15 + 0.00010018 -0.00002905 -0.00002907 + -0.00002905 0.00010007 -0.00002902 + -0.00002907 -0.00002902 0.00010008 + #*EXTRAS*# Step: 2 Bead: 15 + 0.00009813 -0.00002486 -0.00002466 + -0.00002486 0.00009829 -0.00002457 + -0.00002466 -0.00002457 0.00009881 + #*EXTRAS*# Step: 3 Bead: 15 + 0.00009939 -0.00002752 -0.00002748 + -0.00002752 0.00009935 -0.00002738 + -0.00002748 -0.00002738 0.00009956 + #*EXTRAS*# Step: 4 Bead: 15 + 0.00009925 -0.00002723 -0.00002718 + -0.00002723 0.00009922 -0.00002708 + -0.00002718 -0.00002708 0.00009947 + #*EXTRAS*# Step: 5 Bead: 15 + 0.00009939 -0.00002751 -0.00002747 + -0.00002751 0.00009934 -0.00002737 + -0.00002747 -0.00002737 0.00009956 + #*EXTRAS*# Step: 6 Bead: 15 + 0.00009940 -0.00002753 -0.00002750 + -0.00002753 0.00009936 -0.00002739 + -0.00002750 -0.00002739 0.00009956 + #*EXTRAS*# Step: 7 Bead: 15 + 0.00009942 -0.00002757 -0.00002753 + -0.00002757 0.00009937 -0.00002743 + -0.00002753 -0.00002743 0.00009958 + #*EXTRAS*# Step: 8 Bead: 15 + 0.00009942 -0.00002757 -0.00002754 + -0.00002757 0.00009937 -0.00002744 + -0.00002754 -0.00002744 0.00009958 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 new file mode 100644 index 000000000..702bbbd68 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 @@ -0,0 +1 @@ +3.848816013467453844e-03 8.168849192070688130e-05 8.117592854329587677e-05 2.962103052563885321e-03 7.737806929705504978e-05 7.595675177554375636e-05 8.975563515802296478e-04 6.848565001727331637e-05 6.561133136189707432e-05 -2.279414089407330070e-03 5.449456957949019137e-05 5.142695233042486537e-05 -5.819192557942849849e-03 3.517614308405234093e-05 3.458346556665543576e-05 -8.619900403653483686e-03 1.512031549807616858e-05 1.737695997800449278e-05 -1.050642290345041308e-02 7.000723082972680365e-06 6.483629802385290260e-06 -1.077156939376164649e-02 2.403438865849462230e-06 2.367109196458023822e-06 -9.590799175848638281e-03 5.722235238920154082e-06 5.179207098056606810e-06 -7.529661465569640992e-03 1.250728202561327896e-05 1.262622107606156164e-05 -4.570709393129483017e-03 2.102853683006754019e-05 2.145574844841502055e-05 -2.199434432594933077e-03 2.989454560225144667e-05 2.996517364354508100e-05 -5.537097967210666098e-04 3.760926945321859982e-05 3.731691345500043485e-05 5.452320173647189159e-04 4.349293265564602813e-05 4.288886364187012985e-05 1.207055123009427361e-03 4.724537850899594851e-05 4.653315033514263973e-05 1.489936701812690943e-03 4.898796923558525440e-05 4.827437869671750428e-05 4.756585481032841307e-13 5.511521605213636210e-01 -5.676965204487502605e-10 4.896548224208646806e-13 5.511521605134122037e-01 -5.763532532219209933e-10 4.881943095111531276e-13 5.511521605264637635e-01 -5.636988022399026912e-10 4.162489825411322898e-13 5.511521606215992186e-01 -4.670684602112703929e-10 2.748815967240572581e-13 5.511521607900793374e-01 -2.970966278006180707e-10 1.322238212863753943e-13 5.511521609500706909e-01 -1.381621920360443077e-10 4.228008071949504894e-14 5.511521610459323428e-01 -4.335852348985841361e-11 -5.628166873325347571e-15 5.511521610947808236e-01 5.370058672060792098e-12 3.086039872903703092e-14 5.511521610561048723e-01 -3.328257264253010421e-11 1.218258078601125395e-13 5.511521609584872916e-01 -1.309164509509935022e-10 2.197823580693126418e-13 5.511521608518080706e-01 -2.372725164466611198e-10 2.345608691806549038e-13 5.511521608343793455e-01 -2.546135821108957362e-10 2.346714708399622283e-13 5.511521608327488719e-01 -2.563549098278644410e-10 2.332240545357269058e-13 5.511521608327861754e-01 -2.565116327920593380e-10 2.309275105286272925e-13 5.511521608336157341e-01 -2.558209768911843809e-10 2.277690898883131463e-13 5.511521608349958523e-01 -2.544938715600596783e-10 4.753823797942655208e-13 -5.676965204487502605e-10 5.511521605220229825e-01 4.899740903349011554e-13 -5.763532532219209933e-10 5.511521605126608048e-01 4.888643683112122866e-13 -5.636988022399026912e-10 5.511521605249173339e-01 4.156063245953167610e-13 -4.670684602112703929e-10 5.511521606230426196e-01 2.728483934342467479e-13 -2.970966278006180707e-10 5.511521607944908085e-01 1.311257108518350478e-13 -1.381621920360443077e-10 5.511521609523751808e-01 4.218373058284853604e-14 -4.335852348985841361e-11 5.511521610461301846e-01 -5.606326919321834710e-15 5.370058672060792098e-12 5.511521610947391903e-01 3.085806226771893369e-14 -3.328257264253010421e-11 5.511521610561098683e-01 1.218387915056642939e-13 -1.309164509509935022e-10 5.511521609584596471e-01 2.194961976319706031e-13 -2.372725164466611198e-10 5.511521608524263538e-01 2.341957540808614450e-13 -2.546135821108957362e-10 5.511521608351727108e-01 2.344098775140466797e-13 -2.563549098278644410e-10 5.511521608333207478e-01 2.331403207051633409e-13 -2.565116327920593380e-10 5.511521608329703614e-01 2.309697927147226834e-13 -2.558209768911843809e-10 5.511521608335221423e-01 2.278584650633292919e-13 -2.544938715600596783e-10 5.511521608347962342e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 new file mode 100644 index 000000000..b9f66511c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 @@ -0,0 +1 @@ +1.022250950873395889e-02 8.168849171540636946e-05 8.117592833633839231e-05 9.314407321804780981e-03 7.737806913220926519e-05 7.595675160898745311e-05 7.278376835342327891e-03 6.848564994995253363e-05 6.561133129398484575e-05 3.839627858465096723e-03 5.449456966952433200e-05 5.142695242202354361e-05 -1.235483919753982938e-03 3.517614328163232363e-05 3.458346576414425739e-05 -6.460585866343576331e-03 1.512031563377981681e-05 1.737696011194258383e-05 -9.720477741770972707e-03 7.000723126361082503e-06 6.483629845682273826e-06 -1.089281043220580690e-02 2.403438865595860142e-06 2.367109196198344273e-06 -9.506461776959478430e-03 5.722235108785362929e-06 5.179206968071776910e-06 -6.572535358646245524e-03 1.250728341084602608e-05 1.262622246032084599e-05 -2.837894456659251739e-03 2.102853777149363580e-05 2.145574938850087286e-05 -2.484929710929685218e-04 2.989454631292735295e-05 2.996517435392006358e-05 1.515222886837315486e-03 3.760927004338793169e-05 3.731691404599285234e-05 2.675238157588899317e-03 4.349293317036180057e-05 4.288886415777347637e-05 3.345622494813633996e-03 4.724537896897752933e-05 4.653315079606289568e-05 3.633865862444505580e-03 4.898796965941733250e-05 4.827437912121075597e-05 2.703580413307583857e-13 5.511521603186859686e-01 -7.651463142724816371e-10 3.248090363729109867e-13 5.511521602630644612e-01 -8.227628429228076383e-10 4.208735329804183436e-13 5.511521601824186378e-01 -9.071396388601220390e-10 5.062831226641827345e-13 5.511521601654791880e-01 -9.255875701053610310e-10 4.724615823866634858e-13 5.511521603360959309e-01 -7.499046070455007176e-10 2.679274700679838702e-13 5.511521606950948726e-01 -3.900800269419927783e-10 8.566848284963499992e-14 5.511521609597531679e-01 -1.293526217250779925e-10 -5.881769073666515335e-15 5.511521611017147215e-01 1.229174133093861704e-11 -9.927439258136484675e-14 5.511521610166586482e-01 -7.262290928369203041e-11 1.507058555768717822e-12 5.511521602268968367e-01 -8.619433763561921486e-10 1.161208453036284952e-12 5.511521601655102742e-01 -9.225854992733558791e-10 9.452367766457263920e-13 5.511521602357430938e-01 -8.530451911171518194e-10 8.248408005983791478e-13 5.511521602871567449e-01 -8.027784534129508419e-10 7.479398267253954023e-13 5.511521603249700529e-01 -7.655473142625396778e-10 6.909090921392663053e-13 5.511521603580815665e-01 -7.323463412986064471e-10 6.516011675045972317e-13 5.511521603817637338e-01 -7.084411357047056412e-10 2.684248910602787833e-13 -7.651463142724816371e-10 5.511521603296661853e-01 3.234177870682267496e-13 -8.227628429228076383e-10 5.511521602701273670e-01 4.209521359718583480e-13 -9.071396388601220390e-10 5.511521601820796867e-01 5.072050015764997785e-13 -9.255875701053610310e-10 5.511521601621117705e-01 4.703372162888127459e-13 -7.499046070455007176e-10 5.511521603428551908e-01 2.650638020208627260e-13 -3.900800269419927783e-10 5.511521607034786108e-01 8.548071456600408005e-14 -1.293526217250779925e-10 5.511521609603208249e-01 -5.866006640857568178e-15 1.229174133093861704e-11 5.511521611016487743e-01 -9.912676757080312601e-14 -7.262290928369203041e-11 5.511521610168750307e-01 1.506098075541328232e-12 -8.619433763561921486e-10 5.511521602279958465e-01 1.159582051071548834e-12 -9.225854992733558791e-10 5.511521601680967608e-01 9.445707365418246590e-13 -8.530451911171518194e-10 5.511521602369456874e-01 8.254022949076064589e-13 -8.027784534129508419e-10 5.511521602860645075e-01 7.490436647789404468e-13 -7.655473142625396778e-10 5.511521603227121924e-01 6.918900465207069115e-13 -7.323463412986064471e-10 5.511521603560035620e-01 6.523517159948754699e-13 -7.084411357047056412e-10 5.511521603801327052e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 new file mode 100644 index 000000000..86a53757c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 @@ -0,0 +1 @@ +1.213474489650410125e-02 8.168849700374486216e-05 8.117593367649364444e-05 1.128424870710178010e-02 7.737807465904134963e-05 7.595675721331588293e-05 9.440621591194747406e-03 6.848565654012305447e-05 6.561133801227827492e-05 6.320083573381450603e-03 5.449457970774858502e-05 5.142696261665835280e-05 1.494213710163675574e-03 3.517617640907361805e-05 3.458349859360403659e-05 -4.628095741883485673e-03 1.511977055843484447e-05 1.737642638271837242e-05 -8.872511444336286107e-03 7.000722920284769805e-06 6.483629639143110138e-06 -1.090919162834840667e-02 2.403438871147049381e-06 2.367109201734640978e-06 -9.871846414026550984e-03 5.722235221697636454e-06 5.179207080818901880e-06 -7.093829044566472321e-03 1.250728214748009681e-05 1.262622119777729592e-05 -3.068959554078140150e-03 2.102853695074402942e-05 2.145574856892599954e-05 -2.219397023078864789e-04 2.989454576690063492e-05 2.996517380827204720e-05 1.697511820478513544e-03 3.760926967861484636e-05 3.731691368095627878e-05 2.951930272532381390e-03 4.349293293855055340e-05 4.288886392584222835e-05 3.667268201574347929e-03 4.724537883408970766e-05 4.653315066164967674e-05 3.976081782074991806e-03 4.898796958399663119e-05 4.827437904671262261e-05 5.558696534331097481e-12 5.511521583695530024e-01 -2.744057024231243171e-09 5.851641115052203308e-12 5.511521582455521928e-01 -2.880626678497070631e-09 7.011044048241369889e-12 5.511521578126543641e-01 -3.336447183175965589e-09 1.054450737744966950e-11 5.511521567015560397e-01 -4.453198177427882760e-09 3.359990287600885206e-11 5.511521516080973848e-01 -9.396597659134412891e-09 -5.448074175018051431e-10 5.511521088167019577e-01 -5.118431443330913843e-08 -1.204078300376211055e-13 5.511521608867114841e-01 -2.037629958781918905e-10 -3.305796914762238071e-16 5.511521611017179412e-01 1.229468806433471576e-11 1.363788106388006488e-14 5.511521610202351207e-01 -6.906580174727430600e-11 2.436926262134731966e-13 5.511521602376366902e-01 -8.512698745463684233e-10 3.404588471785187252e-13 5.511521601735831499e-01 -9.145919014279664702e-10 3.992100602842416411e-13 5.511521602342810411e-01 -8.544932818821358959e-10 4.600677186171777081e-13 5.511521602726872082e-01 -8.172308994084592148e-10 5.161285821640344071e-13 5.511521602961261257e-01 -7.947733155018685915e-10 5.560212674589925133e-13 5.511521603174508455e-01 -7.739499286793696513e-10 5.761804664852089093e-13 5.511521603335632902e-01 -7.580045307676715695e-10 5.608580146409156458e-12 -2.744057024231243171e-09 5.511521583205227781e-01 5.927746217711726468e-12 -2.880626678497070631e-09 5.511521581711048556e-01 7.139245559000621467e-12 -3.336447183175965589e-09 5.511521576917327581e-01 1.070183981228245095e-11 -4.453198177427882760e-09 5.511521565696427816e-01 3.329979699691218952e-11 -9.396597659134412891e-09 5.511521517767101752e-01 -5.334641604106086912e-10 -5.118431443330913843e-08 5.511521109707457899e-01 -1.210584493707743558e-13 -2.037629958781918905e-10 5.511521608845161291e-01 -3.297097853820426015e-16 1.229468806433471576e-11 5.511521611016514388e-01 1.362035700338916265e-14 -6.906580174727430600e-11 5.511521610204128674e-01 2.435545247122672577e-13 -8.512698745463684233e-10 5.511521602386033614e-01 3.400071777418803425e-13 -9.145919014279664702e-10 5.511521601760118738e-01 3.989227196953342904e-13 -8.544932818821358959e-10 5.511521602355113902e-01 4.603657240382528359e-13 -8.172308994084592148e-10 5.511521602716291657e-01 5.171124183277519517e-13 -7.947733155018685915e-10 5.511521602930991026e-01 5.574768273141885669e-13 -7.739499286793696513e-10 5.511521603134038605e-01 5.778535817977709306e-13 -7.580045307676715695e-10 5.511521603291678062e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 new file mode 100644 index 000000000..a7c31b429 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 @@ -0,0 +1 @@ +1.148727464454150568e-02 8.168849550871075805e-05 8.117593217108051359e-05 1.069052542290745665e-02 7.737807295971834852e-05 7.595675549244376734e-05 8.978329026521949738e-03 6.848565384129504986e-05 6.561133526328859970e-05 6.105210616616484239e-03 5.449457362791876238e-05 5.142695644576762297e-05 1.694406448271799969e-03 3.517614903071349352e-05 3.458347145993574532e-05 -4.064637037711391586e-03 1.512033434225979787e-05 1.737697842824592576e-05 -8.418996877365858555e-03 7.000723080360539176e-06 6.483629800054897640e-06 -1.077154444001353871e-02 2.403438870605099490e-06 2.367109201194806552e-06 -1.023511732673308521e-02 5.722235199242722718e-06 5.179207058382723667e-06 -7.994935036065664233e-03 1.250728140544632609e-05 1.262622045576768089e-05 -4.087040763840558630e-03 2.102853758902800398e-05 2.145574917449845614e-05 -1.043952669360425712e-03 2.989560876566563834e-05 2.996622367393672032e-05 9.893587631268044476e-04 3.760916837160726374e-05 3.731681225179358895e-05 2.332544146037315250e-03 4.349292015974616477e-05 4.288885079716610359e-05 3.140028989046306663e-03 4.724537408046027177e-05 4.653314566207486660e-05 3.502635738655277171e-03 4.898796663002114059e-05 4.827437590318597134e-05 4.063662430881635696e-12 5.511521589380419250e-01 -2.172078095477291178e-09 4.152318115752613051e-12 5.511521586728382882e-01 -2.448105267342441530e-09 4.312216041533378824e-12 5.511521580340895676e-01 -3.110388660660705836e-09 4.464677551550094175e-12 5.511521567565818014e-01 -4.397017206738851148e-09 6.221542748716405658e-12 5.511521515864775678e-01 -9.418260295684605978e-09 1.897640745181470589e-11 5.511521087977395705e-01 -5.120304998926697556e-08 3.966793953922608162e-14 5.511521608824353491e-01 -2.079086051123496080e-10 -8.725296980836753789e-16 5.511521611015488542e-01 1.211695830240388816e-11 -8.817032641791125975e-15 5.511521610218647060e-01 -6.751828580050805921e-11 -4.983411439441867365e-13 5.511521603371335454e-01 -7.524289837664857125e-10 9.787428225621367145e-13 5.511521615240350114e-01 4.200722261448114165e-10 1.063397975062885625e-09 5.511522227849084965e-01 6.093361079365765211e-08 -1.008469398625218168e-10 5.511521729787619561e-01 1.190374001004779939e-08 -1.226267580713257810e-11 5.511521636559422177e-01 2.639790795855090065e-09 -4.197608167422198893e-12 5.511521621603934218e-01 1.134096174061590751e-09 -2.377795025657471446e-12 5.511521617394657957e-01 7.024909593661340369e-10 4.103167015826818304e-12 -2.172078095477291178e-09 5.511521588960132112e-01 4.206874102449894273e-12 -2.448105267342441530e-09 5.511521586089257463e-01 4.390255888497085413e-12 -3.110388660660705836e-09 5.511521579225111545e-01 4.530949081985711996e-12 -4.397017206738851148e-09 5.511521566270032313e-01 6.166128707973944523e-12 -9.418260295684605978e-09 5.511521517550046489e-01 1.858136714125196845e-11 -5.120304998926697556e-08 5.511521109522343753e-01 3.985333806332250267e-14 -2.079086051123496080e-10 5.511521608804971217e-01 -8.695442376942530056e-16 1.211695830240388816e-11 5.511521611014645883e-01 -8.815821102797558275e-15 -6.751828580050805921e-11 5.511521610218824696e-01 -4.984550901597501560e-13 -7.524289837664857125e-10 5.511521603367925959e-01 9.455796352675250402e-13 4.200722261448114165e-10 5.511521614950728454e-01 1.050264587391547796e-09 6.093361079365765211e-08 5.511522212703875434e-01 -1.009687969688070562e-10 1.190374001004779939e-08 5.511521730075137349e-01 -1.261156370593685958e-11 2.639790795855090065e-09 5.511521638040741689e-01 -4.442097981735285692e-12 1.134096174061590751e-09 5.511521622888533312e-01 -2.565673069591487310e-12 7.024909593661340369e-10 5.511521618463761651e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 new file mode 100644 index 000000000..19baee6ec --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 @@ -0,0 +1 @@ +1.194609519088017310e-02 8.168866876252675558e-05 8.117610847307584160e-05 1.116848124441446877e-02 7.737838301283975011e-05 7.595707360947497901e-05 9.495229746956303229e-03 6.848727722154936961e-05 6.561301824779411449e-05 6.690657496589770201e-03 5.422663114131081658e-05 5.114983527271563897e-05 2.354532922473803833e-03 3.517585203656454731e-05 3.458317441170667277e-05 -3.508678470960618044e-03 1.512011131095072591e-05 1.737676009667945287e-05 -8.150396893536930934e-03 7.000722515964341281e-06 6.483629231955818983e-06 -1.067836609500128452e-02 2.403438873721513274e-06 2.367109204286613182e-06 -1.033584371098340664e-02 5.722235192068733973e-06 5.179207051211823203e-06 -8.183758531896713484e-03 1.250728184889370181e-05 1.262622089931744426e-05 -4.276490789822882423e-03 2.102853657718814078e-05 2.145574819694395232e-05 -1.149239313849215530e-03 2.989452918275996136e-05 2.996515742430733275e-05 9.352184531151144700e-04 3.760926346121555672e-05 3.731690745631323114e-05 2.309581701104157156e-03 4.349293059126632796e-05 4.288886152552526330e-05 3.135005222865847475e-03 4.724537730818806954e-05 4.653314907783503399e-05 3.505364494002718035e-03 4.898796834715435112e-05 4.827437775594430166e-05 1.773174784314222454e-10 5.511521451855092568e-01 -1.618056100807836841e-08 3.142054395203040535e-10 5.511521378909758351e-01 -2.379740009192075632e-08 1.627692470357670862e-09 5.511520918193216767e-01 -7.180922139511712548e-08 -2.679380219303927123e-07 5.511500296497280349e-01 -2.204454410957910228e-06 -2.907726062005159603e-10 5.511521334395411698e-01 -2.765962685182482183e-08 -2.040549016203031689e-10 5.511521067403231111e-01 -5.320245317180295586e-08 -5.247282585024413128e-13 5.511521607364220365e-01 -3.553196966544836533e-10 2.243884244282036897e-15 5.511521610931457982e-01 3.719149447666536059e-12 -1.599102107170741120e-14 5.511521610233308666e-01 -6.604229666964056829e-11 -5.489376856941828928e-14 5.511521603373742417e-01 -7.521776573702375300e-10 -3.309704053645203043e-14 5.511521615243316630e-01 4.203554526608867761e-10 -1.618493061332452149e-11 5.511522227864783519e-01 6.093516134113727624e-08 -5.757331572204494416e-12 5.511521729819934823e-01 1.190695432439285548e-08 -1.831155641509630742e-12 5.511521636587757289e-01 2.642632480471970944e-09 -9.698803700001246776e-13 5.511521621613556521e-01 1.135068931958450479e-09 -6.606618134995239459e-13 5.511521617388250860e-01 7.018408290427240437e-10 1.804051623412379161e-10 -1.618056100807836841e-08 5.511521446268166091e-01 3.223239053202732732e-10 -2.379740009192075632e-08 5.511521366767052621e-01 1.687374761402610505e-09 -7.180922139511712548e-08 5.511520866464232338e-01 -2.771166421029032047e-07 -2.204454410957910228e-06 5.511498811171823276e-01 -2.908821003637339904e-10 -2.765962685182482183e-08 5.511521334187166055e-01 -1.997501993308963627e-10 -5.320245317180295586e-08 5.511521090092086350e-01 -5.282457408661083667e-13 -3.553196966544836533e-10 5.511521607316748339e-01 2.222262348238359919e-15 3.719149447666536059e-12 5.511521610930720794e-01 -1.598672114610569521e-14 -6.604229666964056829e-11 5.511521610233682811e-01 -5.490532709959895736e-14 -7.521776573702375300e-10 5.511521603370549416e-01 -3.197486765801182999e-14 4.203554526608867761e-10 5.511521614953432957e-01 -1.598504199455734085e-11 6.093516134113727624e-08 5.511522212719190961e-01 -5.764277328406737922e-12 1.190695432439285548e-08 5.511521730107108441e-01 -1.883204547021388141e-12 2.642632480471970944e-09 5.511521638069240003e-01 -1.026337815243301887e-12 1.135068931958450479e-09 5.511521622898367667e-01 -7.129147404835939678e-13 7.018408290427240437e-10 5.511521618457164706e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 new file mode 100644 index 000000000..37bc291fa --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 @@ -0,0 +1 @@ +1.196183917173967819e-02 8.168850961281770562e-05 8.117594655196902920e-05 1.118984777531227374e-02 7.737809163103933469e-05 7.595677469883255250e-05 9.529360275040041697e-03 6.848570028469011875e-05 6.561138348959391381e-05 6.738434369764941499e-03 5.449558214546306654e-05 5.142799959903568668e-05 2.443959019660742974e-03 3.517615040909386777e-05 3.458347289658708710e-05 -3.397842537391878269e-03 1.512032423335174485e-05 1.737696852731456654e-05 -8.078209948545826344e-03 7.000723089538597710e-06 6.483629809372825031e-06 -1.064136406300011765e-02 2.403438870984566015e-06 2.367109201576260216e-06 -1.037801800467184031e-02 5.722235214373190093e-06 5.179207073509804603e-06 -8.285907016976842149e-03 1.250728186130603622e-05 1.262622091173203855e-05 -4.420146180520683268e-03 2.102853675958730423e-05 2.145574837320423094e-05 -1.263483854937507214e-03 2.989459471148623251e-05 2.996522214375597798e-05 8.388988987292986949e-04 3.760928659939345383e-05 3.731693062200491323e-05 2.225628301235645697e-03 4.349293865206814376e-05 4.288886981181363968e-05 3.060211249714175300e-03 4.724538244508970900e-05 4.653315449754097101e-05 3.437943879029638737e-03 4.898797262214283607e-05 4.827438233027248868e-05 1.816776937504030192e-11 5.511521451803104155e-01 -1.618578732525582605e-08 2.282363911015333401e-11 5.511521378856951703e-01 -2.380272332478414526e-08 5.075561110514579111e-11 5.511520918138224090e-01 -7.181479250297925298e-08 1.012982221858732238e-09 5.511500297723587183e-01 -2.204329205748493972e-06 7.599923122978640365e-12 5.511521334379325676e-01 -2.766123307817034152e-08 8.867499397919887931e-12 5.511521067396160101e-01 -5.320317192774800879e-08 4.884599759849672394e-14 5.511521607360732045e-01 -3.556622403884388879e-10 -4.930629623813490367e-16 5.511521610929706050e-01 3.541892266442918413e-12 6.313435279810250904e-15 5.511521610234257906e-01 -6.594569598088282138e-11 -4.248143339068855715e-14 5.511521603374575085e-01 -7.520961724628136594e-10 1.493021231631938468e-13 5.511521615286397724e-01 4.246457657886060592e-10 4.934379565795613953e-11 5.511522228051066730e-01 6.095359260555205305e-08 1.738084632276309895e-11 5.511521730331154778e-01 1.195785400956425934e-08 6.229646173031579167e-12 5.511521637676544128e-01 2.753035016648047418e-09 4.167021271254762545e-12 5.511521623490096555e-01 1.328698790435420181e-09 3.614326672908227553e-12 5.511521619850342502e-01 9.577816990819015875e-10 1.848405552448303609e-11 -1.618578732525582605e-08 5.511521446215627007e-01 2.341326289792069372e-11 -2.380272332478414526e-08 5.511521366713391101e-01 5.261656120689161690e-11 -7.181479250297925298e-08 5.511520866407794150e-01 1.047684217142814380e-09 -2.204329205748493972e-06 5.511498812449926454e-01 7.602780050954048299e-12 -2.766123307817034152e-08 5.511521334171127773e-01 8.680435783202303266e-12 -5.320317192774800879e-08 5.511521090084779972e-01 4.917126526988335079e-14 -3.556622403884388879e-10 5.511521607313384363e-01 -4.880906581602812015e-16 3.541892266442918413e-12 5.511521610928926673e-01 6.311260387834471753e-15 -6.594569598088282138e-11 5.511521610234666468e-01 -4.249073360458570311e-14 -7.520961724628136594e-10 5.511521603371346556e-01 1.442854094908636081e-13 4.246457657886060592e-10 5.511521614996158780e-01 4.873440664979866414e-11 6.095359260555205305e-08 5.511522212901553974e-01 1.740141435448434962e-11 1.195785400956425934e-08 5.511521730613891945e-01 6.403083831626514001e-12 2.753035016648047418e-09 5.511521639188716737e-01 4.393368119440338579e-12 1.328698790435420181e-09 5.511521624896327243e-01 3.861413447033865401e-12 9.577816990819015875e-10 5.511521621117736469e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 new file mode 100644 index 000000000..e01b13275 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 @@ -0,0 +1 @@ +1.200016753583814898e-02 8.168847279019404717e-05 8.117590908806338068e-05 1.123199108145899947e-02 7.737803675327323922e-05 7.595671840282052455e-05 9.579599301549840060e-03 6.848554189056633328e-05 6.561121928719634453e-05 6.801936875236425616e-03 5.449134255689154808e-05 5.142361477326099731e-05 2.526880692213784134e-03 3.517610803590462084e-05 3.458343050704775970e-05 -3.313770477595053519e-03 1.512026624252606510e-05 1.737691176000734876e-05 -8.032227676602419347e-03 7.000722853805530394e-06 6.483629572072869582e-06 -1.062068470943312685e-02 2.403438872305497803e-06 2.367109202882778891e-06 -1.039706173624113140e-02 5.722235199179500179e-06 5.179207058321046963e-06 -8.325938225652021116e-03 1.250728181472054888e-05 1.262622086513309186e-05 -4.470717683830401946e-03 2.102853666422046779e-05 2.145574828104688703e-05 -1.298606139429777078e-03 2.989455168866636772e-05 2.996517965227207475e-05 8.131127725153922082e-04 3.760926958601434498e-05 3.731691358849250885e-05 2.205805383523282495e-03 4.349293220956482718e-05 4.288886318995238401e-05 3.044098646491445303e-03 4.724537803668690090e-05 4.653314984968488283e-05 3.424167966510261677e-03 4.898796877332344056e-05 4.827437821832526255e-05 -1.865485428976108960e-11 5.511521451678402794e-01 -1.619866573040677813e-08 -3.205412698789609181e-11 5.511521378670778404e-01 -2.382219168971532569e-08 -1.076385126794936371e-10 5.511520917863800273e-01 -7.184371600355541428e-08 -3.226606349662299339e-09 5.511500297449033470e-01 -2.204357918932243236e-06 -3.477326612394739076e-11 5.511521334056278532e-01 -2.769387456071488596e-08 -4.912332628139585333e-11 5.511521067215676695e-01 -5.322063517401172563e-08 -1.868870698858813461e-13 5.511521607329519234e-01 -3.588013163230157884e-10 8.278686476077146447e-16 5.511521610926268799e-01 3.200175487202451685e-12 -8.880254848944250688e-15 5.511521610235123880e-01 -6.585916281980453983e-11 -8.906692155818844546e-14 5.511521603375976186e-01 -7.519557285902273555e-10 5.393528719424191941e-14 5.511521615288347276e-01 4.248427705969897798e-10 6.320975793420797653e-12 5.511522228052051497e-01 6.095369026097176907e-08 3.674672118000830782e-13 5.511521730331221391e-01 1.195786062797528356e-08 -2.128571419352805749e-13 5.511521637676861651e-01 2.753064948178598263e-09 -2.413815360231809021e-13 5.511521623491559829e-01 1.328838145877133473e-09 -2.344927208183605756e-13 5.511521619852632892e-01 9.580013067615405916e-10 -1.897985012491591699e-11 -1.619866573040677813e-08 5.511521446082626730e-01 -3.288274913596305452e-11 -2.382219168971532569e-08 5.511521366509807285e-01 -1.115858363666935595e-10 -7.184371600355541428e-08 5.511520866102949112e-01 -3.337141557544958380e-09 -2.204357918932243236e-06 5.511498812149641102e-01 -3.478675927620656034e-11 -2.769387456071488596e-08 5.511521333841309378e-01 -4.808687143385368070e-11 -5.322063517401172563e-08 5.511521089915808469e-01 -1.881286901702747537e-13 -3.588013163230157884e-10 5.511521607281815172e-01 8.184281006649142078e-16 3.200175487202451685e-12 5.511521610925529391e-01 -8.877497172870469302e-15 -6.585916281980453983e-11 5.511521610235531332e-01 -8.908967954847416453e-14 -7.519557285902273555e-10 5.511521603372754319e-01 5.212806515489982089e-14 4.248427705969897798e-10 5.511521614998149410e-01 6.242922746089320882e-12 6.095369026097176907e-08 5.511522212902522089e-01 3.679019474853450807e-13 1.195786062797528356e-08 5.511521730613957448e-01 -2.187774209710848842e-13 2.753064948178598263e-09 5.511521639188998734e-01 -2.544879663431090900e-13 1.328838145877133473e-09 5.511521624897653959e-01 -2.505337758143741582e-13 9.580013067615405916e-10 5.511521621119841452e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 new file mode 100644 index 000000000..db9fd84ec --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 @@ -0,0 +1 @@ +1.200930518458296140e-02 8.168850031394288443e-05 8.117593709132900771e-05 1.124254127796948249e-02 7.737807725997106157e-05 7.595675995664787951e-05 9.593217322184778226e-03 6.848565593918205883e-05 6.561133751819932182e-05 6.820735304878434643e-03 5.449430020211852517e-05 5.142667373979726788e-05 2.553562004725284072e-03 3.517613663847057458e-05 3.458345912070116465e-05 -3.284428553004262001e-03 1.512030422896776519e-05 1.737694894496922857e-05 -8.014908915282050947e-03 7.000723004646764462e-06 6.483629723908972646e-06 -1.061226483013992875e-02 2.403438871505481537e-06 2.367109202090435050e-06 -1.040508087313818733e-02 5.722235208759063342e-06 5.179207067897670921e-06 -8.344010006203475896e-03 1.250728185353025852e-05 1.262622090395466843e-05 -4.495663575051244906e-03 2.102853670162307782e-05 2.145574831718771613e-05 -1.317498643081258230e-03 2.989456954589724591e-05 2.996519728895552956e-05 7.979217700936241161e-04 3.760927615231312600e-05 3.731692016254095016e-05 2.193052376306329002e-03 4.349293443633833452e-05 4.288886547868126924e-05 3.032955635145838640e-03 4.724537939415126696e-05 4.653315128086622137e-05 3.414265251563279851e-03 4.898796986952100226e-05 4.827437938939939838e-05 8.868894552845111131e-12 5.511521451671540506e-01 -1.619934702417882326e-08 8.452570836201241094e-12 5.511521378667435522e-01 -2.382251756863293668e-08 6.410103052634350595e-12 5.511520917863580449e-01 -7.184373339040264921e-08 -2.689611226845306107e-10 5.511500297444990037e-01 -2.204358363155267775e-06 -6.170700171204049640e-12 5.511521334052973398e-01 -2.769421217854284012e-08 -1.113688458214228647e-11 5.511521067212266090e-01 -5.322095687669273544e-08 -3.604583575689914593e-14 5.511521607329087358e-01 -3.588453129606688890e-10 2.785217201028614703e-17 5.511521610926266579e-01 3.200025338994255916e-12 6.993079200069004598e-16 5.511521610235126101e-01 -6.585893720151299056e-11 -5.025721226145817982e-14 5.511521603376180467e-01 -7.519355432267673345e-10 9.133789741915530852e-14 5.511521615291128384e-01 4.251209887183846514e-10 2.417820667132331498e-11 5.511522228059394513e-01 6.095441713036122434e-08 6.933765992555206428e-12 5.511521730344033365e-01 1.195913495163170699e-08 2.013916367350442402e-12 5.511521637694063447e-01 2.754813899036565292e-09 1.116082833163727225e-12 5.511521623511356216e-01 1.330898915900606179e-09 8.617048437084673168e-13 5.511521619872800093e-01 9.601251100754930572e-10 9.023415498917623428e-12 -1.619934702417882326e-08 5.511521446075863251e-01 8.671078221543159340e-12 -2.382251756863293668e-08 5.511521366506630937e-01 6.645166614426772349e-12 -7.184373339040264921e-08 5.511520866102811445e-01 -2.781750212733276203e-10 -2.204358363155267775e-06 5.511498812144769444e-01 -6.173105867896660987e-12 -2.769421217854284012e-08 5.511521333837861025e-01 -1.090190955330275254e-11 -5.322095687669273544e-08 5.511521089912774229e-01 -3.629258713028714108e-14 -3.588453129606688890e-10 5.511521607281366641e-01 2.608436313747171848e-17 3.200025338994255916e-12 5.511521610925528281e-01 6.991263867155419665e-16 -6.585893720151299056e-11 5.511521610235533553e-01 -5.026810376442409349e-14 -7.519355432267673345e-10 5.511521603372954159e-01 8.826889339957348759e-14 4.251209887183846514e-10 5.511521615000932739e-01 2.387960620084051051e-11 6.095441713036122434e-08 5.511522212909717444e-01 6.941950387633462989e-12 1.195913495163170699e-08 5.511521730626632865e-01 2.069951467511333706e-12 2.754813899036565292e-09 5.511521639206780065e-01 1.176693371779026789e-12 1.330898915900606179e-09 5.511521624919105689e-01 9.205403591267005536e-13 9.601251100754930572e-10 5.511521621142206895e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener new file mode 100644 index 000000000..085f61416 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.06537776555844366 +1 0.06842840551476514 +2 0.07563770918924644 +3 0.08790095468383863 +4 0.10538783775378793 +5 0.12528362884254654 +6 0.14068829284912457 +7 0.1461764612687949 +8 0.14016344893874955 +9 0.12712439965785238 +10 0.10983889792154287 +11 0.09258127399307692 +12 0.0785531932506661 +13 0.06852373141042968 +14 0.06231255846883983 +15 0.05955519530225097 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz new file mode 100644 index 000000000..da9ba5065 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.06576135339134 -4.036977577669698e-05 -4.03463370142543e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.0799379986567645 -3.9872849638913154e-05 -3.989885072496056e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.111762005589272 -3.881648447878733e-05 -3.8869764093055744e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.162745192727229 -3.6688731640361026e-05 -3.663208693183834e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.233971607719767 -3.260399530531656e-05 -3.236283492760897e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.3247011922205028 -2.550397741657568e-05 -2.5292168501822956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.431298374974536 -1.5291976853077628e-05 -1.5257128673206789e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.547155042590501 -3.3712361796752077e-06 -3.3581738254979327e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.663764407093567 8.698200609595615e-06 8.697542060115588e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7730715160409685 1.9368513676873852e-05 1.9370564946948017e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8690765826574727 2.795830574700837e-05 2.7921903538529764e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9486107853901364 3.436355184889286e-05 3.431006188664314e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0107836513609896 3.888125633027276e-05 3.883791455518526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0558864229391904 4.191617690764468e-05 4.190113445407812e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.0846425024467283 4.380763178863292e-05 4.381565284163732e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.09771729893857 4.4749415184144526e-05 4.476697456611449e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener new file mode 100644 index 000000000..e3890bfac --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.048010793705999144 +1 0.05006230761537636 +2 0.055167515402352374 +3 0.06530035693631965 +4 0.08283835118220956 +5 0.10794612286167661 +6 0.13311540055758112 +7 0.14578290160402213 +8 0.14080551258723087 +9 0.12402205532312414 +10 0.10070845223403804 +11 0.07872570175415318 +12 0.061990000932250065 +13 0.05071974760920981 +14 0.04395987380765516 +15 0.04082131565137507 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz new file mode 100644 index 000000000..418f6c213 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9657613533913398 -5.8202069490434e-05 -5.771866984911536e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9808403042617393 -5.954580709354527e-05 -5.926234119974396e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.01295774550751 -6.175921295031682e-05 -6.177219820570546e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.065394422534147 -6.326764817066309e-05 -6.335080194055869e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.1420089836739553 -6.154561995206643e-05 -6.122952499016171e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.244690369108785 -5.2998130516496316e-05 -5.245657964740542e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3706039960943808 -3.5390012816408726e-05 -3.531199956865308e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5118110993782414 -1.1823584811031625e-05 -1.1795690495273182e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6564888880281594 1.3673936162686538e-05 1.3659927640233507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7928306798508027 3.664353990332544e-05 3.6632284516012933e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.9120333154196882 5.4992400435010195e-05 5.491720488447381e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 3.010016890698354 6.837861109276882e-05 6.831349223243517e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.086161101335155 7.758941766024247e-05 7.760506372253507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.141416678427201 8.367831999734887e-05 8.376357674166844e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1771747403887316 8.744139486333775e-05 8.754036352842724e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1946133120708797 8.930080161392669e-05 8.938865662257378e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener new file mode 100644 index 000000000..4a34dd317 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.053551887997109415 +1 0.055821523787737866 +2 0.06104397476068316 +3 0.070540369673141 +4 0.08586896151139578 +5 0.10731810114616054 +6 0.13012540827844282 +7 0.14435658014354713 +8 0.1440744580029646 +9 0.1317573290770667 +10 0.11270517536494683 +11 0.09214406697587658 +12 0.07521632481201693 +13 0.06317455833056673 +14 0.0557056992021589 +15 0.0521766654434155 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz new file mode 100644 index 000000000..03279a1fe --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.003410922436927 -2.019089826258433e-05 -1.912678519726927e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.0166975261971185 -2.3257199650390734e-05 -2.2247937752807154e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0445755874166265 -2.865878295841778e-05 -2.7840079323915293e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.089474518135972 -3.481137112022684e-05 -3.437133012466438e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.1544582649569106 -3.92844857593742e-05 -3.917576381189261e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.2420446957327496 -3.892039048008819e-05 -3.867303719014884e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3517982652580818 -2.9870679789311668e-05 -2.9689240918028162e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.47823469448337 -1.2294756793963556e-05 -1.2226080548025182e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6114737533745647 9.220341758268867e-06 9.23047117336199e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7401495529015643 2.9081816922087504e-05 2.911729255699749e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.854896883175759 4.431245358068483e-05 4.434217346078701e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9505556492764846 5.44273456611705e-05 5.449515852337697e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0256642421278923 6.054520758177529e-05 6.0580983641131965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0805986298376604 6.404198772553064e-05 6.386715555669364e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.116383287627362 6.583509310841344e-05 6.541672177816995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.13399370443819 6.655043744003064e-05 6.599499369725066e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener new file mode 100644 index 000000000..7f8a756ae --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.05104097515712119 +1 0.05306951644368564 +2 0.05782256256069674 +3 0.06669383309098245 +4 0.08146358784021217 +5 0.10291615059174383 +6 0.1270534587852278 +7 0.14334274627411497 +8 0.14474698761547658 +9 0.13287887029520795 +10 0.11361730053412121 +11 0.09233877126651915 +12 0.0747290768002318 +13 0.0622286250911736 +14 0.05450969761310025 +15 0.05087332238233164 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz new file mode 100644 index 000000000..7a35e4969 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9874962540886816 -3.5103373834124876e-05 -3.4130810633550696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.000464822853745 -3.702801532724975e-05 -3.618747959311343e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.027758128739662 -4.029813818870549e-05 -3.972245038332976e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.071941220035372 -4.368456406598558e-05 -4.343080885451845e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.136316736944003 -4.524378713224654e-05 -4.514688481395709e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.2237441215902525 -4.229597210110211e-05 -4.2008081049005955e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.334205800733934 -3.157896506770632e-05 -3.134536665709115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.462511308082689 -1.2845770647930886e-05 -1.2805405688684325e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.598846134728532 1.0066091822875302e-05 1.0033635778585991e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7314158518194604 3.198392723105558e-05 3.200027067034645e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8502892735604335 4.961915023133467e-05 4.9586830797757707e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9496898227973714 6.198125461898199e-05 6.195698137054672e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0278455495047085 6.978524375308098e-05 6.983185251663175e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0850375702576183 7.43805508222998e-05 7.443572771261109e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1222951858572316 7.688811658934849e-05 7.68602037356926e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.14062975868737 7.798590311639581e-05 7.787451423465271e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener new file mode 100644 index 000000000..dd1eaee39 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.05113388898041316 +1 0.05315468032355862 +2 0.05788076548489761 +3 0.06668110401421838 +4 0.08130346544361368 +5 0.10253287771705626 +6 0.12654370455256153 +7 0.1430434023270727 +8 0.14499112687101906 +9 0.13362758166350597 +10 0.11486952483536592 +11 0.0938044536225434 +12 0.07618623057397172 +13 0.06360637717503197 +14 0.05580505037353811 +15 0.05212372038791605 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz new file mode 100644 index 000000000..f16f6084b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9881132783422466 -3.1725043571321754e-05 -3.068960605493158e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.0009884491959355 -3.357488820436078e-05 -3.2640067991699516e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.028072074027783 -3.67438851685318e-05 -3.603485939119004e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0718819548958547 -4.008501825292844e-05 -3.970781531005999e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.1356516269476638 -4.175625012253249e-05 -4.164120141586025e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.222167547136141 -3.9262465503888336e-05 -3.9060106184827616e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3314256236731645 -2.952913967753447e-05 -2.9275917815924268e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.458422661518627 -1.1617933392790702e-05 -1.1578335993530693e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.593609264503044 1.0697913936911713e-05 1.0669681309218199e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.725388015454487 3.2199177642932124e-05 3.222497783467351e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8438783613390433 4.9365438526928155e-05 4.9344584955500745e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.943161541981536 6.111436483605497e-05 6.110073997710469e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0213293451304386 6.820465545899864e-05 6.825977668149615e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0785799900010846 7.21150551456202e-05 7.216378943398968e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.115894800919542 7.409113202235872e-05 7.403276965452013e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1342619266026532 7.489621250238764e-05 7.473929616956903e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener new file mode 100644 index 000000000..dec5591c4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.05096590857496589 +1 0.05296025606468151 +2 0.05762923639623487 +3 0.06633787559093109 +4 0.08084381285521451 +5 0.10198573435910428 +6 0.12607642557685142 +7 0.14284298456344546 +8 0.1451019566831399 +9 0.13390376560117467 +10 0.11523346685962982 +11 0.09413744671544252 +12 0.07644109075721481 +13 0.0637921276786535 +14 0.05594442270948384 +15 0.05224097116990205 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz new file mode 100644 index 000000000..a031f6698 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9869959945567084 -3.235588538026311e-05 -3.132364631607926e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.999790845512831 -3.415415574828053e-05 -3.3223720876963385e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0267124595615718 -3.723042384440743e-05 -3.6526440921082085e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.070279855779636 -4.04579756379904e-05 -4.008344318313165e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.133739664963162 -4.201914098164972e-05 -4.1903714777187574e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.219920672446604 -3.9446296613399574e-05 -3.92468052376286e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3289082063854503 -2.9704154078014313e-05 -2.944778562151041e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.455791146619531 -1.179899379578984e-05 -1.1761552890889106e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5910695556756833 1.0577440101088408e-05 1.0547050970922665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7231219283228514 3.22638676155198e-05 3.2288301380567665e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.841995349169877 4.969153037373674e-05 4.966932784427873e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.941675559373527 6.171526181113743e-05 6.16952782165634e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0201917030369465 6.90337339336999e-05 6.908525087386455e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0777130519897202 7.310241862169309e-05 7.316497258225675e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1152100709250803 7.517576763333801e-05 7.515194634206205e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1336683060080013 7.603064627275364e-05 7.591857078036052e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener new file mode 100644 index 000000000..fc62b4fc2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.05094187433573566 +1 0.0529298251585715 +2 0.05758385082110203 +3 0.06626549962662247 +4 0.08073133514217475 +5 0.10183206447338992 +6 0.125926637864579 +7 0.14276948725526517 +8 0.14514562154489985 +9 0.13403132328658401 +10 0.11542990653474229 +11 0.09435240856147208 +12 0.07664205640103602 +13 0.0639729291756765 +14 0.056108504280995376 +15 0.052396357945602295 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz new file mode 100644 index 000000000..572ce1484 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9868354779851642 -3.226417335080169e-05 -3.122893380422429e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9996026733280081 -3.402884161097801e-05 -3.309268289001407e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.026466305571826 -3.704771897292677e-05 -3.633388887768044e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0699411574235818 -4.0211512564476274e-05 -3.9825976577662086e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.133271201686821 -4.172650366702104e-05 -4.160802874973194e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.219290387431041 -3.9153830337802e-05 -3.896381456926752e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.328107309129175 -2.94954841083799e-05 -2.923792925264978e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4548455605069495 -1.1677089312347159e-05 -1.1640350438179178e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.590036103347134 1.0647134901478912e-05 1.061668167018751e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.722067299043064 3.232624857430142e-05 3.235085243410479e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8409750998646413 4.975487454324541e-05 4.973333833060576e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9407156729184627 6.176493941056483e-05 6.174452089446403e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.019295028959897 6.904756658501146e-05 6.909898967341392e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.076870008735045 7.30683943438249e-05 7.313289186327829e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1144048866942033 7.509881444143623e-05 7.507863869028115e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.132882495933586 7.592909444034276e-05 7.582119205131972e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener new file mode 100644 index 000000000..bbbcd3287 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.050919370072655595 +1 0.05290320294685336 +2 0.05754808218924119 +3 0.06621437972546856 +4 0.08065941548510698 +5 0.10174199948043824 +6 0.12584532755081587 +7 0.14273224115687608 +8 0.1451657473533179 +9 0.1340864802905247 +10 0.11550856746259959 +11 0.09443177425200715 +12 0.07671030737855557 +13 0.06402971605434313 +14 0.05615693406720792 +15 0.05244064585222887 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz new file mode 100644 index 000000000..6062a3587 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9866850273986039 -3.2305860104540206e-05 -3.12703294686253e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9994378884395796 -3.405881426510707e-05 -3.3121933062634965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0262721287516 -3.705730471897021e-05 -3.6341967160473165e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0697017458568143 -4.019768612195744e-05 -3.981013365295688e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.132971532488317 -4.169347101729316e-05 -4.157427830738678e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.2189211317131208 -3.9114491911721445e-05 -3.892673141640411e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3276737541836696 -2.9473849035048844e-05 -2.921586536761708e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.454370168604051 -1.16749027180496e-05 -1.1638507252232225e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.589552996042531 1.0644678897939056e-05 1.061400922297992e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.721609676386341 3.234163701300121e-05 3.2366054826199795e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8405657820583787 4.979809141462031e-05 4.97765764170584e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.940361149221517 6.183516655769054e-05 6.181404125495404e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0189905842206826 6.913611168713314e-05 6.918706267085788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0766053861354705 7.316562798941619e-05 7.323175115589965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.114167429500616 7.519893138440071e-05 7.518285667877604e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1326587164143738 7.603010705557766e-05 7.592756707577359e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 new file mode 100644 index 000000000..122ea3a03 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 @@ -0,0 +1 @@ +1.211720761571505843e-02 1.339870819610409710e-04 1.360808927209427536e-04 1.134630141982721774e-02 1.269269298678142284e-04 1.297407724649498218e-04 9.689738882759238794e-03 1.134079951150337848e-04 1.170899365757808411e-04 6.908816133368049159e-03 9.477212433123437447e-05 9.837324525751751643e-05 2.634129529348241266e-03 7.330998793279303982e-05 7.455310335816610400e-05 -3.215217516627745173e-03 5.085424134226921959e-05 4.833412323727535322e-05 -7.979773345621454100e-03 2.224458523295589978e-05 2.286298843202176352e-05 -1.060830783469399186e-02 5.936683831159546867e-06 5.746054465677738401e-06 -1.042735772591469982e-02 3.935735542469341629e-06 3.615363592539134991e-06 -8.380452352951643646e-03 1.408366762291792115e-05 1.409731663410453964e-05 -4.540310698796260966e-03 2.899104242590973030e-05 2.929756245350242070e-05 -1.360895464848485212e-03 4.534135768375485969e-05 4.488524817596351870e-05 7.574700407592376700e-04 5.885132838912696313e-05 5.819546608878853030e-05 2.151657818134531872e-03 6.785123070855844304e-05 6.854114065953120262e-05 2.988895800948385834e-03 7.319593016904220643e-05 7.576889790622987498e-05 3.369164542445018604e-03 7.605463863359418269e-05 7.959193960478886244e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener new file mode 100644 index 000000000..bbbcd3287 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.050919370072655595 +1 0.05290320294685336 +2 0.05754808218924119 +3 0.06621437972546856 +4 0.08065941548510698 +5 0.10174199948043824 +6 0.12584532755081587 +7 0.14273224115687608 +8 0.1451657473533179 +9 0.1340864802905247 +10 0.11550856746259959 +11 0.09443177425200715 +12 0.07671030737855557 +13 0.06402971605434313 +14 0.05615693406720792 +15 0.05244064585222887 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz new file mode 100644 index 000000000..6062a3587 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9866850273986039 -3.2305860104540206e-05 -3.12703294686253e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9994378884395796 -3.405881426510707e-05 -3.3121933062634965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0262721287516 -3.705730471897021e-05 -3.6341967160473165e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0697017458568143 -4.019768612195744e-05 -3.981013365295688e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.132971532488317 -4.169347101729316e-05 -4.157427830738678e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.2189211317131208 -3.9114491911721445e-05 -3.892673141640411e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3276737541836696 -2.9473849035048844e-05 -2.921586536761708e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.454370168604051 -1.16749027180496e-05 -1.1638507252232225e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.589552996042531 1.0644678897939056e-05 1.061400922297992e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.721609676386341 3.234163701300121e-05 3.2366054826199795e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8405657820583787 4.979809141462031e-05 4.97765764170584e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.940361149221517 6.183516655769054e-05 6.181404125495404e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0189905842206826 6.913611168713314e-05 6.918706267085788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0766053861354705 7.316562798941619e-05 7.323175115589965e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.114167429500616 7.519893138440071e-05 7.518285667877604e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1326587164143738 7.603010705557766e-05 7.592756707577359e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz new file mode 100644 index 000000000..93fc95899 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0018510171490633024 1.7805444612468837e-05 1.723470966461007e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0019993534862349617 1.87715890863559e-05 1.8255224986929376e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0022791667179112743 2.042421358000848e-05 2.0029953738734423e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002636354850968157 2.215504157690982e-05 2.1941441196084636e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002934912185468499 2.2979446654498968e-05 2.2913753334847966e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002897394824317648 2.1558036747058737e-05 2.145455214429737e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002253700475321969 1.6244575591289603e-05 1.6102387335458818e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0010546977141204122 6.43464786356143e-06 6.414588423922328e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.000402628280509582 -5.866837778701736e-06 -5.8499341210681e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0016590765439645418 -1.7825163132884215e-05 -1.7838621063397695e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002439153445089345 -2.744632570129498e-05 -2.7434467663892897e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002724728219458331 -3.408058567959351e-05 -3.406894242333663e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027438220079638877 -3.810451736568086e-05 -3.813259911047038e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026572409261364713 -4.0325393983829086e-05 -4.036183790993452e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0025590230172260983 -4.14460535441252e-05 -4.143719393538129e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0024994095898694248 -4.19041578115393e-05 -4.1847642680072234e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..40df50387 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.002608941726057982 2.2249889162020644e-05 2.22369708374471e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0027028221704973707 2.197600724727929e-05 2.1990337802044984e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0028649977762466887 2.1393789306376403e-05 2.1423154480922444e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0029801311282103677 2.0221073731213658e-05 2.01898538776971e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002841619470618425 1.7969762472673544e-05 1.7836846409330875e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00227738121980783 1.4056572269520682e-05 1.3939833328416719e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0012958536758315143 8.428206089902662e-06 8.408999440256819e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -4.7295560127201694e-05 1.8580641059707294e-06 1.8508647612370095e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0011416766538413117 -4.794032063567673e-06 -4.793669102598571e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.002053451479545508 -1.0674998170098429e-05 -1.0676128732032786e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0025535693852966807 -1.5409280632861575e-05 -1.5389217476990163e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027346652423528113 -1.89395458642246e-05 -1.8910064755934075e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002749481416171601 -2.1429488452300353e-05 -2.140560053929543e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002697597106316366 -2.3102191487253547e-05 -2.309390080646225e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002638896950870834 -2.414467093251329e-05 -2.4149091753210876e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0026059177089612275 -2.466373688622762e-05 -2.467341477754776e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..5a4f5487d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015866879082761635 3.2078196379527555e-05 3.1811769622544945e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001779782887207077 3.2818800263419405e-05 3.266256742345567e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0021458600645275923 3.403872368474696e-05 3.4045880536316696e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0026063375764652725 3.4870101016304144e-05 3.491593139628484e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002955235797480483 3.3921001442167684e-05 3.3746785020804436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0027942971250027476 2.9210034167864484e-05 2.8911557236025204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0018858317640575316 1.9505282044744876e-05 1.9462284874650753e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00043229039317776416 6.5165943204237665e-06 6.50122030801139e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0010725121557649269 -7.536419466663044e-06 -7.528698639239388e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0021833188483289675 -2.019616620768311e-05 -2.018996277664193e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0026754749113868633 -3.0309180343248975e-05 -3.0267736153066545e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002749922192120615 -3.7687019276070466e-05 -3.7651128875469896e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002635264876363245 -4.276357522110991e-05 -4.277219858215502e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002468779691415813 -4.611948690286834e-05 -4.616647634174752e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002329314917974392 -4.819351374759928e-05 -4.824806054124348e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00225380625806679 -4.9218329796530575e-05 -4.926675127440895e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..575b2dfd3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0020435620619153948 1.1128257211759362e-05 1.0541768996167511e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002184410316908276 1.2818255848200258e-05 1.2261998972241888e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0024443566387581783 1.579535016172374e-05 1.5344119884275956e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002758528834162892 1.91863624233978e-05 1.8943832877725624e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002973839230012961 2.165172922356445e-05 2.1591806887252127e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002806542007049702 2.1451057323543524e-05 2.1314728023240884e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0020526859012169082 1.646328971908829e-05 1.6363289293074765e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0007985818262157207 6.7762817770614735e-06 6.738430715697031e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006281297085835031 -5.081811286052631e-06 -5.087394135071777e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0018096081293385185 -1.6028506245014523e-05 -1.6048058717861173e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00250012596324479 -2.4422904554167718e-05 -2.4439284730313353e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027367262130361023 -2.9997749183513347e-05 -3.0035124389068103e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027379602862758184 -3.336962200230117e-05 -3.338934005473086e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026483120375402065 -3.52968799353864e-05 -3.520052080770394e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002552255529894339 -3.628515384222327e-05 -3.6054567579421726e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0024948370194203618 -3.6679417416517135e-05 -3.637328339732037e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..3fe6a3522 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001860743459578863 1.934730035020667e-05 1.8811270040414197e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0020108720647718766 2.040807066846475e-05 1.9944807582122663e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00229336238461937 2.22104059505839e-05 2.1893114372538264e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0026514834070125223 2.4076841891215858e-05 2.3936984158028055e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0029430996918390208 2.4936211053806013e-05 2.488280313166621e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0028809270895277703 2.331151642889897e-05 2.315284465337788e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0022007967824139384 1.740481484203269e-05 1.7276066573195092e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0009679469788825094 7.079974253465762e-06 7.057727018944733e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0004988845411847778 -5.547948261901959e-06 -5.530060042951492e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0017397826838640555 -1.7628010613522073e-05 -1.763701833540687e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0024812942508029693 -2.7347701881419204e-05 -2.7329888955758077e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00273582188174067 -3.416110243028366e-05 -3.4147724176951895e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002735801497984479 -3.8462287906660425e-05 -3.848797642741715e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002637957110120812 -4.099500132872973e-05 -4.102541219106699e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002533690943366815 -4.237705162031239e-05 -4.2361667390697777e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002471592204966878 -4.298209903710934e-05 -4.29207068142153e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..d9e57d969 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0018681150453619304 1.748532632498904e-05 1.6914642700157567e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002016720712402111 1.8504872192168113e-05 1.7989644011729812e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002296343852633139 2.0251471717456688e-05 1.9860690628006687e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002651087269884273 2.209294443740915e-05 2.1885048220277927e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0029415339123703196 2.3014047494022885e-05 2.295063815070994e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0028864588794659863 2.163959271216568e-05 2.1528061936148787e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002223456356661316 1.6275049148383574e-05 1.6135485372122032e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.001011607049582267 6.403249096829184e-06 6.3814249046535115e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00044475706208978763 -5.896178385477194e-06 -5.880617911710681e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0016904523210539292 -1.7746646343203208e-05 -1.7760866174637995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002453878054266583 -2.7207868127241882e-05 -2.7196374636283234e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027283193763479345 -3.3683314252997115e-05 -3.367580488254213e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002741895690669336 -3.7591143252584355e-05 -3.762152343348575e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002652871615288606 -3.9746368490589105e-05 -3.9773228498943095e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0025537564472888257 -4.083548753168231e-05 -4.0803320986521775e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002493914080168783 -4.1279209378101136e-05 -4.119272460215793e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..c48c7693c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0018547501734087837 1.7833016151292608e-05 1.726409536030679e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002003319620338011 1.8824136750848423e-05 1.831132556076905e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0022833875309751705 2.0519628560119106e-05 2.0131626850558315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0026402915904934522 2.2298500706180303e-05 2.2092076334286783e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0029368611373069365 2.3158940359155995e-05 2.3095322957120335e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0028940933998384353 2.1740911625448258e-05 2.163096152257339e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0022437925797000173 1.6371508713429806e-05 1.6230210684592526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0010396099567918956 6.503040929229874e-06 6.482405293580692e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00041839991947731955 -5.82977897050845e-06 -5.813029935743975e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0016716757321801937 -1.778230036139572e-05 -1.77957670838054e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002445554851394332 -2.738759435332406e-05 -2.737535738123163e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027264418255349555 -3.401449991940589e-05 -3.400348591807009e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002742849995383501 -3.8048091645628646e-05 -3.807648531853311e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026548010111791622 -4.0290556004207406e-05 -4.032503275475677e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0025558517623980492 -4.143328679266805e-05 -4.142015763650137e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002495954801956268 -4.190445500225114e-05 -4.184268435241351e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..092a62e8c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0018528239628381662 1.7782468868057054e-05 1.7211894354715718e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002001206091686079 1.875506959325909e-05 1.823910369107713e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002281029499533148 2.0418930375360984e-05 2.002550137571532e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002637987812325792 2.2162662050584255e-05 2.1950173058273883e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002935677407018618 2.2997652670783e-05 2.2932354964084222e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0028961820290551495 2.157971820560689e-05 2.147499060413805e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002250225571629458 1.625649980871134e-05 1.611454789337662e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.001049652729339132 6.435853009733955e-06 6.415604299840281e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00040765505105648623 -5.868191410360371e-06 -5.85140704612196e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.001662894952375722 -1.7816681761639036e-05 -1.7830242232140806e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0024409936020780725 -2.742250662924118e-05 -2.7410636899103156e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027251953081305984 -3.404187983568803e-05 -3.403062612641284e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002743579091495408 -3.8055715541292614e-05 -3.808405748759552e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002656660603384589 -4.027180344993085e-05 -4.0307351397162486e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002558302829672356 -4.139087387464866e-05 -4.137975396579794e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002498645557316557 -4.1848484490355295e-05 -4.178901385545854e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..93fc95899 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0018510171490633024 1.7805444612468837e-05 1.723470966461007e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0019993534862349617 1.87715890863559e-05 1.8255224986929376e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0022791667179112743 2.042421358000848e-05 2.0029953738734423e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002636354850968157 2.215504157690982e-05 2.1941441196084636e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002934912185468499 2.2979446654498968e-05 2.2913753334847966e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002897394824317648 2.1558036747058737e-05 2.145455214429737e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002253700475321969 1.6244575591289603e-05 1.6102387335458818e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0010546977141204122 6.43464786356143e-06 6.414588423922328e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.000402628280509582 -5.866837778701736e-06 -5.8499341210681e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0016590765439645418 -1.7825163132884215e-05 -1.7838621063397695e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002439153445089345 -2.744632570129498e-05 -2.7434467663892897e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002724728219458331 -3.408058567959351e-05 -3.406894242333663e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027438220079638877 -3.810451736568086e-05 -3.813259911047038e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026572409261364713 -4.0325393983829086e-05 -4.036183790993452e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0025590230172260983 -4.14460535441252e-05 -4.143719393538129e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0024994095898694248 -4.19041578115393e-05 -4.1847642680072234e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 b/drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 new file mode 100644 index 000000000..aa2c39b08 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_00 b/drivers/py/pes/friction/frictionH/080K/inst.raw_00 new file mode 100644 index 000000000..9c2e17fee --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_00 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 0 +{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} + #*EXTRAS*# Step: 1 Bead: 0 +{"friction": [[0.0001343325901679972, -2.3029816478463187e-05, -2.2775283311006272e-05], [-2.3029816478463187e-05, 0.00013452857993798977, -2.2912148578879323e-05], [-2.2775283311006272e-05, -2.2912148578879323e-05, 0.0001345066031031012]]} + #*EXTRAS*# Step: 2 Bead: 0 +{"friction": [[0.0001362189769165877, -1.2519544510922201e-05, -1.1991851051186898e-05], [-1.2519544510922201e-05, 0.00013628685189819752, -1.2386884344101075e-05], [-1.1991851051186898e-05, -1.2386884344101075e-05, 0.0001368253923285999]]} + #*EXTRAS*# Step: 3 Bead: 0 +{"friction": [[0.00013549040085582398, -1.6714181591711767e-05, -1.624245031402653e-05], [-1.6714181591711767e-05, 0.0001356057406669174, -1.6575056620968432e-05], [-1.624245031402653e-05, -1.6575056620968432e-05, 0.0001359479668833992]]} + #*EXTRAS*# Step: 4 Bead: 0 +{"friction": [[0.0001357891516320171, -1.4977046550053155e-05, -1.447084000436214e-05], [-1.4977046550053155e-05, 0.00013588358550651897, -1.4838606081290266e-05], [-1.447084000436214e-05, -1.4838606081290266e-05, 0.0001363129737319015]]} + #*EXTRAS*# Step: 5 Bead: 0 +{"friction": [[0.00013577736796275977, -1.5045370482195335e-05, -1.4540235805003285e-05], [-1.5045370482195335e-05, 0.00013587259507233013, -1.4906849639791598e-05], [-1.4540235805003285e-05, -1.4906849639791598e-05, 0.0001362987023273524]]} + #*EXTRAS*# Step: 6 Bead: 0 +{"friction": [[0.00013579871948064717, -1.49215941447545e-05, -1.4414535573054557e-05], [-1.49215941447545e-05, 0.000135892511502374, -1.4783222117114463e-05], [-1.4414535573054557e-05, -1.4783222117114463e-05, 0.00013632455330610078]]} + #*EXTRAS*# Step: 7 Bead: 0 +{"friction": [[0.00013580179219248217, -1.4903790311347482e-05, -1.4396461599257387e-05], [-1.4903790311347482e-05, 0.00013589537851007013, -1.4765440867407678e-05], [-1.4396461599257387e-05, -1.4765440867407678e-05, 0.00013632827051372336]]} + #*EXTRAS*# Step: 8 Bead: 0 +{"friction": [[0.00013580467341873405, -1.488709809791072e-05, -1.437951762333288e-05], [-1.488709809791072e-05, 0.00013589806704095714, -1.4748770096723624e-05], [-1.437951762333288e-05, -1.4748770096723624e-05, 0.00013633175537668956]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_01 b/drivers/py/pes/friction/frictionH/080K/inst.raw_01 new file mode 100644 index 000000000..d124bb725 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_01 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 1 +{"friction": [[0.00013154835182754853, -3.2245612347009654e-05, -3.218171211344349e-05], [-3.2245612347009654e-05, 0.00013178701661774967, -3.222276035226155e-05], [-3.218171211344349e-05, -3.222276035226155e-05, 0.00013130290733224788]]} + #*EXTRAS*# Step: 1 Bead: 1 +{"friction": [[0.00013404800539914356, -2.436037887371007e-05, -2.415899864701066e-05], [-2.436037887371007e-05, 0.00013425935339702558, -2.4251978728149912e-05], [-2.415899864701066e-05, -2.4251978728149912e-05, 0.00013415696335680426]]} + #*EXTRAS*# Step: 2 Bead: 1 +{"friction": [[0.00013591755732220224, -1.4234991320132281e-05, -1.371873807356159e-05], [-1.4234991320132281e-05, 0.00013600355259382716, -1.4097704601413974e-05], [-1.371873807356159e-05, -1.4097704601413974e-05, 0.0001364677476022238]]} + #*EXTRAS*# Step: 3 Bead: 1 +{"friction": [[0.00013524657105314206, -1.812481719770889e-05, -1.7691148695722927e-05], [-1.812481719770889e-05, 0.00013537977721473854, -1.7987225520532583e-05], [-1.7691148695722927e-05, -1.7987225520532583e-05, 0.00013564601497308176]]} + #*EXTRAS*# Step: 4 Bead: 1 +{"friction": [[0.0001355450056975202, -1.6396530953391097e-05, -1.591741415317564e-05], [-1.6396530953391097e-05, 0.00013565641809378282, -1.625731938638031e-05], [-1.591741415317564e-05, -1.625731938638031e-05, 0.0001360151427437123]]} + #*EXTRAS*# Step: 5 Bead: 1 +{"friction": [[0.0001355352813789965, -1.6453118447610952e-05, -1.5975283472627247e-05], [-1.6453118447610952e-05, 0.0001356473903732143, -1.6313915356692954e-05], [-1.5975283472627247e-05, -1.6313915356692954e-05, 0.00013600319345187937]]} + #*EXTRAS*# Step: 6 Bead: 1 +{"friction": [[0.0001355575350584718, -1.6323612614509698e-05, -1.5842865982210645e-05], [-1.6323612614509698e-05, 0.00013566805183654317, -1.618439456637294e-05], [-1.5842865982210645e-05, -1.618439456637294e-05, 0.00013603052986069702]]} + #*EXTRAS*# Step: 7 Bead: 1 +{"friction": [[0.0001355610358521006, -1.6303237443329304e-05, -1.582203982961405e-05], [-1.6303237443329304e-05, 0.00013567130278302, -1.6164018478018974e-05], [-1.582203982961405e-05, -1.6164018478018974e-05, 0.00013603482729681386]]} + #*EXTRAS*# Step: 8 Bead: 1 +{"friction": [[0.0001355641025040489, -1.628538867452416e-05, -1.580379759533389e-05], [-1.628538867452416e-05, 0.00013567415071609625, -1.614616922652582e-05], [-1.580379759533389e-05, -1.614616922652582e-05, 0.00013603859113422458]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_02 b/drivers/py/pes/friction/frictionH/080K/inst.raw_02 new file mode 100644 index 000000000..44e482970 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_02 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 2 +{"friction": [[0.0001305169912654799, -3.426881693488592e-05, -3.4119381770048507e-05], [-3.426881693488592e-05, 0.0001307291042872236, -3.427459924542595e-05], [-3.4119381770048507e-05, -3.427459924542595e-05, 0.00013021252399325722]]} + #*EXTRAS*# Step: 1 Bead: 2 +{"friction": [[0.0001333421958542713, -2.721058277411568e-05, -2.7110687558216453e-05], [-2.721058277411568e-05, 0.00013357972977769557, -2.7127363461520503e-05], [-2.7110687558216453e-05, -2.7127363461520503e-05, 0.00013331183750996584]]} + #*EXTRAS*# Step: 2 Bead: 2 +{"friction": [[0.00013531490655029104, -1.7731381075050537e-05, -1.7286276380385558e-05], [-1.7731381075050537e-05, 0.00013544307036614567, -1.7593172998998247e-05], [-1.7286276380385558e-05, -1.7593172998998247e-05, 0.0001357309253988662]]} + #*EXTRAS*# Step: 3 Bead: 2 +{"friction": [[0.0001347357222289454, -2.0969690891298787e-05, -2.0633871563717828e-05], [-2.0969690891298787e-05, 0.00013490587286603701, -2.084090341880157e-05], [-2.0633871563717828e-05, -2.084090341880157e-05, 0.00013500801100379162]]} + #*EXTRAS*# Step: 4 Bead: 2 +{"friction": [[0.00013504485961717802, -1.9271988745538337e-05, -1.887488096892055e-05], [-1.9271988745538337e-05, 0.00013519293339583072, -1.913702867957289e-05], [-1.887488096892055e-05, -1.913702867957289e-05, 0.00013539448378420538]]} + #*EXTRAS*# Step: 5 Bead: 2 +{"friction": [[0.00013503912983159528, -1.9304193527458456e-05, -1.890817541314613e-05], [-1.9304193527458456e-05, 0.0001351876231709267, -1.9169325269716634e-05], [-1.890817541314613e-05, -1.9169325269716634e-05, 0.0001353873250454647]]} + #*EXTRAS*# Step: 6 Bead: 2 +{"friction": [[0.00013506393885172595, -1.9164581595844938e-05, -1.876386305372332e-05], [-1.9164581595844938e-05, 0.00013521061382802799, -1.902932241492807e-05], [-1.876386305372332e-05, -1.902932241492807e-05, 0.00013541831724196514]]} + #*EXTRAS*# Step: 7 Bead: 2 +{"friction": [[0.00013506842913240275, -1.9139265931955758e-05, -1.8737701640547414e-05], [-1.9139265931955758e-05, 0.000135214774536433, -1.9003937836132406e-05], [-1.8737701640547414e-05, -1.9003937836132406e-05, 0.00013542392548549084]]} + #*EXTRAS*# Step: 8 Bead: 2 +{"friction": [[0.0001350719710107683, -1.911928733224865e-05, -1.8717057035135313e-05], [-1.911928733224865e-05, 0.00013521805635962274, -1.8983905277351872e-05], [-1.8717057035135313e-05, -1.8983905277351872e-05, 0.00013542834893299835]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_03 b/drivers/py/pes/friction/frictionH/080K/inst.raw_03 new file mode 100644 index 000000000..59ea064da --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_03 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 3 +{"friction": [[0.0001286764741586319, -3.714973769009648e-05, -3.679697296268993e-05], [-3.714973769009648e-05, 0.0001288266109833087, -3.7198122442431674e-05], [-3.679697296268993e-05, -3.7198122442431674e-05, 0.00012832661431276367]]} + #*EXTRAS*# Step: 1 Bead: 3 +{"friction": [[0.00013191977533222, -3.13970076878384e-05, -3.1349103889760666e-05], [-3.13970076878384e-05, 0.00013216432768522565, -3.136275911216881e-05], [-3.1349103889760666e-05, -3.136275911216881e-05, 0.00013170498747656282]]} + #*EXTRAS*# Step: 2 Bead: 3 +{"friction": [[0.00013433977145286933, -2.29948709154431e-05, -2.2738932745629637e-05], [-2.29948709154431e-05, 0.00013453534014958122, -2.2876981505907903e-05], [-2.2738932745629637e-05, -2.2876981505907903e-05, 0.00013451548097735057]]} + #*EXTRAS*# Step: 3 Bead: 3 +{"friction": [[0.00013384743571721785, -2.523414830719826e-05, -2.5066497021623274e-05], [-2.523414830719826e-05, 0.00013406797008689572, -2.5132707681851815e-05], [-2.5066497021623274e-05, -2.5132707681851815e-05, 0.0001339134312752118]]} + #*EXTRAS*# Step: 4 Bead: 3 +{"friction": [[0.0001342103213001641, -2.3614516675869967e-05, -2.3383471561309267e-05], [-2.3614516675869967e-05, 0.00013441323289915791, -2.350072184567294e-05], [-2.3383471561309267e-05, -2.350072184567294e-05, 0.00013435584182325486]]} + #*EXTRAS*# Step: 5 Bead: 3 +{"friction": [[0.00013421150627610878, -2.360894385672489e-05, -2.3377675400495666e-05], [-2.360894385672489e-05, 0.0001344143530812138, -2.349511062997733e-05], [-2.3377675400495666e-05, -2.349511062997733e-05, 0.0001343572991992221]]} + #*EXTRAS*# Step: 6 Bead: 3 +{"friction": [[0.0001342434454434474, -2.3458042730717532e-05, -2.3220720987423197e-05], [-2.3458042730717532e-05, 0.0001344445287256725, -2.3343180621906002e-05], [-2.3220720987423197e-05, -2.3343180621906002e-05, 0.00013439660884210155]]} + #*EXTRAS*# Step: 7 Bead: 3 +{"friction": [[0.00013425017478119327, -2.342607843833155e-05, -2.318747327526734e-05], [-2.342607843833155e-05, 0.00013445088231866728, -2.331100107022074e-05], [-2.318747327526734e-05, -2.331100107022074e-05, 0.00013440489797196685]]} + #*EXTRAS*# Step: 8 Bead: 3 +{"friction": [[0.00013425492671827313, -2.340347107654896e-05, -2.3163957982854646e-05], [-2.340347107654896e-05, 0.0001344553680509689, -2.3288242028624953e-05], [-2.3163957982854646e-05, -2.3288242028624953e-05, 0.00013441075278418816]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_04 b/drivers/py/pes/friction/frictionH/080K/inst.raw_04 new file mode 100644 index 000000000..fb9e7325f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_04 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 4 +{"friction": [[0.000126076844382827, -4.029075427069417e-05, -3.973794837135237e-05], [-4.029075427069417e-05, 0.000126150633634249, -4.038143906978131e-05], [-3.973794837135237e-05, -4.038143906978131e-05, 0.00012574927445048358]]} + #*EXTRAS*# Step: 1 Bead: 4 +{"friction": [[0.00012916032508804648, -3.6458225563158106e-05, -3.615935859269742e-05], [-3.6458225563158106e-05, 0.00012932726140209104, -3.649636992782728e-05], [-3.615935859269742e-05, -3.649636992782728e-05, 0.00012881671220173058]]} + #*EXTRAS*# Step: 2 Bead: 4 +{"friction": [[0.0001325510175585019, -2.9749316428185093e-05, -2.9702321549309065e-05], [-2.9749316428185093e-05, 0.00013279895321071728, -2.9694247485264653e-05], [-2.9702321549309065e-05, -2.9694247485264653e-05, 0.00013240364099129632]]} + #*EXTRAS*# Step: 3 Bead: 4 +{"friction": [[0.0001321817719200597, -3.074742930420066e-05, -3.0704152949807736e-05], [-3.074742930420066e-05, 0.00013242882098973667, -3.070475462516475e-05], [-3.0704152949807736e-05, -3.070475462516475e-05, 0.00013199246526964938]]} + #*EXTRAS*# Step: 4 Bead: 4 +{"friction": [[0.0001327107674198355, -2.9283941788712823e-05, -2.923137267902519e-05], [-2.9283941788712823e-05, 0.00013295803618974233, -2.9223338001015876e-05], [-2.923137267902519e-05, -2.9223338001015876e-05, 0.0001325838937358768]]} + #*EXTRAS*# Step: 5 Bead: 4 +{"friction": [[0.0001327290806396648, -2.9229193714563068e-05, -2.9175826149668666e-05], [-2.9229193714563068e-05, 0.00013297622972392048, -2.9167949398532285e-05], [-2.9175826149668666e-05, -2.9167949398532285e-05, 0.00013260465334777457]]} + #*EXTRAS*# Step: 6 Bead: 4 +{"friction": [[0.0001327813236003448, -2.9071377621087906e-05, -2.9015549204634447e-05], [-2.9071377621087906e-05, 0.00013302808105940012, -2.900829961724895e-05], [-2.9015549204634447e-05, -2.900829961724895e-05, 0.00013266398603481637]]} + #*EXTRAS*# Step: 7 Bead: 4 +{"friction": [[0.0001327940340261804, -2.9032611588393457e-05, -2.897614324060199e-05], [-2.9032611588393457e-05, 0.00013304068485569975, -2.8969086055272503e-05], [-2.897614324060199e-05, -2.8969086055272503e-05, 0.0001326784463475374]]} + #*EXTRAS*# Step: 8 Bead: 4 +{"friction": [[0.00013280214627510851, -2.900779318337574e-05, -2.895090793637561e-05], [-2.900779318337574e-05, 0.00013304872670841133, -2.894398174060807e-05], [-2.895090793637561e-05, -2.894398174060807e-05, 0.0001326876805833189]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_05 b/drivers/py/pes/friction/frictionH/080K/inst.raw_05 new file mode 100644 index 000000000..56746df16 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_05 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 5 +{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} + #*EXTRAS*# Step: 1 Bead: 5 +{"friction": [[0.00012524174352568902, -4.112217748095818e-05, -4.057345154621127e-05], [-4.112217748095818e-05, 0.00012530328643784738, -4.122062361627243e-05], [-4.057345154621127e-05, -4.122062361627243e-05, 0.0001249413281591193]]} + #*EXTRAS*# Step: 2 Bead: 5 +{"friction": [[0.00012869361339990943, -3.712591209730373e-05, -3.6775021785806604e-05], [-3.712591209730373e-05, 0.0001288443427447816, -3.717394569400575e-05], [-3.6775021785806604e-05, -3.717394569400575e-05, 0.00012834391438783729]]} + #*EXTRAS*# Step: 3 Bead: 5 +{"friction": [[0.00012880940349611984, -3.696369827082483e-05, -3.662555173834946e-05], [-3.696369827082483e-05, 0.00012896414364333724, -3.70093371328214e-05], [-3.662555173834946e-05, -3.70093371328214e-05, 0.00012846090510532763]]} + #*EXTRAS*# Step: 4 Bead: 5 +{"friction": [[0.000129598168644794, -3.579587980885944e-05, -3.5546594890148564e-05], [-3.579587980885944e-05, 0.0001297802328293621, -3.5824175283994236e-05], [-3.5546594890148564e-05, -3.5824175283994236e-05, 0.0001292634388336609]]} + #*EXTRAS*# Step: 5 Bead: 5 +{"friction": [[0.0001296648498303819, -3.569165958659948e-05, -3.5449902784487e-05], [-3.569165958659948e-05, 0.00012984919207512823, -3.5718406362556186e-05], [-3.5449902784487e-05, -3.5718406362556186e-05, 0.00012933176199810443]]} + #*EXTRAS*# Step: 6 Bead: 5 +{"friction": [[0.00012975945919063456, -3.5542172287482884e-05, -3.5311059497915575e-05], [-3.5542172287482884e-05, 0.00012994701604101812, -3.5566699393191735e-05], [-3.5311059497915575e-05, -3.5566699393191735e-05, 0.00012942883887239875]]} + #*EXTRAS*# Step: 7 Bead: 5 +{"friction": [[0.00012978590640224725, -3.550003819371587e-05, -3.527189120738363e-05], [-3.550003819371587e-05, 0.00012997435777114185, -3.5523940106106974e-05], [-3.527189120738363e-05, -3.5523940106106974e-05, 0.0001294560052654466]]} + #*EXTRAS*# Step: 8 Bead: 5 +{"friction": [[0.0001298013813935833, -3.547531313262659e-05, -3.5248899288938976e-05], [-3.547531313262659e-05, 0.00012999035527845652, -3.549884827080739e-05], [-3.5248899288938976e-05, -3.549884827080739e-05, 0.00012947190710448135]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_06 b/drivers/py/pes/friction/frictionH/080K/inst.raw_06 new file mode 100644 index 000000000..68bfaeeae --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_06 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 6 +{"friction": [[0.00012028748904337296, -4.4090190695074945e-05, -4.407165498061319e-05], [-4.4090190695074945e-05, 0.00012019515217934021, -4.396133059277882e-05], [-4.407165498061319e-05, -4.396133059277882e-05, 0.00012024878352738596]]} + #*EXTRAS*# Step: 1 Bead: 6 +{"friction": [[0.00012145407206483506, -4.36594650306861e-05, -4.3632636413704307e-05], [-4.36594650306861e-05, 0.00012147494648405821, -4.36515025590799e-05], [-4.3632636413704307e-05, -4.36515025590799e-05, 0.00012137143681311038]]} + #*EXTRAS*# Step: 2 Bead: 6 +{"friction": [[0.0001235448745571419, -4.2524887299287357e-05, -4.2174609255368744e-05], [-4.2524887299287357e-05, 0.00012361235660101615, -4.26198549194068e-05], [-4.2174609255368744e-05, -4.26198549194068e-05, 0.00012333442605315625]]} + #*EXTRAS*# Step: 3 Bead: 6 +{"friction": [[0.00012421148542347664, -4.2024759833114514e-05, -4.1568199107195194e-05], [-4.2024759833114514e-05, 0.0001242735613923723, -4.21260067308781e-05], [-4.1568199107195194e-05, -4.21260067308781e-05, 0.00012396068828996064]]} + #*EXTRAS*# Step: 4 Bead: 6 +{"friction": [[0.0001248686064523669, -4.1465830720107914e-05, -4.0938297559525664e-05], [-4.1465830720107914e-05, 0.00012492829878418794, -4.156642492842184e-05], [-4.0938297559525664e-05, -4.156642492842184e-05, 0.0001245840371275614]]} + #*EXTRAS*# Step: 5 Bead: 6 +{"friction": [[0.00012497632652204392, -4.136846768549615e-05, -4.083334364254299e-05], [-4.136846768549615e-05, 0.00012503627748784233, -4.146854001333588e-05], [-4.083334364254299e-05, -4.146854001333588e-05, 0.00012468692478294943]]} + #*EXTRAS*# Step: 6 Bead: 6 +{"friction": [[0.00012507489479930057, -4.127805107825864e-05, -4.0737051840557874e-05], [-4.127805107825864e-05, 0.00012513528198639266, -4.137757347499097e-05], [-4.0737051840557874e-05, -4.137757347499097e-05, 0.00012478125670705895]]} + #*EXTRAS*# Step: 7 Bead: 6 +{"friction": [[0.0001251064567061992, -4.1248835732025334e-05, -4.070616621868756e-05], [-4.1248835732025334e-05, 0.00012516702329372418, -4.134816828432282e-05], [-4.070616621868756e-05, -4.134816828432282e-05, 0.00012481149913710996]]} + #*EXTRAS*# Step: 8 Bead: 6 +{"friction": [[0.0001251235824522183, -4.1232930136881925e-05, -4.0689395966985576e-05], [-4.1232930136881925e-05, 0.00012518425421827227, -4.133215694720476e-05], [-4.0689395966985576e-05, -4.133215694720476e-05, 0.00012482791632483918]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_07 b/drivers/py/pes/friction/frictionH/080K/inst.raw_07 new file mode 100644 index 000000000..481841bcb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_07 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 7 +{"friction": [[0.00011665083949596382, -4.4607528816683966e-05, -4.431825914901668e-05], [-4.4607528816683966e-05, 0.0001162267076263409, -4.4207173972077276e-05], [-4.431825914901668e-05, -4.4207173972077276e-05, 0.00011666327977368902]]} + #*EXTRAS*# Step: 1 Bead: 7 +{"friction": [[0.00011690567754713395, -4.462486812304193e-05, -4.4341095634371984e-05], [-4.462486812304193e-05, 0.0001164850838147236, -4.422278371703446e-05], [-4.4341095634371984e-05, -4.422278371703446e-05, 0.00011691588812359782]]} + #*EXTRAS*# Step: 2 Bead: 7 +{"friction": [[0.00011832949096438044, -4.45529575046454e-05, -4.436843069541386e-05], [-4.45529575046454e-05, 0.00011800532179359694, -4.4217590435120216e-05], [-4.436843069541386e-05, -4.4217590435120216e-05, 0.00011832635331643656]]} + #*EXTRAS*# Step: 3 Bead: 7 +{"friction": [[0.0001196784855374387, -4.427195657573872e-05, -4.421352131142412e-05], [-4.427195657573872e-05, 0.0001195120146170067, -4.407322522886284e-05], [-4.421352131142412e-05, -4.407322522886284e-05, 0.0001196545377292183]]} + #*EXTRAS*# Step: 4 Bead: 7 +{"friction": [[0.0001202933229784124, -4.408830014675597e-05, -4.407004140621317e-05], [-4.408830014675597e-05, 0.00012020167125612617, -4.396010658379329e-05], [-4.407004140621317e-05, -4.396010658379329e-05, 0.00012025445391588654]]} + #*EXTRAS*# Step: 5 Bead: 7 +{"friction": [[0.00012045040626937716, -4.403636580288439e-05, -4.4024636311831246e-05], [-4.403636580288439e-05, 0.00012037691640357787, -4.392601393703019e-05], [-4.4024636311831246e-05, -4.392601393703019e-05, 0.00012040695455346231]]} + #*EXTRAS*# Step: 6 Bead: 7 +{"friction": [[0.00012055080215192555, -4.400214417375305e-05, -4.3993583037086455e-05], [-4.400214417375305e-05, 0.00012048859101988257, -4.390305739800719e-05], [-4.3993583037086455e-05, -4.390305739800719e-05, 0.0001205042327488948]]} + #*EXTRAS*# Step: 7 Bead: 7 +{"friction": [[0.00012058673645645107, -4.398970261248895e-05, -4.398207052982151e-05], [-4.398970261248895e-05, 0.00012052849124395085, -4.389461491524374e-05], [-4.398207052982151e-05, -4.389461491524374e-05, 0.0001205390136251474]]} + #*EXTRAS*# Step: 8 Bead: 7 +{"friction": [[0.00012060477353813617, -4.398341954849152e-05, -4.397621148730388e-05], [-4.398341954849152e-05, 0.00012054850395012206, -4.3890331880578624e-05], [-4.397621148730388e-05, -4.3890331880578624e-05, 0.00012055646410073887]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_08 b/drivers/py/pes/friction/frictionH/080K/inst.raw_08 new file mode 100644 index 000000000..9c5433d48 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_08 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 8 +{"friction": [[0.00011321589094004546, -4.351814646398022e-05, -4.345964836559014e-05], [-4.351814646398022e-05, 0.00011306154132995574, -4.343115956369095e-05], [-4.345964836559014e-05, -4.343115956369095e-05, 0.00011326318332248197]]} + #*EXTRAS*# Step: 1 Bead: 8 +{"friction": [[0.00011254918292050029, -4.316243939422925e-05, -4.316520295598142e-05], [-4.316243939422925e-05, 0.00011246549909959065, -4.3144161407362884e-05], [-4.316520295598142e-05, -4.3144161407362884e-05, 0.00011260444690783562]]} + #*EXTRAS*# Step: 2 Bead: 8 +{"friction": [[0.00011280634231605482, -4.330348128256488e-05, -4.328397752837003e-05], [-4.330348128256488e-05, 0.00011269673018217933, -4.326060576583219e-05], [-4.328397752837003e-05, -4.326060576583219e-05, 0.00011285847888635022]]} + #*EXTRAS*# Step: 3 Bead: 8 +{"friction": [[0.00011443782095465676, -4.406815682033918e-05, -4.388776453379777e-05], [-4.406815682033918e-05, 0.00011414545785474514, -4.383585835559629e-05], [-4.388776453379777e-05, -4.383585835559629e-05, 0.00011447159801876669]]} + #*EXTRAS*# Step: 4 Bead: 8 +{"friction": [[0.00011490889838863745, -4.423698197134576e-05, -4.4015578219284754e-05], [-4.423698197134576e-05, 0.0001145698671843195, -4.395225526526253e-05], [-4.4015578219284754e-05, -4.395225526526253e-05, 0.00011493781465384376]]} + #*EXTRAS*# Step: 5 Bead: 8 +{"friction": [[0.00011510610153504759, -4.4299595045300337e-05, -4.40631157529807e-05], [-4.4299595045300337e-05, 0.00011474973901092989, -4.399473815620762e-05], [-4.40631157529807e-05, -4.399473815620762e-05, 0.0001151330370449228]]} + #*EXTRAS*# Step: 6 Bead: 8 +{"friction": [[0.0001152021349035972, -4.4328292995944204e-05, -4.408500665338837e-05], [-4.4328292995944204e-05, 0.0001148378923560084, -4.401411830990458e-05], [-4.408500665338837e-05, -4.401411830990458e-05, 0.00011522811707731956]]} + #*EXTRAS*# Step: 7 Bead: 8 +{"friction": [[0.00011524128732347879, -4.433965049905932e-05, -4.409369625519902e-05], [-4.433965049905932e-05, 0.0001148739443500732, -4.4021775792487194e-05], [-4.409369625519902e-05, -4.4021775792487194e-05, 0.00011526688291454595]]} + #*EXTRAS*# Step: 8 Bead: 8 +{"friction": [[0.00011525960476942507, -4.434489548063291e-05, -4.409771502253044e-05], [-4.434489548063291e-05, 0.0001148908342153642, -4.4025310061854805e-05], [-4.409771502253044e-05, -4.4025310061854805e-05, 0.00011528501991106724]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_09 b/drivers/py/pes/friction/frictionH/080K/inst.raw_09 new file mode 100644 index 000000000..c4fd5514c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_09 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 9 +{"friction": [[0.00011023000206976872, -4.1719099977050135e-05, -4.179519325177442e-05], [-4.1719099977050135e-05, 0.00011025478793267088, -4.1768623177242506e-05], [-4.179519325177442e-05, -4.1768623177242506e-05, 0.00011030747133180427]]} + #*EXTRAS*# Step: 1 Bead: 9 +{"friction": [[0.0001088530991364734, -4.069880420453629e-05, -4.073760919444428e-05], [-4.069880420453629e-05, 0.00010886695037594943, -4.071412661461412e-05], [-4.073760919444428e-05, -4.071412661461412e-05, 0.00010891343847498907]]} + #*EXTRAS*# Step: 2 Bead: 9 +{"friction": [[0.00010820791967953468, -4.0171509275046815e-05, -4.018531301274981e-05], [-4.0171509275046815e-05, 0.00010821179247971602, -4.0175042536591634e-05], [-4.018531301274981e-05, -4.0175042536591634e-05, 0.000108244120728227]]} + #*EXTRAS*# Step: 3 Bead: 9 +{"friction": [[0.00010993960158630413, -4.1515138528648044e-05, -4.158657967591049e-05], [-4.1515138528648044e-05, 0.00010996477356742037, -4.1558847507488136e-05], [-4.158657967591049e-05, -4.1558847507488136e-05, 0.00011001651748715463]]} + #*EXTRAS*# Step: 4 Bead: 9 +{"friction": [[0.000110230941139765, -4.171975028584762e-05, -4.1795854912505604e-05], [-4.171975028584762e-05, 0.00011025572242726744, -4.1769289478255534e-05], [-4.1795854912505604e-05, -4.1769289478255534e-05, 0.00011030841010447916]]} + #*EXTRAS*# Step: 5 Bead: 9 +{"friction": [[0.00011043290881662265, -4.185825633626275e-05, -4.1936203434194356e-05], [-4.185825633626275e-05, 0.00011045615719484379, -4.191073238593357e-05], [-4.1936203434194356e-05, -4.191073238593357e-05, 0.0001105100309062005]]} + #*EXTRAS*# Step: 6 Bead: 9 +{"friction": [[0.00011050903392794061, -4.1909768612844365e-05, -4.198808757022613e-05], [-4.1909768612844365e-05, 0.00011053140652433243, -4.196306849984698e-05], [-4.198808757022613e-05, -4.196306849984698e-05, 0.00011058588768548832]]} + #*EXTRAS*# Step: 7 Bead: 9 +{"friction": [[0.00011054450019550659, -4.1933640026952586e-05, -4.201206919069996e-05], [-4.1933640026952586e-05, 0.00011056640605521217, -4.198726592806423e-05], [-4.201206919069996e-05, -4.198726592806423e-05, 0.00011062120500468696]]} + #*EXTRAS*# Step: 8 Bead: 9 +{"friction": [[0.00011055989721789381, -4.1943978192678186e-05, -4.202244251025011e-05], [-4.1943978192678186e-05, 0.00011058158859663468, -4.199773380156925e-05], [-4.202244251025011e-05, -4.199773380156925e-05, 0.0001106365327702565]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_10 b/drivers/py/pes/friction/frictionH/080K/inst.raw_10 new file mode 100644 index 000000000..4778a501f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_10 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 10 +{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} + #*EXTRAS*# Step: 1 Bead: 10 +{"friction": [[0.0001057721423295425, -3.78545515320464e-05, -3.7796997696729915e-05], [-3.78545515320464e-05, 0.00010576991461882027, -3.79261815546144e-05], [-3.7796997696729915e-05, -3.79261815546144e-05, 0.00010560881423484789]]} + #*EXTRAS*# Step: 2 Bead: 10 +{"friction": [[0.00010449000500139373, -3.637523863065668e-05, -3.630630183780285e-05], [-3.637523863065668e-05, 0.00010448927880300736, -3.6519355057688e-05], [-3.630630183780285e-05, -3.6519355057688e-05, 0.00010419237666424612]]} + #*EXTRAS*# Step: 3 Bead: 10 +{"friction": [[0.00010621385722659852, -3.831740356874446e-05, -3.826857923142562e-05], [-3.831740356874446e-05, 0.00010621004126137114, -3.836621588831704e-05], [-3.826857923142562e-05, -3.836621588831704e-05, 0.00010609571529716862]]} + #*EXTRAS*# Step: 4 Bead: 10 +{"friction": [[0.00010635891569301347, -3.846486442209238e-05, -3.841936481057238e-05], [-3.846486442209238e-05, 0.00010635466720509825, -3.8506838671620094e-05], [-3.841936481057238e-05, -3.8506838671620094e-05, 0.00010625508805064093]]} + #*EXTRAS*# Step: 5 Bead: 10 +{"friction": [[0.00010656184168632478, -3.8667565200767354e-05, -3.8627075492118905e-05], [-3.8667565200767354e-05, 0.00010655712630285816, -3.870064797296415e-05], [-3.8627075492118905e-05, -3.870064797296415e-05, 0.00010647747652884425]]} + #*EXTRAS*# Step: 6 Bead: 10 +{"friction": [[0.00010662167027733569, -3.872654749032652e-05, -3.868761255457008e-05], [-3.872654749032652e-05, 0.00010661685513516313, -3.875717362387767e-05], [-3.868761255457008e-05, -3.875717362387767e-05, 0.00010654290390950731]]} + #*EXTRAS*# Step: 7 Bead: 10 +{"friction": [[0.0001066541268558249, -3.875839874917558e-05, -3.87203217864592e-05], [-3.875839874917558e-05, 0.00010664926578572724, -3.8787725586677235e-05], [-3.87203217864592e-05, -3.8787725586677235e-05, 0.0001065783693082501]]} + #*EXTRAS*# Step: 8 Bead: 10 +{"friction": [[0.00010666715605311408, -3.877115618343743e-05, -3.873342649438059e-05], [-3.877115618343743e-05, 0.00010666227823436151, -3.8799968190310435e-05], [-3.873342649438059e-05, -3.8799968190310435e-05, 0.00010659260057903704]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_11 b/drivers/py/pes/friction/frictionH/080K/inst.raw_11 new file mode 100644 index 000000000..7120da2f3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_11 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 11 +{"friction": [[0.00010562036954718544, -3.769046910141249e-05, -3.763042875179934e-05], [-3.769046910141249e-05, 0.00010561870141779494, -3.7770470863789636e-05], [-3.763042875179934e-05, -3.7770470863789636e-05, 0.0001054411173289977]]} + #*EXTRAS*# Step: 1 Bead: 11 +{"friction": [[0.00010348761360071319, -3.503542064480136e-05, -3.497684435890506e-05], [-3.503542064480136e-05, 0.0001034740250603811, -3.522188858887473e-05], [-3.497684435890506e-05, -3.522188858887473e-05, 0.00010310216196176272]]} + #*EXTRAS*# Step: 2 Bead: 11 +{"friction": [[0.00010202927103065378, -3.265415452690861e-05, -3.2650615638337266e-05], [-3.265415452690861e-05, 0.00010195011871326056, -3.2816616869330545e-05], [-3.2650615638337266e-05, -3.2816616869330545e-05, 0.00010161603651286742]]} + #*EXTRAS*# Step: 3 Bead: 11 +{"friction": [[0.00010343713004017408, -3.49623672535585e-05, -3.490490753004566e-05], [-3.49623672535585e-05, 0.00010342226463747947, -3.515006529103178e-05], [-3.490490753004566e-05, -3.515006529103178e-05, 0.00010304821743298625]]} + #*EXTRAS*# Step: 4 Bead: 11 +{"friction": [[0.00010345956656237301, -3.499491078171204e-05, -3.4936946642200153e-05], [-3.499491078171204e-05, 0.00010344527831379907, -3.5182076953966355e-05], [-3.4936946642200153e-05, -3.5182076953966355e-05, 0.00010307217663010795]]} + #*EXTRAS*# Step: 5 Bead: 11 +{"friction": [[0.00010363068095214582, -3.523918246007258e-05, -3.517779206125835e-05], [-3.523918246007258e-05, 0.0001036203041081349, -3.542154689443435e-05], [-3.517779206125835e-05, -3.542154689443435e-05, 0.00010325568445369107]]} + #*EXTRAS*# Step: 6 Bead: 11 +{"friction": [[0.00010367010120253335, -3.5294507275976526e-05, -3.523242914364329e-05], [-3.5294507275976526e-05, 0.00010366051001621782, -3.547559251172429e-05], [-3.523242914364329e-05, -3.547559251172429e-05, 0.00010329814176424597]]} + #*EXTRAS*# Step: 7 Bead: 11 +{"friction": [[0.00010369565617608655, -3.533018948496009e-05, -3.526768510217769e-05], [-3.533018948496009e-05, 0.0001036865526496562, -3.551041350279949e-05], [-3.526768510217769e-05, -3.551041350279949e-05, 0.00010332569933593052]]} + #*EXTRAS*# Step: 8 Bead: 11 +{"friction": [[0.00010370511258939588, -3.5343357263702424e-05, -3.528069901176963e-05], [-3.5343357263702424e-05, 0.00010369618528505914, -3.5523256383589847e-05], [-3.528069901176963e-05, -3.5523256383589847e-05, 0.00010333590336834901]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_12 b/drivers/py/pes/friction/frictionH/080K/inst.raw_12 new file mode 100644 index 000000000..6a3348f9e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_12 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 12 +{"friction": [[0.00010410059478635681, -3.587758594138993e-05, -3.5810247906280144e-05], [-3.587758594138993e-05, 0.00010409721165943899, -3.604130532787345e-05], [-3.5810247906280144e-05, -3.604130532787345e-05, 0.00010376542350754372]]} + #*EXTRAS*# Step: 1 Bead: 12 +{"friction": [[0.00010201247487144806, -3.262354319305223e-05, -3.262077151375494e-05], [-3.262354319305223e-05, 0.00010193238868493448, -3.278497164745526e-05], [-3.262077151375494e-05, -3.278497164745526e-05, 0.00010160004958930738]]} + #*EXTRAS*# Step: 2 Bead: 12 +{"friction": [[0.00010042570025337742, -2.9535442820139492e-05, -2.956607705434336e-05], [-2.9535442820139492e-05, 0.00010030308189167838, -2.953489779035083e-05], [-2.956607705434336e-05, -2.953489779035083e-05, 0.00010025536563768875]]} + #*EXTRAS*# Step: 3 Bead: 12 +{"friction": [[0.000101691014836043, -3.202579122971117e-05, -3.2037127193822185e-05], [-3.202579122971117e-05, 0.00010159367507116184, -3.2164204440557716e-05], [-3.2037127193822185e-05, -3.2164204440557716e-05, 0.00010130047289456198]]} + #*EXTRAS*# Step: 4 Bead: 12 +{"friction": [[0.00010164452370351483, -3.193760339307928e-05, -3.195083895108882e-05], [-3.193760339307928e-05, 0.0001015448470299712, -3.207219493936574e-05], [-3.195083895108882e-05, -3.207219493936574e-05, 0.00010125819670674425]]} + #*EXTRAS*# Step: 5 Bead: 12 +{"friction": [[0.00010178384513937206, -3.2200627649962355e-05, -3.220804123004875e-05], [-3.2200627649962355e-05, 0.00010169131928070299, -3.234630629993251e-05], [-3.220804123004875e-05, -3.234630629993251e-05, 0.00010138570003551383]]} + #*EXTRAS*# Step: 6 Bead: 12 +{"friction": [[0.00010180831046105114, -3.224641749606478e-05, -3.22527723417854e-05], [-3.224641749606478e-05, 0.00010171708155735564, -3.2393928587599995e-05], [-3.22527723417854e-05, -3.2393928587599995e-05, 0.00010140833900254269]]} + #*EXTRAS*# Step: 7 Bead: 12 +{"friction": [[0.00010182762546836929, -3.228248052859509e-05, -3.228799305560916e-05], [-3.228248052859509e-05, 0.0001017374277213326, -3.243141374556784e-05], [-3.228799305560916e-05, -3.243141374556784e-05, 0.00010142626367664276]]} + #*EXTRAS*# Step: 8 Bead: 12 +{"friction": [[0.00010183418991213734, -3.229471926624222e-05, -3.2299944288260775e-05], [-3.229471926624222e-05, 0.00010174434398874803, -3.244413085578851e-05], [-3.2299944288260775e-05, -3.244413085578851e-05, 0.00010143236589790384]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_13 b/drivers/py/pes/friction/frictionH/080K/inst.raw_13 new file mode 100644 index 000000000..1de8884d0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_13 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 13 +{"friction": [[0.00010310461147450481, -3.446489117457354e-05, -3.44165270104119e-05], [-3.446489117457354e-05, 0.00010307920642357731, -3.4657347226921115e-05], [-3.44165270104119e-05, -3.4657347226921115e-05, 0.00010269639584043074]]} + #*EXTRAS*# Step: 1 Bead: 13 +{"friction": [[0.00010105610748830827, -3.079237532374079e-05, -3.082369145202307e-05], [-3.079237532374079e-05, 0.00010093383027621988, -3.086900404080006e-05], [-3.082369145202307e-05, -3.086900404080006e-05, 0.00010074802376076155]]} + #*EXTRAS*# Step: 2 Bead: 13 +{"friction": [[9.922798230259201e-05, -2.720111575444535e-05, -2.7146143543515786e-05], [-2.720111575444535e-05, 9.920665371975914e-05, -2.704059602174001e-05], [-2.7146143543515786e-05, -2.704059602174001e-05, 9.945970885460705e-05]]} + #*EXTRAS*# Step: 3 Bead: 13 +{"friction": [[0.00010054212097041622, -2.976773135891528e-05, -2.980053894288423e-05], [-2.976773135891528e-05, 0.0001004171108862999, -2.978224314231892e-05], [-2.980053894288423e-05, -2.978224314231892e-05, 0.00010034211556951886]]} + #*EXTRAS*# Step: 4 Bead: 13 +{"friction": [[0.00010044925646621702, -2.9582405397081683e-05, -2.9613562444920224e-05], [-2.9582405397081683e-05, 0.00010032605431458083, -2.958492824937375e-05], [-2.9613562444920224e-05, -2.958492824937375e-05, 0.00010027276628737106]]} + #*EXTRAS*# Step: 5 Bead: 13 +{"friction": [[0.00010058425768568506, -2.985189137298372e-05, -2.9885236909808787e-05], [-2.985189137298372e-05, 0.00010045868071659685, -2.9871782038939736e-05], [-2.9885236909808787e-05, -2.9871782038939736e-05, 0.00010037398048117427]]} + #*EXTRAS*# Step: 6 Bead: 13 +{"friction": [[0.00010060233839611672, -2.988801195002687e-05, -2.9921548912667568e-05], [-2.988801195002687e-05, 0.00010047656549181346, -2.9910197969582903e-05], [-2.9921548912667568e-05, -2.9910197969582903e-05, 0.00010038773022463971]]} + #*EXTRAS*# Step: 7 Bead: 13 +{"friction": [[0.00010061991249763063, -2.992312334073741e-05, -2.9956823981258088e-05], [-2.992312334073741e-05, 0.00010049397601341848, -2.9947532788298766e-05], [-2.9956823981258088e-05, -2.9947532788298766e-05, 0.00010040113891931563]]} + #*EXTRAS*# Step: 8 Bead: 13 +{"friction": [[0.00010062542722465122, -2.993414165546153e-05, -2.996788914158192e-05], [-2.993414165546153e-05, 0.00010049944482865864, -2.995924723261611e-05], [-2.996788914158192e-05, -2.995924723261611e-05, 0.00010040535554239079]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_14 b/drivers/py/pes/friction/frictionH/080K/inst.raw_14 new file mode 100644 index 000000000..c5c4e74f8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_14 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 14 +{"friction": [[0.0001025334360101724, -3.35409127376559e-05, -3.351447758652769e-05], [-3.35409127376559e-05, 0.00010248196407672836, -3.372632209749448e-05], [-3.351447758652769e-05, -3.372632209749448e-05, 0.00010210975134216749]]} + #*EXTRAS*# Step: 1 Bead: 14 +{"friction": [[0.00010045753428263073, -2.9598913664620585e-05, -2.9630244306177948e-05], [-2.9598913664620585e-05, 0.00010033413916083015, -2.9602512159249237e-05], [-2.9630244306177948e-05, -2.9602512159249237e-05, 0.00010027889924373719]]} + #*EXTRAS*# Step: 2 Bead: 14 +{"friction": [[9.846641718517142e-05, -2.5645723860343796e-05, -2.549205806325441e-05], [-2.5645723860343796e-05, 9.856660411301771e-05, -2.5389137557014936e-05], [-2.549205806325441e-05, -2.5389137557014936e-05, 9.900889378179689e-05]]} + #*EXTRAS*# Step: 3 Bead: 14 +{"friction": [[9.977974733760773e-05, -2.8264965534873702e-05, -2.826341144315718e-05], [-2.8264965534873702e-05, 9.969465488029932e-05, -2.8178048740786784e-05], [-2.826341144315718e-05, -2.8178048740786784e-05, 9.980683477679885e-05]]} + #*EXTRAS*# Step: 4 Bead: 14 +{"friction": [[9.965002135450125e-05, -2.8014937904855224e-05, -2.800267432049681e-05], [-2.8014937904855224e-05, 9.957760768039353e-05, -2.791057338107884e-05], [-2.800267432049681e-05, -2.791057338107884e-05, 9.972283055715417e-05]]} + #*EXTRAS*# Step: 5 Bead: 14 +{"friction": [[9.979042505329167e-05, -2.8285599580978485e-05, -2.828486814641975e-05], [-2.8285599580978485e-05, 9.970436104539265e-05, -2.8200121046125185e-05], [-2.828486814641975e-05, -2.8200121046125185e-05, 9.981382786283588e-05]]} + #*EXTRAS*# Step: 6 Bead: 14 +{"friction": [[9.980538000673983e-05, -2.8314517219414108e-05, -2.8314922260621385e-05], [-2.8314517219414108e-05, 9.971797441681535e-05, -2.8231053498155316e-05], [-2.8314922260621385e-05, -2.8231053498155316e-05, 9.982364340630994e-05]]} + #*EXTRAS*# Step: 7 Bead: 14 +{"friction": [[9.982294649514996e-05, -2.834851338211944e-05, -2.8350229639486725e-05], [-2.834851338211944e-05, 9.973399390365758e-05, -2.8267416891423644e-05], [-2.8350229639486725e-05, -2.8267416891423644e-05, 9.983520505494521e-05]]} + #*EXTRAS*# Step: 8 Bead: 14 +{"friction": [[9.982812292399858e-05, -2.83585374899337e-05, -2.836063519030475e-05], [-2.83585374899337e-05, 9.973872047265023e-05, -2.8278138675487352e-05], [-2.836063519030475e-05, -2.8278138675487352e-05, 9.98386186881815e-05]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_15 b/drivers/py/pes/friction/frictionH/080K/inst.raw_15 new file mode 100644 index 000000000..c7e88a8da --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst.raw_15 @@ -0,0 +1,18 @@ + #*EXTRAS*# Step: 0 Bead: 15 +{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} + #*EXTRAS*# Step: 1 Bead: 15 +{"friction": [[0.00010018186664153547, -2.905119740158293e-05, -2.907382683122514e-05], [-2.905119740158293e-05, 0.00010006841254719833, -2.9018404051194462e-05], [-2.907382683122514e-05, -2.9018404051194462e-05, 0.0001000796950585405]]} + #*EXTRAS*# Step: 2 Bead: 15 +{"friction": [[9.812930691293408e-05, -2.486433241599585e-05, -2.4661652939648045e-05], [-2.486433241599585e-05, 9.829241905848725e-05, -2.456951566119453e-05], [-2.4661652939648045e-05, -2.456951566119453e-05, 9.881193456873603e-05]]} + #*EXTRAS*# Step: 3 Bead: 15 +{"friction": [[9.939177943105922e-05, -2.7518132635428465e-05, -2.7481021140446154e-05], [-2.7518132635428465e-05, 9.93489880132999e-05, -2.7379261898305943e-05], [-2.7481021140446154e-05, -2.7379261898305943e-05, 9.956021835651802e-05]]} + #*EXTRAS*# Step: 4 Bead: 15 +{"friction": [[9.924531406422703e-05, -2.723479875154812e-05, -2.7181785583972395e-05], [-2.723479875154812e-05, 9.922162436164377e-05, -2.707655874342292e-05], [-2.7181785583972395e-05, -2.707655874342292e-05, 9.94702608589478e-05]]} + #*EXTRAS*# Step: 5 Bead: 15 +{"friction": [[9.938585266052157e-05, -2.750670403379218e-05, -2.7468972728109366e-05], [-2.750670403379218e-05, 9.934380367568316e-05, -2.73670462020629e-05], [-2.7468972728109366e-05, -2.73670462020629e-05, 9.955654925448419e-05]]} + #*EXTRAS*# Step: 6 Bead: 15 +{"friction": [[9.939896994049158e-05, -2.753199493294469e-05, -2.7495632619649693e-05], [-2.753199493294469e-05, 9.935528135180367e-05, -2.7394079461541272e-05], [-2.7495632619649693e-05, -2.7394079461541272e-05, 9.956467326920548e-05]]} + #*EXTRAS*# Step: 7 Bead: 15 +{"friction": [[9.94163355937843e-05, -2.7565459999022713e-05, -2.7530894310112865e-05], [-2.7565459999022713e-05, 9.937049649995253e-05, -2.74298530901322e-05], [-2.7530894310112865e-05, -2.74298530901322e-05, 9.957544807321247e-05]]} + #*EXTRAS*# Step: 8 Bead: 15 +{"friction": [[9.942128111579153e-05, -2.757498715948014e-05, -2.754092981262477e-05], [-2.757498715948014e-05, 9.937483381181673e-05, -2.7440038086575633e-05], [-2.754092981262477e-05, -2.7440038086575633e-05, 9.957852074394017e-05]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst1D.dat b/drivers/py/pes/friction/frictionH/080K/inst1D.dat new file mode 100644 index 000000000..bed37db94 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/inst1D.dat @@ -0,0 +1,16 @@ +1.9866850273986039 0.050919370072655595 +1.9994378884395796 0.05290320294685336 +2.0262721287516 0.05754808218924119 +2.0697017458568143 0.06621437972546856 +2.132971532488317 0.08065941548510698 +2.2189211317131208 0.10174199948043824 +2.3276737541836696 0.12584532755081587 +2.454370168604051 0.14273224115687608 +2.589552996042531 0.1451657473533179 +2.721609676386341 0.1340864802905247 +2.8405657820583787 0.11550856746259959 +2.940361149221517 0.09443177425200715 +3.0189905842206826 0.07671030737855557 +3.0766053861354705 0.06402971605434313 +3.114167429500616 0.05615693406720792 +3.1326587164143738 0.05244064585222887 diff --git a/drivers/py/pes/friction/frictionH/080K/z_friction.dat b/drivers/py/pes/friction/frictionH/080K/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/080K/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/100K/MEP.dat b/drivers/py/pes/friction/frictionH/100K/MEP.dat new file mode 100644 index 000000000..e69de29bb diff --git a/drivers/py/pes/friction/frictionH/100K/RESTART b/drivers/py/pes/friction/frictionH/100K/RESTART new file mode 100644 index 000000000..6f10c4583 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/RESTART @@ -0,0 +1,612 @@ + + + [ step, potential{electronvolt} ] + extras + extras + + 3 + 10 + + + + + + [ friction ] + + + + 3.16681520e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 3.09906606e-03, 3.22851909e-03, 3.49093586e-03, 3.88176275e-03, 4.36485396e-03, + 4.84679796e-03, 5.20913573e-03, 5.36951613e-03, 5.28551898e-03, 5.02084485e-03, + 4.65677172e-03, 4.23706344e-03, 3.83387796e-03, 3.50704134e-03, 3.28336292e-03, + 3.17092824e-03 ] + + + [ -2.96578142e-03, 3.12662139e-05, 3.12469565e-05, -2.98003823e-03, 3.11527793e-05, + 3.11240805e-05, -2.96409761e-03, 3.06339897e-05, 3.05569437e-05, -2.83746289e-03, + 2.91424634e-05, 2.89705536e-05, -2.51569483e-03, 2.59096758e-05, 2.56787589e-05, + -1.95742103e-03, 2.02680240e-05, 2.01244996e-05, -1.17861731e-03, 1.23180576e-05, + 1.22859988e-05, -2.49818691e-04, 2.88384895e-06, 2.87013899e-06, 6.70554207e-04, + -7.01954459e-06, -7.00842701e-06, 1.46822483e-03, -1.61622127e-05, -1.61730639e-05, + 2.07187846e-03, -2.38199354e-05, -2.38278020e-05, 2.44409999e-03, -2.97107394e-05, + -2.96955834e-05, 2.63506268e-03, -3.38928394e-05, -3.38669583e-05, 2.71852512e-03, + -3.66320899e-05, -3.66104886e-05, 2.74739598e-03, -3.82428483e-05, -3.82323615e-05, + 2.75418921e-03, -3.89794884e-05, -3.89773293e-05 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00 ] + + True + + [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, + 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, + 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, + 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, + 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, + 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, + 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, + 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, + 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, + 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, + 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, + 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, + 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, + 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, + 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, + 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, + 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, + 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, + 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, + 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, + 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, + 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, + 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, + 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, + 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, + 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, + 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, + 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, + 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, + 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, + 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, + 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, + 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, + 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, + 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, + 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, + 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, + 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, + 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, + 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, + 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, + 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, + 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, + 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, + 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, + 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, + 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, + 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, + 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, + 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, + 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, + 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, + 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, + 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, + 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, + 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, + 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, + 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, + 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, + 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, + 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, + 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, + 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, + 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, + 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, + 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, + 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, + 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, + 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, + 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, + 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, + 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, + 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, + 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, + 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, + 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, + 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, + 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, + 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, + 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, + 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, + 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, + 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, + 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, + 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, + 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, + 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, + 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, + 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, + 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, + 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, + 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, + 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, + 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, + 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, + 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, + 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, + 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, + 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, + 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, + 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, + 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, + 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, + 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, + 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, + 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, + 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, + 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, + 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, + 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, + 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, + 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, + 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, + 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, + 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, + 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, + 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, + 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, + 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, + 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, + 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, + 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, + 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, + 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, + 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, + 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, + 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, + 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, + 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, + 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, + 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, + 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, + 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, + 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, + 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, + 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, + 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, + 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, + 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, + 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, + 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, + 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, + 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, + 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, + 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, + 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, + 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, + 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, + 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, + 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, + 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, + 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, + 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, + 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, + 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, + 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, + 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, + 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, + 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, + 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, + 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, + 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, + 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, + 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, + 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, + 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, + 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, + 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, + 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, + 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, + 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, + 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, + 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, + 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, + 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, + 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, + 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, + 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, + 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, + 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, + 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, + 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, + 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, + 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, + 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, + 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, + 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, + 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, + 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, + 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, + 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, + 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, + 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, + 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, + 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, + 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, + 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, + 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, + 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, + 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, + 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, + 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, + 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, + 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, + 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, + 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, + 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, + 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, + 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, + 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, + 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, + 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, + 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, + 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, + 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, + 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, + 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, + 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, + 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, + 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, + 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, + 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, + 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, + 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, + 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, + 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, + 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, + 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, + 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, + 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, + 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, + 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, + 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, + 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, + 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, + 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, + 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, + 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, + 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, + 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, + 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, + 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, + 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, + 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, + 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, + 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, + 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, + 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, + 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, + 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, + 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, + 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, + 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, + 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, + 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, + 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, + 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, + 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, + 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, + 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, + 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, + 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, + 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, + 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, + 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, + 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, + 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, + 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, + 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, + 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, + 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, + 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, + 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, + 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, + 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, + 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, + 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, + 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, + 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, + 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, + 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, + 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, + 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, + 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, + 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, + 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, + 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, + 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, + 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, + 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, + 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, + 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, + 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, + 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, + 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, + 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, + 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, + 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, + 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, + 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, + 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, + 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, + 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, + 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, + 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, + 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, + 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, + 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, + 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, + 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, + 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, + 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, + 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, + 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, + 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, + 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, + 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, + 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, + 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, + 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, + 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, + 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, + 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, + 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, + 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, + 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, + 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, + 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, + 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, + 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, + 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, + 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, + 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, + 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, + 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, + 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, + 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, + 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, + 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, + 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, + 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, + 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, + 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, + 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, + 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, + 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, + 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, + 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, + 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, + 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, + 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, + 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, + 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, + 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, + 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, + 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, + 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, + 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, + 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, + 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, + 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, + 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, + 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, + 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, + 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, + 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, + 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, + 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, + 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, + 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, + 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, + 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, + 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, + 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, + 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, + 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, + 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, + 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, + 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, + 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, + 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, + 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, + 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, + 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, + 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, + 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, + 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, + 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, + 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, + 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, + 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, + 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, + 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, + 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, + 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, + 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, + 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, + 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, + 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, + 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] + + + [ 1.61128639e-03, 8.96103006e-05, 9.01702301e-05, 5.85637218e-04, 8.47072851e-05, + 8.41412320e-05, -1.44975075e-03, 7.54113422e-05, 7.27918282e-05, -4.09220496e-03, + 6.09609317e-05, 5.75683579e-05, -6.77517000e-03, 4.10634180e-05, 3.97375753e-05, + -8.87065059e-03, 1.87784050e-05, 2.10953763e-05, -1.04382044e-02, 8.16568351e-06, + 8.23902319e-06, -1.09127694e-02, 2.94847080e-06, 2.74567171e-06, -1.01314463e-02, + 4.97950336e-06, 4.43841410e-06, -8.86576512e-03, 1.21417728e-05, 1.18230825e-05, + -6.85083993e-03, 2.09453089e-05, 2.15233821e-05, -4.50208424e-03, 3.07544518e-05, + 3.10764066e-05, -2.71915988e-03, 3.97339843e-05, 3.96487514e-05, -1.48803720e-03, + 4.68628240e-05, 4.64157767e-05, -7.20754239e-04, 5.16924370e-05, 5.09769344e-05, + -3.50367397e-04, 5.40648783e-05, 5.32552981e-05, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, + 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 5.08219768e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.11758237e-19, 5.51152161e-01, + 0.00000000e+00, 4.23516474e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, + 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] + + + [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] + + True + + + + + [ 2.14815131e+00, -5.67288239e-05, -5.66938837e-05, 2.16254780e+00, -5.65230103e-05, + -5.64709397e-05, 2.19147692e+00, -5.55817284e-05, -5.54419375e-05, 2.23497203e+00, + -5.28755314e-05, -5.25636215e-05, 2.29252992e+00, -4.70100230e-05, -4.65910518e-05, + 2.36265144e+00, -3.67739174e-05, -3.65135093e-05, 2.44260635e+00, -2.23496495e-05, + -2.22914825e-05, 2.52850445e+00, -5.23240069e-06, -5.20752561e-06, 2.61565911e+00, + 1.27361282e-05, 1.27159567e-05, 2.69941684e+00, 2.93244114e-05, 2.93440996e-05, + 2.77575774e+00, 4.32184377e-05, 4.32327109e-05, 2.84166905e+00, 5.39066006e-05, + 5.38791018e-05, 2.89533936e+00, 6.14945233e-05, 6.14475651e-05, 2.93588948e+00, + 6.64645673e-05, 6.64253742e-05, 2.96297908e+00, 6.93870968e-05, 6.93680697e-05, + 2.97652439e+00, 7.07236426e-05, 7.07197251e-05 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/frictionH/100K/clean.sh b/drivers/py/pes/friction/frictionH/100K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/frictionH/100K/get1D.sh b/drivers/py/pes/friction/frictionH/100K/get1D.sh new file mode 100755 index 000000000..152292560 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/get1D.sh @@ -0,0 +1,5 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 diff --git a/drivers/py/pes/friction/frictionH/100K/init.xyz b/drivers/py/pes/friction/frictionH/100K/init.xyz new file mode 100644 index 000000000..223399063 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/frictionH/100K/input.xml b/drivers/py/pes/friction/frictionH/100K/input.xml new file mode 100644 index 000000000..c9b86e609 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/input.xml @@ -0,0 +1,45 @@ + + + [ step, potential{electronvolt}] + extras + extras + + 10 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + ['friction'] + + + + 100 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + + z_friction.dat + true + true + none + 0.1 + + + +
diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_00 b/drivers/py/pes/friction/frictionH/100K/inst.fric_00 new file mode 100644 index 000000000..74a7c6344 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_00 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 0 + 0.00013194 -0.00003135 -0.00003130 + -0.00003135 0.00013218 -0.00003131 + -0.00003130 -0.00003131 0.00013173 + #*EXTRAS*# Step: 1 Bead: 0 + 0.00013241 -0.00003014 -0.00003010 + -0.00003014 0.00013266 -0.00003009 + -0.00003010 -0.00003009 0.00013225 + #*EXTRAS*# Step: 2 Bead: 0 + 0.00013237 -0.00003024 -0.00003020 + -0.00003024 0.00013262 -0.00003019 + -0.00003020 -0.00003019 0.00013220 + #*EXTRAS*# Step: 3 Bead: 0 + 0.00013237 -0.00003025 -0.00003020 + -0.00003025 0.00013262 -0.00003020 + -0.00003020 -0.00003020 0.00013220 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_01 b/drivers/py/pes/friction/frictionH/100K/inst.fric_01 new file mode 100644 index 000000000..aaf40a293 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_01 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 1 + 0.00013155 -0.00003225 -0.00003218 + -0.00003225 0.00013179 -0.00003222 + -0.00003218 -0.00003222 0.00013130 + #*EXTRAS*# Step: 1 Bead: 1 + 0.00013197 -0.00003128 -0.00003124 + -0.00003128 0.00013221 -0.00003125 + -0.00003124 -0.00003125 0.00013176 + #*EXTRAS*# Step: 2 Bead: 1 + 0.00013193 -0.00003138 -0.00003133 + -0.00003138 0.00013217 -0.00003135 + -0.00003133 -0.00003135 0.00013171 + #*EXTRAS*# Step: 3 Bead: 1 + 0.00013193 -0.00003138 -0.00003133 + -0.00003138 0.00013217 -0.00003135 + -0.00003133 -0.00003135 0.00013171 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_02 b/drivers/py/pes/friction/frictionH/100K/inst.fric_02 new file mode 100644 index 000000000..3150a6731 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_02 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 2 + 0.00013052 -0.00003427 -0.00003412 + -0.00003427 0.00013073 -0.00003427 + -0.00003412 -0.00003427 0.00013021 + #*EXTRAS*# Step: 1 Bead: 2 + 0.00013095 -0.00003347 -0.00003336 + -0.00003347 0.00013117 -0.00003347 + -0.00003336 -0.00003347 0.00013066 + #*EXTRAS*# Step: 2 Bead: 2 + 0.00013090 -0.00003356 -0.00003344 + -0.00003356 0.00013113 -0.00003355 + -0.00003344 -0.00003355 0.00013062 + #*EXTRAS*# Step: 3 Bead: 2 + 0.00013090 -0.00003356 -0.00003345 + -0.00003356 0.00013113 -0.00003355 + -0.00003345 -0.00003355 0.00013062 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_03 b/drivers/py/pes/friction/frictionH/100K/inst.fric_03 new file mode 100644 index 000000000..db082403f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_03 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 3 + 0.00012868 -0.00003715 -0.00003680 + -0.00003715 0.00012883 -0.00003720 + -0.00003680 -0.00003720 0.00012833 + #*EXTRAS*# Step: 1 Bead: 3 + 0.00012916 -0.00003645 -0.00003616 + -0.00003645 0.00012933 -0.00003649 + -0.00003616 -0.00003649 0.00012882 + #*EXTRAS*# Step: 2 Bead: 3 + 0.00012912 -0.00003652 -0.00003622 + -0.00003652 0.00012928 -0.00003656 + -0.00003622 -0.00003656 0.00012877 + #*EXTRAS*# Step: 3 Bead: 3 + 0.00012912 -0.00003652 -0.00003622 + -0.00003652 0.00012928 -0.00003656 + -0.00003622 -0.00003656 0.00012877 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_04 b/drivers/py/pes/friction/frictionH/100K/inst.fric_04 new file mode 100644 index 000000000..2a203a96c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_04 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 4 + 0.00012608 -0.00004029 -0.00003974 + -0.00004029 0.00012615 -0.00004038 + -0.00003974 -0.00004038 0.00012575 + #*EXTRAS*# Step: 1 Bead: 4 + 0.00012663 -0.00003970 -0.00003917 + -0.00003970 0.00012671 -0.00003978 + -0.00003917 -0.00003978 0.00012629 + #*EXTRAS*# Step: 2 Bead: 4 + 0.00012659 -0.00003974 -0.00003921 + -0.00003974 0.00012668 -0.00003982 + -0.00003921 -0.00003982 0.00012625 + #*EXTRAS*# Step: 3 Bead: 4 + 0.00012659 -0.00003974 -0.00003921 + -0.00003974 0.00012667 -0.00003983 + -0.00003921 -0.00003983 0.00012625 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_05 b/drivers/py/pes/friction/frictionH/100K/inst.fric_05 new file mode 100644 index 000000000..6e08ea1b4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_05 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 5 + 0.00012329 -0.00004270 -0.00004239 + -0.00004270 0.00012336 -0.00004279 + -0.00004239 -0.00004279 0.00012310 + #*EXTRAS*# Step: 1 Bead: 5 + 0.00012385 -0.00004231 -0.00004190 + -0.00004231 0.00012391 -0.00004241 + -0.00004190 -0.00004241 0.00012362 + #*EXTRAS*# Step: 2 Bead: 5 + 0.00012383 -0.00004232 -0.00004192 + -0.00004232 0.00012389 -0.00004242 + -0.00004192 -0.00004242 0.00012360 + #*EXTRAS*# Step: 3 Bead: 5 + 0.00012382 -0.00004232 -0.00004193 + -0.00004232 0.00012389 -0.00004242 + -0.00004193 -0.00004242 0.00012360 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_06 b/drivers/py/pes/friction/frictionH/100K/inst.fric_06 new file mode 100644 index 000000000..9ba1a5b72 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_06 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 6 + 0.00012029 -0.00004409 -0.00004407 + -0.00004409 0.00012020 -0.00004396 + -0.00004407 -0.00004396 0.00012025 + #*EXTRAS*# Step: 1 Bead: 6 + 0.00012106 -0.00004382 -0.00004381 + -0.00004382 0.00012105 -0.00004377 + -0.00004381 -0.00004377 0.00012099 + #*EXTRAS*# Step: 2 Bead: 6 + 0.00012105 -0.00004382 -0.00004381 + -0.00004382 0.00012104 -0.00004378 + -0.00004381 -0.00004378 0.00012098 + #*EXTRAS*# Step: 3 Bead: 6 + 0.00012104 -0.00004382 -0.00004382 + -0.00004382 0.00012103 -0.00004378 + -0.00004382 -0.00004378 0.00012098 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_07 b/drivers/py/pes/friction/frictionH/100K/inst.fric_07 new file mode 100644 index 000000000..09535a10a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_07 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 7 + 0.00011665 -0.00004461 -0.00004432 + -0.00004461 0.00011623 -0.00004421 + -0.00004432 -0.00004421 0.00011666 + #*EXTRAS*# Step: 1 Bead: 7 + 0.00011766 -0.00004462 -0.00004438 + -0.00004462 0.00011727 -0.00004424 + -0.00004438 -0.00004424 0.00011766 + #*EXTRAS*# Step: 2 Bead: 7 + 0.00011766 -0.00004462 -0.00004438 + -0.00004462 0.00011727 -0.00004424 + -0.00004438 -0.00004424 0.00011766 + #*EXTRAS*# Step: 3 Bead: 7 + 0.00011765 -0.00004462 -0.00004438 + -0.00004462 0.00011727 -0.00004424 + -0.00004438 -0.00004424 0.00011766 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_08 b/drivers/py/pes/friction/frictionH/100K/inst.fric_08 new file mode 100644 index 000000000..4b6a5d702 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_08 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 8 + 0.00011322 -0.00004352 -0.00004346 + -0.00004352 0.00011306 -0.00004343 + -0.00004346 -0.00004343 0.00011326 + #*EXTRAS*# Step: 1 Bead: 8 + 0.00011427 -0.00004400 -0.00004384 + -0.00004400 0.00011400 -0.00004379 + -0.00004384 -0.00004379 0.00011431 + #*EXTRAS*# Step: 2 Bead: 8 + 0.00011429 -0.00004401 -0.00004384 + -0.00004401 0.00011401 -0.00004379 + -0.00004384 -0.00004379 0.00011432 + #*EXTRAS*# Step: 3 Bead: 8 + 0.00011428 -0.00004401 -0.00004384 + -0.00004401 0.00011401 -0.00004379 + -0.00004384 -0.00004379 0.00011432 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_09 b/drivers/py/pes/friction/frictionH/100K/inst.fric_09 new file mode 100644 index 000000000..3b4210e02 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_09 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 9 + 0.00011023 -0.00004172 -0.00004180 + -0.00004172 0.00011025 -0.00004177 + -0.00004180 -0.00004177 0.00011031 + #*EXTRAS*# Step: 1 Bead: 9 + 0.00011129 -0.00004242 -0.00004249 + -0.00004242 0.00011129 -0.00004247 + -0.00004249 -0.00004247 0.00011136 + #*EXTRAS*# Step: 2 Bead: 9 + 0.00011132 -0.00004243 -0.00004250 + -0.00004243 0.00011132 -0.00004248 + -0.00004250 -0.00004248 0.00011139 + #*EXTRAS*# Step: 3 Bead: 9 + 0.00011131 -0.00004243 -0.00004250 + -0.00004243 0.00011131 -0.00004248 + -0.00004250 -0.00004248 0.00011138 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_10 b/drivers/py/pes/friction/frictionH/100K/inst.fric_10 new file mode 100644 index 000000000..b78c614e0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_10 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 10 + 0.00010769 -0.00003973 -0.00003972 + -0.00003973 0.00010769 -0.00003973 + -0.00003972 -0.00003973 0.00010770 + #*EXTRAS*# Step: 1 Bead: 10 + 0.00010874 -0.00004061 -0.00004064 + -0.00004061 0.00010875 -0.00004062 + -0.00004064 -0.00004062 0.00010879 + #*EXTRAS*# Step: 2 Bead: 10 + 0.00010877 -0.00004063 -0.00004067 + -0.00004063 0.00010878 -0.00004064 + -0.00004067 -0.00004064 0.00010883 + #*EXTRAS*# Step: 3 Bead: 10 + 0.00010877 -0.00004063 -0.00004066 + -0.00004063 0.00010878 -0.00004064 + -0.00004066 -0.00004064 0.00010882 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_11 b/drivers/py/pes/friction/frictionH/100K/inst.fric_11 new file mode 100644 index 000000000..2efffe772 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_11 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 11 + 0.00010562 -0.00003769 -0.00003763 + -0.00003769 0.00010562 -0.00003777 + -0.00003763 -0.00003777 0.00010544 + #*EXTRAS*# Step: 1 Bead: 11 + 0.00010660 -0.00003870 -0.00003866 + -0.00003870 0.00010659 -0.00003874 + -0.00003866 -0.00003874 0.00010652 + #*EXTRAS*# Step: 2 Bead: 11 + 0.00010663 -0.00003874 -0.00003870 + -0.00003874 0.00010663 -0.00003877 + -0.00003870 -0.00003877 0.00010656 + #*EXTRAS*# Step: 3 Bead: 11 + 0.00010663 -0.00003874 -0.00003870 + -0.00003874 0.00010663 -0.00003877 + -0.00003870 -0.00003877 0.00010655 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_12 b/drivers/py/pes/friction/frictionH/100K/inst.fric_12 new file mode 100644 index 000000000..e7b234434 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_12 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 12 + 0.00010410 -0.00003588 -0.00003581 + -0.00003588 0.00010410 -0.00003604 + -0.00003581 -0.00003604 0.00010377 + #*EXTRAS*# Step: 1 Bead: 12 + 0.00010494 -0.00003692 -0.00003686 + -0.00003692 0.00010494 -0.00003704 + -0.00003686 -0.00003704 0.00010469 + #*EXTRAS*# Step: 2 Bead: 12 + 0.00010498 -0.00003697 -0.00003690 + -0.00003697 0.00010498 -0.00003708 + -0.00003690 -0.00003708 0.00010473 + #*EXTRAS*# Step: 3 Bead: 12 + 0.00010498 -0.00003696 -0.00003690 + -0.00003696 0.00010498 -0.00003708 + -0.00003690 -0.00003708 0.00010473 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_13 b/drivers/py/pes/friction/frictionH/100K/inst.fric_13 new file mode 100644 index 000000000..269e0690c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_13 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 13 + 0.00010310 -0.00003446 -0.00003442 + -0.00003446 0.00010308 -0.00003466 + -0.00003442 -0.00003466 0.00010270 + #*EXTRAS*# Step: 1 Bead: 13 + 0.00010379 -0.00003547 -0.00003540 + -0.00003547 0.00010379 -0.00003564 + -0.00003540 -0.00003564 0.00010343 + #*EXTRAS*# Step: 2 Bead: 13 + 0.00010383 -0.00003551 -0.00003545 + -0.00003551 0.00010382 -0.00003569 + -0.00003545 -0.00003569 0.00010347 + #*EXTRAS*# Step: 3 Bead: 13 + 0.00010383 -0.00003551 -0.00003544 + -0.00003551 0.00010382 -0.00003568 + -0.00003544 -0.00003568 0.00010347 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_14 b/drivers/py/pes/friction/frictionH/100K/inst.fric_14 new file mode 100644 index 000000000..1e6a6d78b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_14 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 14 + 0.00010253 -0.00003354 -0.00003351 + -0.00003354 0.00010248 -0.00003373 + -0.00003351 -0.00003373 0.00010211 + #*EXTRAS*# Step: 1 Bead: 14 + 0.00010309 -0.00003445 -0.00003440 + -0.00003445 0.00010307 -0.00003464 + -0.00003440 -0.00003464 0.00010268 + #*EXTRAS*# Step: 2 Bead: 14 + 0.00010312 -0.00003449 -0.00003445 + -0.00003449 0.00010310 -0.00003469 + -0.00003445 -0.00003469 0.00010272 + #*EXTRAS*# Step: 3 Bead: 14 + 0.00010312 -0.00003449 -0.00003444 + -0.00003449 0.00010310 -0.00003468 + -0.00003444 -0.00003468 0.00010271 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_15 b/drivers/py/pes/friction/frictionH/100K/inst.fric_15 new file mode 100644 index 000000000..9347f9578 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.fric_15 @@ -0,0 +1,16 @@ + #*EXTRAS*# Step: 0 Bead: 15 + 0.00010230 -0.00003314 -0.00003313 + -0.00003314 0.00010224 -0.00003332 + -0.00003313 -0.00003332 0.00010188 + #*EXTRAS*# Step: 1 Bead: 15 + 0.00010276 -0.00003392 -0.00003389 + -0.00003392 0.00010272 -0.00003412 + -0.00003389 -0.00003412 0.00010234 + #*EXTRAS*# Step: 2 Bead: 15 + 0.00010279 -0.00003397 -0.00003394 + -0.00003397 0.00010276 -0.00003416 + -0.00003394 -0.00003416 0.00010237 + #*EXTRAS*# Step: 3 Bead: 15 + 0.00010279 -0.00003397 -0.00003393 + -0.00003397 0.00010275 -0.00003416 + -0.00003393 -0.00003416 0.00010237 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 new file mode 100644 index 000000000..a6a052bfa --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 @@ -0,0 +1 @@ +1.050517860129783747e-03 9.137377647459879134e-05 9.080076934705130103e-05 1.178129399549104179e-04 8.656782020056923263e-05 8.497857656328429692e-05 -1.839923589039999972e-03 7.664696890966431740e-05 7.343154878584933279e-05 -4.423996751035020117e-03 6.102020189716153450e-05 5.758595437316045443e-05 -7.047071182251181398e-03 3.940891176778663671e-05 3.874481561485502610e-05 -9.078818164525201406e-03 1.692601931631166281e-05 1.946060847677243339e-05 -1.058199854381223701e-02 7.800639930314340822e-06 7.217351389507211251e-06 -1.083667114478526969e-02 2.593238188225781334e-06 2.552002872206671510e-06 -9.921540925601133459e-03 6.259508353564666123e-06 5.659563371109159885e-06 -8.479624240518145173e-03 1.386635571090646034e-05 1.399879054847931025e-05 -6.229567820365948874e-03 2.345006844083807730e-05 2.392746986455571035e-05 -3.893302608673681730e-03 3.344568950727864077e-05 3.352476241467512746e-05 -2.191828138098487772e-03 4.216422701134765885e-05 4.183657985971831031e-05 -1.038762715447995918e-03 4.882823999975094241e-05 4.815070241842687467e-05 -3.353516870363075736e-04 5.308790475332863455e-05 5.228864694523198940e-05 -1.773106875336378455e-05 5.507021293517846142e-05 5.426922874764085643e-05 3.878564293902863461e-11 5.511521556556987500e-01 -5.431729595932984637e-09 5.546704409993564131e-11 5.511521547152667955e-01 -6.368490155958578424e-09 5.835394086916648821e-11 5.511521550791331769e-01 -5.993312153256271465e-09 4.064924801164622677e-11 5.511521567029800117e-01 -4.358216563799630414e-09 1.599955001862748218e-11 5.511521588887506873e-01 -2.180299948695036550e-09 3.687192521261455043e-12 5.511521602952530463e-01 -7.887951571223996942e-10 3.190542404788802543e-13 5.511521609502595398e-01 -1.387516896008230498e-10 -3.113685996160978671e-15 5.511521610953061812e-01 5.885055055099548622e-12 1.984859460352787048e-14 5.511521611151838362e-01 2.578351401817867988e-11 4.702753944874935729e-13 5.511521613557449628e-01 2.666397360173306995e-10 2.393661953991340362e-12 5.511521620116702769e-01 9.223853510470508265e-10 4.587836567963637808e-12 5.511521624595412394e-01 1.369203256571597783e-09 7.067273421773703991e-12 5.511521628127235006e-01 1.721902298582995282e-09 1.010535776248566286e-11 5.511521631424967094e-01 2.051920644821578343e-09 1.436326966518886797e-11 5.511521635340919101e-01 2.444138555299355913e-09 2.035507864618434081e-11 5.511521639819079166e-01 2.892442619407331377e-09 3.877164154775360834e-11 -5.431729595932984637e-09 5.511521556596211679e-01 5.541802710219232855e-11 -6.368490155958578424e-09 5.511521547265276766e-01 5.818942496015227270e-11 -5.993312153256271465e-09 5.511521551129745511e-01 4.038797799560765619e-11 -4.358216563799630414e-09 5.511521567591854964e-01 1.585167523763928647e-11 -2.180299948695036550e-09 5.511521589292412981e-01 3.662390690904984888e-12 -7.887951571223996942e-10 5.511521603059005292e-01 3.181857067751855997e-13 -1.387516896008230498e-10 5.511521609510159347e-01 -3.097207287799526332e-15 5.885055055099548622e-12 5.511521610952438976e-01 1.984061053531491511e-14 2.578351401817867988e-11 5.511521611151630751e-01 4.707781743740401551e-13 2.666397360173306995e-10 5.511521613563146182e-01 2.393934359094164782e-12 9.223853510470508265e-10 5.511521620118802200e-01 4.584661932497964804e-12 1.369203256571597783e-09 5.511521624576457556e-01 7.061403876044906421e-12 1.721902298582995282e-09 5.511521628098621228e-01 1.009951972210817901e-11 2.051920644821578343e-09 5.511521631401251620e-01 1.435995957830825988e-11 2.444138555299355913e-09 5.511521635329652558e-01 2.035454836594628425e-11 2.892442619407331377e-09 5.511521639817571483e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 new file mode 100644 index 000000000..00a2f50d1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 @@ -0,0 +1 @@ +1.547049005068653824e-03 9.137371869098474320e-05 9.080071160986283058e-05 5.234389164450525345e-04 8.656774464689491314e-05 8.497850107882375006e-05 -1.511610417664242204e-03 7.664689661880846655e-05 7.343147668609034901e-05 -4.151875635085658725e-03 6.102015657549366134e-05 5.758590933842922053e-05 -6.824704535833937998e-03 3.940889689596180253e-05 3.874480087994355398e-05 -8.899779785322367923e-03 1.692601853917599972e-05 1.946060771880295072e-05 -1.045003894060336606e-02 7.800653391470694229e-06 7.217364788324546908e-06 -1.089439484638547208e-02 -1.021424290081238819e-05 -1.016375295004150610e-05 -1.010995660169375192e-02 6.259539924342483732e-06 5.659594618558983883e-06 -8.831010053073339375e-03 1.386636484358593459e-05 1.399879962938895070e-05 -6.802865082104048340e-03 2.345007354320162646e-05 2.392747499577482938e-05 -4.447323738845432306e-03 3.344569019976786537e-05 3.352476312077794690e-05 -2.664370271146937041e-03 4.216422376575357131e-05 4.183657661963358256e-05 -1.435560871580145951e-03 4.882823258936063430e-05 4.815069501232059493e-05 -6.709264511840144860e-04 5.308789210481572123e-05 5.228863429953312282e-05 -3.018892205201477788e-04 5.507019350437198317e-05 5.426920931733990100e-05 -1.899797110752491445e-11 5.511521545857042126e-01 -6.492557399128173309e-09 -2.008663022283076502e-11 5.511521539176257312e-01 -7.164554419274858609e-09 -1.393691497990999496e-11 5.511521546935270743e-01 -6.383621401557910681e-09 -4.672419860233382060e-12 5.511521566315045195e-01 -4.433283872031866492e-09 1.127725184388341346e-12 5.511521588729922927e-01 -2.194810161549793273e-09 2.910056859636346388e-12 5.511521599863095089e-01 -1.100915062180056710e-09 1.378021059394880733e-11 5.511521591926804575e-01 -1.888009422939506122e-09 -1.280748109215185544e-05 5.511616021473888516e-01 9.373442552017758995e-06 3.159062641182510646e-11 5.511521647317467743e-01 3.605075527036901181e-09 9.602954868184017190e-12 5.511521631983460345e-01 2.097690815967441940e-09 7.496025504844782051e-12 5.511521634464904285e-01 2.366250588646460493e-09 5.280325789939219483e-12 5.511521632670358661e-01 2.181939016785759146e-09 3.821679334311839881e-12 5.511521631991660453e-01 2.109573494894366702e-09 2.694967457533918124e-12 5.511521632912748103e-01 2.200617933298613764e-09 1.714756754187457254e-12 5.511521635742250291e-01 2.484110766697943730e-09 9.242721704923633655e-13 5.511521639891461266e-01 2.899666373774540462e-09 -1.896554692666287935e-11 -6.492557399128173309e-09 5.511521546078815836e-01 -2.006643344406034815e-11 -7.164554419274858609e-09 5.511521539320370922e-01 -1.391033402970311800e-11 -6.383621401557910681e-09 5.511521547179047964e-01 -4.646753240684107385e-12 -4.433283872031866492e-09 5.511521566803458949e-01 1.116763764728796893e-12 -2.194810161549793273e-09 5.511521589158804302e-01 2.904421207701438581e-12 -1.100915062180056710e-09 5.511521599905715441e-01 1.371700304278314234e-11 -1.888009422939506122e-09 5.511521592100401268e-01 -1.271575582534538322e-05 9.373442552017758995e-06 5.511614674007467851e-01 3.126729043492881165e-11 3.605075527036901181e-09 5.511521646575683331e-01 9.551687814119367623e-12 2.097690815967441940e-09 5.511521631758881101e-01 7.525153477189238591e-12 2.366250588646460493e-09 5.511521634648476331e-01 5.290764750036390172e-12 2.181939016785759146e-09 5.511521632756566369e-01 3.821319148818858819e-12 2.109573494894366702e-09 5.511521631987659209e-01 2.693413445270125018e-12 2.200617933298613764e-09 5.511521632887417255e-01 1.714260711190161131e-12 2.484110766697943730e-09 5.511521635727771873e-01 9.242474072422969921e-13 2.899666373774540462e-09 5.511521639889664925e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 new file mode 100644 index 000000000..f340d3406 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 @@ -0,0 +1 @@ +1.504880127178795596e-03 9.137416157409622105e-05 9.080115634843696423e-05 4.810600177144456926e-04 8.656783736698244814e-05 8.497859353809481084e-05 -1.549569322990012763e-03 7.664685544291771234e-05 7.343143513033669205e-05 -4.180263121993529028e-03 6.102012117303012818e-05 5.758587404095699328e-05 -6.841759056459575938e-03 3.940888291383285098e-05 3.874478703187218272e-05 -8.907886529546129445e-03 1.692601221105240398e-05 1.946060140314252322e-05 -1.045298517733375329e-02 7.800637204616011670e-06 7.217348675717499570e-06 -1.090810133748788477e-02 2.593923888822581751e-06 2.552683661425936504e-06 -1.011160454568261167e-02 6.259505570746042522e-06 5.659560616555116020e-06 -8.837031777241995123e-03 1.386635187035533797e-05 1.399878672540840682e-05 -6.817189420895747483e-03 2.345005984786747343e-05 2.392746124733194095e-05 -4.465634650934999055e-03 3.344567645512027407e-05 3.352474934910418378e-05 -2.682616101407273718e-03 4.216420882818310364e-05 4.183656168482858260e-05 -1.453158177267646492e-03 4.882821544821529930e-05 4.815067788550444854e-05 -6.879176932980816169e-04 5.308787176017931139e-05 5.228861397049401155e-05 -3.186410377093020310e-04 5.507016958296459351e-05 5.426918540974884521e-05 4.238851403649504143e-10 5.511521716004851301e-01 1.055802006292393764e-08 7.263345731094296724e-11 5.511521635089769999e-01 2.411579117044852458e-09 -5.511280573956027312e-11 5.511521582315089818e-01 -2.876355490938555675e-09 -4.007488339049367056e-11 5.511521575660071059e-01 -3.511819269740003725e-09 -1.285440376486393354e-11 5.511521590452613806e-01 -2.024501481999041767e-09 -3.418066736406546727e-12 5.511521600065242277e-01 -1.080661201556777941e-09 -2.406644088104912849e-12 5.511521591938925990e-01 -1.886796025306010208e-09 6.856974831145022653e-10 5.511616012172290135e-01 9.372512204770956957e-06 -2.762970029401101594e-12 5.511521647319608253e-01 3.605288950698538458e-09 -3.370275728720705661e-12 5.511521632021948447e-01 2.101521274652597781e-09 -6.199308647203065054e-12 5.511521634705879302e-01 2.390393670275831714e-09 -8.464321798869456809e-12 5.511521633320169977e-01 2.246972928805925670e-09 -1.111589113116243584e-11 5.511521633133432685e-01 2.223479932791307490e-09 -1.444617787612688549e-11 5.511521634560607730e-01 2.364573152707615681e-09 -1.862987965486285384e-11 5.511521637794406514e-01 2.687866566928897554e-09 -2.299713522175376640e-11 5.511521642173146107e-01 3.126007943062966230e-09 4.257730272032909475e-10 1.055802006292393764e-08 5.511521716943308391e-01 7.239283762272789054e-11 2.411579117044852458e-09 5.511521634929770208e-01 -5.546608768224437133e-11 -2.876355490938555675e-09 5.511521581947212978e-01 -3.994422546731439709e-11 -3.511819269740003725e-09 5.511521575889544167e-01 -1.273130760800347450e-11 -2.024501481999041767e-09 5.511521590842509699e-01 -3.411239219614883232e-12 -1.080661201556777941e-09 5.511521600108646446e-01 -2.395604004366810750e-12 -1.886796025306010208e-09 5.511521592112548218e-01 6.807861220593759092e-10 9.372512204770956957e-06 5.511614664702625399e-01 -2.734713432814151614e-12 3.605288950698538458e-09 5.511521646577811628e-01 -3.352292729859714780e-12 2.101521274652597781e-09 5.511521631797002829e-01 -6.223289409589567332e-12 2.390393670275831714e-09 5.511521634890363952e-01 -8.480909012933123051e-12 2.246972928805925670e-09 5.511521633407433507e-01 -1.111348584778844879e-11 2.223479932791307490e-09 5.511521633124022435e-01 -1.443340270446139239e-11 2.364573152707615681e-09 5.511521634518704582e-01 -1.861477839774182587e-11 2.687866566928897554e-09 5.511521637750835811e-01 -2.298334364987898664e-11 3.126007943062966230e-09 5.511521642134957766e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener new file mode 100644 index 000000000..938fa6134 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.08401548407667692 +1 0.08754521678856948 +2 0.09470243661361648 +3 0.10537225682720777 +4 0.1185798979659253 +5 0.1317789623338205 +6 0.1417109668300342 +7 0.1461109436421305 +8 0.1438103938424093 +9 0.13656002811924284 +10 0.1265854826602397 +11 0.11509595940389292 +12 0.1040808765227056 +13 0.09516630384107448 +14 0.08907266597203442 +15 0.0860117519104789 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz new file mode 100644 index 000000000..0996dff6a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.146859278870165 -5.449829941095884e-05 -5.4478625218686e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1612971314069163 -5.446285174334084e-05 -5.441472189867923e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.1903005179820383 -5.4043839955618416e-05 -5.389147513190431e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.2339066720680725 -5.211221350891898e-05 -5.1777265362761315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.291623338866595 -4.7065760539437984e-05 -4.6630758365943643e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.361961026553299 -3.749023624795268e-05 -3.723806101933786e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.442192509627326 -2.353491062911471e-05 -2.3470849671114148e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.528420283284796 -6.657887038781299e-06 -6.622758944598768e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.615920230803764 1.1194041937275928e-05 1.1189539146511076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7000073768459254 2.7722486330324536e-05 2.7752118580099324e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7766202660352324 4.163782020597758e-05 4.164255869950001e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.8427079146927157 5.243925876247678e-05 5.240297371747839e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.8964780415567897 6.0247298557699757e-05 6.0197261682826016e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.9370766621284594 6.551663498040769e-05 6.547878488392058e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.964185114883056 6.874877652775765e-05 6.873293303065284e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.977734879913919 7.031145716070451e-05 7.030962544190375e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener new file mode 100644 index 000000000..60c934b53 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.0843255133367963 +1 0.08784695646818827 +2 0.09498561716298513 +3 0.10561815627972837 +4 0.11876220966359217 +5 0.13187767823589117 +6 0.14174105051536662 +7 0.14611096877995308 +8 0.14383135833979266 +9 0.1366328848797003 +10 0.12672863574611695 +11 0.11530963583959201 +12 0.10433880599460289 +13 0.09544487775657724 +14 0.08935791114416519 +15 0.08629819900209464 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz new file mode 100644 index 000000000..0224c3c50 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.148133397641608 -5.6368817387021064e-05 -5.6333119372623966e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1625253624323557 -5.6185428690941034e-05 -5.613389377798902e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.1914462608314498 -5.528578740524542e-05 -5.514856639305492e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.2349304568519095 -5.2637078253721405e-05 -5.23284958154783e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.292476040325305 -4.683882154297555e-05 -4.6421798679784094e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.3625855268875413 -3.666988901860317e-05 -3.6409279339036924e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4425304901279286 -2.2301406193119662e-05 -2.2243185290963054e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.528422374249604 -5.229420370114218e-06 -5.204522741712072e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6155755462322707 1.2704219275441677e-05 1.2684153189650736e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.699336099904963 2.925968573649099e-05 2.9279682346767077e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7756827079288064 4.312105337360357e-05 4.313514219806029e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.841600109751384 5.377668675700697e-05 5.374908241960164e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.8952755148976133 6.133475936142847e-05 6.128817999069391e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.9358293111973652 6.628040058734201e-05 6.624213561593327e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.9629211858445386 6.91858274747947e-05 6.916823171139528e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.9764675121102053 7.051364415499827e-05 7.051140746154286e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener new file mode 100644 index 000000000..b920c5bf6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.08432987489204383 +1 0.0878524706854077 +2 0.09499319420842016 +3 0.10562813455736628 +4 0.11877371459529028 +5 0.13188807751455592 +6 0.14174778956629122 +7 0.1461119622637928 +8 0.14382628338760886 +9 0.13662413424783038 +10 0.12671720061007438 +11 0.1152963578742579 +12 0.10432512307868111 +13 0.09543144662083826 +14 0.08934484742343426 +15 0.0862853441449061 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz new file mode 100644 index 000000000..abaf7a4b9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.1481513105503063 -5.6728823888303693e-05 -5.669388366511533e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1625477986976436 -5.6523010310080725e-05 -5.647093972619754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.191476918067772 -5.558172842824559e-05 -5.5441937521734e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.234972025953747 -5.287553137511578e-05 -5.256362153179287e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.2925299213224477 -4.7010023031763155e-05 -4.659105181171756e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.362651437553636 -3.6773917361895325e-05 -3.651350928961778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4426063516256007 -2.2349649542041483e-05 -2.229148249397201e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.528504449913656 -5.2324006940668625e-06 -5.2075256118839885e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.615659112134053 1.2736128217445895e-05 1.2715956697533609e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6994168427892715 2.9324411359713385e-05 2.9344099598348424e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7757577354079017 4.321843774305908e-05 4.3232710888588496e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.841669045376808 5.3906600632539787e-05 5.387910180261609e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.8953393601572226 6.149452327187083e-05 6.144756513831276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.935889475107298 6.64645673476594e-05 6.64253742280368e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.962979080068986 6.938709677345481e-05 6.93680696838832e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.976524391003271 7.072364257571076e-05 7.07197250689878e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 new file mode 100644 index 000000000..1cd016dfe --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 @@ -0,0 +1 @@ +1.611286394922204282e-03 8.961030064316105972e-05 9.017023014854777443e-05 5.856372175742745323e-04 8.470728513569665704e-05 8.414123196024390645e-05 -1.449750754399124417e-03 7.541134224952320995e-05 7.279182823453407168e-05 -4.092204957287064182e-03 6.096093172076889595e-05 5.756835785661582907e-05 -6.775169995944501505e-03 4.106341803733507760e-05 3.973757527314467498e-05 -8.870650586407785934e-03 1.877840498689645112e-05 2.109537634456014397e-05 -1.043820444269192606e-02 8.165683506793692430e-06 8.239023186875773044e-06 -1.091276940996600310e-02 2.948470800730174351e-06 2.745671705410905833e-06 -1.013144625619836342e-02 4.979503363004260527e-06 4.438414103693054803e-06 -8.865765120917839387e-03 1.214177282481926725e-05 1.182308253333018487e-05 -6.850839932681651590e-03 2.094530887679483839e-05 2.152338214046350961e-05 -4.502084240976802695e-03 3.075445180364604709e-05 3.107640664454439767e-05 -2.719159883747502768e-03 3.973398434496290131e-05 3.964875140589896579e-05 -1.488037204041506995e-03 4.686282404387732341e-05 4.641577665866609926e-05 -7.207542386444745069e-04 5.169243702285745631e-05 5.097693437666156826e-05 -3.503673974517441253e-04 5.406487834837693084e-05 5.325529805098400344e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 5.082197683525802034e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener new file mode 100644 index 000000000..b920c5bf6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.08432987489204383 +1 0.0878524706854077 +2 0.09499319420842016 +3 0.10562813455736628 +4 0.11877371459529028 +5 0.13188807751455592 +6 0.14174778956629122 +7 0.1461119622637928 +8 0.14382628338760886 +9 0.13662413424783038 +10 0.12671720061007438 +11 0.1152963578742579 +12 0.10432512307868111 +13 0.09543144662083826 +14 0.08934484742343426 +15 0.0862853441449061 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz new file mode 100644 index 000000000..abaf7a4b9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.1481513105503063 -5.6728823888303693e-05 -5.669388366511533e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1625477986976436 -5.6523010310080725e-05 -5.647093972619754e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.191476918067772 -5.558172842824559e-05 -5.5441937521734e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.234972025953747 -5.287553137511578e-05 -5.256362153179287e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.2925299213224477 -4.7010023031763155e-05 -4.659105181171756e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.362651437553636 -3.6773917361895325e-05 -3.651350928961778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4426063516256007 -2.2349649542041483e-05 -2.229148249397201e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.528504449913656 -5.2324006940668625e-06 -5.2075256118839885e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.615659112134053 1.2736128217445895e-05 1.2715956697533609e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6994168427892715 2.9324411359713385e-05 2.9344099598348424e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7757577354079017 4.321843774305908e-05 4.3232710888588496e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.841669045376808 5.3906600632539787e-05 5.387910180261609e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.8953393601572226 6.149452327187083e-05 6.144756513831276e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.935889475107298 6.64645673476594e-05 6.64253742280368e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.962979080068986 6.938709677345481e-05 6.93680696838832e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.976524391003271 7.072364257571076e-05 7.07197250689878e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz new file mode 100644 index 000000000..df3cd38c8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.002965781422542287 3.126621388209799e-05 3.124695650257878e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002980038231166456 3.1152779283678856e-05 3.1124080468842454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002964097613290698 3.0633989740311134e-05 3.0556943680086626e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002837462892814288 2.91424633861449e-05 2.8970553601932426e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0025156948253141557 2.5909675786818254e-05 2.567875889345587e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0019574210269958075 2.0268024025731247e-05 2.0124499553930356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.001178617306289033 1.2318057644686657e-05 1.2285998750438975e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00024981869133459684 2.883848950220575e-06 2.870138994918208e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006705542066480325 -7.019544590956866e-06 -7.00842701416475e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0014682248333194579 -1.616221269358029e-05 -1.6173063908852032e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002071878461740548 -2.3819935360994266e-05 -2.382780203599835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002444099987435397 -2.9710739435606978e-05 -2.96955833960671e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0026350626818643402 -3.3892839396453387e-05 -3.3866958319662135e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002718525123006677 -3.663208992953378e-05 -3.661048855695395e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027473959786251194 -3.8242848338408254e-05 -3.8232361516871624e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0027541892093779375 -3.897948844571658e-05 -3.897732930342013e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..fc6ca5306 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0029637837465429457 3.0036855496046588e-05 3.002601202245773e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0029793848871368313 3.0017318437433344e-05 2.999079156953521e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002965877267357862 2.9786379185108204e-05 2.9702402983244174e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0028418873815580933 2.872175909459239e-05 2.8537151699984712e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0025218828978923157 2.5940395634626974e-05 2.570064324662699e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.001963566040956436 2.0662824727810906e-05 2.0523837805586632e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0011829421770344526 1.2971316854282227e-05 1.2936009518838759e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00025073678981234583 3.669508829713351e-06 3.650147904689699e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006731939856464283 -6.169620405054888e-06 -6.167138682193907e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0014734394037977704 -1.527930825172944e-05 -1.5295640130230752e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0020777451416223525 -2.294877458957601e-05 -2.2951386220521206e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0024487190118945156 -2.89020107928648e-05 -2.8882012211898714e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002638095490720559 -3.32054287998739e-05 -3.3177850868153086e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00272022843538358 -3.610963495675642e-05 -3.6088773794280107e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027482042226856396 -3.789103675552515e-05 -3.788230457785662e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002754553735061706 -3.875231156346635e-05 -3.87513020076908e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..ce0dea908 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0029657545314150744 3.1067795520909834e-05 3.1048120483128274e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0029800274958416808 3.096672044474596e-05 3.0938316866100904e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002964145163029242 3.0470881205929584e-05 3.0395251548513925e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0028376366906880733 2.901103943296988e-05 2.884096355525796e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0025160634794188647 2.5815317716291247e-05 2.558547466401959e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.001958008155519629 2.0210688579511225e-05 2.0067052991417474e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.001179410286124635 1.2291468218670207e-05 1.2259379642626017e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0002507139810108103 2.8822063382333284e-06 2.868483956533485e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006697092216754329 -7.001957908613163e-06 -6.990898442064881e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0014675113076843098 -1.612653902646341e-05 -1.6137560201431533e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002071366989822023 -2.3766261755312533e-05 -2.3774026841359067e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002443792154821744 -2.9639137122351565e-05 -2.962392293213518e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0026348914229473593 -3.380478517194899e-05 -3.3779112851106453e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0027184377131445796 -3.653058602158401e-05 -3.650949619989807e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027473561732979917 -3.8131918329490784e-05 -3.812222038646718e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0027541711082983028 -3.8863747362315525e-05 -3.886251460388388e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..df3cd38c8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.002965781422542287 3.126621388209799e-05 3.124695650257878e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002980038231166456 3.1152779283678856e-05 3.1124080468842454e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002964097613290698 3.0633989740311134e-05 3.0556943680086626e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002837462892814288 2.91424633861449e-05 2.8970553601932426e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0025156948253141557 2.5909675786818254e-05 2.567875889345587e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0019574210269958075 2.0268024025731247e-05 2.0124499553930356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.001178617306289033 1.2318057644686657e-05 1.2285998750438975e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00024981869133459684 2.883848950220575e-06 2.870138994918208e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006705542066480325 -7.019544590956866e-06 -7.00842701416475e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0014682248333194579 -1.616221269358029e-05 -1.6173063908852032e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002071878461740548 -2.3819935360994266e-05 -2.382780203599835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002444099987435397 -2.9710739435606978e-05 -2.96955833960671e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0026350626818643402 -3.3892839396453387e-05 -3.3866958319662135e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002718525123006677 -3.663208992953378e-05 -3.661048855695395e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027473959786251194 -3.8242848338408254e-05 -3.8232361516871624e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0027541892093779375 -3.897948844571658e-05 -3.897732930342013e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 b/drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 new file mode 100644 index 000000000..aa2c39b08 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_00 b/drivers/py/pes/friction/frictionH/100K/inst.raw_00 new file mode 100644 index 000000000..921f2f18b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_00 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 0 +{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} + #*EXTRAS*# Step: 1 Bead: 0 +{"friction": [[0.00013241049292501075, -3.014138508434695e-05, -3.009727779414303e-05], [-3.014138508434695e-05, 0.00013265847632881606, -3.009110158821114e-05], [-3.009727779414303e-05, -3.009110158821114e-05, 0.00013224628677061011]]} + #*EXTRAS*# Step: 2 Bead: 0 +{"friction": [[0.0001323728844522918, -3.0243698063094377e-05, -3.020005181941969e-05], [-3.0243698063094377e-05, 0.0001326207984892998, -3.0194681323071223e-05], [-3.020005181941969e-05, -3.0194681323071223e-05, 0.00013220435948451466]]} + #*EXTRAS*# Step: 3 Bead: 0 +{"friction": [[0.0001323723536194066, -3.024513447791457e-05, -3.0201493813233374e-05], [-3.024513447791457e-05, 0.00013262026643441214, -3.0196135574590085e-05], [-3.0201493813233374e-05, -3.0196135574590085e-05, 0.0001322037682428345]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_01 b/drivers/py/pes/friction/frictionH/100K/inst.raw_01 new file mode 100644 index 000000000..73a37c494 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_01 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 1 +{"friction": [[0.00013154835182754853, -3.2245612347009654e-05, -3.218171211344349e-05], [-3.2245612347009654e-05, 0.00013178701661774967, -3.222276035226155e-05], [-3.218171211344349e-05, -3.222276035226155e-05, 0.00013130290733224788]]} + #*EXTRAS*# Step: 1 Bead: 1 +{"friction": [[0.00013196653667926246, -3.128434745737252e-05, -3.1237689188435446e-05], [-3.128434745737252e-05, 0.00013221164032712512, -3.1248618231329475e-05], [-3.1237689188435446e-05, -3.1248618231329475e-05, 0.00013175605235207647]]} + #*EXTRAS*# Step: 2 Bead: 1 +{"friction": [[0.00013192690141785403, -3.137992775646232e-05, -3.1332225269561344e-05], [-3.137992775646232e-05, 0.00013217154065750227, -3.134545419891963e-05], [-3.1332225269561344e-05, -3.134545419891963e-05, 0.00013171276271381206]]} + #*EXTRAS*# Step: 3 Bead: 1 +{"friction": [[0.00013192617456524053, -3.138167134170412e-05, -3.133394850999344e-05], [-3.138167134170412e-05, 0.00013217080498963396, -3.134722074290985e-05], [-3.133394850999344e-05, -3.134722074290985e-05, 0.00013171196953902834]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_02 b/drivers/py/pes/friction/frictionH/100K/inst.raw_02 new file mode 100644 index 000000000..08ff2a346 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_02 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 2 +{"friction": [[0.0001305169912654799, -3.426881693488592e-05, -3.4119381770048507e-05], [-3.426881693488592e-05, 0.0001307291042872236, -3.427459924542595e-05], [-3.4119381770048507e-05, -3.427459924542595e-05, 0.00013021252399325722]]} + #*EXTRAS*# Step: 1 Bead: 2 +{"friction": [[0.00013094800444368891, -3.347208021256161e-05, -3.3363682543472525e-05], [-3.347208021256161e-05, 0.0001311725627001041, -3.3466375413923914e-05], [-3.3363682543472525e-05, -3.3466375413923914e-05, 0.00013066432379213962]]} + #*EXTRAS*# Step: 2 Bead: 2 +{"friction": [[0.00013090444819934417, -3.355541023963473e-05, -3.344313737024578e-05], [-3.355541023963473e-05, 0.00013112782007524884, -3.355089551199853e-05], [-3.344313737024578e-05, -3.355089551199853e-05, 0.00013061844076678366]]} + #*EXTRAS*# Step: 3 Bead: 2 +{"friction": [[0.00013090327966982303, -3.355763652894214e-05, -3.344525873597896e-05], [-3.355763652894214e-05, 0.0001311266194699744, -3.355315363498642e-05], [-3.344525873597896e-05, -3.355315363498642e-05, 0.00013061721055669854]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_03 b/drivers/py/pes/friction/frictionH/100K/inst.raw_03 new file mode 100644 index 000000000..ffadda0b9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_03 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 3 +{"friction": [[0.0001286764741586319, -3.714973769009648e-05, -3.679697296268993e-05], [-3.714973769009648e-05, 0.0001288266109833087, -3.7198122442431674e-05], [-3.679697296268993e-05, -3.7198122442431674e-05, 0.00012832661431276367]]} + #*EXTRAS*# Step: 1 Bead: 3 +{"friction": [[0.00012916313081760334, -3.6454096780161434e-05, -3.6155546656339866e-05], [-3.6454096780161434e-05, 0.0001293301646357157, -3.649217979347395e-05], [-3.6155546656339866e-05, -3.649217979347395e-05, 0.00012881956476362225]]} + #*EXTRAS*# Step: 2 Bead: 3 +{"friction": [[0.00012911886117451568, -3.651907593755638e-05, -3.621553020732557e-05], [-3.651907593755638e-05, 0.00012928435621188122, -3.65581243279753e-05], [-3.621553020732557e-05, -3.65581243279753e-05, 0.0001287745708447942]]} + #*EXTRAS*# Step: 3 Bead: 3 +{"friction": [[0.0001291170621567432, -3.6521709076363386e-05, -3.621796051228171e-05], [-3.6521709076363386e-05, 0.0001292824946485849, -3.656079657817937e-05], [-3.621796051228171e-05, -3.656079657817937e-05, 0.0001287727430540458]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_04 b/drivers/py/pes/friction/frictionH/100K/inst.raw_04 new file mode 100644 index 000000000..e5997d434 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_04 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 4 +{"friction": [[0.000126076844382827, -4.029075427069417e-05, -3.973794837135237e-05], [-4.029075427069417e-05, 0.000126150633634249, -4.038143906978131e-05], [-3.973794837135237e-05, -4.038143906978131e-05, 0.00012574927445048358]]} + #*EXTRAS*# Step: 1 Bead: 4 +{"friction": [[0.00012662713675010322, -3.969736472933639e-05, -3.91661900500724e-05], [-3.969736472933639e-05, 0.00012671347809779037, -3.978112464531575e-05], [-3.91661900500724e-05, -3.978112464531575e-05, 0.0001262872538841391]]} + #*EXTRAS*# Step: 2 Bead: 4 +{"friction": [[0.00012659017450728093, -3.973835386854741e-05, -3.920524497404498e-05], [-3.973835386854741e-05, 0.00012667558551988773, -3.982261818977218e-05], [-3.920524497404498e-05, -3.982261818977218e-05, 0.00012625098816427898]]} + #*EXTRAS*# Step: 3 Bead: 4 +{"friction": [[0.00012658784052356454, -3.974093662473778e-05, -3.920770773140275e-05], [-3.974093662473778e-05, 0.00012667319317443055, -3.9825232615144797e-05], [-3.920770773140275e-05, -3.9825232615144797e-05, 0.00012624869878371224]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_05 b/drivers/py/pes/friction/frictionH/100K/inst.raw_05 new file mode 100644 index 000000000..23c986860 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_05 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 5 +{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} + #*EXTRAS*# Step: 1 Bead: 5 +{"friction": [[0.00012384764487746069, -4.230644904853384e-05, -4.190463885290095e-05], [-4.230644904853384e-05, 0.00012391271374757542, -4.240537211215134e-05], [-4.190463885290095e-05, -4.240537211215134e-05, 0.00012361827576529272]]} + #*EXTRAS*# Step: 2 Bead: 5 +{"friction": [[0.0001238255850732477, -4.232285939039786e-05, -4.192464654714575e-05], [-4.232285939039786e-05, 0.00012389084208806034, -4.2421561486696214e-05], [-4.192464654714575e-05, -4.2421561486696214e-05, 0.00012359756533038296]]} + #*EXTRAS*# Step: 3 Bead: 5 +{"friction": [[0.0001238232586613388, -4.232458550391126e-05, -4.192675365724461e-05], [-4.232458550391126e-05, 0.00012388853547303105, -4.242326371568662e-05], [-4.192675365724461e-05, -4.242326371568662e-05, 0.00012359538151910022]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_06 b/drivers/py/pes/friction/frictionH/100K/inst.raw_06 new file mode 100644 index 000000000..c8643b67b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_06 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 6 +{"friction": [[0.00012028748904337296, -4.4090190695074945e-05, -4.407165498061319e-05], [-4.4090190695074945e-05, 0.00012019515217934021, -4.396133059277882e-05], [-4.407165498061319e-05, -4.396133059277882e-05, 0.00012024878352738596]]} + #*EXTRAS*# Step: 1 Bead: 6 +{"friction": [[0.00012105973524236423, -4.381667770746481e-05, -4.380956687073731e-05], [-4.381667770746481e-05, 0.00012104923789500364, -4.377185326774247e-05], [-4.380956687073731e-05, -4.377185326774247e-05, 0.00012099478770101877]]} + #*EXTRAS*# Step: 2 Bead: 6 +{"friction": [[0.00012104730372598911, -4.3821441567513924e-05, -4.38146297635182e-05], [-4.3821441567513924e-05, 0.0001210356774853799, -4.3775368252327964e-05], [-4.38146297635182e-05, -4.3775368252327964e-05, 0.00012098286165606746]]} + #*EXTRAS*# Step: 3 Bead: 6 +{"friction": [[0.00012104451178443285, -4.3822509881205753e-05, -4.381576266322912e-05], [-4.3822509881205753e-05, 0.00012103263092868946, -4.37761554370922e-05], [-4.381576266322912e-05, -4.37761554370922e-05, 0.00012098018281360565]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_07 b/drivers/py/pes/friction/frictionH/100K/inst.raw_07 new file mode 100644 index 000000000..be9fb0835 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_07 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 7 +{"friction": [[0.00011665083949596382, -4.4607528816683966e-05, -4.431825914901668e-05], [-4.4607528816683966e-05, 0.0001162267076263409, -4.4207173972077276e-05], [-4.431825914901668e-05, -4.4207173972077276e-05, 0.00011666327977368902]]} + #*EXTRAS*# Step: 1 Bead: 7 +{"friction": [[0.00011765715504790232, -4.46199139017368e-05, -4.437744402313602e-05], [-4.46199139017368e-05, 0.00011727374701921973, -4.4239063405498226e-05], [-4.437744402313602e-05, -4.4239063405498226e-05, 0.00011766079945326452]]} + #*EXTRAS*# Step: 2 Bead: 7 +{"friction": [[0.00011765707061276232, -4.4619918819381765e-05, -4.43774426152651e-05], [-4.4619918819381765e-05, 0.00011727365647092287, -4.4239063996128744e-05], [-4.43774426152651e-05, -4.4239063996128744e-05, 0.0001176607157907547]]} + #*EXTRAS*# Step: 3 Bead: 7 +{"friction": [[0.0001176537563883208, -4.4620111117280195e-05, -4.4377386865271886e-05], [-4.4620111117280195e-05, 0.0001172701025942119, -4.423908675760213e-05], [-4.4377386865271886e-05, -4.423908675760213e-05, 0.00011765743188217148]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_08 b/drivers/py/pes/friction/frictionH/100K/inst.raw_08 new file mode 100644 index 000000000..75fa5f024 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_08 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 8 +{"friction": [[0.00011321589094004546, -4.351814646398022e-05, -4.345964836559014e-05], [-4.351814646398022e-05, 0.00011306154132995574, -4.343115956369095e-05], [-4.345964836559014e-05, -4.343115956369095e-05, 0.00011326318332248197]]} + #*EXTRAS*# Step: 1 Bead: 8 +{"friction": [[0.00011427340352367481, -4.400314389839773e-05, -4.383835702708663e-05], [-4.400314389839773e-05, 0.00011399870247804618, -4.3790177173609096e-05], [-4.383835702708663e-05, -4.3790177173609096e-05, 0.00011430892127181576]]} + #*EXTRAS*# Step: 2 Bead: 8 +{"friction": [[0.00011428612220636616, -4.400828110279431e-05, -4.3842268479836776e-05], [-4.400828110279431e-05, 0.0001140100348907737, -4.379380571514355e-05], [-4.3842268479836776e-05, -4.379380571514355e-05, 0.0001143215044690975]]} + #*EXTRAS*# Step: 3 Bead: 8 +{"friction": [[0.00011428303825712806, -4.40070371113712e-05, -4.3841321435874e-05], [-4.40070371113712e-05, 0.00011400728678894107, -4.37929273542915e-05], [-4.3841321435874e-05, -4.37929273542915e-05, 0.00011431845335864552]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_09 b/drivers/py/pes/friction/frictionH/100K/inst.raw_09 new file mode 100644 index 000000000..df76fe251 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_09 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 9 +{"friction": [[0.00011023000206976872, -4.1719099977050135e-05, -4.179519325177442e-05], [-4.1719099977050135e-05, 0.00011025478793267088, -4.1768623177242506e-05], [-4.179519325177442e-05, -4.1768623177242506e-05, 0.00011030747133180427]]} + #*EXTRAS*# Step: 1 Bead: 9 +{"friction": [[0.00011129227295643751, -4.2418718901641605e-05, -4.2489083831242044e-05], [-4.2418718901641605e-05, 0.00011129448241102563, -4.2468759923897396e-05], [-4.2489083831242044e-05, -4.2468759923897396e-05, 0.0001113630036578243]]} + #*EXTRAS*# Step: 2 Bead: 9 +{"friction": [[0.00011131521570227761, -4.243307134533579e-05, -4.250284642606272e-05], [-4.243307134533579e-05, 0.00011131649148380761, -4.248263452041488e-05], [-4.250284642606272e-05, -4.248263452041488e-05, 0.00011138569718004684]]} + #*EXTRAS*# Step: 3 Bead: 9 +{"friction": [[0.00011131245546942118, -4.2431346219940264e-05, -4.250119342716394e-05], [-4.2431346219940264e-05, 0.00011131384471044707, -4.2480968194840246e-05], [-4.250119342716394e-05, -4.2480968194840246e-05, 0.00011138296708126943]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_10 b/drivers/py/pes/friction/frictionH/100K/inst.raw_10 new file mode 100644 index 000000000..ab62c70af --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_10 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 10 +{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} + #*EXTRAS*# Step: 1 Bead: 10 +{"friction": [[0.00010873690700669689, -4.0606269396953805e-05, -4.0640685927403815e-05], [-4.0606269396953805e-05, 0.0001087489278758463, -4.0618852558316136e-05], [-4.0640685927403815e-05, -4.0618852558316136e-05, 0.0001087937999443303]]} + #*EXTRAS*# Step: 2 Bead: 10 +{"friction": [[0.00010876758944238498, -4.0630806696776885e-05, -4.066639091255203e-05], [-4.0630806696776885e-05, 0.00010878009654283601, -4.0644093725262454e-05], [-4.066639091255203e-05, -4.0644093725262454e-05, 0.00010882542862972189]]} + #*EXTRAS*# Step: 3 Bead: 10 +{"friction": [[0.00010876513371408232, -4.0628845507335164e-05, -4.066433648239336e-05], [-4.0628845507335164e-05, 0.00010877760195671858, -4.0642075657745885e-05], [-4.066433648239336e-05, -4.0642075657745885e-05, 0.00010882289813159212]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_11 b/drivers/py/pes/friction/frictionH/100K/inst.raw_11 new file mode 100644 index 000000000..ceb5e9092 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_11 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 11 +{"friction": [[0.00010562036954718544, -3.769046910141249e-05, -3.763042875179934e-05], [-3.769046910141249e-05, 0.00010561870141779494, -3.7770470863789636e-05], [-3.763042875179934e-05, -3.7770470863789636e-05, 0.0001054411173289977]]} + #*EXTRAS*# Step: 1 Bead: 11 +{"friction": [[0.00010659901857314309, -3.870425743209769e-05, -3.8664729746876114e-05], [-3.870425743209769e-05, 0.00010659423894840385, -3.8735804384514815e-05], [-3.8664729746876114e-05, -3.8735804384514815e-05, 0.00010651814035426669]]} + #*EXTRAS*# Step: 2 Bead: 11 +{"friction": [[0.00010663424047059139, -3.873889540262935e-05, -3.87002915473587e-05], [-3.873889540262935e-05, 0.00010662940683763141, -3.8769015499020965e-05], [-3.87002915473587e-05, -3.8769015499020965e-05, 0.00010655664181312053]]} + #*EXTRAS*# Step: 3 Bead: 11 +{"friction": [[0.0001066320477384514, -3.873674255270047e-05, -3.8698080834126625e-05], [-3.873674255270047e-05, 0.00010662721726753652, -3.8766950665293334e-05], [-3.8698080834126625e-05, -3.8766950665293334e-05, 0.00010655424560561226]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_12 b/drivers/py/pes/friction/frictionH/100K/inst.raw_12 new file mode 100644 index 000000000..a21e2ed22 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_12 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 12 +{"friction": [[0.00010410059478635681, -3.587758594138993e-05, -3.5810247906280144e-05], [-3.587758594138993e-05, 0.00010409721165943899, -3.604130532787345e-05], [-3.5810247906280144e-05, -3.604130532787345e-05, 0.00010376542350754372]]} + #*EXTRAS*# Step: 1 Bead: 12 +{"friction": [[0.00010494306621244808, -3.6923583822871577e-05, -3.685601015820406e-05], [-3.6923583822871577e-05, 0.0001049430353597666, -3.7042386372285086e-05], [-3.685601015820406e-05, -3.7042386372285086e-05, 0.00010469209498702028]]} + #*EXTRAS*# Step: 2 Bead: 12 +{"friction": [[0.00010497866576286726, -3.696539758299062e-05, -3.689806398806715e-05], [-3.696539758299062e-05, 0.0001049786102977853, -3.708215379115218e-05], [-3.689806398806715e-05, -3.708215379115218e-05, 0.00010473144025740636]]} + #*EXTRAS*# Step: 3 Bead: 12 +{"friction": [[0.00010497677371856505, -3.696317971352253e-05, -3.689583289655348e-05], [-3.696317971352253e-05, 0.00010497671979745289, -3.7080044785837816e-05], [-3.689583289655348e-05, -3.7080044785837816e-05, 0.00010472934894678369]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_13 b/drivers/py/pes/friction/frictionH/100K/inst.raw_13 new file mode 100644 index 000000000..158e834fa --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_13 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 13 +{"friction": [[0.00010310461147450481, -3.446489117457354e-05, -3.44165270104119e-05], [-3.446489117457354e-05, 0.00010307920642357731, -3.4657347226921115e-05], [-3.44165270104119e-05, -3.4657347226921115e-05, 0.00010269639584043074]]} + #*EXTRAS*# Step: 1 Bead: 13 +{"friction": [[0.00010379317762040019, -3.546506429569328e-05, -3.54010714373525e-05], [-3.546506429569328e-05, 0.00010378578521589729, -3.564178326908264e-05], [-3.54010714373525e-05, -3.564178326908264e-05, 0.00010343109470027845]]} + #*EXTRAS*# Step: 2 Bead: 13 +{"friction": [[0.00010382683546350151, -3.551114865072701e-05, -3.544669172365276e-05], [-3.551114865072701e-05, 0.00010381998079165979, -3.568658180368192e-05], [-3.544669172365276e-05, -3.568658180368192e-05, 0.00010346755110348192]]} + #*EXTRAS*# Step: 3 Bead: 13 +{"friction": [[0.00010382520936415705, -3.550892758432382e-05, -3.544449250292804e-05], [-3.550892758432382e-05, 0.0001038183293145309, -3.5684423716109555e-05], [-3.544449250292804e-05, -3.5684423716109555e-05, 0.0001034657888826882]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_14 b/drivers/py/pes/friction/frictionH/100K/inst.raw_14 new file mode 100644 index 000000000..812633348 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_14 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 14 +{"friction": [[0.0001025334360101724, -3.35409127376559e-05, -3.351447758652769e-05], [-3.35409127376559e-05, 0.00010248196407672836, -3.372632209749448e-05], [-3.351447758652769e-05, -3.372632209749448e-05, 0.00010210975134216749]]} + #*EXTRAS*# Step: 1 Bead: 14 +{"friction": [[0.00010309218543363696, -3.4445728979633114e-05, -3.439776387630997e-05], [-3.4445728979633114e-05, 0.00010306631247558792, -3.463824075438718e-05], [-3.439776387630997e-05, -3.463824075438718e-05, 0.00010268337884146531]]} + #*EXTRAS*# Step: 2 Bead: 14 +{"friction": [[0.00010312352386576237, -3.449397587494829e-05, -3.4445012177632566e-05], [-3.449397587494829e-05, 0.00010309882109006887, -3.468632973255586e-05], [-3.4445012177632566e-05, -3.468632973255586e-05, 0.00010271622696250368]]} + #*EXTRAS*# Step: 3 Bead: 14 +{"friction": [[0.00010312208559256927, -3.449176740016379e-05, -3.444284896247926e-05], [-3.449176740016379e-05, 0.00010309732983078113, -3.468412976566287e-05], [-3.444284896247926e-05, -3.468412976566287e-05, 0.00010271471800731003]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_15 b/drivers/py/pes/friction/frictionH/100K/inst.raw_15 new file mode 100644 index 000000000..200491929 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst.raw_15 @@ -0,0 +1,8 @@ + #*EXTRAS*# Step: 0 Bead: 15 +{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} + #*EXTRAS*# Step: 1 Bead: 15 +{"friction": [[0.00010276392794825833, -3.392437257841892e-05, -3.388830127282243e-05], [-3.392437257841892e-05, 0.00010272398228244049, -3.411501912503905e-05], [-3.388830127282243e-05, -3.411501912503905e-05, 0.00010234342483199773]]} + #*EXTRAS*# Step: 2 Bead: 15 +{"friction": [[0.00010279406233929465, -3.397345062563802e-05, -3.393618848508074e-05], [-3.397345062563802e-05, 0.0001027555345506456, -3.4164540048979556e-05], [-3.393618848508074e-05, -3.4164540048979556e-05, 0.00010237429898943283]]} + #*EXTRAS*# Step: 3 Bead: 15 +{"friction": [[0.00010279270751910095, -3.397124938221481e-05, -3.3934040394869786e-05], [-3.397124938221481e-05, 0.00010275411647805539, -3.41623200863447e-05], [-3.3934040394869786e-05, -3.41623200863447e-05, 0.00010237290937688125]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst1D.dat b/drivers/py/pes/friction/frictionH/100K/inst1D.dat new file mode 100644 index 000000000..1d6c0d4cb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/inst1D.dat @@ -0,0 +1,16 @@ +2.1481513105503063 0.08432987489204383 +2.1625477986976436 0.0878524706854077 +2.191476918067772 0.09499319420842016 +2.234972025953747 0.10562813455736628 +2.2925299213224477 0.11877371459529028 +2.362651437553636 0.13188807751455592 +2.4426063516256007 0.14174778956629122 +2.528504449913656 0.1461119622637928 +2.615659112134053 0.14382628338760886 +2.6994168427892715 0.13662413424783038 +2.7757577354079017 0.12671720061007438 +2.841669045376808 0.1152963578742579 +2.8953393601572226 0.10432512307868111 +2.935889475107298 0.09543144662083826 +2.962979080068986 0.08934484742343426 +2.976524391003271 0.0862853441449061 diff --git a/drivers/py/pes/friction/frictionH/100K/z_friction.dat b/drivers/py/pes/friction/frictionH/100K/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/100K/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/120K/RESTART b/drivers/py/pes/friction/frictionH/120K/RESTART new file mode 100644 index 000000000..e67a530ad --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/RESTART @@ -0,0 +1,612 @@ + + + [ step, potential{electronvolt} ] + extras + extras + + 30 + 30 + + + + + + [ friction ] + + + + 3.80017824e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 5.37239687e-03, 5.37240995e-03, 5.37241752e-03, 5.37238587e-03, 5.37227257e-03, + 5.37203475e-03, 5.37163807e-03, 5.37106548e-03, 5.37032257e-03, 5.36943943e-03, + 5.36846890e-03, 5.36748153e-03, 5.36655763e-03, 5.36577781e-03, 5.36521322e-03, + 5.36491681e-03 ] + + + [ -1.19732308e-04, 1.40818188e-06, 1.39988637e-06, -1.15096254e-04, 1.35221829e-06, + 1.34385535e-06, -1.06007213e-04, 1.24267246e-06, 1.23445814e-06, -9.28237734e-05, + 1.08433099e-06, 1.07705256e-06, -7.60652415e-05, 8.84505191e-07, 8.79048461e-07, + -5.63901608e-05, 6.53102804e-07, 6.49508188e-07, -3.45689285e-05, 4.00697602e-07, + 3.98314933e-07, -1.14512248e-05, 1.34945413e-07, 1.34139829e-07, 1.20682495e-05, + -1.35502917e-07, -1.34660844e-07, 3.50849966e-05, -4.01960889e-07, -3.99517275e-07, + 5.67197001e-05, -6.55048051e-07, -6.51100717e-07, 7.61513206e-05, -8.85063207e-07, + -8.79659961e-07, 9.26471121e-05, -1.08247361e-06, -1.07575696e-06, 1.05588624e-04, + -1.23871356e-06, -1.23092323e-06, 1.14493026e-04, -1.34684715e-06, -1.33833155e-06, + 1.19029339e-04, -1.40210358e-06, -1.39323429e-06 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00 ] + + True + + [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, + 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, + 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, + 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, + 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, + 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, + 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, + 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, + 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, + 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, + 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, + 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, + 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, + 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, + 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, + 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, + 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, + 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, + 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, + 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, + 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, + 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, + 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, + 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, + 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, + 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, + 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, + 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, + 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, + 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, + 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, + 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, + 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, + 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, + 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, + 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, + 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, + 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, + 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, + 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, + 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, + 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, + 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, + 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, + 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, + 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, + 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, + 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, + 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, + 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, + 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, + 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, + 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, + 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, + 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, + 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, + 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, + 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, + 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, + 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, + 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, + 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, + 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, + 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, + 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, + 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, + 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, + 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, + 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, + 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, + 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, + 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, + 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, + 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, + 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, + 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, + 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, + 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, + 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, + 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, + 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, + 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, + 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, + 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, + 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, + 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, + 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, + 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, + 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, + 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, + 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, + 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, + 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, + 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, + 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, + 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, + 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, + 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, + 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, + 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, + 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, + 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, + 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, + 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, + 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, + 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, + 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, + 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, + 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, + 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, + 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, + 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, + 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, + 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, + 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, + 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, + 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, + 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, + 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, + 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, + 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, + 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, + 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, + 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, + 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, + 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, + 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, + 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, + 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, + 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, + 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, + 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, + 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, + 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, + 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, + 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, + 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, + 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, + 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, + 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, + 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, + 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, + 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, + 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, + 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, + 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, + 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, + 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, + 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, + 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, + 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, + 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, + 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, + 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, + 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, + 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, + 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, + 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, + 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, + 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, + 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, + 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, + 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, + 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, + 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, + 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, + 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, + 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, + 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, + 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, + 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, + 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, + 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, + 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, + 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, + 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, + 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, + 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, + 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, + 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, + 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, + 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, + 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, + 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, + 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, + 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, + 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, + 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, + 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, + 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, + 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, + 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, + 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, + 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, + 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, + 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, + 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, + 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, + 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, + 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, + 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, + 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, + 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, + 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, + 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, + 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, + 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, + 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, + 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, + 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, + 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, + 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, + 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, + 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, + 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, + 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, + 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, + 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, + 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, + 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, + 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, + 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, + 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, + 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, + 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, + 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, + 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, + 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, + 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, + 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, + 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, + 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, + 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, + 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, + 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, + 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, + 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, + 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, + 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, + 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, + 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, + 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, + 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, + 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, + 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, + 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, + 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, + 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, + 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, + 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, + 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, + 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, + 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, + 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, + 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, + 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, + 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, + 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, + 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, + 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, + 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, + 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, + 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, + 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, + 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, + 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, + 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, + 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, + 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, + 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, + 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, + 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, + 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, + 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, + 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, + 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, + 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, + 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, + 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, + 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, + 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, + 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, + 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, + 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, + 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, + 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, + 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, + 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, + 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, + 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, + 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, + 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, + 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, + 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, + 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, + 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, + 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, + 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, + 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, + 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, + 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, + 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, + 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, + 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, + 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, + 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, + 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, + 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, + 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, + 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, + 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, + 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, + 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, + 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, + 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, + 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, + 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, + 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, + 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, + 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, + 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, + 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, + 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, + 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, + 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, + 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, + 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, + 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, + 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, + 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, + 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, + 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, + 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, + 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, + 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, + 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, + 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, + 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, + 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, + 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, + 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, + 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, + 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, + 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, + 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, + 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, + 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, + 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, + 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, + 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, + 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, + 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, + 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, + 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, + 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, + 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, + 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, + 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, + 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, + 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, + 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, + 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, + 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, + 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, + 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, + 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, + 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, + 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, + 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, + 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, + 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, + 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, + 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, + 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, + 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, + 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, + 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, + 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, + 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, + 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, + 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, + 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, + 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, + 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, + 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, + 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, + 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, + 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, + 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, + 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, + 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, + 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, + 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, + 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, + 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, + 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, + 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, + 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, + 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, + 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] + + + [ -1.08428410e-02, 1.00796208e-07, 4.02972510e-08, -1.08401463e-02, 9.28468679e-08, + 3.59717644e-08, -1.08347470e-02, 7.81576417e-08, 2.81268864e-08, -1.08266407e-02, + 5.89885129e-08, 1.82493117e-08, -1.08158654e-02, 3.83468505e-08, 8.27356179e-09, + -1.08025451e-02, 1.95729598e-08, 2.76289399e-10, -1.07871701e-02, 5.91587407e-09, + -3.85006934e-09, -1.07705448e-02, -1.82444641e-10, -2.73787140e-09, -1.07532992e-02, + 2.38144468e-09, 4.20002544e-09, -1.07360964e-02, 1.33707478e-08, 1.66739763e-08, + -1.07196312e-02, 3.12744513e-08, 3.35377633e-08, -1.07045970e-02, 5.35531486e-08, + 5.29383504e-08, -1.06916508e-02, 7.70293007e-08, 7.25730606e-08, -1.06813757e-02, + 9.83584791e-08, 9.00149101e-08, -1.06742452e-02, 1.14511607e-07, 1.03057467e-07, + -1.06705935e-02, 1.23201936e-07, 1.10028708e-07, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, -1.05879118e-19, 5.51152161e-01, 0.00000000e+00, + -1.05879118e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, -1.05879118e-19, 5.51152161e-01, 0.00000000e+00, 5.29395592e-20, + 5.51152161e-01, 0.00000000e+00, 5.29395592e-20, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 5.29395592e-20, 5.51152161e-01, 0.00000000e+00, + 5.29395592e-20, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.05879118e-19, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] + + + [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] + + True + + + + + [ 2.54046169e+00, -2.55497842e-06, -2.53992720e-06, 2.54088920e+00, -2.45343914e-06, + -2.43826559e-06, 2.54172768e+00, -2.25468129e-06, -2.23977738e-06, 2.54294465e+00, + -1.96738953e-06, -1.95418367e-06, 2.54449304e+00, -1.60482940e-06, -1.59492881e-06, + 2.54631299e+00, -1.18497731e-06, -1.17845531e-06, 2.54833424e+00, -7.27018109e-07, + -7.22695041e-07, 2.55047886e+00, -2.44842391e-07, -2.43380754e-07, 2.55266429e+00, + 2.45853915e-07, 2.44326075e-07, 2.55480653e+00, 7.29310194e-07, 7.24876546e-07, + 2.55682339e+00, 1.18850673e-06, 1.18134476e-06, 2.55863762e+00, 1.60584185e-06, + 1.59603831e-06, 2.56017981e+00, 1.96401954e-06, 1.95183297e-06, 2.56139106e+00, + 2.24749833e-06, 2.23336370e-06, 2.56222516e+00, 2.44369387e-06, 2.42824331e-06, + 2.56265031e+00, 2.54395008e-06, 2.52785780e-06 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/frictionH/120K/clean.sh b/drivers/py/pes/friction/frictionH/120K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/frictionH/120K/get1D.sh b/drivers/py/pes/friction/frictionH/120K/get1D.sh new file mode 100755 index 000000000..152292560 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/get1D.sh @@ -0,0 +1,5 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 diff --git a/drivers/py/pes/friction/frictionH/120K/init.xyz b/drivers/py/pes/friction/frictionH/120K/init.xyz new file mode 100644 index 000000000..223399063 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/frictionH/120K/input.xml b/drivers/py/pes/friction/frictionH/120K/input.xml new file mode 100644 index 000000000..2a0629d36 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/input.xml @@ -0,0 +1,45 @@ + + + [ step, potential{electronvolt}] + extras + extras + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + ['friction'] + + + + 120 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + + z_friction.dat + true + true + none + 0.1 + + + +
diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_00 b/drivers/py/pes/friction/frictionH/120K/inst.fric_00 new file mode 100644 index 000000000..683fa6135 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_00 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 0 + 0.00013194 -0.00003135 -0.00003130 + -0.00003135 0.00013218 -0.00003131 + -0.00003130 -0.00003131 0.00013173 + #*EXTRAS*# Step: 1 Bead: 0 + 0.00012916 -0.00003645 -0.00003615 + -0.00003645 0.00012933 -0.00003649 + -0.00003615 -0.00003649 0.00012882 + #*EXTRAS*# Step: 2 Bead: 0 + 0.00012595 -0.00004042 -0.00003987 + -0.00004042 0.00012602 -0.00004051 + -0.00003987 -0.00004051 0.00012563 + #*EXTRAS*# Step: 3 Bead: 0 + 0.00012376 -0.00004237 -0.00004198 + -0.00004237 0.00012383 -0.00004247 + -0.00004198 -0.00004247 0.00012354 + #*EXTRAS*# Step: 4 Bead: 0 + 0.00012251 -0.00004316 -0.00004300 + -0.00004316 0.00012257 -0.00004323 + -0.00004300 -0.00004323 0.00012236 + #*EXTRAS*# Step: 5 Bead: 0 + 0.00012165 -0.00004358 -0.00004353 + -0.00004358 0.00012168 -0.00004358 + -0.00004353 -0.00004358 0.00012156 + #*EXTRAS*# Step: 6 Bead: 0 + 0.00012100 -0.00004384 -0.00004383 + -0.00004384 0.00012098 -0.00004379 + -0.00004383 -0.00004379 0.00012093 + #*EXTRAS*# Step: 7 Bead: 0 + 0.00012048 -0.00004403 -0.00004402 + -0.00004403 0.00012040 -0.00004392 + -0.00004402 -0.00004392 0.00012043 + #*EXTRAS*# Step: 8 Bead: 0 + 0.00012005 -0.00004417 -0.00004413 + -0.00004417 0.00011993 -0.00004401 + -0.00004413 -0.00004401 0.00012001 + #*EXTRAS*# Step: 9 Bead: 0 + 0.00011969 -0.00004427 -0.00004421 + -0.00004427 0.00011952 -0.00004407 + -0.00004421 -0.00004407 0.00011966 + #*EXTRAS*# Step: 10 Bead: 0 + 0.00011938 -0.00004435 -0.00004426 + -0.00004435 0.00011918 -0.00004412 + -0.00004426 -0.00004412 0.00011937 + #*EXTRAS*# Step: 11 Bead: 0 + 0.00011912 -0.00004441 -0.00004430 + -0.00004441 0.00011889 -0.00004415 + -0.00004430 -0.00004415 0.00011911 + #*EXTRAS*# Step: 12 Bead: 0 + 0.00011889 -0.00004446 -0.00004433 + -0.00004446 0.00011863 -0.00004417 + -0.00004433 -0.00004417 0.00011888 + #*EXTRAS*# Step: 13 Bead: 0 + 0.00011869 -0.00004450 -0.00004435 + -0.00004450 0.00011841 -0.00004419 + -0.00004435 -0.00004419 0.00011869 + #*EXTRAS*# Step: 14 Bead: 0 + 0.00011851 -0.00004453 -0.00004436 + -0.00004453 0.00011821 -0.00004421 + -0.00004436 -0.00004421 0.00011851 + #*EXTRAS*# Step: 15 Bead: 0 + 0.00011836 -0.00004455 -0.00004437 + -0.00004455 0.00011803 -0.00004422 + -0.00004437 -0.00004422 0.00011835 + #*EXTRAS*# Step: 16 Bead: 0 + 0.00011821 -0.00004457 -0.00004437 + -0.00004457 0.00011788 -0.00004422 + -0.00004437 -0.00004422 0.00011821 + #*EXTRAS*# Step: 17 Bead: 0 + 0.00011809 -0.00004458 -0.00004438 + -0.00004458 0.00011774 -0.00004423 + -0.00004438 -0.00004423 0.00011808 + #*EXTRAS*# Step: 18 Bead: 0 + 0.00011797 -0.00004460 -0.00004438 + -0.00004460 0.00011761 -0.00004423 + -0.00004438 -0.00004423 0.00011797 + #*EXTRAS*# Step: 19 Bead: 0 + 0.00011786 -0.00004461 -0.00004438 + -0.00004461 0.00011750 -0.00004424 + -0.00004438 -0.00004424 0.00011787 + #*EXTRAS*# Step: 20 Bead: 0 + 0.00011777 -0.00004461 -0.00004438 + -0.00004461 0.00011739 -0.00004424 + -0.00004438 -0.00004424 0.00011777 + #*EXTRAS*# Step: 21 Bead: 0 + 0.00011768 -0.00004462 -0.00004438 + -0.00004462 0.00011730 -0.00004424 + -0.00004438 -0.00004424 0.00011769 + #*EXTRAS*# Step: 22 Bead: 0 + 0.00011760 -0.00004462 -0.00004438 + -0.00004462 0.00011722 -0.00004424 + -0.00004438 -0.00004424 0.00011761 + #*EXTRAS*# Step: 23 Bead: 0 + 0.00011753 -0.00004463 -0.00004437 + -0.00004463 0.00011714 -0.00004424 + -0.00004437 -0.00004424 0.00011754 + #*EXTRAS*# Step: 24 Bead: 0 + 0.00011747 -0.00004463 -0.00004437 + -0.00004463 0.00011707 -0.00004424 + -0.00004437 -0.00004424 0.00011747 + #*EXTRAS*# Step: 25 Bead: 0 + 0.00011741 -0.00004463 -0.00004437 + -0.00004463 0.00011701 -0.00004424 + -0.00004437 -0.00004424 0.00011741 + #*EXTRAS*# Step: 26 Bead: 0 + 0.00011735 -0.00004463 -0.00004437 + -0.00004463 0.00011695 -0.00004424 + -0.00004437 -0.00004424 0.00011736 + #*EXTRAS*# Step: 27 Bead: 0 + 0.00011730 -0.00004463 -0.00004437 + -0.00004463 0.00011689 -0.00004424 + -0.00004437 -0.00004424 0.00011731 + #*EXTRAS*# Step: 28 Bead: 0 + 0.00011725 -0.00004463 -0.00004436 + -0.00004463 0.00011685 -0.00004424 + -0.00004436 -0.00004424 0.00011726 + #*EXTRAS*# Step: 29 Bead: 0 + 0.00011721 -0.00004463 -0.00004436 + -0.00004463 0.00011680 -0.00004423 + -0.00004436 -0.00004423 0.00011722 + #*EXTRAS*# Step: 30 Bead: 0 + 0.00011717 -0.00004463 -0.00004436 + -0.00004463 0.00011676 -0.00004423 + -0.00004436 -0.00004423 0.00011718 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_01 b/drivers/py/pes/friction/frictionH/120K/inst.fric_01 new file mode 100644 index 000000000..c201772ed --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_01 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 1 + 0.00013155 -0.00003225 -0.00003218 + -0.00003225 0.00013179 -0.00003222 + -0.00003218 -0.00003222 0.00013130 + #*EXTRAS*# Step: 1 Bead: 1 + 0.00012869 -0.00003713 -0.00003678 + -0.00003713 0.00012884 -0.00003718 + -0.00003678 -0.00003718 0.00012834 + #*EXTRAS*# Step: 2 Bead: 1 + 0.00012556 -0.00004082 -0.00004026 + -0.00004082 0.00012562 -0.00004091 + -0.00004026 -0.00004091 0.00012525 + #*EXTRAS*# Step: 3 Bead: 1 + 0.00012351 -0.00004255 -0.00004221 + -0.00004255 0.00012357 -0.00004265 + -0.00004221 -0.00004265 0.00012330 + #*EXTRAS*# Step: 4 Bead: 1 + 0.00012230 -0.00004327 -0.00004314 + -0.00004327 0.00012236 -0.00004332 + -0.00004314 -0.00004332 0.00012217 + #*EXTRAS*# Step: 5 Bead: 1 + 0.00012148 -0.00004365 -0.00004362 + -0.00004365 0.00012150 -0.00004364 + -0.00004362 -0.00004364 0.00012139 + #*EXTRAS*# Step: 6 Bead: 1 + 0.00012084 -0.00004390 -0.00004389 + -0.00004390 0.00012081 -0.00004383 + -0.00004389 -0.00004383 0.00012078 + #*EXTRAS*# Step: 7 Bead: 1 + 0.00012033 -0.00004408 -0.00004406 + -0.00004408 0.00012025 -0.00004395 + -0.00004406 -0.00004395 0.00012029 + #*EXTRAS*# Step: 8 Bead: 1 + 0.00011992 -0.00004420 -0.00004416 + -0.00004420 0.00011978 -0.00004403 + -0.00004416 -0.00004403 0.00011989 + #*EXTRAS*# Step: 9 Bead: 1 + 0.00011957 -0.00004430 -0.00004423 + -0.00004430 0.00011940 -0.00004409 + -0.00004423 -0.00004409 0.00011955 + #*EXTRAS*# Step: 10 Bead: 1 + 0.00011928 -0.00004437 -0.00004428 + -0.00004437 0.00011907 -0.00004413 + -0.00004428 -0.00004413 0.00011927 + #*EXTRAS*# Step: 11 Bead: 1 + 0.00011903 -0.00004443 -0.00004431 + -0.00004443 0.00011878 -0.00004416 + -0.00004431 -0.00004416 0.00011902 + #*EXTRAS*# Step: 12 Bead: 1 + 0.00011881 -0.00004447 -0.00004434 + -0.00004447 0.00011854 -0.00004418 + -0.00004434 -0.00004418 0.00011880 + #*EXTRAS*# Step: 13 Bead: 1 + 0.00011862 -0.00004451 -0.00004435 + -0.00004451 0.00011832 -0.00004420 + -0.00004435 -0.00004420 0.00011861 + #*EXTRAS*# Step: 14 Bead: 1 + 0.00011844 -0.00004454 -0.00004436 + -0.00004454 0.00011813 -0.00004421 + -0.00004436 -0.00004421 0.00011844 + #*EXTRAS*# Step: 15 Bead: 1 + 0.00011829 -0.00004456 -0.00004437 + -0.00004456 0.00011796 -0.00004422 + -0.00004437 -0.00004422 0.00011829 + #*EXTRAS*# Step: 16 Bead: 1 + 0.00011816 -0.00004458 -0.00004437 + -0.00004458 0.00011781 -0.00004423 + -0.00004437 -0.00004423 0.00011815 + #*EXTRAS*# Step: 17 Bead: 1 + 0.00011803 -0.00004459 -0.00004438 + -0.00004459 0.00011768 -0.00004423 + -0.00004438 -0.00004423 0.00011803 + #*EXTRAS*# Step: 18 Bead: 1 + 0.00011792 -0.00004460 -0.00004438 + -0.00004460 0.00011756 -0.00004423 + -0.00004438 -0.00004423 0.00011792 + #*EXTRAS*# Step: 19 Bead: 1 + 0.00011782 -0.00004461 -0.00004438 + -0.00004461 0.00011745 -0.00004424 + -0.00004438 -0.00004424 0.00011782 + #*EXTRAS*# Step: 20 Bead: 1 + 0.00011773 -0.00004462 -0.00004438 + -0.00004462 0.00011735 -0.00004424 + -0.00004438 -0.00004424 0.00011773 + #*EXTRAS*# Step: 21 Bead: 1 + 0.00011765 -0.00004462 -0.00004438 + -0.00004462 0.00011726 -0.00004424 + -0.00004438 -0.00004424 0.00011765 + #*EXTRAS*# Step: 22 Bead: 1 + 0.00011757 -0.00004462 -0.00004438 + -0.00004462 0.00011718 -0.00004424 + -0.00004438 -0.00004424 0.00011757 + #*EXTRAS*# Step: 23 Bead: 1 + 0.00011750 -0.00004463 -0.00004437 + -0.00004463 0.00011711 -0.00004424 + -0.00004437 -0.00004424 0.00011751 + #*EXTRAS*# Step: 24 Bead: 1 + 0.00011744 -0.00004463 -0.00004437 + -0.00004463 0.00011704 -0.00004424 + -0.00004437 -0.00004424 0.00011744 + #*EXTRAS*# Step: 25 Bead: 1 + 0.00011738 -0.00004463 -0.00004437 + -0.00004463 0.00011698 -0.00004424 + -0.00004437 -0.00004424 0.00011739 + #*EXTRAS*# Step: 26 Bead: 1 + 0.00011733 -0.00004463 -0.00004437 + -0.00004463 0.00011692 -0.00004424 + -0.00004437 -0.00004424 0.00011733 + #*EXTRAS*# Step: 27 Bead: 1 + 0.00011728 -0.00004463 -0.00004436 + -0.00004463 0.00011687 -0.00004424 + -0.00004436 -0.00004424 0.00011729 + #*EXTRAS*# Step: 28 Bead: 1 + 0.00011723 -0.00004463 -0.00004436 + -0.00004463 0.00011682 -0.00004424 + -0.00004436 -0.00004424 0.00011724 + #*EXTRAS*# Step: 29 Bead: 1 + 0.00011719 -0.00004463 -0.00004436 + -0.00004463 0.00011678 -0.00004423 + -0.00004436 -0.00004423 0.00011720 + #*EXTRAS*# Step: 30 Bead: 1 + 0.00011716 -0.00004463 -0.00004436 + -0.00004463 0.00011674 -0.00004423 + -0.00004436 -0.00004423 0.00011716 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_02 b/drivers/py/pes/friction/frictionH/120K/inst.fric_02 new file mode 100644 index 000000000..81e934e6a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_02 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 2 + 0.00013052 -0.00003427 -0.00003412 + -0.00003427 0.00013073 -0.00003427 + -0.00003412 -0.00003427 0.00013021 + #*EXTRAS*# Step: 1 Bead: 2 + 0.00012765 -0.00003850 -0.00003805 + -0.00003850 0.00012776 -0.00003857 + -0.00003805 -0.00003857 0.00012729 + #*EXTRAS*# Step: 2 Bead: 2 + 0.00012482 -0.00004151 -0.00004099 + -0.00004151 0.00012488 -0.00004161 + -0.00004099 -0.00004161 0.00012453 + #*EXTRAS*# Step: 3 Bead: 2 + 0.00012301 -0.00004288 -0.00004262 + -0.00004288 0.00012308 -0.00004296 + -0.00004262 -0.00004296 0.00012283 + #*EXTRAS*# Step: 4 Bead: 2 + 0.00012190 -0.00004346 -0.00004339 + -0.00004346 0.00012195 -0.00004349 + -0.00004339 -0.00004349 0.00012180 + #*EXTRAS*# Step: 5 Bead: 2 + 0.00012113 -0.00004379 -0.00004378 + -0.00004379 0.00012112 -0.00004375 + -0.00004378 -0.00004375 0.00012106 + #*EXTRAS*# Step: 6 Bead: 2 + 0.00012053 -0.00004401 -0.00004400 + -0.00004401 0.00012046 -0.00004391 + -0.00004400 -0.00004391 0.00012048 + #*EXTRAS*# Step: 7 Bead: 2 + 0.00012005 -0.00004416 -0.00004413 + -0.00004416 0.00011993 -0.00004401 + -0.00004413 -0.00004401 0.00012002 + #*EXTRAS*# Step: 8 Bead: 2 + 0.00011967 -0.00004427 -0.00004422 + -0.00004427 0.00011950 -0.00004407 + -0.00004422 -0.00004407 0.00011965 + #*EXTRAS*# Step: 9 Bead: 2 + 0.00011935 -0.00004436 -0.00004427 + -0.00004436 0.00011914 -0.00004412 + -0.00004427 -0.00004412 0.00011933 + #*EXTRAS*# Step: 10 Bead: 2 + 0.00011908 -0.00004442 -0.00004431 + -0.00004442 0.00011884 -0.00004415 + -0.00004431 -0.00004415 0.00011907 + #*EXTRAS*# Step: 11 Bead: 2 + 0.00011885 -0.00004447 -0.00004433 + -0.00004447 0.00011858 -0.00004418 + -0.00004433 -0.00004418 0.00011884 + #*EXTRAS*# Step: 12 Bead: 2 + 0.00011864 -0.00004450 -0.00004435 + -0.00004450 0.00011835 -0.00004420 + -0.00004435 -0.00004420 0.00011864 + #*EXTRAS*# Step: 13 Bead: 2 + 0.00011847 -0.00004453 -0.00004436 + -0.00004453 0.00011816 -0.00004421 + -0.00004436 -0.00004421 0.00011846 + #*EXTRAS*# Step: 14 Bead: 2 + 0.00011831 -0.00004456 -0.00004437 + -0.00004456 0.00011798 -0.00004422 + -0.00004437 -0.00004422 0.00011830 + #*EXTRAS*# Step: 15 Bead: 2 + 0.00011817 -0.00004457 -0.00004437 + -0.00004457 0.00011783 -0.00004423 + -0.00004437 -0.00004423 0.00011817 + #*EXTRAS*# Step: 16 Bead: 2 + 0.00011804 -0.00004459 -0.00004438 + -0.00004459 0.00011769 -0.00004423 + -0.00004438 -0.00004423 0.00011804 + #*EXTRAS*# Step: 17 Bead: 2 + 0.00011793 -0.00004460 -0.00004438 + -0.00004460 0.00011757 -0.00004423 + -0.00004438 -0.00004423 0.00011793 + #*EXTRAS*# Step: 18 Bead: 2 + 0.00011783 -0.00004461 -0.00004438 + -0.00004461 0.00011746 -0.00004424 + -0.00004438 -0.00004424 0.00011783 + #*EXTRAS*# Step: 19 Bead: 2 + 0.00011773 -0.00004462 -0.00004438 + -0.00004462 0.00011736 -0.00004424 + -0.00004438 -0.00004424 0.00011774 + #*EXTRAS*# Step: 20 Bead: 2 + 0.00011765 -0.00004462 -0.00004438 + -0.00004462 0.00011727 -0.00004424 + -0.00004438 -0.00004424 0.00011765 + #*EXTRAS*# Step: 21 Bead: 2 + 0.00011757 -0.00004462 -0.00004438 + -0.00004462 0.00011718 -0.00004424 + -0.00004438 -0.00004424 0.00011758 + #*EXTRAS*# Step: 22 Bead: 2 + 0.00011750 -0.00004463 -0.00004437 + -0.00004463 0.00011711 -0.00004424 + -0.00004437 -0.00004424 0.00011751 + #*EXTRAS*# Step: 23 Bead: 2 + 0.00011744 -0.00004463 -0.00004437 + -0.00004463 0.00011704 -0.00004424 + -0.00004437 -0.00004424 0.00011745 + #*EXTRAS*# Step: 24 Bead: 2 + 0.00011738 -0.00004463 -0.00004437 + -0.00004463 0.00011698 -0.00004424 + -0.00004437 -0.00004424 0.00011739 + #*EXTRAS*# Step: 25 Bead: 2 + 0.00011733 -0.00004463 -0.00004437 + -0.00004463 0.00011692 -0.00004424 + -0.00004437 -0.00004424 0.00011733 + #*EXTRAS*# Step: 26 Bead: 2 + 0.00011728 -0.00004463 -0.00004437 + -0.00004463 0.00011687 -0.00004424 + -0.00004437 -0.00004424 0.00011729 + #*EXTRAS*# Step: 27 Bead: 2 + 0.00011723 -0.00004463 -0.00004436 + -0.00004463 0.00011683 -0.00004424 + -0.00004436 -0.00004424 0.00011724 + #*EXTRAS*# Step: 28 Bead: 2 + 0.00011719 -0.00004463 -0.00004436 + -0.00004463 0.00011678 -0.00004423 + -0.00004436 -0.00004423 0.00011720 + #*EXTRAS*# Step: 29 Bead: 2 + 0.00011716 -0.00004463 -0.00004436 + -0.00004463 0.00011674 -0.00004423 + -0.00004436 -0.00004423 0.00011716 + #*EXTRAS*# Step: 30 Bead: 2 + 0.00011712 -0.00004463 -0.00004436 + -0.00004463 0.00011671 -0.00004423 + -0.00004436 -0.00004423 0.00011713 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_03 b/drivers/py/pes/friction/frictionH/120K/inst.fric_03 new file mode 100644 index 000000000..fe0c320e9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_03 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 3 + 0.00012868 -0.00003715 -0.00003680 + -0.00003715 0.00012883 -0.00003720 + -0.00003680 -0.00003720 0.00012833 + #*EXTRAS*# Step: 1 Bead: 3 + 0.00012608 -0.00004029 -0.00003974 + -0.00004029 0.00012615 -0.00004038 + -0.00003974 -0.00004038 0.00012575 + #*EXTRAS*# Step: 2 Bead: 3 + 0.00012382 -0.00004233 -0.00004193 + -0.00004233 0.00012388 -0.00004243 + -0.00004193 -0.00004243 0.00012359 + #*EXTRAS*# Step: 3 Bead: 3 + 0.00012229 -0.00004328 -0.00004315 + -0.00004328 0.00012235 -0.00004333 + -0.00004315 -0.00004333 0.00012216 + #*EXTRAS*# Step: 4 Bead: 3 + 0.00012130 -0.00004372 -0.00004370 + -0.00004372 0.00012131 -0.00004370 + -0.00004370 -0.00004370 0.00012123 + #*EXTRAS*# Step: 5 Bead: 3 + 0.00012060 -0.00004399 -0.00004398 + -0.00004399 0.00012054 -0.00004389 + -0.00004398 -0.00004389 0.00012055 + #*EXTRAS*# Step: 6 Bead: 3 + 0.00012006 -0.00004416 -0.00004413 + -0.00004416 0.00011994 -0.00004401 + -0.00004413 -0.00004401 0.00012003 + #*EXTRAS*# Step: 7 Bead: 3 + 0.00011964 -0.00004428 -0.00004422 + -0.00004428 0.00011947 -0.00004408 + -0.00004422 -0.00004408 0.00011962 + #*EXTRAS*# Step: 8 Bead: 3 + 0.00011930 -0.00004437 -0.00004428 + -0.00004437 0.00011909 -0.00004413 + -0.00004428 -0.00004413 0.00011929 + #*EXTRAS*# Step: 9 Bead: 3 + 0.00011902 -0.00004443 -0.00004431 + -0.00004443 0.00011877 -0.00004416 + -0.00004431 -0.00004416 0.00011901 + #*EXTRAS*# Step: 10 Bead: 3 + 0.00011878 -0.00004448 -0.00004434 + -0.00004448 0.00011851 -0.00004418 + -0.00004434 -0.00004418 0.00011877 + #*EXTRAS*# Step: 11 Bead: 3 + 0.00011858 -0.00004451 -0.00004435 + -0.00004451 0.00011828 -0.00004420 + -0.00004435 -0.00004420 0.00011857 + #*EXTRAS*# Step: 12 Bead: 3 + 0.00011840 -0.00004454 -0.00004436 + -0.00004454 0.00011809 -0.00004421 + -0.00004436 -0.00004421 0.00011840 + #*EXTRAS*# Step: 13 Bead: 3 + 0.00011825 -0.00004456 -0.00004437 + -0.00004456 0.00011791 -0.00004422 + -0.00004437 -0.00004422 0.00011824 + #*EXTRAS*# Step: 14 Bead: 3 + 0.00011811 -0.00004458 -0.00004438 + -0.00004458 0.00011776 -0.00004423 + -0.00004438 -0.00004423 0.00011811 + #*EXTRAS*# Step: 15 Bead: 3 + 0.00011799 -0.00004459 -0.00004438 + -0.00004459 0.00011763 -0.00004423 + -0.00004438 -0.00004423 0.00011799 + #*EXTRAS*# Step: 16 Bead: 3 + 0.00011788 -0.00004460 -0.00004438 + -0.00004460 0.00011751 -0.00004424 + -0.00004438 -0.00004424 0.00011788 + #*EXTRAS*# Step: 17 Bead: 3 + 0.00011778 -0.00004461 -0.00004438 + -0.00004461 0.00011740 -0.00004424 + -0.00004438 -0.00004424 0.00011778 + #*EXTRAS*# Step: 18 Bead: 3 + 0.00011769 -0.00004462 -0.00004438 + -0.00004462 0.00011731 -0.00004424 + -0.00004438 -0.00004424 0.00011769 + #*EXTRAS*# Step: 19 Bead: 3 + 0.00011761 -0.00004462 -0.00004438 + -0.00004462 0.00011722 -0.00004424 + -0.00004438 -0.00004424 0.00011761 + #*EXTRAS*# Step: 20 Bead: 3 + 0.00011753 -0.00004463 -0.00004437 + -0.00004463 0.00011714 -0.00004424 + -0.00004437 -0.00004424 0.00011754 + #*EXTRAS*# Step: 21 Bead: 3 + 0.00011747 -0.00004463 -0.00004437 + -0.00004463 0.00011707 -0.00004424 + -0.00004437 -0.00004424 0.00011747 + #*EXTRAS*# Step: 22 Bead: 3 + 0.00011741 -0.00004463 -0.00004437 + -0.00004463 0.00011701 -0.00004424 + -0.00004437 -0.00004424 0.00011741 + #*EXTRAS*# Step: 23 Bead: 3 + 0.00011735 -0.00004463 -0.00004437 + -0.00004463 0.00011695 -0.00004424 + -0.00004437 -0.00004424 0.00011736 + #*EXTRAS*# Step: 24 Bead: 3 + 0.00011730 -0.00004463 -0.00004437 + -0.00004463 0.00011689 -0.00004424 + -0.00004437 -0.00004424 0.00011731 + #*EXTRAS*# Step: 25 Bead: 3 + 0.00011725 -0.00004463 -0.00004436 + -0.00004463 0.00011685 -0.00004424 + -0.00004436 -0.00004424 0.00011726 + #*EXTRAS*# Step: 26 Bead: 3 + 0.00011721 -0.00004463 -0.00004436 + -0.00004463 0.00011680 -0.00004423 + -0.00004436 -0.00004423 0.00011722 + #*EXTRAS*# Step: 27 Bead: 3 + 0.00011717 -0.00004463 -0.00004436 + -0.00004463 0.00011676 -0.00004423 + -0.00004436 -0.00004423 0.00011718 + #*EXTRAS*# Step: 28 Bead: 3 + 0.00011714 -0.00004463 -0.00004436 + -0.00004463 0.00011672 -0.00004423 + -0.00004436 -0.00004423 0.00011714 + #*EXTRAS*# Step: 29 Bead: 3 + 0.00011710 -0.00004463 -0.00004436 + -0.00004463 0.00011669 -0.00004423 + -0.00004436 -0.00004423 0.00011711 + #*EXTRAS*# Step: 30 Bead: 3 + 0.00011707 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011708 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_04 b/drivers/py/pes/friction/frictionH/120K/inst.fric_04 new file mode 100644 index 000000000..3d5dbd9ed --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_04 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 4 + 0.00012608 -0.00004029 -0.00003974 + -0.00004029 0.00012615 -0.00004038 + -0.00003974 -0.00004038 0.00012575 + #*EXTRAS*# Step: 1 Bead: 4 + 0.00012421 -0.00004202 -0.00004157 + -0.00004202 0.00012427 -0.00004213 + -0.00004157 -0.00004213 0.00012396 + #*EXTRAS*# Step: 2 Bead: 4 + 0.00012262 -0.00004310 -0.00004292 + -0.00004310 0.00012269 -0.00004317 + -0.00004292 -0.00004317 0.00012247 + #*EXTRAS*# Step: 3 Bead: 4 + 0.00012136 -0.00004370 -0.00004368 + -0.00004370 0.00012137 -0.00004368 + -0.00004368 -0.00004368 0.00012128 + #*EXTRAS*# Step: 4 Bead: 4 + 0.00012050 -0.00004402 -0.00004401 + -0.00004402 0.00012044 -0.00004391 + -0.00004401 -0.00004391 0.00012046 + #*EXTRAS*# Step: 5 Bead: 4 + 0.00011991 -0.00004421 -0.00004417 + -0.00004421 0.00011977 -0.00004403 + -0.00004417 -0.00004403 0.00011988 + #*EXTRAS*# Step: 6 Bead: 4 + 0.00011946 -0.00004433 -0.00004425 + -0.00004433 0.00011926 -0.00004411 + -0.00004425 -0.00004411 0.00011944 + #*EXTRAS*# Step: 7 Bead: 4 + 0.00011911 -0.00004441 -0.00004430 + -0.00004441 0.00011887 -0.00004415 + -0.00004430 -0.00004415 0.00011910 + #*EXTRAS*# Step: 8 Bead: 4 + 0.00011883 -0.00004447 -0.00004433 + -0.00004447 0.00011856 -0.00004418 + -0.00004433 -0.00004418 0.00011882 + #*EXTRAS*# Step: 9 Bead: 4 + 0.00011860 -0.00004451 -0.00004435 + -0.00004451 0.00011830 -0.00004420 + -0.00004435 -0.00004420 0.00011859 + #*EXTRAS*# Step: 10 Bead: 4 + 0.00011841 -0.00004454 -0.00004436 + -0.00004454 0.00011809 -0.00004421 + -0.00004436 -0.00004421 0.00011840 + #*EXTRAS*# Step: 11 Bead: 4 + 0.00011824 -0.00004457 -0.00004437 + -0.00004457 0.00011791 -0.00004422 + -0.00004437 -0.00004422 0.00011824 + #*EXTRAS*# Step: 12 Bead: 4 + 0.00011809 -0.00004458 -0.00004438 + -0.00004458 0.00011775 -0.00004423 + -0.00004438 -0.00004423 0.00011809 + #*EXTRAS*# Step: 13 Bead: 4 + 0.00011797 -0.00004460 -0.00004438 + -0.00004460 0.00011761 -0.00004423 + -0.00004438 -0.00004423 0.00011797 + #*EXTRAS*# Step: 14 Bead: 4 + 0.00011786 -0.00004461 -0.00004438 + -0.00004461 0.00011749 -0.00004424 + -0.00004438 -0.00004424 0.00011786 + #*EXTRAS*# Step: 15 Bead: 4 + 0.00011776 -0.00004461 -0.00004438 + -0.00004461 0.00011738 -0.00004424 + -0.00004438 -0.00004424 0.00011776 + #*EXTRAS*# Step: 16 Bead: 4 + 0.00011767 -0.00004462 -0.00004438 + -0.00004462 0.00011728 -0.00004424 + -0.00004438 -0.00004424 0.00011767 + #*EXTRAS*# Step: 17 Bead: 4 + 0.00011759 -0.00004462 -0.00004438 + -0.00004462 0.00011720 -0.00004424 + -0.00004438 -0.00004424 0.00011759 + #*EXTRAS*# Step: 18 Bead: 4 + 0.00011751 -0.00004463 -0.00004437 + -0.00004463 0.00011712 -0.00004424 + -0.00004437 -0.00004424 0.00011752 + #*EXTRAS*# Step: 19 Bead: 4 + 0.00011745 -0.00004463 -0.00004437 + -0.00004463 0.00011705 -0.00004424 + -0.00004437 -0.00004424 0.00011745 + #*EXTRAS*# Step: 20 Bead: 4 + 0.00011739 -0.00004463 -0.00004437 + -0.00004463 0.00011699 -0.00004424 + -0.00004437 -0.00004424 0.00011739 + #*EXTRAS*# Step: 21 Bead: 4 + 0.00011733 -0.00004463 -0.00004437 + -0.00004463 0.00011693 -0.00004424 + -0.00004437 -0.00004424 0.00011734 + #*EXTRAS*# Step: 22 Bead: 4 + 0.00011728 -0.00004463 -0.00004437 + -0.00004463 0.00011688 -0.00004424 + -0.00004437 -0.00004424 0.00011729 + #*EXTRAS*# Step: 23 Bead: 4 + 0.00011724 -0.00004463 -0.00004436 + -0.00004463 0.00011683 -0.00004424 + -0.00004436 -0.00004424 0.00011725 + #*EXTRAS*# Step: 24 Bead: 4 + 0.00011720 -0.00004463 -0.00004436 + -0.00004463 0.00011679 -0.00004423 + -0.00004436 -0.00004423 0.00011720 + #*EXTRAS*# Step: 25 Bead: 4 + 0.00011716 -0.00004463 -0.00004436 + -0.00004463 0.00011675 -0.00004423 + -0.00004436 -0.00004423 0.00011717 + #*EXTRAS*# Step: 26 Bead: 4 + 0.00011712 -0.00004463 -0.00004436 + -0.00004463 0.00011671 -0.00004423 + -0.00004436 -0.00004423 0.00011713 + #*EXTRAS*# Step: 27 Bead: 4 + 0.00011709 -0.00004463 -0.00004435 + -0.00004463 0.00011668 -0.00004423 + -0.00004435 -0.00004423 0.00011710 + #*EXTRAS*# Step: 28 Bead: 4 + 0.00011706 -0.00004463 -0.00004435 + -0.00004463 0.00011665 -0.00004423 + -0.00004435 -0.00004423 0.00011707 + #*EXTRAS*# Step: 29 Bead: 4 + 0.00011704 -0.00004463 -0.00004435 + -0.00004463 0.00011662 -0.00004423 + -0.00004435 -0.00004423 0.00011705 + #*EXTRAS*# Step: 30 Bead: 4 + 0.00011701 -0.00004463 -0.00004435 + -0.00004463 0.00011659 -0.00004423 + -0.00004435 -0.00004423 0.00011702 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_05 b/drivers/py/pes/friction/frictionH/120K/inst.fric_05 new file mode 100644 index 000000000..0c998d4f5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_05 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 5 + 0.00012329 -0.00004270 -0.00004239 + -0.00004270 0.00012336 -0.00004279 + -0.00004239 -0.00004279 0.00012310 + #*EXTRAS*# Step: 1 Bead: 5 + 0.00012223 -0.00004331 -0.00004319 + -0.00004331 0.00012229 -0.00004335 + -0.00004319 -0.00004335 0.00012211 + #*EXTRAS*# Step: 2 Bead: 5 + 0.00012120 -0.00004376 -0.00004375 + -0.00004376 0.00012121 -0.00004373 + -0.00004375 -0.00004373 0.00012113 + #*EXTRAS*# Step: 3 Bead: 5 + 0.00012018 -0.00004412 -0.00004410 + -0.00004412 0.00012008 -0.00004398 + -0.00004410 -0.00004398 0.00012014 + #*EXTRAS*# Step: 4 Bead: 5 + 0.00011952 -0.00004431 -0.00004424 + -0.00004431 0.00011933 -0.00004410 + -0.00004424 -0.00004410 0.00011950 + #*EXTRAS*# Step: 5 Bead: 5 + 0.00011907 -0.00004442 -0.00004431 + -0.00004442 0.00011883 -0.00004416 + -0.00004431 -0.00004416 0.00011906 + #*EXTRAS*# Step: 6 Bead: 5 + 0.00011873 -0.00004449 -0.00004434 + -0.00004449 0.00011845 -0.00004419 + -0.00004434 -0.00004419 0.00011873 + #*EXTRAS*# Step: 7 Bead: 5 + 0.00011848 -0.00004453 -0.00004436 + -0.00004453 0.00011817 -0.00004421 + -0.00004436 -0.00004421 0.00011847 + #*EXTRAS*# Step: 8 Bead: 5 + 0.00011827 -0.00004456 -0.00004437 + -0.00004456 0.00011794 -0.00004422 + -0.00004437 -0.00004422 0.00011827 + #*EXTRAS*# Step: 9 Bead: 5 + 0.00011810 -0.00004458 -0.00004438 + -0.00004458 0.00011776 -0.00004423 + -0.00004438 -0.00004423 0.00011810 + #*EXTRAS*# Step: 10 Bead: 5 + 0.00011796 -0.00004460 -0.00004438 + -0.00004460 0.00011760 -0.00004423 + -0.00004438 -0.00004423 0.00011796 + #*EXTRAS*# Step: 11 Bead: 5 + 0.00011784 -0.00004461 -0.00004438 + -0.00004461 0.00011747 -0.00004424 + -0.00004438 -0.00004424 0.00011784 + #*EXTRAS*# Step: 12 Bead: 5 + 0.00011773 -0.00004462 -0.00004438 + -0.00004462 0.00011736 -0.00004424 + -0.00004438 -0.00004424 0.00011774 + #*EXTRAS*# Step: 13 Bead: 5 + 0.00011764 -0.00004462 -0.00004438 + -0.00004462 0.00011726 -0.00004424 + -0.00004438 -0.00004424 0.00011765 + #*EXTRAS*# Step: 14 Bead: 5 + 0.00011756 -0.00004462 -0.00004438 + -0.00004462 0.00011717 -0.00004424 + -0.00004438 -0.00004424 0.00011756 + #*EXTRAS*# Step: 15 Bead: 5 + 0.00011749 -0.00004463 -0.00004437 + -0.00004463 0.00011709 -0.00004424 + -0.00004437 -0.00004424 0.00011749 + #*EXTRAS*# Step: 16 Bead: 5 + 0.00011742 -0.00004463 -0.00004437 + -0.00004463 0.00011702 -0.00004424 + -0.00004437 -0.00004424 0.00011743 + #*EXTRAS*# Step: 17 Bead: 5 + 0.00011736 -0.00004463 -0.00004437 + -0.00004463 0.00011696 -0.00004424 + -0.00004437 -0.00004424 0.00011737 + #*EXTRAS*# Step: 18 Bead: 5 + 0.00011731 -0.00004463 -0.00004437 + -0.00004463 0.00011690 -0.00004424 + -0.00004437 -0.00004424 0.00011732 + #*EXTRAS*# Step: 19 Bead: 5 + 0.00011726 -0.00004463 -0.00004436 + -0.00004463 0.00011685 -0.00004424 + -0.00004436 -0.00004424 0.00011727 + #*EXTRAS*# Step: 20 Bead: 5 + 0.00011722 -0.00004463 -0.00004436 + -0.00004463 0.00011681 -0.00004423 + -0.00004436 -0.00004423 0.00011722 + #*EXTRAS*# Step: 21 Bead: 5 + 0.00011718 -0.00004463 -0.00004436 + -0.00004463 0.00011676 -0.00004423 + -0.00004436 -0.00004423 0.00011718 + #*EXTRAS*# Step: 22 Bead: 5 + 0.00011714 -0.00004463 -0.00004436 + -0.00004463 0.00011673 -0.00004423 + -0.00004436 -0.00004423 0.00011715 + #*EXTRAS*# Step: 23 Bead: 5 + 0.00011711 -0.00004463 -0.00004436 + -0.00004463 0.00011669 -0.00004423 + -0.00004436 -0.00004423 0.00011711 + #*EXTRAS*# Step: 24 Bead: 5 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011708 + #*EXTRAS*# Step: 25 Bead: 5 + 0.00011705 -0.00004463 -0.00004435 + -0.00004463 0.00011663 -0.00004423 + -0.00004435 -0.00004423 0.00011706 + #*EXTRAS*# Step: 26 Bead: 5 + 0.00011702 -0.00004463 -0.00004435 + -0.00004463 0.00011660 -0.00004423 + -0.00004435 -0.00004423 0.00011703 + #*EXTRAS*# Step: 27 Bead: 5 + 0.00011700 -0.00004463 -0.00004435 + -0.00004463 0.00011658 -0.00004423 + -0.00004435 -0.00004423 0.00011701 + #*EXTRAS*# Step: 28 Bead: 5 + 0.00011698 -0.00004463 -0.00004435 + -0.00004463 0.00011656 -0.00004423 + -0.00004435 -0.00004423 0.00011699 + #*EXTRAS*# Step: 29 Bead: 5 + 0.00011696 -0.00004463 -0.00004435 + -0.00004463 0.00011654 -0.00004423 + -0.00004435 -0.00004423 0.00011697 + #*EXTRAS*# Step: 30 Bead: 5 + 0.00011694 -0.00004463 -0.00004434 + -0.00004463 0.00011652 -0.00004422 + -0.00004434 -0.00004422 0.00011695 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_06 b/drivers/py/pes/friction/frictionH/120K/inst.fric_06 new file mode 100644 index 000000000..54bf45aed --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_06 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 6 + 0.00012029 -0.00004409 -0.00004407 + -0.00004409 0.00012020 -0.00004396 + -0.00004407 -0.00004396 0.00012025 + #*EXTRAS*# Step: 1 Bead: 6 + 0.00011985 -0.00004422 -0.00004418 + -0.00004422 0.00011971 -0.00004404 + -0.00004418 -0.00004404 0.00011983 + #*EXTRAS*# Step: 2 Bead: 6 + 0.00011947 -0.00004433 -0.00004425 + -0.00004433 0.00011928 -0.00004410 + -0.00004425 -0.00004410 0.00011945 + #*EXTRAS*# Step: 3 Bead: 6 + 0.00011880 -0.00004448 -0.00004434 + -0.00004448 0.00011853 -0.00004418 + -0.00004434 -0.00004418 0.00011879 + #*EXTRAS*# Step: 4 Bead: 6 + 0.00011839 -0.00004454 -0.00004437 + -0.00004454 0.00011807 -0.00004421 + -0.00004437 -0.00004421 0.00011839 + #*EXTRAS*# Step: 5 Bead: 6 + 0.00011812 -0.00004458 -0.00004438 + -0.00004458 0.00011778 -0.00004423 + -0.00004438 -0.00004423 0.00011812 + #*EXTRAS*# Step: 6 Bead: 6 + 0.00011793 -0.00004460 -0.00004438 + -0.00004460 0.00011756 -0.00004423 + -0.00004438 -0.00004423 0.00011793 + #*EXTRAS*# Step: 7 Bead: 6 + 0.00011777 -0.00004461 -0.00004438 + -0.00004461 0.00011740 -0.00004424 + -0.00004438 -0.00004424 0.00011778 + #*EXTRAS*# Step: 8 Bead: 6 + 0.00011765 -0.00004462 -0.00004438 + -0.00004462 0.00011727 -0.00004424 + -0.00004438 -0.00004424 0.00011766 + #*EXTRAS*# Step: 9 Bead: 6 + 0.00011755 -0.00004463 -0.00004438 + -0.00004463 0.00011716 -0.00004424 + -0.00004438 -0.00004424 0.00011756 + #*EXTRAS*# Step: 10 Bead: 6 + 0.00011747 -0.00004463 -0.00004437 + -0.00004463 0.00011708 -0.00004424 + -0.00004437 -0.00004424 0.00011748 + #*EXTRAS*# Step: 11 Bead: 6 + 0.00011740 -0.00004463 -0.00004437 + -0.00004463 0.00011700 -0.00004424 + -0.00004437 -0.00004424 0.00011741 + #*EXTRAS*# Step: 12 Bead: 6 + 0.00011734 -0.00004463 -0.00004437 + -0.00004463 0.00011693 -0.00004424 + -0.00004437 -0.00004424 0.00011734 + #*EXTRAS*# Step: 13 Bead: 6 + 0.00011728 -0.00004463 -0.00004437 + -0.00004463 0.00011687 -0.00004424 + -0.00004437 -0.00004424 0.00011729 + #*EXTRAS*# Step: 14 Bead: 6 + 0.00011723 -0.00004463 -0.00004436 + -0.00004463 0.00011682 -0.00004424 + -0.00004436 -0.00004424 0.00011724 + #*EXTRAS*# Step: 15 Bead: 6 + 0.00011719 -0.00004463 -0.00004436 + -0.00004463 0.00011678 -0.00004423 + -0.00004436 -0.00004423 0.00011720 + #*EXTRAS*# Step: 16 Bead: 6 + 0.00011715 -0.00004463 -0.00004436 + -0.00004463 0.00011674 -0.00004423 + -0.00004436 -0.00004423 0.00011716 + #*EXTRAS*# Step: 17 Bead: 6 + 0.00011711 -0.00004463 -0.00004436 + -0.00004463 0.00011670 -0.00004423 + -0.00004436 -0.00004423 0.00011712 + #*EXTRAS*# Step: 18 Bead: 6 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011667 -0.00004423 + -0.00004435 -0.00004423 0.00011709 + #*EXTRAS*# Step: 19 Bead: 6 + 0.00011705 -0.00004463 -0.00004435 + -0.00004463 0.00011664 -0.00004423 + -0.00004435 -0.00004423 0.00011706 + #*EXTRAS*# Step: 20 Bead: 6 + 0.00011703 -0.00004463 -0.00004435 + -0.00004463 0.00011661 -0.00004423 + -0.00004435 -0.00004423 0.00011704 + #*EXTRAS*# Step: 21 Bead: 6 + 0.00011700 -0.00004463 -0.00004435 + -0.00004463 0.00011658 -0.00004423 + -0.00004435 -0.00004423 0.00011701 + #*EXTRAS*# Step: 22 Bead: 6 + 0.00011698 -0.00004463 -0.00004435 + -0.00004463 0.00011656 -0.00004423 + -0.00004435 -0.00004423 0.00011699 + #*EXTRAS*# Step: 23 Bead: 6 + 0.00011696 -0.00004463 -0.00004435 + -0.00004463 0.00011654 -0.00004423 + -0.00004435 -0.00004423 0.00011697 + #*EXTRAS*# Step: 24 Bead: 6 + 0.00011694 -0.00004463 -0.00004434 + -0.00004463 0.00011652 -0.00004422 + -0.00004434 -0.00004422 0.00011695 + #*EXTRAS*# Step: 25 Bead: 6 + 0.00011692 -0.00004463 -0.00004434 + -0.00004463 0.00011650 -0.00004422 + -0.00004434 -0.00004422 0.00011693 + #*EXTRAS*# Step: 26 Bead: 6 + 0.00011691 -0.00004463 -0.00004434 + -0.00004463 0.00011649 -0.00004422 + -0.00004434 -0.00004422 0.00011692 + #*EXTRAS*# Step: 27 Bead: 6 + 0.00011690 -0.00004462 -0.00004434 + -0.00004462 0.00011647 -0.00004422 + -0.00004434 -0.00004422 0.00011691 + #*EXTRAS*# Step: 28 Bead: 6 + 0.00011688 -0.00004462 -0.00004434 + -0.00004462 0.00011646 -0.00004422 + -0.00004434 -0.00004422 0.00011689 + #*EXTRAS*# Step: 29 Bead: 6 + 0.00011687 -0.00004462 -0.00004434 + -0.00004462 0.00011645 -0.00004422 + -0.00004434 -0.00004422 0.00011688 + #*EXTRAS*# Step: 30 Bead: 6 + 0.00011686 -0.00004462 -0.00004434 + -0.00004462 0.00011644 -0.00004422 + -0.00004434 -0.00004422 0.00011687 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_07 b/drivers/py/pes/friction/frictionH/120K/inst.fric_07 new file mode 100644 index 000000000..c903d80c5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_07 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 7 + 0.00011665 -0.00004461 -0.00004432 + -0.00004461 0.00011623 -0.00004421 + -0.00004432 -0.00004421 0.00011666 + #*EXTRAS*# Step: 1 Bead: 7 + 0.00011708 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011709 + #*EXTRAS*# Step: 2 Bead: 7 + 0.00011753 -0.00004463 -0.00004437 + -0.00004463 0.00011714 -0.00004424 + -0.00004437 -0.00004424 0.00011754 + #*EXTRAS*# Step: 3 Bead: 7 + 0.00011731 -0.00004463 -0.00004437 + -0.00004463 0.00011691 -0.00004424 + -0.00004437 -0.00004424 0.00011732 + #*EXTRAS*# Step: 4 Bead: 7 + 0.00011719 -0.00004463 -0.00004436 + -0.00004463 0.00011678 -0.00004423 + -0.00004436 -0.00004423 0.00011720 + #*EXTRAS*# Step: 5 Bead: 7 + 0.00011713 -0.00004463 -0.00004436 + -0.00004463 0.00011671 -0.00004423 + -0.00004436 -0.00004423 0.00011713 + #*EXTRAS*# Step: 6 Bead: 7 + 0.00011707 -0.00004463 -0.00004435 + -0.00004463 0.00011666 -0.00004423 + -0.00004435 -0.00004423 0.00011708 + #*EXTRAS*# Step: 7 Bead: 7 + 0.00011704 -0.00004463 -0.00004435 + -0.00004463 0.00011662 -0.00004423 + -0.00004435 -0.00004423 0.00011705 + #*EXTRAS*# Step: 8 Bead: 7 + 0.00011700 -0.00004463 -0.00004435 + -0.00004463 0.00011659 -0.00004423 + -0.00004435 -0.00004423 0.00011701 + #*EXTRAS*# Step: 9 Bead: 7 + 0.00011698 -0.00004463 -0.00004435 + -0.00004463 0.00011656 -0.00004423 + -0.00004435 -0.00004423 0.00011699 + #*EXTRAS*# Step: 10 Bead: 7 + 0.00011696 -0.00004463 -0.00004434 + -0.00004463 0.00011654 -0.00004423 + -0.00004434 -0.00004423 0.00011697 + #*EXTRAS*# Step: 11 Bead: 7 + 0.00011694 -0.00004463 -0.00004434 + -0.00004463 0.00011652 -0.00004422 + -0.00004434 -0.00004422 0.00011695 + #*EXTRAS*# Step: 12 Bead: 7 + 0.00011692 -0.00004463 -0.00004434 + -0.00004463 0.00011650 -0.00004422 + -0.00004434 -0.00004422 0.00011693 + #*EXTRAS*# Step: 13 Bead: 7 + 0.00011690 -0.00004462 -0.00004434 + -0.00004462 0.00011648 -0.00004422 + -0.00004434 -0.00004422 0.00011691 + #*EXTRAS*# Step: 14 Bead: 7 + 0.00011689 -0.00004462 -0.00004434 + -0.00004462 0.00011647 -0.00004422 + -0.00004434 -0.00004422 0.00011690 + #*EXTRAS*# Step: 15 Bead: 7 + 0.00011688 -0.00004462 -0.00004434 + -0.00004462 0.00011645 -0.00004422 + -0.00004434 -0.00004422 0.00011689 + #*EXTRAS*# Step: 16 Bead: 7 + 0.00011686 -0.00004462 -0.00004434 + -0.00004462 0.00011644 -0.00004422 + -0.00004434 -0.00004422 0.00011687 + #*EXTRAS*# Step: 17 Bead: 7 + 0.00011685 -0.00004462 -0.00004434 + -0.00004462 0.00011643 -0.00004422 + -0.00004434 -0.00004422 0.00011686 + #*EXTRAS*# Step: 18 Bead: 7 + 0.00011684 -0.00004462 -0.00004434 + -0.00004462 0.00011642 -0.00004422 + -0.00004434 -0.00004422 0.00011685 + #*EXTRAS*# Step: 19 Bead: 7 + 0.00011684 -0.00004462 -0.00004434 + -0.00004462 0.00011641 -0.00004422 + -0.00004434 -0.00004422 0.00011685 + #*EXTRAS*# Step: 20 Bead: 7 + 0.00011683 -0.00004462 -0.00004433 + -0.00004462 0.00011640 -0.00004422 + -0.00004433 -0.00004422 0.00011684 + #*EXTRAS*# Step: 21 Bead: 7 + 0.00011682 -0.00004462 -0.00004433 + -0.00004462 0.00011640 -0.00004422 + -0.00004433 -0.00004422 0.00011683 + #*EXTRAS*# Step: 22 Bead: 7 + 0.00011681 -0.00004462 -0.00004433 + -0.00004462 0.00011639 -0.00004422 + -0.00004433 -0.00004422 0.00011682 + #*EXTRAS*# Step: 23 Bead: 7 + 0.00011681 -0.00004462 -0.00004433 + -0.00004462 0.00011638 -0.00004422 + -0.00004433 -0.00004422 0.00011682 + #*EXTRAS*# Step: 24 Bead: 7 + 0.00011680 -0.00004462 -0.00004433 + -0.00004462 0.00011638 -0.00004422 + -0.00004433 -0.00004422 0.00011681 + #*EXTRAS*# Step: 25 Bead: 7 + 0.00011680 -0.00004462 -0.00004433 + -0.00004462 0.00011637 -0.00004422 + -0.00004433 -0.00004422 0.00011681 + #*EXTRAS*# Step: 26 Bead: 7 + 0.00011679 -0.00004462 -0.00004433 + -0.00004462 0.00011637 -0.00004422 + -0.00004433 -0.00004422 0.00011680 + #*EXTRAS*# Step: 27 Bead: 7 + 0.00011679 -0.00004462 -0.00004433 + -0.00004462 0.00011636 -0.00004422 + -0.00004433 -0.00004422 0.00011680 + #*EXTRAS*# Step: 28 Bead: 7 + 0.00011678 -0.00004462 -0.00004433 + -0.00004462 0.00011636 -0.00004422 + -0.00004433 -0.00004422 0.00011679 + #*EXTRAS*# Step: 29 Bead: 7 + 0.00011678 -0.00004462 -0.00004433 + -0.00004462 0.00011635 -0.00004422 + -0.00004433 -0.00004422 0.00011679 + #*EXTRAS*# Step: 30 Bead: 7 + 0.00011677 -0.00004462 -0.00004433 + -0.00004462 0.00011635 -0.00004422 + -0.00004433 -0.00004422 0.00011679 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_08 b/drivers/py/pes/friction/frictionH/120K/inst.fric_08 new file mode 100644 index 000000000..c5097d5ce --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_08 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 8 + 0.00011322 -0.00004352 -0.00004346 + -0.00004352 0.00011306 -0.00004343 + -0.00004346 -0.00004343 0.00011326 + #*EXTRAS*# Step: 1 Bead: 8 + 0.00011440 -0.00004405 -0.00004388 + -0.00004405 0.00011411 -0.00004383 + -0.00004388 -0.00004383 0.00011443 + #*EXTRAS*# Step: 2 Bead: 8 + 0.00011561 -0.00004444 -0.00004417 + -0.00004444 0.00011522 -0.00004409 + -0.00004417 -0.00004409 0.00011564 + #*EXTRAS*# Step: 3 Bead: 8 + 0.00011584 -0.00004449 -0.00004421 + -0.00004449 0.00011544 -0.00004412 + -0.00004421 -0.00004412 0.00011586 + #*EXTRAS*# Step: 4 Bead: 8 + 0.00011601 -0.00004452 -0.00004424 + -0.00004452 0.00011559 -0.00004414 + -0.00004424 -0.00004414 0.00011602 + #*EXTRAS*# Step: 5 Bead: 8 + 0.00011614 -0.00004454 -0.00004426 + -0.00004454 0.00011572 -0.00004416 + -0.00004426 -0.00004416 0.00011615 + #*EXTRAS*# Step: 6 Bead: 8 + 0.00011623 -0.00004456 -0.00004427 + -0.00004456 0.00011581 -0.00004417 + -0.00004427 -0.00004417 0.00011624 + #*EXTRAS*# Step: 7 Bead: 8 + 0.00011630 -0.00004457 -0.00004428 + -0.00004457 0.00011588 -0.00004418 + -0.00004428 -0.00004418 0.00011631 + #*EXTRAS*# Step: 8 Bead: 8 + 0.00011636 -0.00004458 -0.00004429 + -0.00004458 0.00011593 -0.00004418 + -0.00004429 -0.00004418 0.00011637 + #*EXTRAS*# Step: 9 Bead: 8 + 0.00011640 -0.00004458 -0.00004429 + -0.00004458 0.00011598 -0.00004419 + -0.00004429 -0.00004419 0.00011642 + #*EXTRAS*# Step: 10 Bead: 8 + 0.00011644 -0.00004459 -0.00004430 + -0.00004459 0.00011602 -0.00004419 + -0.00004430 -0.00004419 0.00011645 + #*EXTRAS*# Step: 11 Bead: 8 + 0.00011647 -0.00004459 -0.00004430 + -0.00004459 0.00011605 -0.00004419 + -0.00004430 -0.00004419 0.00011648 + #*EXTRAS*# Step: 12 Bead: 8 + 0.00011650 -0.00004459 -0.00004430 + -0.00004459 0.00011607 -0.00004420 + -0.00004430 -0.00004420 0.00011651 + #*EXTRAS*# Step: 13 Bead: 8 + 0.00011652 -0.00004459 -0.00004430 + -0.00004459 0.00011610 -0.00004420 + -0.00004430 -0.00004420 0.00011653 + #*EXTRAS*# Step: 14 Bead: 8 + 0.00011654 -0.00004460 -0.00004431 + -0.00004460 0.00011612 -0.00004420 + -0.00004431 -0.00004420 0.00011656 + #*EXTRAS*# Step: 15 Bead: 8 + 0.00011656 -0.00004460 -0.00004431 + -0.00004460 0.00011614 -0.00004420 + -0.00004431 -0.00004420 0.00011657 + #*EXTRAS*# Step: 16 Bead: 8 + 0.00011658 -0.00004460 -0.00004431 + -0.00004460 0.00011615 -0.00004420 + -0.00004431 -0.00004420 0.00011659 + #*EXTRAS*# Step: 17 Bead: 8 + 0.00011659 -0.00004460 -0.00004431 + -0.00004460 0.00011617 -0.00004420 + -0.00004431 -0.00004420 0.00011660 + #*EXTRAS*# Step: 18 Bead: 8 + 0.00011660 -0.00004460 -0.00004431 + -0.00004460 0.00011618 -0.00004420 + -0.00004431 -0.00004420 0.00011662 + #*EXTRAS*# Step: 19 Bead: 8 + 0.00011661 -0.00004460 -0.00004431 + -0.00004460 0.00011619 -0.00004420 + -0.00004431 -0.00004420 0.00011663 + #*EXTRAS*# Step: 20 Bead: 8 + 0.00011662 -0.00004461 -0.00004432 + -0.00004461 0.00011620 -0.00004421 + -0.00004432 -0.00004421 0.00011664 + #*EXTRAS*# Step: 21 Bead: 8 + 0.00011663 -0.00004461 -0.00004432 + -0.00004461 0.00011621 -0.00004421 + -0.00004432 -0.00004421 0.00011665 + #*EXTRAS*# Step: 22 Bead: 8 + 0.00011664 -0.00004461 -0.00004432 + -0.00004461 0.00011622 -0.00004421 + -0.00004432 -0.00004421 0.00011665 + #*EXTRAS*# Step: 23 Bead: 8 + 0.00011665 -0.00004461 -0.00004432 + -0.00004461 0.00011623 -0.00004421 + -0.00004432 -0.00004421 0.00011666 + #*EXTRAS*# Step: 24 Bead: 8 + 0.00011666 -0.00004461 -0.00004432 + -0.00004461 0.00011623 -0.00004421 + -0.00004432 -0.00004421 0.00011667 + #*EXTRAS*# Step: 25 Bead: 8 + 0.00011666 -0.00004461 -0.00004432 + -0.00004461 0.00011624 -0.00004421 + -0.00004432 -0.00004421 0.00011668 + #*EXTRAS*# Step: 26 Bead: 8 + 0.00011667 -0.00004461 -0.00004432 + -0.00004461 0.00011624 -0.00004421 + -0.00004432 -0.00004421 0.00011668 + #*EXTRAS*# Step: 27 Bead: 8 + 0.00011667 -0.00004461 -0.00004432 + -0.00004461 0.00011625 -0.00004421 + -0.00004432 -0.00004421 0.00011669 + #*EXTRAS*# Step: 28 Bead: 8 + 0.00011668 -0.00004461 -0.00004432 + -0.00004461 0.00011625 -0.00004421 + -0.00004432 -0.00004421 0.00011669 + #*EXTRAS*# Step: 29 Bead: 8 + 0.00011668 -0.00004461 -0.00004432 + -0.00004461 0.00011626 -0.00004421 + -0.00004432 -0.00004421 0.00011670 + #*EXTRAS*# Step: 30 Bead: 8 + 0.00011669 -0.00004461 -0.00004432 + -0.00004461 0.00011626 -0.00004421 + -0.00004432 -0.00004421 0.00011670 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_09 b/drivers/py/pes/friction/frictionH/120K/inst.fric_09 new file mode 100644 index 000000000..10f766150 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_09 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 9 + 0.00011023 -0.00004172 -0.00004180 + -0.00004172 0.00011025 -0.00004177 + -0.00004180 -0.00004177 0.00011031 + #*EXTRAS*# Step: 1 Bead: 9 + 0.00011201 -0.00004285 -0.00004289 + -0.00004285 0.00011197 -0.00004287 + -0.00004289 -0.00004287 0.00011207 + #*EXTRAS*# Step: 2 Bead: 9 + 0.00011383 -0.00004382 -0.00004369 + -0.00004382 0.00011361 -0.00004365 + -0.00004369 -0.00004365 0.00011387 + #*EXTRAS*# Step: 3 Bead: 9 + 0.00011446 -0.00004408 -0.00004390 + -0.00004408 0.00011417 -0.00004384 + -0.00004390 -0.00004384 0.00011450 + #*EXTRAS*# Step: 4 Bead: 9 + 0.00011489 -0.00004423 -0.00004401 + -0.00004423 0.00011455 -0.00004395 + -0.00004401 -0.00004395 0.00011491 + #*EXTRAS*# Step: 5 Bead: 9 + 0.00011520 -0.00004433 -0.00004408 + -0.00004433 0.00011483 -0.00004401 + -0.00004408 -0.00004401 0.00011522 + #*EXTRAS*# Step: 6 Bead: 9 + 0.00011542 -0.00004439 -0.00004413 + -0.00004439 0.00011504 -0.00004405 + -0.00004413 -0.00004405 0.00011544 + #*EXTRAS*# Step: 7 Bead: 9 + 0.00011559 -0.00004443 -0.00004417 + -0.00004443 0.00011520 -0.00004408 + -0.00004417 -0.00004408 0.00011562 + #*EXTRAS*# Step: 8 Bead: 9 + 0.00011573 -0.00004446 -0.00004419 + -0.00004446 0.00011533 -0.00004411 + -0.00004419 -0.00004411 0.00011575 + #*EXTRAS*# Step: 9 Bead: 9 + 0.00011585 -0.00004449 -0.00004421 + -0.00004449 0.00011544 -0.00004412 + -0.00004421 -0.00004412 0.00011587 + #*EXTRAS*# Step: 10 Bead: 9 + 0.00011594 -0.00004451 -0.00004423 + -0.00004451 0.00011553 -0.00004414 + -0.00004423 -0.00004414 0.00011596 + #*EXTRAS*# Step: 11 Bead: 9 + 0.00011602 -0.00004452 -0.00004424 + -0.00004452 0.00011561 -0.00004415 + -0.00004424 -0.00004415 0.00011604 + #*EXTRAS*# Step: 12 Bead: 9 + 0.00011609 -0.00004454 -0.00004425 + -0.00004454 0.00011568 -0.00004415 + -0.00004425 -0.00004415 0.00011611 + #*EXTRAS*# Step: 13 Bead: 9 + 0.00011615 -0.00004455 -0.00004426 + -0.00004455 0.00011573 -0.00004416 + -0.00004426 -0.00004416 0.00011617 + #*EXTRAS*# Step: 14 Bead: 9 + 0.00011621 -0.00004455 -0.00004427 + -0.00004455 0.00011579 -0.00004417 + -0.00004427 -0.00004417 0.00011622 + #*EXTRAS*# Step: 15 Bead: 9 + 0.00011625 -0.00004456 -0.00004427 + -0.00004456 0.00011583 -0.00004417 + -0.00004427 -0.00004417 0.00011627 + #*EXTRAS*# Step: 16 Bead: 9 + 0.00011630 -0.00004457 -0.00004428 + -0.00004457 0.00011587 -0.00004418 + -0.00004428 -0.00004418 0.00011631 + #*EXTRAS*# Step: 17 Bead: 9 + 0.00011633 -0.00004457 -0.00004428 + -0.00004457 0.00011591 -0.00004418 + -0.00004428 -0.00004418 0.00011635 + #*EXTRAS*# Step: 18 Bead: 9 + 0.00011637 -0.00004458 -0.00004429 + -0.00004458 0.00011595 -0.00004418 + -0.00004429 -0.00004418 0.00011638 + #*EXTRAS*# Step: 19 Bead: 9 + 0.00011640 -0.00004458 -0.00004429 + -0.00004458 0.00011598 -0.00004419 + -0.00004429 -0.00004419 0.00011641 + #*EXTRAS*# Step: 20 Bead: 9 + 0.00011643 -0.00004458 -0.00004429 + -0.00004458 0.00011600 -0.00004419 + -0.00004429 -0.00004419 0.00011644 + #*EXTRAS*# Step: 21 Bead: 9 + 0.00011645 -0.00004459 -0.00004430 + -0.00004459 0.00011603 -0.00004419 + -0.00004430 -0.00004419 0.00011647 + #*EXTRAS*# Step: 22 Bead: 9 + 0.00011648 -0.00004459 -0.00004430 + -0.00004459 0.00011605 -0.00004419 + -0.00004430 -0.00004419 0.00011649 + #*EXTRAS*# Step: 23 Bead: 9 + 0.00011650 -0.00004459 -0.00004430 + -0.00004459 0.00011607 -0.00004420 + -0.00004430 -0.00004420 0.00011651 + #*EXTRAS*# Step: 24 Bead: 9 + 0.00011652 -0.00004459 -0.00004430 + -0.00004459 0.00011609 -0.00004420 + -0.00004430 -0.00004420 0.00011653 + #*EXTRAS*# Step: 25 Bead: 9 + 0.00011653 -0.00004460 -0.00004431 + -0.00004460 0.00011611 -0.00004420 + -0.00004431 -0.00004420 0.00011655 + #*EXTRAS*# Step: 26 Bead: 9 + 0.00011655 -0.00004460 -0.00004431 + -0.00004460 0.00011613 -0.00004420 + -0.00004431 -0.00004420 0.00011656 + #*EXTRAS*# Step: 27 Bead: 9 + 0.00011657 -0.00004460 -0.00004431 + -0.00004460 0.00011614 -0.00004420 + -0.00004431 -0.00004420 0.00011658 + #*EXTRAS*# Step: 28 Bead: 9 + 0.00011658 -0.00004460 -0.00004431 + -0.00004460 0.00011615 -0.00004420 + -0.00004431 -0.00004420 0.00011659 + #*EXTRAS*# Step: 29 Bead: 9 + 0.00011659 -0.00004460 -0.00004431 + -0.00004460 0.00011617 -0.00004420 + -0.00004431 -0.00004420 0.00011660 + #*EXTRAS*# Step: 30 Bead: 9 + 0.00011660 -0.00004460 -0.00004431 + -0.00004460 0.00011618 -0.00004420 + -0.00004431 -0.00004420 0.00011662 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_10 b/drivers/py/pes/friction/frictionH/120K/inst.fric_10 new file mode 100644 index 000000000..d4ce847fb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_10 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 10 + 0.00010769 -0.00003973 -0.00003972 + -0.00003973 0.00010769 -0.00003973 + -0.00003972 -0.00003973 0.00010770 + #*EXTRAS*# Step: 1 Bead: 10 + 0.00010994 -0.00004152 -0.00004159 + -0.00004152 0.00010997 -0.00004156 + -0.00004159 -0.00004156 0.00011002 + #*EXTRAS*# Step: 2 Bead: 10 + 0.00011224 -0.00004299 -0.00004301 + -0.00004299 0.00011219 -0.00004300 + -0.00004301 -0.00004300 0.00011230 + #*EXTRAS*# Step: 3 Bead: 10 + 0.00011322 -0.00004352 -0.00004346 + -0.00004352 0.00011306 -0.00004343 + -0.00004346 -0.00004343 0.00011327 + #*EXTRAS*# Step: 4 Bead: 10 + 0.00011387 -0.00004383 -0.00004371 + -0.00004383 0.00011364 -0.00004367 + -0.00004371 -0.00004367 0.00011391 + #*EXTRAS*# Step: 5 Bead: 10 + 0.00011434 -0.00004403 -0.00004386 + -0.00004403 0.00011405 -0.00004381 + -0.00004386 -0.00004381 0.00011437 + #*EXTRAS*# Step: 6 Bead: 10 + 0.00011468 -0.00004416 -0.00004396 + -0.00004416 0.00011436 -0.00004390 + -0.00004396 -0.00004390 0.00011471 + #*EXTRAS*# Step: 7 Bead: 10 + 0.00011495 -0.00004425 -0.00004402 + -0.00004425 0.00011460 -0.00004396 + -0.00004402 -0.00004396 0.00011497 + #*EXTRAS*# Step: 8 Bead: 10 + 0.00011516 -0.00004432 -0.00004407 + -0.00004432 0.00011480 -0.00004401 + -0.00004407 -0.00004401 0.00011518 + #*EXTRAS*# Step: 9 Bead: 10 + 0.00011533 -0.00004437 -0.00004411 + -0.00004437 0.00011496 -0.00004404 + -0.00004411 -0.00004404 0.00011536 + #*EXTRAS*# Step: 10 Bead: 10 + 0.00011548 -0.00004440 -0.00004414 + -0.00004440 0.00011509 -0.00004407 + -0.00004414 -0.00004407 0.00011550 + #*EXTRAS*# Step: 11 Bead: 10 + 0.00011560 -0.00004444 -0.00004417 + -0.00004444 0.00011521 -0.00004409 + -0.00004417 -0.00004409 0.00011563 + #*EXTRAS*# Step: 12 Bead: 10 + 0.00011571 -0.00004446 -0.00004419 + -0.00004446 0.00011531 -0.00004410 + -0.00004419 -0.00004410 0.00011573 + #*EXTRAS*# Step: 13 Bead: 10 + 0.00011581 -0.00004448 -0.00004420 + -0.00004448 0.00011540 -0.00004412 + -0.00004420 -0.00004412 0.00011583 + #*EXTRAS*# Step: 14 Bead: 10 + 0.00011589 -0.00004450 -0.00004422 + -0.00004450 0.00011548 -0.00004413 + -0.00004422 -0.00004413 0.00011591 + #*EXTRAS*# Step: 15 Bead: 10 + 0.00011597 -0.00004451 -0.00004423 + -0.00004451 0.00011556 -0.00004414 + -0.00004423 -0.00004414 0.00011599 + #*EXTRAS*# Step: 16 Bead: 10 + 0.00011603 -0.00004453 -0.00004424 + -0.00004453 0.00011562 -0.00004415 + -0.00004424 -0.00004415 0.00011605 + #*EXTRAS*# Step: 17 Bead: 10 + 0.00011609 -0.00004454 -0.00004425 + -0.00004454 0.00011568 -0.00004415 + -0.00004425 -0.00004415 0.00011611 + #*EXTRAS*# Step: 18 Bead: 10 + 0.00011615 -0.00004454 -0.00004426 + -0.00004454 0.00011573 -0.00004416 + -0.00004426 -0.00004416 0.00011617 + #*EXTRAS*# Step: 19 Bead: 10 + 0.00011620 -0.00004455 -0.00004426 + -0.00004455 0.00011578 -0.00004417 + -0.00004426 -0.00004417 0.00011621 + #*EXTRAS*# Step: 20 Bead: 10 + 0.00011624 -0.00004456 -0.00004427 + -0.00004456 0.00011582 -0.00004417 + -0.00004427 -0.00004417 0.00011626 + #*EXTRAS*# Step: 21 Bead: 10 + 0.00011628 -0.00004457 -0.00004428 + -0.00004457 0.00011586 -0.00004418 + -0.00004428 -0.00004418 0.00011630 + #*EXTRAS*# Step: 22 Bead: 10 + 0.00011632 -0.00004457 -0.00004428 + -0.00004457 0.00011590 -0.00004418 + -0.00004428 -0.00004418 0.00011634 + #*EXTRAS*# Step: 23 Bead: 10 + 0.00011635 -0.00004457 -0.00004429 + -0.00004457 0.00011593 -0.00004418 + -0.00004429 -0.00004418 0.00011637 + #*EXTRAS*# Step: 24 Bead: 10 + 0.00011639 -0.00004458 -0.00004429 + -0.00004458 0.00011596 -0.00004419 + -0.00004429 -0.00004419 0.00011640 + #*EXTRAS*# Step: 25 Bead: 10 + 0.00011641 -0.00004458 -0.00004429 + -0.00004458 0.00011599 -0.00004419 + -0.00004429 -0.00004419 0.00011643 + #*EXTRAS*# Step: 26 Bead: 10 + 0.00011644 -0.00004459 -0.00004430 + -0.00004459 0.00011602 -0.00004419 + -0.00004430 -0.00004419 0.00011645 + #*EXTRAS*# Step: 27 Bead: 10 + 0.00011646 -0.00004459 -0.00004430 + -0.00004459 0.00011604 -0.00004419 + -0.00004430 -0.00004419 0.00011648 + #*EXTRAS*# Step: 28 Bead: 10 + 0.00011649 -0.00004459 -0.00004430 + -0.00004459 0.00011606 -0.00004419 + -0.00004430 -0.00004419 0.00011650 + #*EXTRAS*# Step: 29 Bead: 10 + 0.00011651 -0.00004459 -0.00004430 + -0.00004459 0.00011608 -0.00004420 + -0.00004430 -0.00004420 0.00011652 + #*EXTRAS*# Step: 30 Bead: 10 + 0.00011652 -0.00004460 -0.00004430 + -0.00004460 0.00011610 -0.00004420 + -0.00004430 -0.00004420 0.00011654 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_11 b/drivers/py/pes/friction/frictionH/120K/inst.fric_11 new file mode 100644 index 000000000..8b0f7ce81 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_11 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 11 + 0.00010562 -0.00003769 -0.00003763 + -0.00003769 0.00010562 -0.00003777 + -0.00003763 -0.00003777 0.00010544 + #*EXTRAS*# Step: 1 Bead: 11 + 0.00010821 -0.00004018 -0.00004019 + -0.00004018 0.00010822 -0.00004018 + -0.00004019 -0.00004018 0.00010825 + #*EXTRAS*# Step: 2 Bead: 11 + 0.00011087 -0.00004215 -0.00004223 + -0.00004215 0.00011089 -0.00004221 + -0.00004223 -0.00004221 0.00011095 + #*EXTRAS*# Step: 3 Bead: 11 + 0.00011213 -0.00004293 -0.00004296 + -0.00004293 0.00011209 -0.00004294 + -0.00004296 -0.00004294 0.00011219 + #*EXTRAS*# Step: 4 Bead: 11 + 0.00011298 -0.00004339 -0.00004336 + -0.00004339 0.00011285 -0.00004333 + -0.00004336 -0.00004333 0.00011303 + #*EXTRAS*# Step: 5 Bead: 11 + 0.00011358 -0.00004370 -0.00004360 + -0.00004370 0.00011339 -0.00004357 + -0.00004360 -0.00004357 0.00011363 + #*EXTRAS*# Step: 6 Bead: 11 + 0.00011403 -0.00004390 -0.00004376 + -0.00004390 0.00011378 -0.00004372 + -0.00004376 -0.00004372 0.00011407 + #*EXTRAS*# Step: 7 Bead: 11 + 0.00011437 -0.00004404 -0.00004387 + -0.00004404 0.00011409 -0.00004382 + -0.00004387 -0.00004382 0.00011441 + #*EXTRAS*# Step: 8 Bead: 11 + 0.00011465 -0.00004415 -0.00004395 + -0.00004415 0.00011434 -0.00004389 + -0.00004395 -0.00004389 0.00011468 + #*EXTRAS*# Step: 9 Bead: 11 + 0.00011488 -0.00004423 -0.00004401 + -0.00004423 0.00011454 -0.00004395 + -0.00004401 -0.00004395 0.00011491 + #*EXTRAS*# Step: 10 Bead: 11 + 0.00011507 -0.00004429 -0.00004405 + -0.00004429 0.00011472 -0.00004399 + -0.00004405 -0.00004399 0.00011510 + #*EXTRAS*# Step: 11 Bead: 11 + 0.00011523 -0.00004434 -0.00004409 + -0.00004434 0.00011487 -0.00004402 + -0.00004409 -0.00004402 0.00011526 + #*EXTRAS*# Step: 12 Bead: 11 + 0.00011538 -0.00004438 -0.00004412 + -0.00004438 0.00011500 -0.00004405 + -0.00004412 -0.00004405 0.00011540 + #*EXTRAS*# Step: 13 Bead: 11 + 0.00011550 -0.00004441 -0.00004415 + -0.00004441 0.00011512 -0.00004407 + -0.00004415 -0.00004407 0.00011553 + #*EXTRAS*# Step: 14 Bead: 11 + 0.00011561 -0.00004444 -0.00004417 + -0.00004444 0.00011522 -0.00004409 + -0.00004417 -0.00004409 0.00011564 + #*EXTRAS*# Step: 15 Bead: 11 + 0.00011571 -0.00004446 -0.00004419 + -0.00004446 0.00011531 -0.00004410 + -0.00004419 -0.00004410 0.00011573 + #*EXTRAS*# Step: 16 Bead: 11 + 0.00011580 -0.00004448 -0.00004420 + -0.00004448 0.00011540 -0.00004412 + -0.00004420 -0.00004412 0.00011582 + #*EXTRAS*# Step: 17 Bead: 11 + 0.00011588 -0.00004450 -0.00004422 + -0.00004450 0.00011547 -0.00004413 + -0.00004422 -0.00004413 0.00011590 + #*EXTRAS*# Step: 18 Bead: 11 + 0.00011595 -0.00004451 -0.00004423 + -0.00004451 0.00011554 -0.00004414 + -0.00004423 -0.00004414 0.00011597 + #*EXTRAS*# Step: 19 Bead: 11 + 0.00011602 -0.00004452 -0.00004424 + -0.00004452 0.00011561 -0.00004415 + -0.00004424 -0.00004415 0.00011604 + #*EXTRAS*# Step: 20 Bead: 11 + 0.00011608 -0.00004453 -0.00004425 + -0.00004453 0.00011566 -0.00004415 + -0.00004425 -0.00004415 0.00011610 + #*EXTRAS*# Step: 21 Bead: 11 + 0.00011613 -0.00004454 -0.00004426 + -0.00004454 0.00011571 -0.00004416 + -0.00004426 -0.00004416 0.00011615 + #*EXTRAS*# Step: 22 Bead: 11 + 0.00011618 -0.00004455 -0.00004426 + -0.00004455 0.00011576 -0.00004416 + -0.00004426 -0.00004416 0.00011620 + #*EXTRAS*# Step: 23 Bead: 11 + 0.00011623 -0.00004456 -0.00004427 + -0.00004456 0.00011581 -0.00004417 + -0.00004427 -0.00004417 0.00011624 + #*EXTRAS*# Step: 24 Bead: 11 + 0.00011627 -0.00004456 -0.00004427 + -0.00004456 0.00011585 -0.00004417 + -0.00004427 -0.00004417 0.00011628 + #*EXTRAS*# Step: 25 Bead: 11 + 0.00011631 -0.00004457 -0.00004428 + -0.00004457 0.00011588 -0.00004418 + -0.00004428 -0.00004418 0.00011632 + #*EXTRAS*# Step: 26 Bead: 11 + 0.00011634 -0.00004457 -0.00004428 + -0.00004457 0.00011592 -0.00004418 + -0.00004428 -0.00004418 0.00011636 + #*EXTRAS*# Step: 27 Bead: 11 + 0.00011637 -0.00004458 -0.00004429 + -0.00004458 0.00011595 -0.00004418 + -0.00004429 -0.00004418 0.00011639 + #*EXTRAS*# Step: 28 Bead: 11 + 0.00011640 -0.00004458 -0.00004429 + -0.00004458 0.00011598 -0.00004419 + -0.00004429 -0.00004419 0.00011642 + #*EXTRAS*# Step: 29 Bead: 11 + 0.00011643 -0.00004458 -0.00004429 + -0.00004458 0.00011600 -0.00004419 + -0.00004429 -0.00004419 0.00011644 + #*EXTRAS*# Step: 30 Bead: 11 + 0.00011645 -0.00004459 -0.00004430 + -0.00004459 0.00011603 -0.00004419 + -0.00004430 -0.00004419 0.00011647 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_12 b/drivers/py/pes/friction/frictionH/120K/inst.fric_12 new file mode 100644 index 000000000..2ad298472 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_12 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 12 + 0.00010410 -0.00003588 -0.00003581 + -0.00003588 0.00010410 -0.00003604 + -0.00003581 -0.00003604 0.00010377 + #*EXTRAS*# Step: 1 Bead: 12 + 0.00010683 -0.00003893 -0.00003890 + -0.00003893 0.00010683 -0.00003895 + -0.00003890 -0.00003895 0.00010677 + #*EXTRAS*# Step: 2 Bead: 12 + 0.00010976 -0.00004138 -0.00004145 + -0.00004138 0.00010978 -0.00004142 + -0.00004145 -0.00004142 0.00010983 + #*EXTRAS*# Step: 3 Bead: 12 + 0.00011124 -0.00004238 -0.00004246 + -0.00004238 0.00011124 -0.00004244 + -0.00004246 -0.00004244 0.00011131 + #*EXTRAS*# Step: 4 Bead: 12 + 0.00011224 -0.00004299 -0.00004301 + -0.00004299 0.00011219 -0.00004299 + -0.00004301 -0.00004299 0.00011230 + #*EXTRAS*# Step: 5 Bead: 12 + 0.00011296 -0.00004338 -0.00004335 + -0.00004338 0.00011283 -0.00004333 + -0.00004335 -0.00004333 0.00011301 + #*EXTRAS*# Step: 6 Bead: 12 + 0.00011349 -0.00004365 -0.00004357 + -0.00004365 0.00011330 -0.00004353 + -0.00004357 -0.00004353 0.00011353 + #*EXTRAS*# Step: 7 Bead: 12 + 0.00011390 -0.00004384 -0.00004372 + -0.00004384 0.00011366 -0.00004368 + -0.00004372 -0.00004368 0.00011394 + #*EXTRAS*# Step: 8 Bead: 12 + 0.00011423 -0.00004398 -0.00004382 + -0.00004398 0.00011396 -0.00004378 + -0.00004382 -0.00004378 0.00011426 + #*EXTRAS*# Step: 9 Bead: 12 + 0.00011450 -0.00004409 -0.00004391 + -0.00004409 0.00011420 -0.00004385 + -0.00004391 -0.00004385 0.00011453 + #*EXTRAS*# Step: 10 Bead: 12 + 0.00011473 -0.00004417 -0.00004397 + -0.00004417 0.00011441 -0.00004391 + -0.00004397 -0.00004391 0.00011476 + #*EXTRAS*# Step: 11 Bead: 12 + 0.00011492 -0.00004424 -0.00004402 + -0.00004424 0.00011458 -0.00004396 + -0.00004402 -0.00004396 0.00011495 + #*EXTRAS*# Step: 12 Bead: 12 + 0.00011509 -0.00004430 -0.00004406 + -0.00004430 0.00011474 -0.00004399 + -0.00004406 -0.00004399 0.00011512 + #*EXTRAS*# Step: 13 Bead: 12 + 0.00011525 -0.00004434 -0.00004409 + -0.00004434 0.00011488 -0.00004402 + -0.00004409 -0.00004402 0.00011527 + #*EXTRAS*# Step: 14 Bead: 12 + 0.00011538 -0.00004438 -0.00004412 + -0.00004438 0.00011500 -0.00004405 + -0.00004412 -0.00004405 0.00011540 + #*EXTRAS*# Step: 15 Bead: 12 + 0.00011550 -0.00004441 -0.00004415 + -0.00004441 0.00011511 -0.00004407 + -0.00004415 -0.00004407 0.00011552 + #*EXTRAS*# Step: 16 Bead: 12 + 0.00011560 -0.00004444 -0.00004417 + -0.00004444 0.00011521 -0.00004409 + -0.00004417 -0.00004409 0.00011563 + #*EXTRAS*# Step: 17 Bead: 12 + 0.00011570 -0.00004446 -0.00004419 + -0.00004446 0.00011530 -0.00004410 + -0.00004419 -0.00004410 0.00011572 + #*EXTRAS*# Step: 18 Bead: 12 + 0.00011579 -0.00004448 -0.00004420 + -0.00004448 0.00011538 -0.00004411 + -0.00004420 -0.00004411 0.00011581 + #*EXTRAS*# Step: 19 Bead: 12 + 0.00011587 -0.00004449 -0.00004421 + -0.00004449 0.00011546 -0.00004413 + -0.00004421 -0.00004413 0.00011589 + #*EXTRAS*# Step: 20 Bead: 12 + 0.00011594 -0.00004451 -0.00004423 + -0.00004451 0.00011553 -0.00004413 + -0.00004423 -0.00004413 0.00011596 + #*EXTRAS*# Step: 21 Bead: 12 + 0.00011600 -0.00004452 -0.00004424 + -0.00004452 0.00011559 -0.00004414 + -0.00004424 -0.00004414 0.00011602 + #*EXTRAS*# Step: 22 Bead: 12 + 0.00011606 -0.00004453 -0.00004425 + -0.00004453 0.00011565 -0.00004415 + -0.00004425 -0.00004415 0.00011608 + #*EXTRAS*# Step: 23 Bead: 12 + 0.00011612 -0.00004454 -0.00004425 + -0.00004454 0.00011570 -0.00004416 + -0.00004425 -0.00004416 0.00011614 + #*EXTRAS*# Step: 24 Bead: 12 + 0.00011617 -0.00004455 -0.00004426 + -0.00004455 0.00011575 -0.00004416 + -0.00004426 -0.00004416 0.00011618 + #*EXTRAS*# Step: 25 Bead: 12 + 0.00011621 -0.00004455 -0.00004427 + -0.00004455 0.00011579 -0.00004417 + -0.00004427 -0.00004417 0.00011623 + #*EXTRAS*# Step: 26 Bead: 12 + 0.00011626 -0.00004456 -0.00004427 + -0.00004456 0.00011584 -0.00004417 + -0.00004427 -0.00004417 0.00011627 + #*EXTRAS*# Step: 27 Bead: 12 + 0.00011629 -0.00004457 -0.00004428 + -0.00004457 0.00011587 -0.00004418 + -0.00004428 -0.00004418 0.00011631 + #*EXTRAS*# Step: 28 Bead: 12 + 0.00011633 -0.00004457 -0.00004428 + -0.00004457 0.00011591 -0.00004418 + -0.00004428 -0.00004418 0.00011634 + #*EXTRAS*# Step: 29 Bead: 12 + 0.00011636 -0.00004458 -0.00004429 + -0.00004458 0.00011594 -0.00004418 + -0.00004429 -0.00004418 0.00011638 + #*EXTRAS*# Step: 30 Bead: 12 + 0.00011639 -0.00004458 -0.00004429 + -0.00004458 0.00011597 -0.00004419 + -0.00004429 -0.00004419 0.00011641 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_13 b/drivers/py/pes/friction/frictionH/120K/inst.fric_13 new file mode 100644 index 000000000..b1039c57f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_13 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 13 + 0.00010310 -0.00003446 -0.00003442 + -0.00003446 0.00010308 -0.00003466 + -0.00003442 -0.00003466 0.00010270 + #*EXTRAS*# Step: 1 Bead: 13 + 0.00010583 -0.00003791 -0.00003786 + -0.00003791 0.00010582 -0.00003798 + -0.00003786 -0.00003798 0.00010567 + #*EXTRAS*# Step: 2 Bead: 13 + 0.00010890 -0.00004074 -0.00004078 + -0.00004074 0.00010892 -0.00004076 + -0.00004078 -0.00004076 0.00010897 + #*EXTRAS*# Step: 3 Bead: 13 + 0.00011055 -0.00004194 -0.00004202 + -0.00004194 0.00011057 -0.00004199 + -0.00004202 -0.00004199 0.00011063 + #*EXTRAS*# Step: 4 Bead: 13 + 0.00011167 -0.00004265 -0.00004271 + -0.00004265 0.00011166 -0.00004269 + -0.00004271 -0.00004269 0.00011174 + #*EXTRAS*# Step: 5 Bead: 13 + 0.00011248 -0.00004312 -0.00004313 + -0.00004312 0.00011240 -0.00004311 + -0.00004313 -0.00004311 0.00011253 + #*EXTRAS*# Step: 6 Bead: 13 + 0.00011307 -0.00004344 -0.00004340 + -0.00004344 0.00011293 -0.00004337 + -0.00004340 -0.00004337 0.00011312 + #*EXTRAS*# Step: 7 Bead: 13 + 0.00011353 -0.00004367 -0.00004358 + -0.00004367 0.00011334 -0.00004355 + -0.00004358 -0.00004355 0.00011357 + #*EXTRAS*# Step: 8 Bead: 13 + 0.00011390 -0.00004384 -0.00004372 + -0.00004384 0.00011366 -0.00004368 + -0.00004372 -0.00004368 0.00011394 + #*EXTRAS*# Step: 9 Bead: 13 + 0.00011420 -0.00004397 -0.00004382 + -0.00004397 0.00011393 -0.00004377 + -0.00004382 -0.00004377 0.00011424 + #*EXTRAS*# Step: 10 Bead: 13 + 0.00011446 -0.00004408 -0.00004389 + -0.00004408 0.00011417 -0.00004384 + -0.00004389 -0.00004384 0.00011449 + #*EXTRAS*# Step: 11 Bead: 13 + 0.00011468 -0.00004416 -0.00004396 + -0.00004416 0.00011436 -0.00004390 + -0.00004396 -0.00004390 0.00011471 + #*EXTRAS*# Step: 12 Bead: 13 + 0.00011488 -0.00004423 -0.00004401 + -0.00004423 0.00011454 -0.00004394 + -0.00004401 -0.00004394 0.00011490 + #*EXTRAS*# Step: 13 Bead: 13 + 0.00011504 -0.00004428 -0.00004405 + -0.00004428 0.00011469 -0.00004398 + -0.00004405 -0.00004398 0.00011507 + #*EXTRAS*# Step: 14 Bead: 13 + 0.00011520 -0.00004433 -0.00004408 + -0.00004433 0.00011483 -0.00004401 + -0.00004408 -0.00004401 0.00011522 + #*EXTRAS*# Step: 15 Bead: 13 + 0.00011533 -0.00004436 -0.00004411 + -0.00004436 0.00011496 -0.00004404 + -0.00004411 -0.00004404 0.00011535 + #*EXTRAS*# Step: 16 Bead: 13 + 0.00011545 -0.00004440 -0.00004414 + -0.00004440 0.00011507 -0.00004406 + -0.00004414 -0.00004406 0.00011547 + #*EXTRAS*# Step: 17 Bead: 13 + 0.00011556 -0.00004442 -0.00004416 + -0.00004442 0.00011517 -0.00004408 + -0.00004416 -0.00004408 0.00011558 + #*EXTRAS*# Step: 18 Bead: 13 + 0.00011566 -0.00004445 -0.00004418 + -0.00004445 0.00011526 -0.00004409 + -0.00004418 -0.00004409 0.00011568 + #*EXTRAS*# Step: 19 Bead: 13 + 0.00011575 -0.00004447 -0.00004419 + -0.00004447 0.00011535 -0.00004411 + -0.00004419 -0.00004411 0.00011577 + #*EXTRAS*# Step: 20 Bead: 13 + 0.00011583 -0.00004449 -0.00004421 + -0.00004449 0.00011542 -0.00004412 + -0.00004421 -0.00004412 0.00011585 + #*EXTRAS*# Step: 21 Bead: 13 + 0.00011590 -0.00004450 -0.00004422 + -0.00004450 0.00011549 -0.00004413 + -0.00004422 -0.00004413 0.00011592 + #*EXTRAS*# Step: 22 Bead: 13 + 0.00011597 -0.00004451 -0.00004423 + -0.00004451 0.00011556 -0.00004414 + -0.00004423 -0.00004414 0.00011599 + #*EXTRAS*# Step: 23 Bead: 13 + 0.00011603 -0.00004452 -0.00004424 + -0.00004452 0.00011562 -0.00004415 + -0.00004424 -0.00004415 0.00011605 + #*EXTRAS*# Step: 24 Bead: 13 + 0.00011609 -0.00004453 -0.00004425 + -0.00004453 0.00011567 -0.00004415 + -0.00004425 -0.00004415 0.00011611 + #*EXTRAS*# Step: 25 Bead: 13 + 0.00011614 -0.00004454 -0.00004426 + -0.00004454 0.00011572 -0.00004416 + -0.00004426 -0.00004416 0.00011616 + #*EXTRAS*# Step: 26 Bead: 13 + 0.00011619 -0.00004455 -0.00004426 + -0.00004455 0.00011577 -0.00004417 + -0.00004426 -0.00004417 0.00011621 + #*EXTRAS*# Step: 27 Bead: 13 + 0.00011623 -0.00004456 -0.00004427 + -0.00004456 0.00011581 -0.00004417 + -0.00004427 -0.00004417 0.00011625 + #*EXTRAS*# Step: 28 Bead: 13 + 0.00011627 -0.00004456 -0.00004427 + -0.00004456 0.00011585 -0.00004417 + -0.00004427 -0.00004417 0.00011629 + #*EXTRAS*# Step: 29 Bead: 13 + 0.00011631 -0.00004457 -0.00004428 + -0.00004457 0.00011589 -0.00004418 + -0.00004428 -0.00004418 0.00011633 + #*EXTRAS*# Step: 30 Bead: 13 + 0.00011634 -0.00004457 -0.00004428 + -0.00004457 0.00011592 -0.00004418 + -0.00004428 -0.00004418 0.00011636 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_14 b/drivers/py/pes/friction/frictionH/120K/inst.fric_14 new file mode 100644 index 000000000..bbb8ff42c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_14 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 14 + 0.00010253 -0.00003354 -0.00003351 + -0.00003354 0.00010248 -0.00003373 + -0.00003351 -0.00003373 0.00010211 + #*EXTRAS*# Step: 1 Bead: 14 + 0.00010519 -0.00003721 -0.00003715 + -0.00003721 0.00010519 -0.00003732 + -0.00003715 -0.00003732 0.00010497 + #*EXTRAS*# Step: 2 Bead: 14 + 0.00010833 -0.00004028 -0.00004030 + -0.00004028 0.00010834 -0.00004028 + -0.00004030 -0.00004028 0.00010838 + #*EXTRAS*# Step: 3 Bead: 14 + 0.00011008 -0.00004162 -0.00004169 + -0.00004162 0.00011011 -0.00004166 + -0.00004169 -0.00004166 0.00011016 + #*EXTRAS*# Step: 4 Bead: 14 + 0.00011129 -0.00004242 -0.00004249 + -0.00004242 0.00011129 -0.00004247 + -0.00004249 -0.00004247 0.00011136 + #*EXTRAS*# Step: 5 Bead: 14 + 0.00011215 -0.00004293 -0.00004297 + -0.00004293 0.00011210 -0.00004295 + -0.00004297 -0.00004295 0.00011221 + #*EXTRAS*# Step: 6 Bead: 14 + 0.00011278 -0.00004329 -0.00004327 + -0.00004329 0.00011267 -0.00004325 + -0.00004327 -0.00004325 0.00011283 + #*EXTRAS*# Step: 7 Bead: 14 + 0.00011328 -0.00004355 -0.00004348 + -0.00004355 0.00011311 -0.00004345 + -0.00004348 -0.00004345 0.00011332 + #*EXTRAS*# Step: 8 Bead: 14 + 0.00011367 -0.00004374 -0.00004364 + -0.00004374 0.00011347 -0.00004360 + -0.00004364 -0.00004360 0.00011371 + #*EXTRAS*# Step: 9 Bead: 14 + 0.00011400 -0.00004389 -0.00004375 + -0.00004389 0.00011376 -0.00004371 + -0.00004375 -0.00004371 0.00011404 + #*EXTRAS*# Step: 10 Bead: 14 + 0.00011428 -0.00004400 -0.00004384 + -0.00004400 0.00011400 -0.00004379 + -0.00004384 -0.00004379 0.00011431 + #*EXTRAS*# Step: 11 Bead: 14 + 0.00011452 -0.00004410 -0.00004391 + -0.00004410 0.00011422 -0.00004386 + -0.00004391 -0.00004386 0.00011455 + #*EXTRAS*# Step: 12 Bead: 14 + 0.00011472 -0.00004417 -0.00004397 + -0.00004417 0.00011440 -0.00004391 + -0.00004397 -0.00004391 0.00011476 + #*EXTRAS*# Step: 13 Bead: 14 + 0.00011491 -0.00004424 -0.00004402 + -0.00004424 0.00011457 -0.00004395 + -0.00004402 -0.00004395 0.00011494 + #*EXTRAS*# Step: 14 Bead: 14 + 0.00011507 -0.00004429 -0.00004405 + -0.00004429 0.00011472 -0.00004399 + -0.00004405 -0.00004399 0.00011510 + #*EXTRAS*# Step: 15 Bead: 14 + 0.00011522 -0.00004433 -0.00004409 + -0.00004433 0.00011485 -0.00004402 + -0.00004409 -0.00004402 0.00011524 + #*EXTRAS*# Step: 16 Bead: 14 + 0.00011535 -0.00004437 -0.00004412 + -0.00004437 0.00011497 -0.00004404 + -0.00004412 -0.00004404 0.00011537 + #*EXTRAS*# Step: 17 Bead: 14 + 0.00011546 -0.00004440 -0.00004414 + -0.00004440 0.00011508 -0.00004406 + -0.00004414 -0.00004406 0.00011549 + #*EXTRAS*# Step: 18 Bead: 14 + 0.00011557 -0.00004443 -0.00004416 + -0.00004443 0.00011518 -0.00004408 + -0.00004416 -0.00004408 0.00011559 + #*EXTRAS*# Step: 19 Bead: 14 + 0.00011567 -0.00004445 -0.00004418 + -0.00004445 0.00011527 -0.00004410 + -0.00004418 -0.00004410 0.00011569 + #*EXTRAS*# Step: 20 Bead: 14 + 0.00011575 -0.00004447 -0.00004420 + -0.00004447 0.00011535 -0.00004411 + -0.00004420 -0.00004411 0.00011577 + #*EXTRAS*# Step: 21 Bead: 14 + 0.00011583 -0.00004449 -0.00004421 + -0.00004449 0.00011543 -0.00004412 + -0.00004421 -0.00004412 0.00011585 + #*EXTRAS*# Step: 22 Bead: 14 + 0.00011591 -0.00004450 -0.00004422 + -0.00004450 0.00011550 -0.00004413 + -0.00004422 -0.00004413 0.00011593 + #*EXTRAS*# Step: 23 Bead: 14 + 0.00011597 -0.00004451 -0.00004423 + -0.00004451 0.00011556 -0.00004414 + -0.00004423 -0.00004414 0.00011599 + #*EXTRAS*# Step: 24 Bead: 14 + 0.00011604 -0.00004453 -0.00004424 + -0.00004453 0.00011562 -0.00004415 + -0.00004424 -0.00004415 0.00011605 + #*EXTRAS*# Step: 25 Bead: 14 + 0.00011609 -0.00004454 -0.00004425 + -0.00004454 0.00011568 -0.00004415 + -0.00004425 -0.00004415 0.00011611 + #*EXTRAS*# Step: 26 Bead: 14 + 0.00011614 -0.00004454 -0.00004426 + -0.00004454 0.00011573 -0.00004416 + -0.00004426 -0.00004416 0.00011616 + #*EXTRAS*# Step: 27 Bead: 14 + 0.00011619 -0.00004455 -0.00004426 + -0.00004455 0.00011577 -0.00004417 + -0.00004426 -0.00004417 0.00011621 + #*EXTRAS*# Step: 28 Bead: 14 + 0.00011623 -0.00004456 -0.00004427 + -0.00004456 0.00011582 -0.00004417 + -0.00004427 -0.00004417 0.00011625 + #*EXTRAS*# Step: 29 Bead: 14 + 0.00011627 -0.00004456 -0.00004427 + -0.00004456 0.00011585 -0.00004417 + -0.00004427 -0.00004417 0.00011629 + #*EXTRAS*# Step: 30 Bead: 14 + 0.00011631 -0.00004457 -0.00004428 + -0.00004457 0.00011589 -0.00004418 + -0.00004428 -0.00004418 0.00011633 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_15 b/drivers/py/pes/friction/frictionH/120K/inst.fric_15 new file mode 100644 index 000000000..1fbc7b195 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.fric_15 @@ -0,0 +1,124 @@ + #*EXTRAS*# Step: 0 Bead: 15 + 0.00010230 -0.00003314 -0.00003313 + -0.00003314 0.00010224 -0.00003332 + -0.00003313 -0.00003332 0.00010188 + #*EXTRAS*# Step: 1 Bead: 15 + 0.00010491 -0.00003688 -0.00003681 + -0.00003688 0.00010491 -0.00003700 + -0.00003681 -0.00003700 0.00010465 + #*EXTRAS*# Step: 2 Bead: 15 + 0.00010805 -0.00004004 -0.00004004 + -0.00004004 0.00010805 -0.00004004 + -0.00004004 -0.00004004 0.00010808 + #*EXTRAS*# Step: 3 Bead: 15 + 0.00010985 -0.00004145 -0.00004152 + -0.00004145 0.00010987 -0.00004149 + -0.00004152 -0.00004149 0.00010992 + #*EXTRAS*# Step: 4 Bead: 15 + 0.00011109 -0.00004229 -0.00004237 + -0.00004229 0.00011110 -0.00004235 + -0.00004237 -0.00004235 0.00011117 + #*EXTRAS*# Step: 5 Bead: 15 + 0.00011198 -0.00004284 -0.00004288 + -0.00004284 0.00011195 -0.00004286 + -0.00004288 -0.00004286 0.00011204 + #*EXTRAS*# Step: 6 Bead: 15 + 0.00011264 -0.00004321 -0.00004321 + -0.00004321 0.00011255 -0.00004318 + -0.00004321 -0.00004318 0.00011269 + #*EXTRAS*# Step: 7 Bead: 15 + 0.00011315 -0.00004348 -0.00004343 + -0.00004348 0.00011300 -0.00004340 + -0.00004343 -0.00004340 0.00011320 + #*EXTRAS*# Step: 8 Bead: 15 + 0.00011356 -0.00004369 -0.00004359 + -0.00004369 0.00011336 -0.00004356 + -0.00004359 -0.00004356 0.00011360 + #*EXTRAS*# Step: 9 Bead: 15 + 0.00011390 -0.00004384 -0.00004372 + -0.00004384 0.00011367 -0.00004368 + -0.00004372 -0.00004368 0.00011394 + #*EXTRAS*# Step: 10 Bead: 15 + 0.00011419 -0.00004397 -0.00004381 + -0.00004397 0.00011392 -0.00004376 + -0.00004381 -0.00004376 0.00011422 + #*EXTRAS*# Step: 11 Bead: 15 + 0.00011443 -0.00004407 -0.00004389 + -0.00004407 0.00011414 -0.00004383 + -0.00004389 -0.00004383 0.00011447 + #*EXTRAS*# Step: 12 Bead: 15 + 0.00011465 -0.00004415 -0.00004395 + -0.00004415 0.00011433 -0.00004389 + -0.00004395 -0.00004389 0.00011468 + #*EXTRAS*# Step: 13 Bead: 15 + 0.00011484 -0.00004421 -0.00004400 + -0.00004421 0.00011451 -0.00004394 + -0.00004400 -0.00004394 0.00011487 + #*EXTRAS*# Step: 14 Bead: 15 + 0.00011501 -0.00004427 -0.00004404 + -0.00004427 0.00011466 -0.00004397 + -0.00004404 -0.00004397 0.00011503 + #*EXTRAS*# Step: 15 Bead: 15 + 0.00011516 -0.00004431 -0.00004407 + -0.00004431 0.00011480 -0.00004401 + -0.00004407 -0.00004401 0.00011518 + #*EXTRAS*# Step: 16 Bead: 15 + 0.00011529 -0.00004435 -0.00004410 + -0.00004435 0.00011492 -0.00004403 + -0.00004410 -0.00004403 0.00011532 + #*EXTRAS*# Step: 17 Bead: 15 + 0.00011541 -0.00004439 -0.00004413 + -0.00004439 0.00011503 -0.00004405 + -0.00004413 -0.00004405 0.00011544 + #*EXTRAS*# Step: 18 Bead: 15 + 0.00011552 -0.00004442 -0.00004415 + -0.00004442 0.00011514 -0.00004407 + -0.00004415 -0.00004407 0.00011555 + #*EXTRAS*# Step: 19 Bead: 15 + 0.00011562 -0.00004444 -0.00004417 + -0.00004444 0.00011523 -0.00004409 + -0.00004417 -0.00004409 0.00011565 + #*EXTRAS*# Step: 20 Bead: 15 + 0.00011572 -0.00004446 -0.00004419 + -0.00004446 0.00011532 -0.00004410 + -0.00004419 -0.00004410 0.00011574 + #*EXTRAS*# Step: 21 Bead: 15 + 0.00011580 -0.00004448 -0.00004420 + -0.00004448 0.00011540 -0.00004412 + -0.00004420 -0.00004412 0.00011582 + #*EXTRAS*# Step: 22 Bead: 15 + 0.00011588 -0.00004450 -0.00004422 + -0.00004450 0.00011547 -0.00004413 + -0.00004422 -0.00004413 0.00011590 + #*EXTRAS*# Step: 23 Bead: 15 + 0.00011595 -0.00004451 -0.00004423 + -0.00004451 0.00011553 -0.00004414 + -0.00004423 -0.00004414 0.00011596 + #*EXTRAS*# Step: 24 Bead: 15 + 0.00011601 -0.00004452 -0.00004424 + -0.00004452 0.00011560 -0.00004414 + -0.00004424 -0.00004414 0.00011603 + #*EXTRAS*# Step: 25 Bead: 15 + 0.00011607 -0.00004453 -0.00004425 + -0.00004453 0.00011565 -0.00004415 + -0.00004425 -0.00004415 0.00011609 + #*EXTRAS*# Step: 26 Bead: 15 + 0.00011612 -0.00004454 -0.00004425 + -0.00004454 0.00011570 -0.00004416 + -0.00004425 -0.00004416 0.00011614 + #*EXTRAS*# Step: 27 Bead: 15 + 0.00011617 -0.00004455 -0.00004426 + -0.00004455 0.00011575 -0.00004416 + -0.00004426 -0.00004416 0.00011619 + #*EXTRAS*# Step: 28 Bead: 15 + 0.00011622 -0.00004456 -0.00004427 + -0.00004456 0.00011580 -0.00004417 + -0.00004427 -0.00004417 0.00011623 + #*EXTRAS*# Step: 29 Bead: 15 + 0.00011626 -0.00004456 -0.00004427 + -0.00004456 0.00011584 -0.00004417 + -0.00004427 -0.00004417 0.00011627 + #*EXTRAS*# Step: 30 Bead: 15 + 0.00011630 -0.00004457 -0.00004428 + -0.00004457 0.00011587 -0.00004418 + -0.00004428 -0.00004418 0.00011631 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 new file mode 100644 index 000000000..b166fd78a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 @@ -0,0 +1 @@ +-1.920795128952092375e-03 9.590665278592439545e-05 9.531439153300798979e-05 -2.634788617689519212e-03 9.129668089011765911e-05 8.964512122550879765e-05 -4.126319266001262503e-03 8.160863461261790345e-05 7.822493453311501208e-05 -6.079001169949449154e-03 6.585541561690949868e-05 6.216889801991952631e-05 -8.000404735975946008e-03 4.310522452507650418e-05 4.237600186516288610e-05 -9.584780470576755723e-03 1.812953333510000339e-05 2.108092190617069121e-05 -1.075368533055318793e-02 7.344071389060295187e-06 6.594939908400681825e-06 -1.078859441166321424e-02 5.604808296137661117e-08 -3.993392363420405655e-09 -9.943430764024931492e-03 2.615170880645804813e-06 2.194626212395671035e-06 -8.695204200311565726e-03 1.108524985184118150e-05 1.120727783653646313e-05 -6.827238686291679098e-03 2.260531414067749534e-05 2.309346294132444600e-05 -4.773044701719947498e-03 3.529390401000342042e-05 3.537888819133866604e-05 -3.174149395806101243e-03 4.694183758039911135e-05 4.658032953214011893e-05 -2.081389829040176248e-03 5.625492716606427494e-05 5.549200126811749777e-05 -1.419204390668636412e-03 6.247154918095393264e-05 6.156020763871154972e-05 -1.135637492814115575e-03 6.547958516874539687e-05 6.456075897060048398e-05 1.062560859482537989e-14 5.511521611309602164e-01 4.150171587229554736e-11 1.112350482094941867e-14 5.511521611317115044e-01 4.197330568890809944e-11 1.206987391750340031e-14 5.511521611318793701e-01 4.172029054488204660e-11 1.240895302714524971e-14 5.511521611282655941e-01 3.797956451502651611e-11 1.063193592551308352e-14 5.511521611179805991e-01 2.810492807935979192e-11 9.569819725755972325e-15 5.511521611098890716e-01 2.042874392280736906e-11 1.343823193273284639e-14 5.511521611049013947e-01 1.547402174241131514e-11 -3.765268669254705800e-16 5.511521610906253699e-01 1.225620372218649413e-12 9.877296415510013850e-17 5.511521610901893853e-01 7.995781754624027154e-13 1.501470127241477755e-15 5.511521610962147877e-01 6.849008231039622387e-12 5.436815842161614387e-15 5.511521611097558448e-01 2.043271635798144969e-11 8.763975797947965353e-15 5.511521611190862702e-01 2.973631324774860340e-11 1.063947407519102756e-14 5.511521611233650697e-01 3.397391206704143417e-11 1.178032121783160465e-14 5.511521611256409159e-01 3.621891348477240141e-11 1.254106174610384359e-14 5.511521611270243648e-01 3.759624103496127279e-11 1.313654297394549623e-14 5.511521611280354449e-01 3.861178752087490844e-11 1.060807603363854453e-14 4.150171587229554736e-11 5.511521611308231039e-01 1.103196398392061619e-14 4.197330568890809944e-11 5.511521611310178370e-01 1.185138723408525581e-14 4.172029054488204660e-11 5.511521611303550339e-01 1.212295594879510255e-14 3.797956451502651611e-11 5.511521611264940113e-01 1.045127893449379574e-14 2.810492807935979192e-11 5.511521611170172585e-01 9.536943942472718422e-15 2.042874392280736906e-11 5.511521611097485174e-01 1.340573397068739869e-14 1.547402174241131514e-11 5.511521611048265656e-01 -3.735339321873972108e-16 1.225620372218649413e-12 5.511521610906058299e-01 9.878005533809378070e-17 7.995781754624027154e-13 5.511521610901894963e-01 1.506791463282965461e-15 6.849008231039622387e-12 5.511521610962631934e-01 5.454639987433230245e-15 2.043271635798144969e-11 5.511521611098896267e-01 8.775766510330244045e-15 2.973631324774860340e-11 5.511521611191662062e-01 1.063907013502761991e-14 3.397391206704143417e-11 5.511521611233626272e-01 1.176992860201736207e-14 3.621891348477240141e-11 5.511521611255768560e-01 1.252832768726508020e-14 3.759624103496127279e-11 5.511521611269479815e-01 1.312508883922968429e-14 3.861178752087490844e-11 5.511521611279680544e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 new file mode 100644 index 000000000..c1df96056 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 @@ -0,0 +1 @@ +-5.878234667419651206e-03 9.590665291788376672e-05 9.531439166374245655e-05 -6.316336480947132466e-03 9.129668101044936866e-05 8.964512134446801566e-05 -7.138177101058214638e-03 8.160863471345922225e-05 7.822493463253944127e-05 -8.146437443152283395e-03 6.585541569144349203e-05 6.216889809344431717e-05 -9.175761225479393129e-03 4.310522457467583977e-05 4.237600191442235820e-05 -1.014765275641482320e-02 1.812953337237509092e-05 2.108092194346294302e-05 -1.083623925364436864e-02 7.344071425888317034e-06 6.594939945222952318e-06 -1.086476269738883248e-02 5.604808220062536483e-08 -3.993393122613502624e-09 -1.033156319710173965e-02 2.615170880848178348e-06 2.194626212597770555e-06 -9.596527733139674499e-03 1.108524985483350835e-05 1.120727783953573565e-05 -8.661708292527747419e-03 2.260531415222009462e-05 2.309346295291298497e-05 -7.489349383555208607e-03 3.529390403463397301e-05 3.537888821602964257e-05 -6.271318137274248944e-03 4.694183761658495517e-05 4.658032956835164479e-05 -5.267969917379692127e-03 5.625492721079102302e-05 5.549200131282937195e-05 -4.597589830958836478e-03 6.247154923169445878e-05 6.156020768941403393e-05 -4.280114040669086815e-03 6.547958522329278724e-05 6.456075902510174155e-05 1.425849794914355324e-13 5.511521613776230177e-01 2.857203441093425379e-10 1.314552119721383729e-13 5.511521613577147205e-01 2.653362591896610668e-10 1.129111885611377354e-13 5.511521613190605295e-01 2.263437956595867285e-10 8.694295202737018394e-14 5.511521612624096234e-01 1.704406825861126794e-10 6.023126916251259573e-14 5.511521612025068739e-01 1.121380050341692723e-10 4.684490627592791190e-14 5.511521611645403551e-01 7.512503637196079451e-11 5.026625385076388949e-14 5.511521611327082626e-01 4.328524549211728400e-11 -1.137278114876552101e-15 5.511521610927805348e-01 3.376872857100559533e-12 3.011466225604095770e-16 5.511521610917597958e-01 2.367808099470678219e-12 4.493797547661399186e-15 5.511521611085491434e-01 1.921150663892255201e-11 1.697941462093610208e-14 5.511521611479777150e-01 5.880772147001799356e-11 3.339452528005196028e-14 5.511521611914508290e-01 1.022816692214290462e-10 4.682532073962808133e-14 5.511521612211023324e-01 1.317832370368432550e-10 5.650706966464156078e-14 5.511521612391474534e-01 1.496905321190999193e-10 6.328159324158610886e-14 5.511521612502244816e-01 1.607055186963784818e-10 6.768392903743545215e-14 5.511521612567807926e-01 1.672485049654924811e-10 1.413425423213085658e-13 2.857203441093425379e-10 5.511521613726217961e-01 1.299911810835016136e-13 2.653362591896610668e-10 5.511521613517713636e-01 1.112758189210462524e-13 2.263437956595867285e-10 5.511521613124558128e-01 8.564775191608676463e-14 1.704406825861126794e-10 5.511521612572933826e-01 5.971074980218513470e-14 1.121380050341692723e-10 5.511521612005599868e-01 4.682919527856788991e-14 7.512503637196079451e-11 5.511521611644898400e-01 5.022800450343286438e-14 4.328524549211728400e-11 5.511521611326422043e-01 -1.132727028801129931e-15 3.376872857100559533e-12 5.511521610927532233e-01 3.008795475484607635e-16 2.367808099470678219e-12 5.511521610917554659e-01 4.506064072257928718e-15 1.921150663892255201e-11 5.511521611086539485e-01 1.704317894314041225e-14 5.880772147001799356e-11 5.511521611484184735e-01 3.346674623874963064e-14 1.022816692214290462e-10 5.511521611918928087e-01 4.685059731440383668e-14 1.317832370368432550e-10 5.511521612212441079e-01 5.648180114438557780e-14 1.496905321190999193e-10 5.511521612390135605e-01 6.323080749326954813e-14 1.607055186963784818e-10 5.511521612499665768e-01 6.762634047947227161e-14 1.672485049654924811e-10 5.511521612564962425e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 new file mode 100644 index 000000000..45e23edce --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 @@ -0,0 +1 @@ +-1.089498324337528912e-02 9.590665262859725477e-05 9.531439137743751412e-05 -1.090556472677337886e-02 9.129668074321014854e-05 8.964512108052688434e-05 -1.092256768367123876e-02 8.160863448526857336e-05 7.822493440779498320e-05 -1.093841645996890787e-02 6.585541551783197353e-05 6.216889792244496696e-05 -1.094349106548633647e-02 4.310522445796937025e-05 4.237600179870859774e-05 -1.092790838046363115e-02 1.812953328997720303e-05 2.108092186106657980e-05 -1.088342048566535124e-02 7.344071357073237734e-06 6.594939876455097646e-06 -1.080509625404797724e-02 5.604808367501939223e-08 -3.993391648996949735e-09 -1.070349645523251646e-02 2.615170878166376746e-06 2.194626209911648662e-06 -1.059465319704106130e-02 1.108524983634064289e-05 1.120727782096892422e-05 -1.048389650602382303e-02 2.260531409867364987e-05 2.309346289911177980e-05 -1.037746499029680754e-02 3.529390393939177238e-05 3.537888812049794641e-05 -1.028196810517585137e-02 4.694183748823865375e-05 4.658032943983002111e-05 -1.020375054766087079e-02 5.625492705902178050e-05 5.549200116101443031e-05 -1.014825393533603029e-02 6.247154906410474823e-05 6.156020752184679346e-05 -1.011945609026396881e-02 6.547958504627850022e-05 6.456075884812999591e-05 -1.467015569053729281e-13 5.511521614428016580e-01 3.491989387590762357e-10 -1.357840135198280913e-13 5.511521614162173677e-01 3.223975838641986511e-10 -1.152794617719644683e-13 5.511521613662880847e-01 2.725337780856983264e-10 -8.666857973778789985e-14 5.511521612965346595e-01 2.039808002091185478e-10 -5.647520192802647233e-14 5.511521612229567380e-01 1.324417611282986718e-10 -3.555297908747020106e-14 5.511521611719515379e-01 8.259422290517060331e-11 -1.854882586689795798e-14 5.511521611309342372e-01 4.152459219515861904e-11 3.371159182792803756e-16 5.511521610887670786e-01 -6.303927291776383845e-13 -2.380655080724673673e-15 5.511521610962872852e-01 6.910701481135367100e-12 -1.399906964673314612e-14 5.511521611247016672e-01 3.546636990039157592e-11 -3.656703365123797346e-14 5.511521611782302932e-01 8.930337638859001465e-11 -6.184767194125330028e-14 5.511521612368396328e-01 1.479669161487481259e-10 -8.152097589044820116e-14 5.511521612815387661e-01 1.924999650920022913e-10 -9.526217329941720156e-14 5.511521613123380181e-01 2.231123960476801438e-10 -1.043081072186742681e-13 5.511521613324975588e-01 2.431707281679375739e-10 -1.093303436194019907e-13 5.511521613437185829e-01 2.543609786357348007e-10 -1.449623932075728941e-13 3.491989387590762357e-10 5.511521614344684350e-01 -1.339499551311400238e-13 3.223975838641986511e-10 5.511521614074491593e-01 -1.134686488310077857e-13 2.725337780856983264e-10 5.511521613576575440e-01 -8.535160796153819483e-14 2.039808002091185478e-10 5.511521612902867684e-01 -5.600301116768699694e-14 1.324417611282986718e-10 5.511521612207317400e-01 -3.556716100163097318e-14 8.259422290517060331e-11 5.511521611720188174e-01 -1.853984938432112545e-14 4.152459219515861904e-11 5.511521611308949353e-01 3.408895232762104760e-16 -6.303927291776383845e-13 5.511521610887520906e-01 -2.385242741119769499e-15 6.910701481135367100e-12 5.511521610963143747e-01 -1.406074865433789701e-14 3.546636990039157592e-11 5.511521611250148611e-01 -3.675802073198469904e-14 8.930337638859001465e-11 5.511521611791613262e-01 -6.206494639797734362e-14 1.479669161487481259e-10 5.511521612378783574e-01 -8.167103442182267945e-14 1.924999650920022913e-10 5.511521612822465332e-01 -9.533314651658851503e-14 2.231123960476801438e-10 5.511521613126720842e-01 -1.043364357705893010e-13 2.431707281679375739e-10 5.511521613326286761e-01 -1.093454012304564464e-13 2.543609786357348007e-10 5.511521613437873057e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 new file mode 100644 index 000000000..4e466d4ea --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 @@ -0,0 +1 @@ +-1.091901000604686249e-02 9.590665262549037857e-05 9.531439137436184940e-05 -1.092570096802708904e-02 9.129668074042202779e-05 8.964512107777017835e-05 -1.093577802860041387e-02 8.160863448305070230e-05 7.822493440560797124e-05 -1.094323378965814803e-02 6.585541551634253724e-05 6.216889792097695722e-05 -1.094046646480909511e-02 4.310522445718668470e-05 4.237600179793320345e-05 -1.091971704198727369e-02 1.812953328967685870e-05 2.108092186076514788e-05 -1.087459787604991984e-02 7.344071357093303945e-06 6.594939876474061020e-06 -1.080144242922339431e-02 5.604808381344291275e-08 -3.993391510540356051e-09 -1.070990901577809594e-02 2.615170878036389375e-06 2.194626209781911590e-06 -1.061266823472799443e-02 1.108524983581321750e-05 1.120727782044186813e-05 -1.051437223969751283e-02 2.260531409759358122e-05 2.309346289803124359e-05 -1.042040614327356327e-02 3.529390393773608725e-05 3.537888811884144135e-05 -1.033642951534872664e-02 4.694183748609095767e-05 4.658032943768262995e-05 -1.026784862235429786e-02 5.625492705648379874e-05 5.549200115847598098e-05 -1.021928632538044238e-02 6.247154906128509074e-05 6.156020751902731216e-05 -1.019411595408142683e-02 6.547958504330400511e-05 6.456075884515524331e-05 -1.498084319599595403e-13 5.511521614438842365e-01 3.502845303237780036e-10 -1.385721288344555810e-13 5.511521614171278616e-01 3.233098232036611216e-10 -1.174973305946947641e-13 5.511521613668892705e-01 2.731352882263446561e-10 -8.815802204940843115e-14 5.511521612967558159e-01 2.042018261029137638e-10 -5.725788644653787317e-14 5.511521612228161837e-01 1.323013303147408305e-10 -3.585332456353126421e-14 5.511521611715611835e-01 8.220451226359982181e-11 -1.852875962285178604e-14 5.511521611304838197e-01 4.107597816800457656e-11 4.755394364793937849e-16 5.511521610885042888e-01 -8.918827210950118876e-13 -2.510642576380772862e-15 5.511521610964887907e-01 7.110877485750889287e-12 -1.452649507479575738e-14 5.511521611254341924e-01 3.619483670409833440e-11 -3.764710231411338138e-14 5.511521611795574538e-01 9.062484591443908582e-11 -6.350335573986658715e-14 5.511521612387787483e-01 1.499001749878623118e-10 -8.366867116902902839e-14 5.511521612840540874e-01 1.950107484791475227e-10 -9.780015380776448765e-14 5.511521613153405053e-01 2.261124402826676694e-10 -1.071277652762179659e-13 5.511521613358519867e-01 2.465249296074799822e-10 -1.123048393904314499e-13 5.511521613472570857e-01 2.579007357868373858e-10 -1.480380575205051003e-13 3.502845303237780036e-10 5.511521614355571197e-01 -1.367066664862923706e-13 3.233098232036611216e-10 5.511521614083632059e-01 -1.156556670299705679e-13 2.731352882263446561e-10 5.511521613582593959e-01 -8.681961240966833907e-14 2.042018261029137638e-10 5.511521612905075918e-01 -5.677840524582161879e-14 1.323013303147408305e-10 5.511521612205915188e-01 -3.586859266931266751e-14 8.220451226359982181e-11 5.511521611716297953e-01 -1.852088622530398930e-14 4.107597816800457656e-11 5.511521611304481816e-01 4.793461173106711128e-16 -8.918827210950118876e-13 5.511521610884918543e-01 -2.514979766524124765e-15 7.110877485750889287e-12 5.511521610965132156e-01 -1.458780502993940601e-14 3.619483670409833440e-11 5.511521611257392816e-01 -3.783855658409795324e-14 9.062484591443908582e-11 5.511521611804771625e-01 -6.372145398711893222e-14 1.499001749878623118e-10 5.511521612398058156e-01 -8.381842837759980412e-14 1.950107484791475227e-10 5.511521612847527507e-01 -9.787159357721606314e-14 2.261124402826676694e-10 5.511521613156696864e-01 -1.071559197069954233e-13 2.465249296074799822e-10 5.511521613359826599e-01 -1.123201583373030940e-13 2.579007357868373858e-10 5.511521613473283621e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 new file mode 100644 index 000000000..e9b047c4f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 @@ -0,0 +1 @@ +-1.093338983622127100e-02 9.590665262309754438e-05 9.531439137199271858e-05 -1.093719879127762543e-02 9.129668073828541767e-05 8.964512107565878948e-05 -1.094217712034293785e-02 8.160863448137205918e-05 7.822493440395326188e-05 -1.094353624372023694e-02 6.585541551524356281e-05 6.216889791989442201e-05 -1.093524010738374311e-02 4.310522445664381790e-05 4.237600179739520878e-05 -1.091117298151564156e-02 1.812953328950501605e-05 2.108092186059327811e-05 -1.086637942615386113e-02 7.344071357158057919e-06 6.594939876538594766e-06 -1.079817234366960664e-02 5.604808393284456143e-08 -3.993391392054397958e-09 -1.071539084721495269e-02 2.615170877918089366e-06 2.194626209664146481e-06 -1.062808371693989458e-02 1.108524983535319899e-05 1.120727781998214608e-05 -1.054035072380763924e-02 2.260531409667248371e-05 2.309346289711015964e-05 -1.045687747113803294e-02 3.529390393634189134e-05 3.537888811744813991e-05 -1.038255008227815385e-02 4.694183748429688090e-05 4.658032943588938667e-05 -1.032201322504243922e-02 5.625492705437163060e-05 5.549200115636501225e-05 -1.027922638230203967e-02 6.247154905894459641e-05 6.156020751668776650e-05 -1.025707348795989321e-02 6.547958504083843450e-05 6.456075884269007927e-05 -1.522012653722832934e-13 5.511521614445510364e-01 3.509526363367546982e-10 -1.407087373280393455e-13 5.511521614176625450e-01 3.238451381377626364e-10 -1.191759685313506261e-13 5.511521613671884756e-01 2.734343945448833563e-10 -8.925700117604163801e-14 5.511521612967700268e-01 2.042160488126752639e-10 -5.780075190491951093e-14 5.511521612225674938e-01 1.320531208616083255e-10 -3.602516646094962588e-14 5.511521611711456270e-01 8.178994243860113466e-11 -1.846400550587996651e-14 5.511521611300582713e-01 4.065231683979148092e-11 5.949410846704888179e-16 5.511521610882723632e-01 -1.122622715083587438e-12 -2.628942473856882593e-15 5.511521610966685358e-01 7.289393834175156511e-12 -1.498651393419773942e-14 5.511521611260783438e-01 3.683532320167894443e-11 -3.856820136161201082e-14 5.511521611807154164e-01 9.177746225113141412e-11 -6.489755446190492395e-14 5.511521612404618464e-01 1.515771477674624077e-10 -8.546274740602043521e-14 5.511521612862295694e-01 1.971804987531264162e-10 -9.991232520626494226e-14 5.511521613179313217e-01 2.286986603376695480e-10 -1.094682644605662882e-13 5.511521613387425633e-01 2.494122941278013829e-10 -1.147704127231353635e-13 5.511521613503044259e-01 2.609458281094461376e-10 -1.504071853319159476e-13 3.509526363367546982e-10 5.511521614362264732e-01 -1.388180490379072780e-13 3.238451381377626364e-10 5.511521614088991106e-01 -1.173103818914146230e-13 2.734343945448833563e-10 5.511521613585583790e-01 -8.790214296453293559e-14 2.042160488126752639e-10 5.511521612905218026e-01 -5.731640031235658805e-14 1.320531208616083255e-10 5.511521612203438281e-01 -3.604046186059805672e-14 8.178994243860113466e-11 5.511521611712161262e-01 -1.845635255406387667e-14 4.065231683979148092e-11 5.511521611300264079e-01 5.978320756042892601e-16 -1.122622715083587438e-12 5.511521610882622602e-01 -2.632744979722890274e-15 7.289393834175156511e-12 5.511521610966905182e-01 -1.504752776728702984e-14 3.683532320167894443e-11 5.511521611263761056e-01 -3.875964088948581759e-14 9.177746225113141412e-11 5.511521611816244670e-01 -6.511475666565580299e-14 1.515771477674624077e-10 5.511521612414767013e-01 -8.561167498726068733e-14 1.971804987531264162e-10 5.511521612869167974e-01 -9.998256471973101665e-14 2.286986603376695480e-10 5.511521613182512880e-01 -1.094954664601630096e-13 2.494122941278013829e-10 5.511521613388667973e-01 -1.147853163782996418e-13 2.609458281094461376e-10 5.511521613503711503e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 new file mode 100644 index 000000000..9342e5165 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 @@ -0,0 +1 @@ +-1.094099109617489157e-02 9.590665262124845112e-05 9.531439137016361530e-05 -1.094265456604626673e-02 9.129668073664459966e-05 8.964512107403878815e-05 -1.094386590291126886e-02 8.160863448010119805e-05 7.822493440270195705e-05 -1.094079551860349317e-02 6.585541551443813613e-05 6.216889791910193799e-05 -1.092863712739638830e-02 4.310522445627779125e-05 4.237600179703326822e-05 -1.090256191465246126e-02 1.812953328942643849e-05 2.108092186051394501e-05 -1.085873012945542081e-02 7.344071357254306273e-06 6.594939876633470079e-06 -1.079523250971501681e-02 5.604808403578214617e-08 -3.993391289814489608e-09 -1.072013088396654712e-02 2.615170877809345159e-06 2.194626209555379404e-06 -1.064143178733134402e-02 1.108524983494712123e-05 1.120727781957731854e-05 -1.056276946772432071e-02 2.260531409587700457e-05 2.309346289631513790e-05 -1.048824767452061733e-02 3.529390393515477806e-05 3.537888811626118925e-05 -1.042211347197564628e-02 4.694183748277965516e-05 4.658032943437350262e-05 -1.036838448923052027e-02 5.625492705259241418e-05 5.549200115458854699e-05 -1.033047506694807251e-02 6.247154905697786722e-05 6.156020751472266361e-05 -1.031086735721710446e-02 6.547958503876836730e-05 6.456075884062216692e-05 -1.540503533496230681e-13 5.511521614449117479e-01 3.513136922459400135e-10 -1.423495532718905846e-13 5.511521614179220041e-01 3.241046903703147018e-10 -1.204468309693071292e-13 5.511521613672691888e-01 2.735149754124764076e-10 -9.006242931413376025e-14 5.511521612966383543e-01 2.040846598724315432e-10 -5.816677912850284046e-14 5.511521612222476385e-01 1.317340171692277690e-10 -3.610374524036282540e-14 5.511521611707204116e-01 8.136590545441546344e-11 -1.836775733833092000e-14 5.511521611296584799e-01 4.025430099768143012e-11 6.978786664261069412e-16 5.511521610880673050e-01 -1.326692178725889785e-12 -2.737686850057627369e-15 5.511521610968298512e-01 7.449639217390079030e-12 -1.539259186577017829e-14 5.511521611266489984e-01 3.740265825918086741e-11 -3.936368169128684078e-14 5.511521611817339350e-01 9.279096640620452579e-11 -6.608466472259043030e-14 5.511521612419348903e-01 1.530442015971205239e-10 -8.697997321064085385e-14 5.511521612881271626e-01 1.990719014761981554e-10 -1.016915396654547497e-13 5.511521613201861847e-01 2.309477929720546597e-10 -1.114349984909346416e-13 5.511521613412549980e-01 2.519197671027137782e-10 -1.168404796054463835e-13 5.511521613529515307e-01 2.635885405875070738e-10 -1.522362909025645793e-13 3.513136922459400135e-10 5.511521614365879618e-01 -1.404380464680562836e-13 3.241046903703147018e-10 5.511521614091586807e-01 -1.185616926713230032e-13 2.735149754124764076e-10 5.511521613586388701e-01 -8.869463295632733894e-14 2.040846598724315432e-10 5.511521612903906853e-01 -5.767834110682301474e-14 1.317340171692277690e-10 5.511521612200255271e-01 -3.611979504646544150e-14 8.136590545441546344e-11 5.511521611707932422e-01 -1.836147742297913242e-14 4.025430099768143012e-11 5.511521611296301693e-01 7.000719840134584325e-16 -1.326692178725889785e-12 5.511521610880592004e-01 -2.741511853715277215e-15 7.449639217390079030e-12 5.511521610968497242e-01 -1.545235524397748261e-14 3.740265825918086741e-11 5.511521611269400989e-01 -3.955466137840298842e-14 9.279096640620452579e-11 5.511521611826329936e-01 -6.630170721927827198e-14 1.530442015971205239e-10 5.511521612429377548e-01 -8.712756074674647490e-14 1.990719014761981554e-10 5.511521612888019561e-01 -1.017590304840314306e-13 2.309477929720546597e-10 5.511521613204947156e-01 -1.114605745718134475e-13 2.519197671027137782e-10 5.511521613413692400e-01 -1.168532267919588331e-13 2.635885405875070738e-10 5.511521613530093733e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 new file mode 100644 index 000000000..f1e7a7e10 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 @@ -0,0 +1 @@ +-1.094377114735101131e-02 9.590665261981392968e-05 9.531439136874532978e-05 -1.094383719621513755e-02 9.129668073538033861e-05 8.964512107279097987e-05 -1.094227035431528244e-02 8.160863447913919901e-05 7.822493440175546211e-05 -1.093600285605765381e-02 6.585541551385182670e-05 6.216889791852583361e-05 -1.092120356175853638e-02 4.310522445604181464e-05 4.237600179680028672e-05 -1.089406094550794679e-02 1.812953328941328577e-05 2.108092186049986055e-05 -1.085161203389047903e-02 7.344071357368036540e-06 6.594939876746536272e-06 -1.079257298000100077e-02 5.604808412499219219e-08 -3.993391201323078254e-09 -1.072426753035723990e-02 2.615170877708877734e-06 2.194626209455791623e-06 -1.065310070690216569e-02 1.108524983458760995e-05 1.120727781921799192e-05 -1.058230958718674522e-02 2.260531409518537507e-05 2.309346289562392852e-05 -1.051550800421923934e-02 3.529390393413482164e-05 3.537888811524218829e-05 -1.045640861103268836e-02 4.694183748148593769e-05 4.658032943308149278e-05 -1.040850665019359134e-02 5.625492705108205279e-05 5.549200115308017104e-05 -1.037476325422193382e-02 6.247154905531178729e-05 6.156020751305986340e-05 -1.035732692769641625e-02 6.547958503701788223e-05 6.456075883887387736e-05 -1.554848795515392041e-13 5.511521614450460849e-01 3.514481116773328771e-10 -1.436138150649267179e-13 5.511521614179792916e-01 3.241619357747401865e-10 -1.214088280049405348e-13 5.511521613671916953e-01 2.734375778260169036e-10 -9.064873589778962536e-14 5.511521612964044303e-01 2.038513729439911711e-10 -5.840275580132369440e-14 5.511521612218823751e-01 1.313698482978148480e-10 -3.611689638104230168e-14 5.511521611702957513e-01 8.094258325062681274e-11 -1.825402694656909905e-14 5.511521611292840017e-01 3.988161837932737289e-11 7.870887139059492923e-16 5.511521610878848954e-01 -1.508126665946266722e-12 -2.838154468842329428e-15 5.511521610969754015e-01 7.594223741952718552e-12 -1.575210346908771459e-14 5.511521611271575916e-01 3.790825802976108353e-11 -4.005531244888422726e-14 5.511521611826357692e-01 9.368811947566348543e-11 -6.710461932015001681e-14 5.511521612432331851e-01 1.543366935001283176e-10 -8.827368808063492969e-14 5.511521612897942735e-01 2.007326762681757623e-10 -1.032019042805244688e-13 5.511521613221629368e-01 2.329182250766984207e-10 -1.131010814554447100e-13 5.511521613434547939e-01 2.541135072396222330e-10 -1.185909664238089381e-13 5.511521613552677890e-01 2.658991067215359175e-10 -1.536545805444528035e-13 3.514481116773328771e-10 5.511521614367224098e-01 -1.416858580925189208e-13 3.241619357747401865e-10 5.511521614092158572e-01 -1.195081825358537495e-13 2.734375778260169036e-10 5.511521613585615986e-01 -8.927074261074080811e-14 2.038513729439911711e-10 5.511521612901579825e-01 -5.791132513576275744e-14 1.313698482978148480e-10 5.511521612196624842e-01 -3.613387843745887909e-14 8.094258325062681274e-11 5.511521611703712464e-01 -1.824841160879710856e-14 3.988161837932737289e-11 5.511521611292592437e-01 7.885633951180854948e-16 -1.508126665946266722e-12 5.511521610878786781e-01 -2.841099463084636705e-15 7.594223741952718552e-12 5.511521610969933871e-01 -1.581168210643426608e-14 3.790825802976108353e-11 5.511521611274426968e-01 -4.024586945637163845e-14 9.368811947566348543e-11 5.511521611835255019e-01 -6.732071125662656442e-14 1.543366935001283176e-10 5.511521612442243923e-01 -8.841957001253336405e-14 2.007326762681757623e-10 5.511521612904564105e-01 -1.032674052550901312e-13 2.329182250766984207e-10 5.511521613224588112e-01 -1.131233767516611150e-13 2.541135072396222330e-10 5.511521613435569344e-01 -1.186015180401600492e-13 2.658991067215359175e-10 5.511521613553141963e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 new file mode 100644 index 000000000..5177ecf67 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 @@ -0,0 +1 @@ +-1.094310242038760636e-02 9.590665261869931563e-05 9.531439136764392945e-05 -1.094198486613785250e-02 9.129668073440668440e-05 8.964512107183125766e-05 -1.093838462419274501e-02 8.160863447841347474e-05 7.822493440104217905e-05 -1.092984362858553243e-02 6.585541551343248440e-05 6.216889791811460928e-05 -1.091330966313199848e-02 4.310522445590235914e-05 4.237600179666267436e-05 -1.088578104218074390e-02 1.812953328944622180e-05 2.108092186053258651e-05 -1.084498819490786921e-02 7.344071357492404694e-06 6.594939876870148025e-06 -1.079015522579358094e-02 5.604808420210071819e-08 -3.993391124724866438e-09 -1.072790518099790702e-02 2.615170877616709114e-06 2.194626209363156288e-06 -1.066338179595489703e-02 1.108524983426640490e-05 1.120727781889751192e-05 -1.059947991989336306e-02 2.260531409458055289e-05 2.309346289501959423e-05 -1.053939667654083152e-02 3.529390393325222008e-05 3.537888811436159251e-05 -1.048639331705779852e-02 4.694183748037444751e-05 4.658032943197187961e-05 -1.044352558184303940e-02 5.625492704979012426e-05 5.549200115179080394e-05 -1.041337417086176352e-02 6.247154905389117074e-05 6.156020751164136104e-05 -1.039780787463031632e-02 6.547958503552635885e-05 6.456075883738507804e-05 -1.565994983235329469e-13 5.511521614450132223e-01 3.514153061505900702e-10 -1.445874644155010612e-13 5.511521614178882533e-01 3.240710022816425346e-10 -1.221345460291461083e-13 5.511521613670001818e-01 2.732465642940652608e-10 -9.106807477578230137e-14 5.511521612961000072e-01 2.035478886973174761e-10 -5.854221146943116511e-14 5.511521612214901333e-01 1.309789626178793912e-10 -3.608395952683663110e-14 5.511521611698784184e-01 8.052675947415263402e-11 -1.812965839994103021e-14 5.511521611289341704e-01 3.953345450608363422e-11 8.641972401928370728e-16 5.511521610877220256e-01 -1.670163754622268873e-12 -2.930323228319251838e-15 5.511521610971072960e-01 7.725232611359872975e-12 -1.607330898074460132e-14 5.511521611276132271e-01 3.836112901045018906e-11 -4.066013476463407328e-14 5.511521611834386825e-01 9.448673684705775403e-11 -6.798721893569504855e-14 5.511521612443841533e-01 1.554821731314830691e-10 -8.938517545872516836e-14 5.511521612912677615e-01 2.021999186344617485e-10 -1.044938356628464866e-13 5.511521613239065420e-01 2.346552986159662022e-10 -1.145216992239209110e-13 5.511521613453926882e-01 2.560448763393084783e-10 -1.200824837885183682e-13 5.511521613573070466e-01 2.679320501182533849e-10 -1.547559797728247006e-13 3.514153061505900702e-10 5.511521614366896582e-01 -1.426455844147302953e-13 3.240710022816425346e-10 5.511521614091250409e-01 -1.202214657771812697e-13 2.732465642940652608e-10 5.511521613583710844e-01 -8.968196962893110274e-14 2.035478886973174761e-10 5.511521612898554467e-01 -5.804893599102793000e-14 1.309789626178793912e-10 5.511521612192729069e-01 -3.610115372243744080e-14 8.052675947415263402e-11 5.511521611699569112e-01 -1.812479990006975405e-14 3.953345450608363422e-11 5.511521611289127431e-01 8.651616072687769281e-16 -1.670163754622268873e-12 5.511521610877174737e-01 -2.933734948978268482e-15 7.725232611359872975e-12 5.511521610971235052e-01 -1.613216265680684739e-14 3.836112901045018906e-11 5.511521611278928923e-01 -4.085020221840889500e-14 9.448673684705775403e-11 5.511521611843198665e-01 -6.820130806256200272e-14 1.554821731314830691e-10 5.511521612453643693e-01 -8.952918233508994379e-14 2.021999186344617485e-10 5.511521612919174640e-01 -1.045567737187638661e-13 2.346552986159662022e-10 5.511521613241893158e-01 -1.145418778692298207e-13 2.560448763393084783e-10 5.511521613454818391e-01 -1.200903208322631125e-13 2.679320501182533849e-10 5.511521613573407974e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 new file mode 100644 index 000000000..05e88edb4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 @@ -0,0 +1 @@ +-1.093996894327028957e-02 9.590665261783557242e-05 9.531439136679123155e-05 -1.093798371348113363e-02 9.129668073365949292e-05 8.964512107109498952e-05 -1.093291708450144090e-02 8.160863447787096707e-05 7.822493440050987644e-05 -1.092280172032512528e-02 6.585541551313911285e-05 6.216889791782770228e-05 -1.090521103700463172e-02 4.310522445583447453e-05 4.237600179659636185e-05 -1.087779138668330120e-02 1.812953328951247332e-05 2.108092186059766575e-05 -1.083882393617841694e-02 7.344071357621467951e-06 6.594939876998668334e-06 -1.078794882596150612e-02 5.604808426909911188e-08 -3.993391057752020225e-09 -1.073112425349973496e-02 2.615170877530457867e-06 2.194626209277573773e-06 -1.067249864839077585e-02 1.108524983397865764e-05 1.120727781861049311e-05 -1.061466952011998546e-02 2.260531409404672900e-05 2.309346289448661061e-05 -1.056047651209296619e-02 3.529390393248425258e-05 3.537888811359434329e-05 -1.051279635240090667e-02 4.694183747941350557e-05 4.658032943101336358e-05 -1.047431193363406766e-02 5.625492704867847822e-05 5.549200115068154314e-05 -1.044728200483079593e-02 6.247154905267067080e-05 6.156020751042407305e-05 -1.043333897309760977e-02 6.547958503424720358e-05 6.456075883610939222e-05 -1.574632402930721154e-13 5.511521614448574580e-01 3.512597530592398224e-10 -1.453346594888014897e-13 5.511521614176891903e-01 3.238723038289457967e-10 -1.226770536697947916e-13 5.511521613667277331e-01 2.729748636726122584e-10 -9.136144378643062084e-14 5.511521612957482885e-01 2.031974805559949799e-10 -5.861009408318368903e-14 5.511521612210841248e-01 1.305745223877567651e-10 -3.601770734692193275e-14 5.511521611694730760e-01 8.012292564205275006e-11 -1.800059504849744793e-14 5.511521611286077649e-01 3.920872537155955352e-11 9.311956347085052676e-16 5.511521610875759203e-01 -1.815443932585212927e-12 -3.016574590202426825e-15 5.511521610972272001e-01 7.844347601860824800e-12 -1.636105551021592708e-14 5.511521611280230104e-01 3.876847851762972903e-11 -4.119395953763922588e-14 5.511521611841568857e-01 9.520097869670244871e-11 -6.875518695057700981e-14 5.511521612454096664e-01 1.565024465534335438e-10 -9.034611775594595515e-14 5.511521612925768254e-01 2.035029223539553034e-10 -1.056054808615142471e-13 5.511521613254525276e-01 2.361947794112405835e-10 -1.157422038798274557e-13 5.511521613471088710e-01 2.577543712084096916e-10 -1.213616358508509730e-13 5.511521613591119362e-01 2.697303557530767974e-10 -1.556086758553690465e-13 3.512597530592398224e-10 5.511521614365343380e-01 -1.433818463273497595e-13 3.238723038289457967e-10 5.511521614089267551e-01 -1.207537749967918717e-13 2.729748636726122584e-10 5.511521613581001899e-01 -8.996887190257600179e-14 2.031974805559949799e-10 5.511521612895062816e-01 -5.811524764372641469e-14 1.305745223877567651e-10 5.511521612188700070e-01 -3.603607492200160848e-14 8.012292564205275006e-11 5.511521611695545664e-01 -1.799627932804132932e-14 3.920872537155955352e-11 5.511521611285896682e-01 9.321344532406331142e-16 -1.815443932585212927e-12 5.511521610875729227e-01 -3.019317416577113988e-15 7.844347601860824800e-12 5.511521610972418550e-01 -1.641918148595236261e-14 3.876847851762972903e-11 5.511521611282977906e-01 -4.138318508166129408e-14 9.520097869670244871e-11 5.511521611850301872e-01 -6.896855778550946715e-14 1.565024465534335438e-10 5.511521612463794462e-01 -9.048769919848012265e-14 2.035029223539553034e-10 5.511521612932144265e-01 -1.056660332964738268e-13 2.361947794112405835e-10 5.511521613257223118e-01 -1.157591640188596347e-13 2.577543712084096916e-10 5.511521613471846992e-01 -1.213659999081631662e-13 2.697303557530767974e-10 5.511521613591324753e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 new file mode 100644 index 000000000..5406906a1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 @@ -0,0 +1 @@ +-1.093508910251102945e-02 9.590665261716866611e-05 9.531439136613314793e-05 -1.093247933806439261e-02 9.129668073308971757e-05 8.964512107053388779e-05 -1.092638129572676489e-02 8.160863447747030016e-05 7.822493440011736815e-05 -1.091522428994995582e-02 6.585541551294371251e-05 6.216889791763738414e-05 -1.089708627626557493e-02 4.310522445581945155e-05 4.237600179658266702e-05 -1.087013403536022174e-02 1.812953328960108991e-05 2.108092186068515747e-05 -1.083308726115018300e-02 7.344071357751916954e-06 6.594939877128449029e-06 -1.078592927811228286e-02 5.604808432769764526e-08 -3.993390999758369281e-09 -1.073398795316468819e-02 2.615170877450809665e-06 2.194626209197856962e-06 -1.068062643088632871e-02 1.108524983371998902e-05 1.120727781835272913e-05 -1.062818207112251404e-02 2.260531409357605651e-05 2.309346289401618884e-05 -1.057918561236426483e-02 3.529390393181195914e-05 3.537888811292351352e-05 -1.053618385971802351e-02 4.694183747857812779e-05 4.658032943018016099e-05 -1.050154115795129232e-02 5.625492704771601162e-05 5.549200114972159732e-05 -1.047724190053088249e-02 6.247154905161838483e-05 6.156020750937413167e-05 -1.046471736183681757e-02 6.547958503314480036e-05 6.456075883500967240e-05 -1.581301410339462850e-13 5.511521614446123207e-01 3.510151120579448960e-10 -1.459044407414612677e-13 5.511521614174125228e-01 3.235963408797620862e-10 -1.230777146630655725e-13 5.511521613663988850e-01 2.726471747034959343e-10 -9.155684311477451318e-14 5.511521612953665938e-01 2.028173988015552690e-10 -5.862511718603961738e-14 5.511521612206738974e-01 1.301660299744394184e-10 -3.592909200193865789e-14 5.511521611690826106e-01 7.973400727293638419e-11 -1.787014577152262566e-14 5.511521611283036748e-01 3.890622584144399467e-11 9.897941676970027226e-16 5.511521610874444699e-01 -1.946136993412545153e-12 -3.096222696638326402e-15 5.511521610973365570e-01 7.952950819270403055e-12 -1.661972451926460353e-14 5.511521611283929367e-01 3.913616900992654728e-11 -4.166463275544941627e-14 5.511521611848018143e-01 9.584228204242503477e-11 -6.942747908884494197e-14 5.511521612463271547e-01 1.574150498389597316e-10 -9.118149708619586303e-14 5.511521612937447800e-01 2.046651856363983143e-10 -1.065679469748961656e-13 5.511521613268294262e-01 2.375653192381056252e-10 -1.167944888381943224e-13 5.511521613486355387e-01 2.592744141282000205e-10 -1.224640393270257353e-13 5.511521613607166525e-01 2.713284308473332333e-10 -1.562667560549379425e-13 3.510151120579448960e-10 5.511521614362902000e-01 -1.439429423526016683e-13 3.235963408797620862e-10 5.511521614086514198e-01 -1.211462767595711009e-13 2.726471747034959343e-10 5.511521613577735623e-01 -9.015918935457735607e-14 2.028173988015552690e-10 5.511521612891278066e-01 -5.812894072851993968e-14 1.301660299744394184e-10 5.511521612184632213e-01 -3.594858381845933590e-14 7.973400727293638419e-11 5.511521611691672096e-01 -1.786649832639765230e-14 3.890622584144399467e-11 5.511521611282886868e-01 9.901281041454580666e-16 -1.946136993412545153e-12 5.511521610874429156e-01 -3.099034416258516527e-15 7.952950819270403055e-12 5.511521610973497687e-01 -1.667694555053302440e-14 3.913616900992654728e-11 5.511521611286632760e-01 -4.185360533535158087e-14 9.584228204242503477e-11 5.511521611856678993e-01 -6.963938509658389845e-14 1.574150498389597316e-10 5.511521612472872755e-01 -9.132089899758788256e-14 2.046651856363983143e-10 5.511521612943709458e-01 -1.066259802729709025e-13 2.375653192381056252e-10 5.511521613270865538e-01 -1.168091020571043729e-13 2.592744141282000205e-10 5.511521613486981552e-01 -1.224657237659422882e-13 2.713284308473332333e-10 5.511521613607239800e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 new file mode 100644 index 000000000..321c87df0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 @@ -0,0 +1 @@ +-1.092899488606968554e-02 9.590665261665742413e-05 9.531439136562904813e-05 -1.092594871567176273e-02 9.129668073265956036e-05 8.964512107011117091e-05 -1.091915454943928956e-02 8.160863447718088594e-05 7.822493439983431007e-05 -1.090736327784146489e-02 6.585541551282343383e-05 6.216889791752030386e-05 -1.088906086701060122e-02 4.310522445584519458e-05 4.237600179660785439e-05 -1.086283297460423174e-02 1.812953328970364866e-05 2.108092186078768573e-05 -1.082774879019794342e-02 7.344071357881081855e-06 6.594939877256822801e-06 -1.078407645118310137e-02 5.604808437937109535e-08 -3.993390948173530916e-09 -1.073654680775290582e-02 2.615170877376740868e-06 2.194626209124204059e-06 -1.068790483854981967e-02 1.108524983348633837e-05 1.120727781811934614e-05 -1.064025893791839712e-02 2.260531409315648382e-05 2.309346289359771051e-05 -1.059587124486814982e-02 3.529390393122075047e-05 3.537888811233384307e-05 -1.055700372467344855e-02 4.694183747784933387e-05 4.658032942945300014e-05 -1.052574690024242476e-02 5.625492704687932603e-05 5.549200114888789328e-05 -1.050384996561076062e-02 6.247154905070456503e-05 6.156020750846405236e-05 -1.049257204645416379e-02 6.547958503219064824e-05 6.456075883405846118e-05 -1.586413895204933683e-13 5.511521614443035677e-01 3.507070751720880194e-10 -1.463345943566971901e-13 5.511521614170815653e-01 3.232663256556837670e-10 -1.233671232630855184e-13 5.511521613660325114e-01 2.722821684096517634e-10 -9.167712838022516919e-14 5.511521612949679128e-01 2.024205106944196051e-10 -5.859937099342327660e-14 5.511521612202664455e-01 1.297603555757924670e-10 -3.582653422004574726e-14 5.511521611687089095e-01 7.936183816902555553e-11 -1.774098120873289097e-14 5.511521611280206789e-01 3.862470871344679563e-11 1.041467617493438428e-15 5.511521610873258981e-01 -2.064046929005242571e-12 -3.170291570425776040e-15 5.511521610974364771e-01 8.052193402209305901e-12 -1.685337540677426431e-14 5.511521611287278910e-01 3.946903428539928835e-11 -4.208420591229167633e-14 5.511521611853829050e-01 9.642001244381040199e-11 -7.001868978994256961e-14 5.511521612471508291e-01 1.582342806631896729e-10 -9.191029146336774596e-14 5.511521612947908322e-01 2.057058171695312242e-10 -1.074046340336586380e-13 5.511521613280603304e-01 2.387901837358993893e-10 -1.177083140832525918e-13 5.511521613499987815e-01 2.606313135688219000e-10 -1.234181972025838308e-13 5.511521613621488402e-01 2.727541868244603656e-10 -1.567708535032725721e-13 3.507070751720880194e-10 5.511521614359828902e-01 -1.443656598689460644e-13 3.232663256556837670e-10 5.511521614083223497e-01 -1.214293291096900178e-13 2.722821684096517634e-10 5.511521613574099643e-01 -9.027627450686161936e-14 2.024205106944196051e-10 5.511521612887326782e-01 -5.810375510398947371e-14 1.297603555757924670e-10 5.511521612180593221e-01 -3.584605691667147705e-14 7.936183816902555553e-11 5.511521611687966171e-01 -1.773812435052166780e-14 3.862470871344679563e-11 5.511521611280086885e-01 1.041712942658686060e-15 -2.064046929005242571e-12 5.511521610873256760e-01 -3.172687456888010340e-15 8.052193402209305901e-12 5.511521610974483565e-01 -1.691032847941060561e-14 3.946903428539928835e-11 5.511521611289941225e-01 -4.227208304622542819e-14 9.642001244381040199e-11 5.511521611862423287e-01 -7.022905242130190874e-14 1.582342806631896729e-10 5.511521612481020682e-01 -9.204806000290850362e-14 2.057058171695312242e-10 5.511521612954062288e-01 -1.074596871329026941e-13 2.387901837358993893e-10 5.511521613283054677e-01 -1.177191784874346151e-13 2.606313135688219000e-10 5.511521613500487415e-01 -1.234169348892719956e-13 2.727541868244603656e-10 5.511521613621432891e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 new file mode 100644 index 000000000..c2acb1896 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 @@ -0,0 +1 @@ +-1.092208452489277191e-02 9.590665261626951015e-05 9.531439136524725989e-05 -1.091874793154559188e-02 9.129668073233969362e-05 8.964512106979764675e-05 -1.091151665324902736e-02 8.160863447697899395e-05 7.822493439963745961e-05 -1.089940280383444766e-02 6.585541551275961498e-05 6.216889791746015774e-05 -1.088122284423898717e-02 4.310522445589814430e-05 4.237600179666205772e-05 -1.085589990721899135e-02 1.812953328981642602e-05 2.108092186089949069e-05 -1.082278154853561977e-02 7.344071358007541333e-06 6.594939877382418305e-06 -1.078237351692204644e-02 5.604808442444457721e-08 -3.993390903411653784e-09 -1.073884183380559125e-02 2.615170877307631450e-06 2.194626209055292846e-06 -1.069444706624502785e-02 1.108524983327591845e-05 1.120727781790913120e-05 -1.065109506422311225e-02 2.260531409278287453e-05 2.309346289322453152e-05 -1.061081314972881634e-02 3.529390393069933732e-05 3.537888811181336504e-05 -1.057561603786664681e-02 4.694183747720972913e-05 4.658032942881586873e-05 -1.054735762032614661e-02 5.625492704614870252e-05 5.549200114815975665e-05 -1.052758440458246778e-02 6.247154904990999391e-05 6.156020750767154123e-05 -1.051740741675309503e-02 6.547958503136029845e-05 6.456075883323137755e-05 -1.590293083370207186e-13 5.511521614439508499e-01 3.503553758089887313e-10 -1.466544662889621501e-13 5.511521614167140815e-01 3.229000293736930863e-10 -1.235690118580501965e-13 5.511521613656427121e-01 2.718940323655569414e-10 -9.174095049009480828e-14 5.511521612945619042e-01 2.020164441362571517e-10 -5.854641852381591106e-14 5.511521612198666542e-01 1.293624474027657984e-10 -3.571375623726932231e-14 5.511521611683529720e-01 7.900748163880835522e-11 -1.761452151954441413e-14 5.511521611277574451e-01 3.836293144941190813e-11 1.086541097637579808e-15 5.511521610872186505e-01 -2.170687801565946457e-12 -3.239401042850968507e-15 5.511521610975279595e-01 8.143047496732594871e-12 -1.706379557486487850e-14 5.511521611290318701e-01 3.977111158880362318e-11 -4.245781667146521124e-14 5.511521611859079295e-01 9.694193788607531993e-11 -7.054010273688953926e-14 5.511521612478926802e-01 1.589719453329112191e-10 -9.254989423194003855e-14 5.511521612957306360e-01 2.066405527057509433e-10 -1.081352571355171867e-13 5.511521613291643362e-01 2.398885013594232810e-10 -1.185028795097548920e-13 5.511521613512202489e-01 2.618466817760135166e-10 -1.242485410565685764e-13 5.511521613634313699e-01 2.740305449425874428e-10 -1.571526356979987230e-13 3.503553758089887313e-10 5.511521614356321708e-01 -1.446791836720431990e-13 3.229000293736930863e-10 5.511521614079573084e-01 -1.216261773340478412e-13 2.718940323655569414e-10 5.511521613570234956e-01 -9.033642406360229231e-14 2.020164441362571517e-10 5.511521612883305554e-01 -5.804955354079776331e-14 1.293624474027657984e-10 5.511521612176633056e-01 -3.573425220555343642e-14 7.900748163880835522e-11 5.511521611684437882e-01 -1.761252856638167895e-14 3.836293144941190813e-11 5.511521611277483412e-01 1.086474819963315997e-15 -2.170687801565946457e-12 5.511521610872196497e-01 -3.241598734580086469e-15 8.143047496732594871e-12 5.511521610975386176e-01 -1.712054355485748564e-14 3.977111158880362318e-11 5.511521611292943268e-01 -4.264526088837127962e-14 9.694193788607531993e-11 5.511521611867612469e-01 -7.074952798810357173e-14 1.589719453329112191e-10 5.511521612488355926e-01 -9.268519396091591930e-14 2.066405527057509433e-10 5.511521612963359296e-01 -1.081878226012312525e-13 2.398885013594232810e-10 5.511521613293981492e-01 -1.185116961598046800e-13 2.618466817760135166e-10 5.511521613512581075e-01 -1.242440193711708430e-13 2.740305449425874428e-10 5.511521613634134953e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 new file mode 100644 index 000000000..618ed8966 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 @@ -0,0 +1 @@ +-8.211277439097993541e-03 9.590665282295331487e-05 9.531439156956755809e-05 -8.438399618710804018e-03 9.129668091828660036e-05 8.964512125330587110e-05 -8.855057842807533344e-03 8.160863462622363783e-05 7.822493454657866176e-05 -9.403856018757907054e-03 6.585541561619724562e-05 6.216889801932867679e-05 -1.000813382349499160e-02 4.310522451702817329e-05 4.237600185727366867e-05 -1.057171288556930759e-02 1.812953332439839262e-05 2.108092189550233157e-05 -1.090539116140276307e-02 7.344071373629329322e-06 6.594939893003735344e-06 -1.088163610573746401e-02 5.604808315100294248e-08 -3.993392176048664292e-09 -1.053200695647494266e-02 2.615170880120984469e-06 2.194626211868411660e-06 -1.006519486388061414e-02 1.108524984793031519e-05 1.120727783260670290e-05 -9.525374228500284313e-03 2.260531412878916092e-05 2.309346292938895218e-05 -8.933703740708625815e-03 3.529390399165743217e-05 3.537888817296283513e-05 -8.287183521648741613e-03 4.694183755970978951e-05 4.658032951145211169e-05 -7.682671601552028967e-03 5.625492714532271489e-05 5.549200124739548046e-05 -7.219726302428351554e-03 6.247154916083513831e-05 6.156020761861460207e-05 -6.970854563418589847e-03 6.547958514888369398e-05 6.456075895075787661e-05 4.765452386086405555e-14 5.511521613927503616e-01 3.002531606587599567e-10 3.929244488274652717e-14 5.511521613686460874e-01 2.759603502362768052e-10 2.567560239902810493e-14 5.511521613242370554e-01 2.315472556548936152e-10 1.169670586493828175e-14 5.511521612637271250e-01 1.718742385918807902e-10 2.583599464164925762e-15 5.511521612025853667e-01 1.122448983017548171e-10 -1.131790842415280720e-15 5.511521611645697760e-01 7.514880224019233791e-11 -1.992733965811594709e-15 5.511521611327452330e-01 4.332179357443122707e-11 -1.869005339928035399e-16 5.511521610927939685e-01 3.389650496447597014e-12 -4.260471117443892053e-16 5.511521610926103376e-01 3.239339324367628320e-12 -2.409394859443054934e-15 5.511521611100669293e-01 2.079268826405982407e-11 -6.451520656871410231e-15 5.511521611503297224e-01 6.121625195303666981e-11 -9.582017489585119025e-15 5.511521611944709687e-01 1.052785096893976639e-10 -1.004984381250041783e-14 5.511521612239963508e-01 1.345921832624437780e-10 -8.961236649085139330e-15 5.511521612413378124e-01 1.517914022944668065e-10 -7.577720480204281361e-15 5.511521612517199520e-01 1.621349387390427418e-10 -6.725157862666915667e-15 5.511521612579017848e-01 1.683205557756817021e-10 4.716764765942923074e-14 3.002531606587599567e-10 5.511521613865835167e-01 3.882903232998273277e-14 2.759603502362768052e-10 5.511521613620968818e-01 2.531503697522069588e-14 2.315472556548936152e-10 5.511521613176864065e-01 1.153211014980404332e-14 1.718742385918807902e-10 5.511521612588532459e-01 2.562063094898254987e-15 1.122448983017548171e-10 5.511521612007055371e-01 -1.131414887003981900e-15 7.514880224019233791e-11 5.511521611645090468e-01 -1.991212321060647787e-15 4.332179357443122707e-11 5.511521611326782866e-01 -1.861621907249851139e-16 3.389650496447597014e-12 5.511521610927654358e-01 -4.284795241110781036e-16 3.239339324367628320e-12 5.511521610926485293e-01 -2.422969169215416454e-15 2.079268826405982407e-11 5.511521611103011864e-01 -6.480853552892015097e-15 6.121625195303666981e-11 5.511521611508848340e-01 -9.600058394959141279e-15 1.052785096893976639e-10 5.511521611948665411e-01 -1.004893865717874053e-14 1.345921832624437780e-10 5.511521612239704826e-01 -8.952093699533600988e-15 1.517914022944668065e-10 5.511521612410286153e-01 -7.568624405559267973e-15 1.621349387390427418e-10 5.511521612513328172e-01 -6.717527394217957806e-15 1.683205557756817021e-10 5.511521612575215334e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 new file mode 100644 index 000000000..ba259becd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 @@ -0,0 +1 @@ +-1.091465837705730274e-02 9.590665261598004172e-05 9.531439136496328024e-05 -1.091114469345994334e-02 9.129668073210763369e-05 8.964512106957016758e-05 -1.090367630122524543e-02 8.160863447684476972e-05 7.822493439950772127e-05 -1.089147772922693935e-02 6.585541551274110223e-05 6.216889791744244459e-05 -1.087363331644119503e-02 4.310522445597332695e-05 4.237600179673645432e-05 -1.084933804428116037e-02 1.812953328993438382e-05 2.108092186101693689e-05 -1.081816070345330283e-02 7.344071358128755136e-06 6.594939877503374610e-06 -1.078080618336883442e-02 5.604808446448615397e-08 -3.993390863954471857e-09 -1.074090677973905256e-02 2.615170877243267958e-06 2.194626208991426985e-06 -1.070034614258284084e-02 1.108524983308378597e-05 1.120727781771794908e-05 -1.066085016644074610e-02 2.260531409244863533e-05 2.309346289289131214e-05 -1.062423992047939122e-02 3.529390393023800252e-05 3.537888811135258589e-05 -1.059231447760891447e-02 4.694183747664736024e-05 4.658032942825480089e-05 -1.056672227758857080e-02 5.625492704550891481e-05 5.549200114752226611e-05 -1.054883435449781304e-02 6.247154904921548111e-05 6.156020750697956275e-05 -1.053963374648837770e-02 6.547958503063695942e-05 6.456075883251001719e-05 -1.593187709731387152e-13 5.511521614435694882e-01 3.499752298149528361e-10 -1.468865213666251956e-13 5.511521614163237270e-01 3.225111050073071756e-10 -1.237032296979054811e-13 5.511521613652404783e-01 2.714935726957507427e-10 -9.175946094412912923e-14 5.511521612941557846e-01 2.016123991888795691e-10 -5.847123290505383858e-14 5.511521612194781872e-01 1.289758306988389007e-10 -3.559579904556660651e-14 5.511521611680153532e-01 7.867145086293159933e-11 -1.749330745845902405e-14 5.511521611275128629e-01 3.811968179938965423e-11 1.126582675133258297e-15 5.511521610871215060e-01 -2.267342343071216973e-12 -3.303764568436111488e-15 5.511521610976117813e-01 8.226344035537594949e-12 -1.725592848134330215e-14 5.511521611293083156e-01 4.004581174087296100e-11 -4.279205682680005554e-14 5.511521611863833270e-01 9.741457542663256704e-11 -7.100143617080369048e-14 5.511521612485624777e-01 1.596379044718764597e-10 -9.311226248432510667e-14 5.511521612965772920e-01 2.074824973638871986e-10 -1.087750463198623345e-13 5.511521613301573197e-01 2.408761755756689754e-10 -1.191973984415588847e-13 5.511521613523178154e-01 2.629384705986432054e-10 -1.249718849068816009e-13 5.511521613645832263e-01 2.751765368344882270e-10 -1.574366111469788414e-13 3.499752298149528361e-10 5.511521614352532517e-01 -1.449066572550042230e-13 3.225111050073071756e-10 5.511521614075698405e-01 -1.217559222375649873e-13 2.714935726957507427e-10 5.511521613566248146e-01 -9.035414360110787616e-14 2.016123991888795691e-10 5.511521612879285437e-01 -5.797515825819150824e-14 1.289758306988389007e-10 5.511521612172786133e-01 -3.561680519677833456e-14 7.867145086293159933e-11 5.511521611681092780e-01 -1.749157227634237457e-14 3.811968179938965423e-11 5.511521611275064236e-01 1.125932001663184211e-15 -2.267342343071216973e-12 5.511521610871235044e-01 -3.305464384538687823e-15 8.226344035537594949e-12 5.511521610976213292e-01 -1.731172515275667864e-14 4.004581174087296100e-11 5.511521611295673306e-01 -4.297848052239123865e-14 9.741457542663256704e-11 5.511521611872310933e-01 -7.121030641307617287e-14 1.596379044718764597e-10 5.511521612494977296e-01 -9.324626171177993486e-14 2.074824973638871986e-10 5.511521612971732598e-01 -1.088253160778243841e-13 2.408761755756689754e-10 5.511521613303804745e-01 -1.192036735502724118e-13 2.629384705986432054e-10 5.511521613523442387e-01 -1.249653740670898396e-13 2.751765368344882270e-10 5.511521613645535833e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 new file mode 100644 index 000000000..4bb804de3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 @@ -0,0 +1 @@ +-1.090694396647134794e-02 9.590665261576947610e-05 9.531439136475589947e-05 -1.090334100230360044e-02 9.129668073194477298e-05 8.964512106941127775e-05 -1.089578943179757634e-02 8.160863447676417284e-05 7.822493439943022792e-05 -1.088368653771538616e-02 6.585541551275451923e-05 6.216889791745839591e-05 -1.086633371815436816e-02 4.310522445606170975e-05 4.237600179682514206e-05 -1.084314465752767541e-02 1.812953329005470994e-05 2.108092186113626689e-05 -1.081386331081378091e-02 7.344071358246027695e-06 6.594939877619742538e-06 -1.077936214047001996e-02 5.604808449944646610e-08 -3.993390829314275312e-09 -1.074276975117526706e-02 2.615170877183948970e-06 2.194626208931952567e-06 -1.070567949664820266e-02 1.108524983291024586e-05 1.120727781754460718e-05 -1.066965678090943392e-02 2.260531409214927017e-05 2.309346289259219093e-05 -1.063634075842166161e-02 3.529390392982696115e-05 3.537888811094339444e-05 -1.060734163497350710e-02 4.694183747615062624e-05 4.658032942776004555e-05 -1.058412872525643471e-02 5.625492704494643073e-05 5.549200114696179457e-05 -1.056792052595085206e-02 6.247154904860643054e-05 6.156020750637362926e-05 -1.055958902078880240e-02 6.547958503000318904e-05 6.456075883187886244e-05 -1.595293332571126048e-13 5.511521614431711402e-01 3.495783869235534952e-10 -1.470493804314415849e-13 5.511521614159210491e-01 3.221100510025750101e-10 -1.237838225037912216e-13 5.511521613648339146e-01 2.710890145671483258e-10 -9.174603744193211030e-14 5.511521612937549941e-01 2.012137346977776079e-10 -5.838285180612791938e-14 5.511521612191034869e-01 1.286029654322602117e-10 -3.547547319519967252e-14 5.511521611676962751e-01 7.835386358611322763e-11 -1.737603451235520738e-14 5.511521611272857113e-01 3.789379195162308765e-11 1.161542984678529312e-15 5.511521610870332433e-01 -2.355106552121157336e-12 -3.363083553733534267e-15 5.511521610976887198e-01 8.302801195030240324e-12 -1.742946852426526271e-14 5.511521611295601142e-01 4.029604652186085336e-11 -4.309142177511592437e-14 5.511521611868147597e-01 9.784344960502202922e-11 -7.141248022613435309e-14 5.511521612491685485e-01 1.602404789063223442e-10 -9.360899761827169292e-14 5.511521612973417916e-01 2.082426772838445817e-10 -1.093375331022366260e-13 5.511521613310527146e-01 2.417665627165940627e-10 -1.198064501334756104e-13 5.511521613533064690e-01 2.639217413959564651e-10 -1.256056577783842014e-13 5.511521613656203966e-01 2.762081226781971223e-10 -1.576439859436390559e-13 3.495783869235534952e-10 5.511521614348579012e-01 -1.450655435360464672e-13 3.221100510025750101e-10 5.511521614071703823e-01 -1.218334192051513119e-13 2.710890145671483258e-10 5.511521613562222477e-01 -9.033818728371969499e-14 2.012137346977776079e-10 5.511521612875319720e-01 -5.788647255888008022e-14 1.286029654322602117e-10 5.511521612169075768e-01 -3.549747555255481313e-14 7.835386358611322763e-11 5.511521611677931975e-01 -1.737520473382959265e-14 3.789379195162308765e-11 5.511521611272818255e-01 1.160572197983006360e-15 -2.355106552121157336e-12 5.511521610870362409e-01 -3.364938699855408939e-15 8.302801195030240324e-12 5.511521610976972685e-01 -1.748506760976125242e-14 4.029604652186085336e-11 5.511521611298160206e-01 -4.327760191697586292e-14 9.784344960502202922e-11 5.511521611876574189e-01 -7.161949589129716762e-14 1.602404789063223442e-10 5.511521612500968059e-01 -9.374101615442475394e-14 2.082426772838445817e-10 5.511521612979290996e-01 -1.093857846244196846e-13 2.417665627165940627e-10 5.511521613312658774e-01 -1.198096099198538307e-13 2.639217413959564651e-10 5.511521613533221231e-01 -1.255965224556769041e-13 2.762081226781971223e-10 5.511521613655796514e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 new file mode 100644 index 000000000..642158506 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 @@ -0,0 +1 @@ +-1.089911382755496920e-02 9.590665261562092685e-05 9.531439136461079256e-05 -1.089548929907907873e-02 9.129668073183740986e-05 8.964512106930657093e-05 -1.088797228414149602e-02 8.160863447672485696e-05 7.822493439939345991e-05 -1.087610047020595889e-02 6.585541551279350985e-05 6.216889791749824034e-05 -1.085935092053966211e-02 4.310522445616033149e-05 4.237600179692367571e-05 -1.083731283866002162e-02 1.812953329017500894e-05 2.108092186125616610e-05 -1.080986808894644075e-02 7.344071358356961906e-06 6.594939877730220198e-06 -1.077803065163608284e-02 5.604808453103967669e-08 -3.993390798336525154e-09 -1.074445440784762597e-02 2.615170877127984232e-06 2.194626208876565930e-06 -1.071051230696700753e-02 1.108524983275181342e-05 1.120727781738658980e-05 -1.067762615183764918e-02 2.260531409187991708e-05 2.309346289232385089e-05 -1.064727405968715970e-02 3.529390392946149692e-05 3.537888811057886534e-05 -1.062090019806325933e-02 4.694183747571083995e-05 4.658032942732211597e-05 -1.059981712585020622e-02 5.625492704445059797e-05 5.549200114646809633e-05 -1.058511025136823006e-02 6.247154904807147163e-05 6.156020750584010692e-05 -1.057755484659019668e-02 6.547958502944658675e-05 6.456075883132510618e-05 -1.596778867378964988e-13 5.511521614427650206e-01 3.491739100820903245e-10 -1.471567395691660095e-13 5.511521614155141524e-01 3.217049246109934022e-10 -1.238231340585956290e-13 5.511521613644294604e-01 2.706865930529394709e-10 -9.170704970278866032e-14 5.511521612933635295e-01 2.008243993013213960e-10 -5.828422709324625708e-14 5.511521612187441077e-01 1.282455069544284689e-10 -3.535517391193455816e-14 5.511521611673955157e-01 7.805455247611171445e-11 -1.726510024463133651e-14 5.511521611270748799e-01 3.768414569367295191e-11 1.193136196141934923e-15 5.511521610869529741e-01 -2.434924274836761008e-12 -3.419048356756951908e-15 5.511521610977594410e-01 8.373045872497134627e-12 -1.758790053141162398e-14 5.511521611297898193e-01 4.052432498398489961e-11 -4.336077491619758654e-14 5.511521611872068904e-01 9.823328737775621897e-11 -7.177794567261399191e-14 5.511521612497179978e-01 1.607867553908566322e-10 -9.404878294440451537e-14 5.511521612980335716e-01 2.089304549118663940e-10 -1.098333639254543335e-13 5.511521613318617341e-01 2.425709822710860412e-10 -1.203414035905658621e-13 5.511521613541989773e-01 2.648092447680089625e-10 -1.261622594750147202e-13 5.511521613665563146e-01 2.771388074005144695e-10 -1.577890912404110487e-13 3.491739100820903245e-10 5.511521614344550013e-01 -1.451702441801589508e-13 3.217049246109934022e-10 5.511521614067670383e-01 -1.218701907137172398e-13 2.706865930529394709e-10 5.511521613558219013e-01 -9.029834599137222081e-14 2.008243993013213960e-10 5.511521612871447262e-01 -5.778794171061784111e-14 1.282455069544284689e-10 5.511521612165519723e-01 -3.537757708046730602e-14 7.805455247611171445e-11 5.511521611674953247e-01 -1.726472736765123576e-14 3.768414569367295191e-11 5.511521611270733256e-01 1.191549948121451620e-15 -2.434924274836761008e-12 5.511521610869568599e-01 -3.420325523887346523e-15 8.373045872497134627e-12 5.511521610977671015e-01 -1.764308492628224630e-14 4.052432498398489961e-11 5.511521611300429502e-01 -4.354594106056779363e-14 9.823328737775621897e-11 5.511521611880448868e-01 -7.198402726276831845e-14 1.607867553908566322e-10 5.511521612506399270e-01 -9.417894609903620722e-14 2.089304549118663940e-10 5.511521612986128860e-01 -1.098794808588550188e-13 2.425709822710860412e-10 5.511521613320656821e-01 -1.203431340753243004e-13 2.648092447680089625e-10 5.511521613542046394e-01 -1.261502852121336241e-13 2.771388074005144695e-10 5.511521613665051333e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 new file mode 100644 index 000000000..472131dd0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 @@ -0,0 +1 @@ +-1.089129847077502031e-02 9.590665261552200696e-05 9.531439136451417659e-05 -1.088770419037663091e-02 9.129668073177208667e-05 8.964512106924455456e-05 -1.088031086752268457e-02 8.160863447671767412e-05 7.822493439938866232e-05 -1.086877013348016424e-02 6.585541551285110809e-05 6.216889791755677371e-05 -1.085270090815242637e-02 4.310522445626542457e-05 4.237600179702786076e-05 -1.083183274034231307e-02 1.812953329029363421e-05 2.108092186137376477e-05 -1.080615522656194413e-02 7.344071358462711428e-06 6.594939877835198920e-06 -1.077680224992991383e-02 5.604808455852632596e-08 -3.993390770107827043e-09 -1.074598085954941822e-02 2.615170877077020378e-06 2.194626208824983317e-06 -1.071489999792239398e-02 1.108524983260771618e-05 1.120727781724359031e-05 -1.068485261036486618e-02 2.260531409163720148e-05 2.309346289208172822e-05 -1.065717379279769624e-02 3.529390392913532825e-05 3.537888811025357080e-05 -1.063316125102804245e-02 4.694183747532132677e-05 4.658032942693352436e-05 -1.061398990014171886e-02 5.625492704401263450e-05 5.549200114603182693e-05 -1.060062864101904596e-02 6.247154904759970816e-05 6.156020750537106751e-05 -1.059376824597261894e-02 6.547958502895743539e-05 6.456075883083775731e-05 -1.597768082206550186e-13 5.511521614423581239e-01 3.487687617371800307e-10 -1.472220690170250093e-13 5.511521614151092541e-01 3.213018778541096672e-10 -1.238303151459541243e-13 5.511521613640317785e-01 2.702909959609022075e-10 -9.164945468353396733e-14 5.511521612929842773e-01 2.004472530926121760e-10 -5.817913701217672628e-14 5.511521612184012708e-01 1.279044990565438032e-10 -3.523654846895618054e-14 5.511521611671127419e-01 7.777314523369157012e-11 -1.715935064986031298e-14 5.511521611268793697e-01 3.748968158711814988e-11 1.220622842833967009e-15 5.511521610868799215e-01 -2.507614126969960531e-12 -3.470012372763114815e-15 5.511521610978243890e-01 8.437630145859517506e-12 -1.773199786269858646e-14 5.511521611299996515e-01 4.073282729592975912e-11 -4.360348901051600323e-14 5.511521611875639381e-01 9.858816718066526787e-11 -7.210411272547982662e-14 5.511521612502170431e-01 1.612828200405163505e-10 -9.443829293598577788e-14 5.511521612986606256e-01 2.095538458985146064e-10 -1.102713296429658270e-13 5.511521613325941482e-01 2.432991062598451573e-10 -1.208131643144799962e-13 5.511521613550062204e-01 2.656118629907576756e-10 -1.266514121451997009e-13 5.511521613674024156e-01 2.779801110222163381e-10 -1.578857038529343025e-13 3.487687617371800307e-10 5.511521614340515463e-01 -1.452322659125568882e-13 3.213018778541096672e-10 5.511521614063659147e-01 -1.218749926165763842e-13 2.702909959609022075e-10 5.511521613554284382e-01 -9.023981392233637666e-14 2.004472530926121760e-10 5.511521612867696929e-01 -5.768375529989318433e-14 1.279044990565438032e-10 5.511521612162127992e-01 -3.525997828088457518e-14 7.777314523369157012e-11 5.511521611672153265e-01 -1.715974905857602145e-14 3.748968158711814988e-11 5.511521611268799248e-01 1.219778645975572961e-15 -2.507614126969960531e-12 5.511521610868845844e-01 -3.471908165255758154e-15 8.437630145859517506e-12 5.511521610978312724e-01 -1.778608473755637754e-14 4.073282729592975912e-11 5.511521611302501178e-01 -4.378806348896060514e-14 9.858816718066526787e-11 5.511521611883976046e-01 -7.230932437837906926e-14 1.612828200405163505e-10 5.511521612511330881e-01 -9.456753947432597205e-14 2.095538458985146064e-10 5.511521612992326125e-01 -1.103157520908714609e-13 2.432991062598451573e-10 5.511521613327895475e-01 -1.208121695530087603e-13 2.656118629907576756e-10 5.511521613550026677e-01 -1.266376328687885959e-13 2.779801110222163381e-10 5.511521613673416864e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 new file mode 100644 index 000000000..cb845a82e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 @@ -0,0 +1 @@ +-1.088359596945801498e-02 9.590665261546260623e-05 9.531439136445689006e-05 -1.088007111442532669e-02 9.129668073174197296e-05 8.964512106921571479e-05 -1.087286795229581646e-02 8.160863447673628174e-05 7.822493439940820506e-05 -1.086173036871837527e-02 6.585541551292163544e-05 6.216889791762803289e-05 -1.084639147450843985e-02 4.310522445637324847e-05 4.237600179713535263e-05 -1.082669247026305653e-02 1.812953329040922711e-05 2.108092186148900190e-05 -1.080270634412457478e-02 7.344071358562131073e-06 6.594939877934507604e-06 -1.077566850783796826e-02 5.604808458286691619e-08 -3.993390745610132049e-09 -1.074736634580151715e-02 2.615170877028171564e-06 2.194626208776974337e-06 -1.071889012750033322e-02 1.108524983247645826e-05 1.120727781711190379e-05 -1.069141687960097932e-02 2.260531409141888382e-05 2.309346289186338006e-05 -1.066615430635944016e-02 3.529390392884277662e-05 3.537888810996215081e-05 -1.064427052526302660e-02 4.694183747497367734e-05 4.658032942658780616e-05 -1.062681921752767385e-02 5.625492704362471374e-05 5.549200114564572899e-05 -1.061466697986412043e-02 6.247154904718285953e-05 6.156020750495665834e-05 -1.060843053153304183e-02 6.547958502852590937e-05 6.456075883040800667e-05 -1.598362111128415268e-13 5.511521614419557791e-01 3.483682509023912012e-10 -1.472521830543058619e-13 5.511521614147110171e-01 3.209055657590038942e-10 -1.238117046234272068e-13 5.511521613636443107e-01 2.699057003231726162e-10 -9.157892234499176142e-14 5.511521612926192359e-01 2.000843110637638212e-10 -5.807131643655671224e-14 5.511521612180755314e-01 1.275805190207767441e-10 -3.512095662045778631e-14 5.511521611668473986e-01 7.750912359488742653e-11 -1.705993109641728575e-14 5.511521611266980702e-01 3.730940010289248682e-11 1.244963431382222942e-15 5.511521610868133081e-01 -2.573890758000038197e-12 -3.518861168504728292e-15 5.511521610978842300e-01 8.497043970743268977e-12 -1.786325661457314155e-14 5.511521611301914980e-01 4.092346197431666331e-11 -4.382180530946230105e-14 5.511521611878893445e-01 9.891163425574290406e-11 -7.239666259659924038e-14 5.511521612506709022e-01 1.617339387187474757e-10 -9.478594467941361490e-14 5.511521612992299479e-01 2.101197638522745511e-10 -1.106592478485263890e-13 5.511521613332582836e-01 2.439592599565981591e-10 -1.212300167508121637e-13 5.511521613557376353e-01 2.663389517744265001e-10 -1.270829352752311542e-13 5.511521613681686915e-01 2.787419320295152670e-10 -1.579429922893568791e-13 3.483682509023912012e-10 5.511521614336528652e-01 -1.452611105002808879e-13 3.209055657590038942e-10 5.511521614059715635e-01 -1.218554468794581317e-13 2.699057003231726162e-10 5.511521613550453003e-01 -9.016854868365703144e-14 2.000843110637638212e-10 5.511521612864088704e-01 -5.757626409964413515e-14 1.275805190207767441e-10 5.511521612158906125e-01 -3.514474104493318962e-14 7.750912359488742653e-11 5.511521611669526477e-01 -1.706044016740553111e-14 3.730940010289248682e-11 5.511521611267006238e-01 1.244276341031489123e-15 -2.573890758000038197e-12 5.511521610868186372e-01 -3.519917038622227561e-15 8.497043970743268977e-12 5.511521610978903363e-01 -1.791777184236935766e-14 4.092346197431666331e-11 5.511521611304396329e-01 -4.400641313288273809e-14 9.891163425574290406e-11 5.511521611887191252e-01 -7.260074401006987229e-14 1.617339387187474757e-10 5.511521612515815072e-01 -9.491325877231459501e-14 2.101197638522745511e-10 5.511521612997951625e-01 -1.107018491762551031e-13 2.439592599565981591e-10 5.511521613334458003e-01 -1.212265787494048364e-13 2.663389517744265001e-10 5.511521613557255339e-01 -1.270673886741022407e-13 2.787419320295152670e-10 5.511521613680990805e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 new file mode 100644 index 000000000..5b64a6fcb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 @@ -0,0 +1 @@ +-1.087607916180600813e-02 9.590665261543380711e-05 9.531439136443027290e-05 -1.087265284872133281e-02 9.129668073173802917e-05 8.964512106921328888e-05 -1.086568831494738076e-02 8.160863447677215528e-05 7.822493439944567780e-05 -1.085500389740945079e-02 6.585541551300228653e-05 6.216889791770852135e-05 -1.084042423235363241e-02 4.310522445648207527e-05 4.237600179724391515e-05 -1.082187874784066965e-02 1.812953329052152673e-05 2.108092186160029865e-05 -1.079951260180682208e-02 7.344071358655534243e-06 6.594939878027340721e-06 -1.077462186246241210e-02 5.604808460569273359e-08 -3.993390724168217599e-09 -1.074862575974497129e-02 2.615170876983727322e-06 2.194626208732267091e-06 -1.072252383431652675e-02 1.108524983235652517e-05 1.120727781699252296e-05 -1.069738860351442632e-02 2.260531409122106097e-05 2.309346289166632971e-05 -1.067431400340333736e-02 3.529390392858098246e-05 3.537888810970134598e-05 -1.065435317383742024e-02 4.694183747466457808e-05 4.658032942627974367e-05 -1.063845271429178854e-02 5.625492704327957831e-05 5.549200114530247058e-05 -1.062738913623222786e-02 6.247154904681405461e-05 6.156020750458880209e-05 -1.062171407948998315e-02 6.547958502814314535e-05 6.456075883002821065e-05 -1.598650116186008921e-13 5.511521614415620940e-01 3.479763783045806579e-10 -1.472561218600414842e-13 5.511521614143228831e-01 3.205194611786318901e-10 -1.237758273390874339e-13 5.511521613632697214e-01 2.695332313143491664e-10 -9.149827067997238706e-14 5.511521612922697377e-01 1.997369297187146203e-10 -5.796249229963672882e-14 5.511521612177671114e-01 1.272737880266123708e-10 -3.500865582273936638e-14 5.511521611665989306e-01 7.726186736093883708e-11 -1.696652780215058591e-14 5.511521611265305376e-01 3.714279282795668553e-11 1.267789250053043179e-15 5.511521610867524679e-01 -2.634381688389226120e-12 -3.563305419684334103e-15 5.511521610979392971e-01 8.551725145455025005e-12 -1.798318949667704289e-14 5.511521611303670243e-01 4.109791076270627267e-11 -4.401962843450515035e-14 5.511521611881863292e-01 9.920679092386066264e-11 -7.265846005223852310e-14 5.511521612510841273e-01 1.621446980613230149e-10 -9.509504324652362346e-14 5.511521612997475339e-01 2.106342115964121706e-10 -1.110043834814207890e-13 5.511521613338613568e-01 2.445586568507851738e-10 -1.215988215838436409e-13 5.511521613564012156e-01 2.669986073238897414e-10 -1.274656960880058310e-13 5.511521613688636911e-01 2.794328313553187125e-10 -1.579696058661129269e-13 3.479763783045806579e-10 5.511521614332628438e-01 -1.452635364959018187e-13 3.205194611786318901e-10 5.511521614055874263e-01 -1.218179790877732299e-13 2.695332313143491664e-10 5.511521613546749299e-01 -9.008806410484280057e-14 1.997369297187146203e-10 5.511521612860635910e-01 -5.746769876186245445e-14 1.272737880266123708e-10 5.511521612155856342e-01 -3.503344356585678904e-14 7.726186736093883708e-11 5.511521611667066223e-01 -1.696760705886516458e-14 3.714279282795668553e-11 5.511521611265349785e-01 1.265718255236475359e-15 -2.634381688389226120e-12 5.511521610867584631e-01 -3.564624073562386971e-15 8.551725145455025005e-12 5.511521610979446262e-01 -1.803715332830595062e-14 4.109791076270627267e-11 5.511521611306130497e-01 -4.420346370493866207e-14 9.920679092386066264e-11 5.511521611890125572e-01 -7.286154884396444597e-14 1.621446980613230149e-10 5.511521612519898472e-01 -9.522132303947201732e-14 2.106342115964121706e-10 5.511521613003065312e-01 -1.110451057769577090e-13 2.445586568507851738e-10 5.511521613340415460e-01 -1.215944403562044728e-13 2.669986073238897414e-10 5.511521613563812316e-01 -1.274471793750330182e-13 2.794328313553187125e-10 5.511521613687858645e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 new file mode 100644 index 000000000..c35e2fa59 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 @@ -0,0 +1 @@ +-1.086880113890865279e-02 9.590665261542975491e-05 9.531439136442623424e-05 -1.086549446723246611e-02 9.129668073175354682e-05 8.964512106923086651e-05 -1.085880273024589573e-02 8.160863447682255713e-05 7.822493439949679793e-05 -1.084860409206484834e-02 6.585541551308835863e-05 6.216889791779494582e-05 -1.083479613596765104e-02 4.310522445659037351e-05 4.237600179735160353e-05 -1.081737739487390569e-02 1.812953329062837486e-05 2.108092186170698753e-05 -1.079656928416714359e-02 7.344071358742837929e-06 6.594939878114224279e-06 -1.077365548021687672e-02 5.604808462489146326e-08 -3.993390704291995576e-09 -1.074977205548276367e-02 2.615170876942123181e-06 2.194626208691270273e-06 -1.072583696079697571e-02 1.108524983224637531e-05 1.120727781688285761e-05 -1.070282830634894378e-02 2.260531409104206597e-05 2.309346289148764641e-05 -1.068173818567844970e-02 3.529390392834562927e-05 3.537888810946702279e-05 -1.066351746483088642e-02 4.694183747438805909e-05 4.658032942600440375e-05 -1.064901791556978859e-02 5.625492704297312856e-05 5.549200114499726767e-05 -1.063893651653291007e-02 6.247154904648612411e-05 6.156020750426298579e-05 -1.063376756568772119e-02 6.547958502780582295e-05 6.456075882969114575e-05 -1.598690647506254066e-13 5.511521614411799552e-01 3.475961057375096208e-10 -1.472406015559138880e-13 5.511521614139475167e-01 3.201461002239378235e-10 -1.237254283154461738e-13 5.511521613629097871e-01 2.691753636580359162e-10 -9.141220319720824616e-14 5.511521612919367819e-01 1.994059516922362366e-10 -5.785419320792676792e-14 5.511521612174758999e-01 1.269842561119422345e-10 -3.490180681399605658e-14 5.511521611663665610e-01 7.703068759046320272e-11 -1.687922385344035087e-14 5.511521611263764386e-01 3.698956124141852144e-11 1.286987981137787497e-15 5.511521610866968457e-01 -2.689640856442677474e-12 -3.604909545539200354e-15 5.511521610979899233e-01 8.602067116485445319e-12 -1.809333933773642042e-14 5.511521611305277846e-01 4.125766416648245793e-11 -4.419862230530095192e-14 5.511521611884575567e-01 9.947636797218097149e-11 -7.289381634380744341e-14 5.511521612514608259e-01 1.625191168944847366e-10 -9.537156396790431451e-14 5.511521613002186015e-01 2.111024321941733156e-10 -1.113108336285525073e-13 5.511521613344095849e-01 2.451035841875002992e-10 -1.219267499883977958e-13 5.511521613570041778e-01 2.675978772406128503e-10 -1.278030239072816124e-13 5.511521613694949639e-01 2.800602566720315724e-10 -1.579736493201991973e-13 3.475961057375096208e-10 5.511521614328844798e-01 -1.452459575173187517e-13 3.201461002239378235e-10 5.511521614052160567e-01 -1.217668647442366006e-13 2.691753636580359162e-10 5.511521613543191034e-01 -9.000163336520795011e-14 1.994059516922362366e-10 5.511521612857346319e-01 -5.736001266244778067e-14 1.269842561119422345e-10 5.511521612152977534e-01 -3.492675351805852492e-14 7.703068759046320272e-11 5.511521611664765841e-01 -1.688072367385989684e-14 3.698956124141852144e-11 5.511521611263826559e-01 1.285594477429145533e-15 -2.689640856442677474e-12 5.511521610867035070e-01 -3.605620700945492666e-15 8.602067116485445319e-12 5.511521610979946972e-01 -1.814681835602082349e-14 4.125766416648245793e-11 5.511521611307718116e-01 -4.438214681839096766e-14 9.947636797218097149e-11 5.511521611892804540e-01 -7.309586885966744275e-14 1.625191168944847366e-10 5.511521612523619940e-01 -9.549666236057879506e-14 2.111024321941733156e-10 5.511521613007719367e-01 -1.113503055142689779e-13 2.451035841875002992e-10 5.511521613345831128e-01 -1.219202532249988550e-13 2.675978772406128503e-10 5.511521613569768663e-01 -1.277842411123744091e-13 2.800602566720315724e-10 5.511521613694094768e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 new file mode 100644 index 000000000..f8b484879 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 @@ -0,0 +1 @@ +-1.086179947940717726e-02 9.590665261544330743e-05 9.531439136444180610e-05 -1.085862716423796788e-02 9.129668073178576117e-05 8.964512106926335192e-05 -1.085223104851380273e-02 8.160863447688293363e-05 7.822493439955782496e-05 -1.084253710865111520e-02 6.585541551317842873e-05 6.216889791788509723e-05 -1.082950064866678927e-02 4.310522445669663888e-05 4.237600179745744199e-05 -1.081317370701866641e-02 1.812953329073099121e-05 2.108092186180953611e-05 -1.079385747078666011e-02 7.344071358824566444e-06 6.594939878195701225e-06 -1.077276315105271665e-02 5.604808464274464800e-08 -3.993390686578985685e-09 -1.075081656957860114e-02 2.615170876903352789e-06 2.194626208652419412e-06 -1.072886093504417035e-02 1.108524983214693026e-05 1.120727781678336851e-05 -1.070778892883249810e-02 2.260531409087970670e-05 2.309346289132619177e-05 -1.068850128141538708e-02 3.529390392813382360e-05 3.537888810925556270e-05 -1.067185767260792409e-02 4.694183747414077968e-05 4.658032942575826275e-05 -1.065862569554195186e-02 5.625492704269988929e-05 5.549200114472526167e-05 -1.064943194157444775e-02 6.247154904619570701e-05 6.156020750397354446e-05 -1.064472006150514113e-02 6.547958502750469935e-05 6.456075882939243450e-05 -1.598555146713272187e-13 5.511521614408115832e-01 3.472295684179013216e-10 -1.472083930181822125e-13 5.511521614135866942e-01 3.197872755685870464e-10 -1.236650564896941777e-13 5.511521613625656180e-01 2.688332799301974049e-10 -9.132213158823086785e-14 5.511521612916207014e-01 1.990918190064360896e-10 -5.774792916897965472e-14 5.511521612172017859e-01 1.267116682405534549e-10 -3.479918888716959858e-14 5.511521611661496234e-01 7.681485188377896585e-11 -1.679749572734562474e-14 5.511521611262347742e-01 3.684866600900886248e-11 1.304841167270847646e-15 5.511521610866459975e-01 -2.740159532567657358e-12 -3.643680052885433165e-15 5.511521610980365526e-01 8.648425273943646973e-12 -1.819278377214417589e-14 5.511521611306751112e-01 4.140404997349794002e-11 -4.436098298501405309e-14 5.511521611887054695e-01 9.972278181430269185e-11 -7.310562130343633475e-14 5.511521612518045510e-01 1.628607353130657200e-10 -9.561884254000671226e-14 5.511521613006478137e-01 2.115290296130412269e-10 -1.115840701679858491e-13 5.511521613349086302e-01 2.455995511497033182e-10 -1.222171670437804117e-13 5.511521613575526279e-01 2.681429289618432910e-10 -1.281041455324269476e-13 5.511521613700689493e-01 2.806307215254518927e-10 -1.579580811478028991e-13 3.472295684179013216e-10 5.511521614325197715e-01 -1.452134690406089887e-13 3.197872755685870464e-10 5.511521614048591200e-01 -1.217058406800084856e-13 2.688332799301974049e-10 5.511521613539790421e-01 -8.991148264166778143e-14 1.990918190064360896e-10 5.511521612854224372e-01 -5.725417170276319568e-14 1.267116682405534549e-10 5.511521612150267480e-01 -3.482420584423003968e-14 7.681485188377896585e-11 5.511521611662618669e-01 -1.679924682102316676e-14 3.684866600900886248e-11 5.511521611262425457e-01 1.303307486986424660e-15 -2.740159532567657358e-12 5.511521610866533250e-01 -3.644471563424533098e-15 8.648425273943646973e-12 5.511521610980407715e-01 -1.824630817612015172e-14 4.140404997349794002e-11 5.511521611309172508e-01 -4.454360302335406944e-14 9.972278181430269185e-11 5.511521611895253692e-01 -7.330732656441497739e-14 1.628607353130657200e-10 5.511521612527015002e-01 -9.574280220264669583e-14 2.115290296130412269e-10 5.511521613011959309e-01 -1.116223091761974374e-13 2.455995511497033182e-10 5.511521613350760518e-01 -1.222096900568195271e-13 2.681429289618432910e-10 5.511521613575185441e-01 -1.280829478982308544e-13 2.806307215254518927e-10 5.511521613699764677e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 new file mode 100644 index 000000000..c8ef061f9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 @@ -0,0 +1 @@ +-1.085509955243740658e-02 9.590665261547191682e-05 9.531439136447102535e-05 -1.085207123594016977e-02 9.129668073182923768e-05 8.964512106930757381e-05 -1.084598459319774735e-02 8.160863447695027614e-05 7.822493439962562825e-05 -1.083680354556124797e-02 6.585541551326982697e-05 6.216889791797588561e-05 -1.082452864793547950e-02 4.310522445680046479e-05 4.237600179756025823e-05 -1.080925273779440032e-02 1.812953329082883368e-05 2.108092186190650106e-05 -1.079135856323053255e-02 7.344071358899968470e-06 6.594939878270825424e-06 -1.077193920490872488e-02 5.604808465880920356e-08 -3.993390671585116992e-09 -1.075176927652454761e-02 2.615170876867358971e-06 2.194626208616629729e-06 -1.073162347055377913e-02 1.108524983205452066e-05 1.120727781669167888e-05 -1.071231704530322890e-02 2.260531409073270921e-05 2.309346289117933658e-05 -1.069466860907628512e-02 3.529390392794379006e-05 3.537888810906609160e-05 -1.067945636553791107e-02 4.694183747391891804e-05 4.658032942553722781e-05 -1.066737301465978636e-02 5.625492704245541525e-05 5.549200114448256979e-05 -1.065898271240749672e-02 6.247154904593568822e-05 6.156020750371576184e-05 -1.065468427322964137e-02 6.547958502723748417e-05 6.456075882912676431e-05 -1.598269117384301696e-13 5.511521614404584213e-01 3.468782437718925282e-10 -1.471649127331277436e-13 5.511521614132417479e-01 3.194441899425734377e-10 -1.235977110126338538e-13 5.511521613622381022e-01 2.685076959932778133e-10 -9.123073137290250861e-14 5.511521612913217183e-01 1.987946624756856520e-10 -5.764410276150573425e-14 5.511521612169442141e-01 1.264556160747368003e-10 -3.470134592605084444e-14 5.511521611659473407e-01 7.661360373787266178e-11 -1.672209371804493017e-14 5.511521611261044340e-01 3.671908849061737830e-11 1.320905723154172551e-15 5.511521610865994791e-01 -2.786375210551865006e-12 -3.679674012192963268e-15 5.511521610980795183e-01 8.691122012723350659e-12 -1.828519385090169890e-14 5.511521611308101143e-01 4.153825631913450131e-11 -4.450798012317911129e-14 5.511521611889322880e-01 9.994818063722965885e-11 -7.329565760283974775e-14 5.511521612521184110e-01 1.631726865154904565e-10 -9.584070477900277987e-14 5.511521613010392784e-01 2.119180659583369919e-10 -1.118285430225711332e-13 5.511521613353632665e-01 2.460514082543336152e-10 -1.224771835119816657e-13 5.511521613580520063e-01 2.686391854716262323e-10 -1.283713595677841145e-13 5.511521613705914202e-01 2.811499496788089121e-10 -1.579288675176873794e-13 3.468782437718925282e-10 5.511521614321702733e-01 -1.451692485119232297e-13 3.194441899425734377e-10 5.511521614045179485e-01 -1.216380417415798064e-13 2.685076959932778133e-10 5.511521613536554121e-01 -8.982068946200730533e-14 1.987946624756856520e-10 5.511521612851271179e-01 -5.715135810182342338e-14 1.264556160747368003e-10 5.511521612147721738e-01 -3.472724251411381514e-14 7.661360373787266178e-11 5.511521611660616937e-01 -1.672412241608283824e-14 3.671908849061737830e-11 5.511521611261137599e-01 1.318301355559537163e-15 -2.786375210551865006e-12 5.511521610866073617e-01 -3.680261258271571974e-15 8.691122012723350659e-12 5.511521610980831820e-01 -1.833799791773700869e-14 4.153825631913450131e-11 5.511521611310505886e-01 -4.469045862801948374e-14 9.994818063722965885e-11 5.511521611897494122e-01 -7.349679721185449521e-14 1.631726865154904565e-10 5.511521612530115855e-01 -9.596383532076135751e-14 2.119180659583369919e-10 5.511521613015826215e-01 -1.118650040403125949e-13 2.460514082543336152e-10 5.511521613355251370e-01 -1.224674772313387498e-13 2.686391854716262323e-10 5.511521613580117052e-01 -1.283486225462022538e-13 2.811499496788089121e-10 5.511521613704924993e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 new file mode 100644 index 000000000..0262efc6d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 @@ -0,0 +1 @@ +-1.084871711923132351e-02 9.590665261551078547e-05 9.531439136451043609e-05 -1.084583842817175327e-02 9.129668073188045268e-05 8.964512106935947999e-05 -1.084006804732302355e-02 8.160863447702219940e-05 7.822493439969756507e-05 -1.083139974679788939e-02 6.585541551336083219e-05 6.216889791806708056e-05 -1.081986913388058649e-02 4.310522445690012329e-05 4.237600179765953050e-05 -1.080559951771556393e-02 1.812953329092135339e-05 2.108092186199855660e-05 -1.078905563083878624e-02 7.344071358970452623e-06 6.594939878341158805e-06 -1.077117844474075221e-02 5.604808467312774629e-08 -3.993390656143215018e-09 -1.075263899463795546e-02 2.615170876834259041e-06 2.194626208583586551e-06 -1.073414912791843118e-02 1.108524983197079314e-05 1.120727781660796492e-05 -1.071645383917438354e-02 2.260531409059925409e-05 2.309346289104636935e-05 -1.070029778908024136e-02 3.529390392777094113e-05 3.537888810889449628e-05 -1.068638623603992630e-02 4.694183747371998727e-05 4.658032942533959131e-05 -1.067534510824135092e-02 5.625492704223761936e-05 5.549200114426499752e-05 -1.066768306112365200e-02 6.247154904570482092e-05 6.156020750348527402e-05 -1.066375913117856983e-02 6.547958502699961021e-05 6.456075882888990679e-05 -1.597880398748206921e-13 5.511521614401214686e-01 3.465430863483889422e-10 -1.471136910398418573e-13 5.511521614129132329e-01 3.191175786879842261e-10 -1.235257938040439645e-13 5.511521613619274618e-01 2.681989609131709317e-10 -9.113972360636650149e-14 5.511521612910396106e-01 1.985143726166915664e-10 -5.754444762113119274e-14 5.511521612167027406e-01 1.262155786797609730e-10 -3.460882626787765043e-14 5.511521611657589359e-01 7.642617734249862848e-11 -1.665160959761737273e-14 5.511521611259845299e-01 3.659990166005040088e-11 1.335224262784404919e-15 5.511521610865569576e-01 -2.828679003333548620e-12 -3.712774004051750389e-15 5.511521610981190422e-01 8.730450781511935213e-12 -1.836892079780318346e-14 5.511521611309340152e-01 4.166135043077661725e-11 -4.464143427861877411e-14 5.511521611891398997e-01 1.001544818972949419e-10 -7.346850481404400165e-14 5.511521612524051816e-01 1.634577551104440438e-10 -9.603963264178457070e-14 5.511521613013965482e-01 2.122731403744509994e-10 -1.120463362676341034e-13 5.511521613357779348e-01 2.464634442128155211e-10 -1.227080525424285198e-13 5.511521613585070867e-01 2.690914354031100631e-10 -1.286092304713893184e-13 5.511521613710673728e-01 2.816229922115363724e-10 -1.578894548878357177e-13 3.465430863483889422e-10 5.511521614318368734e-01 -1.451173457508263074e-13 3.191175786879842261e-10 5.511521614041932082e-01 -1.215661029544457259e-13 2.681989609131709317e-10 5.511521613533485464e-01 -8.972949184711690412e-14 1.985143726166915664e-10 5.511521612848485629e-01 -5.705208796421698858e-14 1.262155786797609730e-10 5.511521612145335869e-01 -3.463518841177665177e-14 7.642617734249862848e-11 5.511521611658752873e-01 -1.665378891877211254e-14 3.659990166005040088e-11 5.511521611259952991e-01 1.333743257486449992e-15 -2.828679003333548620e-12 5.511521610865652843e-01 -3.713304407404046318e-15 8.730450781511935213e-12 5.511521610981222619e-01 -1.842171103431524106e-14 4.166135043077661725e-11 5.511521611311729352e-01 -4.482342438995797160e-14 1.001544818972949419e-10 5.511521611899544704e-01 -7.366839347742252845e-14 1.634577551104440438e-10 5.511521612532949144e-01 -9.616147295882634267e-14 2.122731403744509994e-10 5.511521613019355614e-01 -1.120825760381342720e-13 2.464634442128155211e-10 5.511521613359345872e-01 -1.226979608181510819e-13 2.690914354031100631e-10 5.511521613584611234e-01 -1.285854734337258598e-13 2.816229922115363724e-10 5.511521613709625678e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 new file mode 100644 index 000000000..487daa118 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 @@ -0,0 +1 @@ +-9.355410162965290335e-03 9.590665272192731578e-05 9.531439146962954233e-05 -9.497253759272124979e-03 9.129668082624237601e-05 8.964512116241954757e-05 -9.760983316589273012e-03 8.160863455078132701e-05 7.822493447228633708e-05 -1.010963417578185711e-02 6.585541556269006592e-05 6.216889796665123701e-05 -1.049045250563568170e-02 4.310522448424977362e-05 4.237600182479492892e-05 -1.079977007702043190e-02 1.812953330416872168e-05 2.108092187527199656e-05 -1.094045452979859785e-02 7.344071362719620347e-06 6.594939882100207168e-06 -1.085791616025431720e-02 5.604808242438758714e-08 -3.993392897625356465e-09 -1.058081367511344746e-02 2.615170879319648949e-06 2.194626211062071023e-06 -1.023572513367495933e-02 1.108524984269189414e-05 1.120727782733021788e-05 -9.849581505306098661e-03 2.260531411391340906e-05 2.309346291441708579e-05 -9.452071341134812496e-03 3.529390396551575925e-05 3.537888814673085494e-05 -9.065534612177199650e-03 4.694183752475508437e-05 4.658032947646401312e-05 -8.705464160017857903e-03 5.625492710446860145e-05 5.549200120656473157e-05 -8.425610554910541172e-03 6.247154911622634465e-05 6.156020757405845998e-05 -8.273100118887152105e-03 6.547958510215772453e-05 6.456075890409285287e-05 -5.337147299472235383e-14 5.511521614016191561e-01 3.086987821112395192e-10 -5.275178401486984813e-14 5.511521613781059648e-01 2.849048877269487628e-10 -4.976671428158847918e-14 5.511521613343207671e-01 2.410346128833301949e-10 -4.181047265329025904e-14 5.511521612734487929e-01 1.811165642864906683e-10 -3.019479696390845519e-14 5.511521612103400525e-01 1.198282999503465344e-10 -2.136146214140645244e-14 5.511521611686767130e-01 7.928722282459301452e-11 -1.290244312392205481e-14 5.511521611334890824e-01 4.407260401084727832e-11 -9.135158905257876777e-16 5.511521610921371606e-01 2.729898969141407811e-12 -1.227382799086963047e-15 5.511521610936235271e-01 4.258867368387143070e-12 -7.647816347566813326e-15 5.511521611140800525e-01 2.485554044043031961e-11 -2.132727154262538083e-14 5.511521611579901503e-01 6.900338489276487732e-11 -3.572368845179870539e-14 5.511521612063638997e-01 1.173280454966240656e-10 -4.500455034535087698e-14 5.511521612410069659e-01 1.517246015104331556e-10 -4.981535271659613451e-14 5.511521612624880051e-01 1.729828305353491457e-10 -5.218650771171730805e-14 5.511521612754829436e-01 1.858714794450768920e-10 -5.345112919177994376e-14 5.511521612828451655e-01 1.932058919212480157e-10 -5.277036766569375707e-14 3.086987821112395192e-10 5.511521613946260834e-01 -5.205728555285849656e-14 2.849048877269487628e-10 5.511521613705541167e-01 -4.897729286157439736e-14 2.410346128833301949e-10 5.511521613266127106e-01 -4.114533575362772727e-14 1.811165642864906683e-10 5.511521612676398840e-01 -2.991667364124794599e-14 1.198282999503465344e-10 5.511521612081214938e-01 -2.136174900106245113e-14 7.928722282459301452e-11 5.511521611686791555e-01 -1.289474017562743170e-14 4.407260401084727832e-11 5.511521611334361248e-01 -9.077388829594699028e-16 2.729898969141407811e-12 5.511521610921027436e-01 -1.234820140612994021e-15 4.258867368387143070e-12 5.511521610936744864e-01 -7.699454770896373217e-15 2.485554044043031961e-11 5.511521611144143407e-01 -2.145271867956777274e-14 6.900338489276487732e-11 5.511521611588008351e-01 -3.583203609733999246e-14 1.173280454966240656e-10 5.511521612070747755e-01 -4.503703932347714699e-14 1.517246015104331556e-10 5.511521612412255688e-01 -4.978284435967812836e-14 1.729828305353491457e-10 5.511521612622612976e-01 -5.212477096863361775e-14 1.858714794450768920e-10 5.511521612750429622e-01 -5.338254820297116964e-14 1.932058919212480157e-10 5.511521612823488958e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 new file mode 100644 index 000000000..3107e60b0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 @@ -0,0 +1 @@ +-9.967998193617863545e-03 9.590665268848954500e-05 9.531439143666133951e-05 -1.006541799080274899e-02 9.129668079713744303e-05 8.964512113377859890e-05 -1.024694329250254096e-02 8.160863452878108955e-05 7.822493445068844705e-05 -1.048442257671991854e-02 6.585541554839735394e-05 6.216889795260175224e-05 -1.072001912696859613e-02 4.310522447615908431e-05 4.237600181676970509e-05 -1.088960495023780575e-02 1.812953329959836568e-05 2.108092187069438657e-05 -1.094232257171415951e-02 7.344071360404448909e-06 6.594939879786468063e-06 -1.084322531929218097e-02 5.604808243287709397e-08 -3.993392886934568998e-09 -1.061603437539516449e-02 2.615170879303587510e-06 2.194626211046839253e-06 -1.034517938365398307e-02 1.108524984197396426e-05 1.120727782660861866e-05 -1.004948293443999607e-02 2.260531411168453672e-05 2.309346291216660395e-05 -9.750292624073031780e-03 3.529390396088978029e-05 3.537888814206762686e-05 -9.471559625406935495e-03 4.694183751730225153e-05 4.658032946897408023e-05 -9.234885369666556015e-03 5.625492709422933514e-05 5.549200119630035921e-05 -9.056150116986903462e-03 6.247154910385149145e-05 6.156020756167147727e-05 -8.958606452857743527e-03 6.547958508859833980e-05 6.456075889052895515e-05 -8.680924804667768964e-14 5.511521614132357527e-01 3.198327955261253981e-10 -8.185672326867208444e-14 5.511521613892796934e-01 2.956319150042617297e-10 -7.176695618034347204e-14 5.511521613444482215e-01 2.508094748091472265e-10 -5.610318953189988679e-14 5.511521612817350535e-01 1.892167200042533501e-10 -3.828548562135057604e-14 5.511521612156807803e-01 1.251505481087495985e-10 -2.593181705836933372e-14 5.511521611709252477e-01 8.155826169608292705e-11 -1.521761469612118111e-14 5.511521611335442605e-01 4.412810721717738110e-11 -9.050263810892229457e-16 5.511521610913351354e-01 1.927334112006412664e-12 -1.243444424387506836e-15 5.511521610942069493e-01 4.842524143796522061e-12 -8.365746779342912487e-15 5.511521611166301238e-01 2.741940138061779234e-11 -2.355614518345810674e-14 5.511521611630191275e-01 7.408675112641386874e-11 -4.034966550336971717e-14 5.511521612140513060e-01 1.251102873203431267e-10 -5.245738607229009805e-14 5.511521612515141166e-01 1.623372641625517461e-10 -6.005461990047111881e-14 5.511521612760932332e-01 1.866784304767359368e-10 -6.456135599985337313e-14 5.511521612915138979e-01 2.019668342927952565e-10 -6.701051146969949533e-14 5.511521613001412190e-01 2.105485231331982248e-10 -8.573857161830792264e-14 3.198327955261253981e-10 5.511521614052975471e-01 -8.069823394444050306e-14 2.956319150042617297e-10 5.511521613808523234e-01 -7.057518273768721782e-14 2.508094748091472265e-10 5.511521613360472749e-01 -5.519481827999863658e-14 1.892167200042533501e-10 5.511521612755581057e-01 -3.794189925663673495e-14 1.251505481087495985e-10 5.511521612134253623e-01 -2.593935826628813317e-14 8.155826169608292705e-11 5.511521611709729873e-01 -1.520847951661602797e-14 4.412810721717738110e-11 5.511521611334919690e-01 -8.970480958966285741e-16 1.927334112006412664e-12 5.511521610912996083e-01 -1.250051707842214327e-15 4.842524143796522061e-12 5.511521610942583527e-01 -8.421053934202913564e-15 2.741940138061779234e-11 5.511521611169920565e-01 -2.370319964936566979e-14 7.408675112641386874e-11 5.511521611639391693e-01 -4.049526498634824920e-14 1.251102873203431267e-10 5.511521612149530291e-01 -5.252696967022034080e-14 1.623372641625517461e-10 5.511521612519447721e-01 -6.004721704146287912e-14 1.866784304767359368e-10 5.511521612760478250e-01 -6.451175183035521735e-14 2.019668342927952565e-10 5.511521612912029244e-01 -6.694644311984170193e-14 2.105485231331982248e-10 5.511521612997382080e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 new file mode 100644 index 000000000..751058856 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 @@ -0,0 +1 @@ +-1.033306601675545826e-02 9.590665266950519207e-05 9.531439141793460656e-05 -1.040378001118455117e-02 9.129668078029794015e-05 8.964512111718908594e-05 -1.053194309569139772e-02 8.160863451554192392e-05 7.822493443766324872e-05 -1.068767536527196090e-02 6.585541553936760325e-05 6.216889794370057437e-05 -1.083253933085586741e-02 4.310522447082162478e-05 4.237600181146797002e-05 -1.092656815210828192e-02 1.812953329672165883e-05 2.108092186781441695e-05 -1.093474907990647609e-02 7.344071359375216634e-06 6.594939878757751631e-06 -1.083338727938064523e-02 5.604808268304135971e-08 -3.993392636831342568e-09 -1.064208426521699030e-02 2.615170879013891655e-06 2.194626210756965097e-06 -1.042076026497613939e-02 1.108524984051061150e-05 1.120727782513997534e-05 -1.018349737515533704e-02 2.260531410812947507e-05 2.309346290859144390e-05 -9.946510748117408721e-03 3.529390395481420947e-05 3.537888813596047188e-05 -9.727768263756812750e-03 4.694183750892388273e-05 4.658032946056277879e-05 -9.544960820500790477e-03 5.625492708391828110e-05 5.549200118596241019e-05 -9.413499018379978614e-03 6.247154909202997438e-05 6.156020754982902154e-05 -9.344607686908609420e-03 6.547958507588788537e-05 6.456075887780050296e-05 -1.057936059986373190e-13 5.511521614227351540e-01 3.291404051205063161e-10 -9.869622739071983013e-14 5.511521613982069967e-01 3.043951935714348375e-10 -8.500612200727941883e-14 5.511521613521389584e-01 2.583910738617517131e-10 -6.513293442845432437e-14 5.511521612873615528e-01 1.948054643135526753e-10 -4.362294384147005936e-14 5.511521612188943209e-01 1.283704718378075430e-10 -2.880852481339728757e-14 5.511521611720404668e-01 8.268053074465917602e-11 -1.624684694034301238e-14 5.511521611332849124e-01 4.386856090528780290e-11 -6.548621151279837768e-16 5.511521610907862412e-01 1.379973431287087001e-12 -1.533140368176572505e-15 5.511521610947412997e-01 5.374720194925105636e-12 -9.829099711028416234e-15 5.511521611187365499e-01 2.952612817220648716e-11 -2.711120520699018315e-14 5.511521611670563425e-01 7.814411923615235598e-11 -4.642523327165301606e-14 5.511521612201610854e-01 1.312690972884975061e-10 -6.083575619756927009e-14 5.511521612596104180e-01 1.705048336427992856e-10 -7.036567402810750875e-14 5.511521612859475727e-01 1.966101689552022188e-10 -7.638287637706926328e-14 5.511521613028789179e-01 2.134070683611967414e-10 -7.972096380268212404e-14 5.511521613124068519e-01 2.228866460899433108e-10 -1.044653013690010250e-13 3.291404051205063161e-10 5.511521614144172521e-01 -9.728774086694824988e-14 3.043951935714348375e-10 5.511521613894546645e-01 -8.360037914263669776e-14 2.583910738617517131e-10 5.511521613435212963e-01 -6.409600249815509708e-14 1.948054643135526753e-10 5.511521612811093318e-01 -4.324363272139842602e-14 1.283704718378075430e-10 5.511521612166516704e-01 -2.881932640724370452e-14 8.268053074465917602e-11 5.511521611721024172e-01 -1.623719576416436400e-14 4.386856090528780290e-11 5.511521611332321768e-01 -6.469448693440610999e-16 1.379973431287087001e-12 5.511521610907537116e-01 -1.539925927528334604e-15 5.374720194925105636e-12 5.511521610947883731e-01 -9.889697934585014324e-15 2.952612817220648716e-11 5.511521611190991488e-01 -2.727835895106623896e-14 7.814411923615235598e-11 5.511521611680167965e-01 -4.660241748506462439e-14 1.312690972884975061e-10 5.511521612211612853e-01 -6.093826998645051177e-14 1.705048336427992856e-10 5.511521612601842923e-01 -7.038516828967339988e-14 1.966101689552022188e-10 5.511521612860574848e-01 -7.635420825824598414e-14 2.134070683611967414e-10 5.511521613027188238e-01 -7.967489797057285479e-14 2.228866460899433108e-10 5.511521613121491692e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 new file mode 100644 index 000000000..edd0f1663 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 @@ -0,0 +1 @@ +-1.056397842881712061e-02 9.590665265499028641e-05 9.531439140358490621e-05 -1.061290444391981870e-02 9.129668076716674751e-05 8.964512110422387110e-05 -1.069906745862823048e-02 8.160863450482159034e-05 7.822493442709447305e-05 -1.080103014135370618e-02 6.585541553163954569e-05 6.216889793607441826e-05 -1.089122468482083168e-02 4.310522446604656802e-05 4.237600180672596110e-05 -1.094072273093216544e-02 1.812953329401480580e-05 2.108092186510594440e-05 -1.092438810445030620e-02 7.344071358182429920e-06 6.594939877565815338e-06 -1.082552092754870791e-02 5.604808289417120395e-08 -3.993392426093937621e-09 -1.066087990002451483e-02 2.615170878855307182e-06 2.194626210599242903e-06 -1.047469509577531217e-02 1.108524983952537497e-05 1.120727782415370711e-05 -1.027795230542445475e-02 2.260531410570251561e-05 2.309346290615542458e-05 -1.008345880961149243e-02 3.529390395064557409e-05 3.537888813177479419e-05 -9.905264049110695107e-03 4.694183750315081109e-05 4.658032945476910054e-05 -9.757121608259835405e-03 5.625492707683194248e-05 5.549200117885418423e-05 -9.650959755100971954e-03 6.247154908398133179e-05 6.156020754175847807e-05 -9.595555070786103077e-03 6.547958506729521723e-05 6.456075886918583907e-05 -1.203085137159266409e-13 5.511521614300686212e-01 3.364299927208931677e-10 -1.118274164643488479e-13 5.511521614049021967e-01 3.110562780437835938e-10 -9.572645161809516379e-14 5.511521613575688372e-01 2.638023237497959918e-10 -7.286099163374294107e-14 5.511521612911199908e-01 1.985610551188528054e-10 -4.839800334232557194e-14 5.511521612208932774e-01 1.303748946117488464e-10 -3.151537833534200675e-14 5.511521611725465064e-01 8.318859512228465199e-11 -1.743963399427177392e-14 5.511521611328673576e-01 4.345155714859553604e-11 -4.437322704435224497e-16 5.511521610902427870e-01 8.386113297816960084e-13 -1.691724710748947054e-15 5.511521610951477523e-01 5.778807209279247983e-12 -1.081433665709040048e-14 5.511521611203743509e-01 3.115946962699567551e-11 -2.953816307082608624e-14 5.511521611701896139e-01 8.128118321503398243e-11 -5.059386785410073077e-14 5.511521612248951874e-01 1.360237360906966293e-10 -6.660882448772103279e-14 5.511521612658796254e-01 1.768136644254011820e-10 -7.745201430732583658e-14 5.511521612935249559e-01 2.042415438171958215e-10 -8.443151912847303896e-14 5.511521613114034324e-01 2.219935613616426477e-10 -8.831363085873893081e-14 5.511521613214317439e-01 2.319766087797221491e-10 -1.188150000700097358e-13 3.364299927208931677e-10 5.511521614216632337e-01 -1.102529610343951186e-13 3.110562780437835938e-10 5.511521613960818078e-01 -9.416915539900896195e-14 2.638023237497959918e-10 5.511521613489139826e-01 -7.172216260123912201e-14 1.985610551188528054e-10 5.511521612848621077e-01 -4.798564416538848256e-14 1.303748946117488464e-10 5.511521612186615071e-01 -3.152779996241535095e-14 8.318859512228465199e-11 5.511521611726124537e-01 -1.742913207709484271e-14 4.345155714859553604e-11 5.511521611328157322e-01 -4.362074640149108371e-16 8.386113297816960084e-13 5.511521610902144763e-01 -1.697648021942106372e-15 5.778807209279247983e-12 5.511521610951900518e-01 -1.087596590303818798e-14 3.115946962699567551e-11 5.511521611207280680e-01 -2.971437680955996673e-14 8.128118321503398243e-11 5.511521611711576174e-01 -5.078809838724731776e-14 1.360237360906966293e-10 5.511521612259364655e-01 -6.673195043526990710e-14 1.768136644254011820e-10 5.511521612665329917e-01 -7.749339352325572455e-14 2.042415438171958215e-10 5.511521612937432257e-01 -8.442475443104789666e-14 2.219935613616426477e-10 5.511521613113677942e-01 -8.828956238360888246e-14 2.319766087797221491e-10 5.511521613213047344e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 new file mode 100644 index 000000000..a69516cf8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 @@ -0,0 +1 @@ +-1.070704923600961610e-02 9.590665264543965789e-05 9.531439139412617738e-05 -1.074071029419736145e-02 9.129668075847219148e-05 8.964512109562496880e-05 -1.079922903748575802e-02 8.160863449766759072e-05 7.822493442003341667e-05 -1.086649201710983802e-02 6.585541552651084929e-05 6.216889793101057070e-05 -1.092184577105243838e-02 4.310522446295776412e-05 4.237600180365882092e-05 -1.094372364105911273e-02 1.812953329238082504e-05 2.108092186347079811e-05 -1.091354653816558121e-02 7.344071357638929535e-06 6.594939877021915154e-06 -1.081922354136362688e-02 5.604808312536211697e-08 -3.993392196314127732e-09 -1.067534963437232094e-02 2.615170878642820496e-06 2.194626210386702855e-06 -1.051552098348847684e-02 1.108524983848711417e-05 1.120727782311460267e-05 -1.034860235144822137e-02 2.260531410332143823e-05 2.309346290376646980e-05 -1.018500528053676787e-02 3.529390394675210245e-05 3.537888812786970803e-05 -1.003604623754423414e-02 4.694183749794504147e-05 4.658032944954926339e-05 -9.912748877628193081e-03 5.625492707059362614e-05 5.549200117260081781e-05 -9.824647772162841200e-03 6.247154907701019642e-05 6.156020753477102546e-05 -9.778745342621837297e-03 6.547958505991871223e-05 6.456075886179217657e-05 -1.298591462914885764e-13 5.511521614351690967e-01 3.415372207698701941e-10 -1.205219734136297542e-13 5.511521614094899713e-01 3.156494660850225659e-10 -1.028804491080669016e-13 5.511521613612111459e-01 2.674478333198038195e-10 -7.798968963314317353e-14 5.511521612935431635e-01 2.009868600944651299e-10 -5.148680913353014180e-14 5.511521612220536825e-01 1.315377984985043261e-10 -3.314936010271762060e-14 5.511521611726650782e-01 8.330742978544804850e-11 -1.798313439336129056e-14 5.511521611323919601e-01 4.297727196051056421e-11 -2.125413543902290102e-16 5.511521610897962553e-01 3.940349974161936644e-13 -1.904211194207688632e-15 5.511521610955002481e-01 6.129033807487406623e-12 -1.185259737605543893e-14 5.511521611217425898e-01 3.252221101804142105e-11 -3.191924198516412843e-14 5.511521611727657755e-01 8.385507274949977790e-11 -5.448733739928970617e-14 5.511521612287541005e-01 1.398896693016713257e-10 -7.181459230452751458e-14 5.511521612709645579e-01 1.819184668392482052e-10 -8.369033256031732205e-14 5.511521612996523878e-01 2.104012952906939078e-10 -9.140264912224607956e-14 5.511521613182850388e-01 2.289168017022558459e-10 -9.569014021349925332e-14 5.511521613287075905e-01 2.392990558728726938e-10 -1.282737307431118853e-13 3.415372207698701941e-10 5.511521614267772540e-01 -1.188518654693748182e-13 3.156494660850225659e-10 5.511521614006803516e-01 -1.012302179753177918e-13 2.674478333198038195e-10 5.511521613525626195e-01 -7.678601032422692406e-14 2.009868600944651299e-10 5.511521612872904985e-01 -5.105278537757835586e-14 1.315377984985043261e-10 5.511521612198269082e-01 -3.316294468987558005e-14 8.330742978544804850e-11 5.511521611727315806e-01 -1.797303245670672152e-14 4.297727196051056421e-11 5.511521611323425551e-01 -2.064276543062290903e-16 3.940349974161936644e-13 5.511521610897718304e-01 -1.910188163332873348e-15 6.129033807487406623e-12 5.511521610955379957e-01 -1.191507118981336216e-14 3.252221101804142105e-11 5.511521611220854266e-01 -3.210333199232560435e-14 8.385507274949977790e-11 5.511521611737292270e-01 -5.469318136474525074e-14 1.398896693016713257e-10 5.511521612298093675e-01 -7.195178772932810867e-14 1.819184668392482052e-10 5.511521612716577811e-01 -8.374676137127816038e-14 2.104012952906939078e-10 5.511521612999354947e-01 -9.141220438575931199e-14 2.289168017022558459e-10 5.511521613183330004e-01 -9.568322013134978671e-14 2.392990558728726938e-10 5.511521613286741728e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 new file mode 100644 index 000000000..a43d68ce9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 @@ -0,0 +1 @@ +-1.079810327176170849e-02 9.590665263806430485e-05 9.531439138681879026e-05 -1.082133986197232091e-02 9.129668075176909799e-05 8.964512108899335135e-05 -1.086104770533694898e-02 8.160863449218595941e-05 7.822493441462198744e-05 -1.090486487629455450e-02 6.585541552262542107e-05 6.216889792717478539e-05 -1.093699389747385987e-02 4.310522446066718374e-05 4.237600180138493725e-05 -1.094102170378864237e-02 1.812953329121437936e-05 2.108092186230421013e-05 -1.090294142063227313e-02 7.344071357286399505e-06 6.594939876669453733e-06 -1.081385188975930028e-02 5.604808333265849523e-08 -3.993391989261059679e-09 -1.068669846587412021e-02 2.615170878469684421e-06 2.194626210213913639e-06 -1.054746866101786799e-02 1.108524983766220403e-05 1.120727782228946213e-05 -1.040349887828524722e-02 2.260531410148688345e-05 2.309346290192826939e-05 -1.026343648015519069e-02 3.529390394380398733e-05 3.537888812491527066e-05 -1.013659798195091707e-02 4.694183749402758185e-05 4.658032944562455995e-05 -1.003201474286635059e-02 5.625492706590676923e-05 5.549200116790511787e-05 -9.957477156249913350e-03 6.247154907177446216e-05 6.156020752952489641e-05 -9.918698476542184284e-03 6.547958505438113608e-05 6.456075885624255222e-05 -1.372345051540735491e-13 5.511521614387121515e-01 3.450934816673409683e-10 -1.272250687983872486e-13 5.511521614126460022e-01 3.188152447307481149e-10 -1.083620778579741356e-13 5.511521613636577444e-01 2.698992410316920175e-10 -8.187512337654252173e-14 5.511521612950849303e-01 2.025304413536532515e-10 -5.377739064604713816e-14 5.511521612226746303e-01 1.321595452694798836e-10 -3.431580511106814791e-14 5.511521611725501701e-01 8.319245420060866337e-11 -1.833566459123447916e-14 5.511521611318969116e-01 4.248368808307077740e-11 -5.244974867519171904e-18 5.511521610894049017e-01 4.461376480120404405e-15 -2.077347404759383418e-15 5.511521610957995643e-01 6.426340798515867453e-12 -1.267750823417400180e-14 5.511521611228864526e-01 3.366070289956308567e-11 -3.375379770006157135e-14 5.511521611748972926e-01 8.598181199456600083e-11 -5.743545374605908976e-14 5.511521612319260077e-01 1.430617097970324829e-10 -7.573205426397560856e-14 5.511521612751275612e-01 1.860896870779573597e-10 -8.837718764265274939e-14 5.511521613046572732e-01 2.154231466443203548e-10 -9.663838841903948489e-14 5.511521613238987705e-01 2.345548248411923024e-10 -1.012277105406046841e-13 5.511521613346396231e-01 2.452596021237108103e-10 -1.355811164218337284e-13 3.450934816673409683e-10 5.511521614303468430e-01 -1.254834857180638160e-13 3.188152447307481149e-10 5.511521614038559225e-01 -1.066416406361404335e-13 2.698992410316920175e-10 5.511521613550187659e-01 -8.062179794613987743e-14 2.025304413536532515e-10 5.511521612888358179e-01 -5.332666918400598888e-14 1.321595452694798836e-10 5.511521612204494103e-01 -3.432953189457771998e-14 8.319245420060866337e-11 5.511521611726165615e-01 -1.832549354608158398e-14 4.248368808307077740e-11 5.511521611318505043e-01 6.254136042124746183e-19 4.461376480120404405e-15 5.511521610893840295e-01 -2.082977547153305715e-15 6.426340798515867453e-12 5.511521610958333151e-01 -1.274021189859703854e-14 3.366070289956308567e-11 5.511521611232186313e-01 -3.394153143302436854e-14 8.598181199456600083e-11 5.511521611758511963e-01 -5.764762021101389148e-14 1.430617097970324829e-10 5.511521612329814968e-01 -7.587649208599053527e-14 1.860896870779573597e-10 5.511521612758372157e-01 -8.844246024549246475e-14 2.154231466443203548e-10 5.511521613049743529e-01 -9.665833786968677757e-14 2.345548248411923024e-10 5.511521613239954709e-01 -1.012328486483025335e-13 2.452596021237108103e-10 5.511521613346633819e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 new file mode 100644 index 000000000..1bf7fcf3c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 @@ -0,0 +1 @@ +-1.085696372905541572e-02 9.590665263268892534e-05 9.531439138149214564e-05 -1.087285026672958968e-02 9.129668074690197891e-05 8.964512108417805713e-05 -1.089934659661038335e-02 8.160863448823787785e-05 7.822493441072447037e-05 -1.092682686540792300e-02 6.585541551986992125e-05 6.216889792445530818e-05 -1.094302784897970351e-02 4.310522445909330843e-05 4.237600179982345573e-05 -1.093527680815354307e-02 1.812953329046918349e-05 2.108092186155901765e-05 -1.089287161528582938e-02 7.344071357129744996e-06 6.594939876512081788e-06 -1.080919798872607106e-02 5.604808351519654382e-08 -3.993391807973187881e-09 -1.069588929542673698e-02 2.615170878308496592e-06 2.194626210053400472e-06 -1.057328834728593799e-02 1.108524983694688809e-05 1.120727782157434102e-05 -1.044759393770748959e-02 2.260531409994671328e-05 2.309346290038548358e-05 -1.032610521628437271e-02 3.529390394137225061e-05 3.537888812247984088e-05 -1.021661944063230812e-02 4.694183749082698993e-05 4.658032944241987516e-05 -1.012665834692254296e-02 5.625492706209476860e-05 5.549200116408882109e-05 -1.006269191828215032e-02 6.247154906752440319e-05 6.156020752526919959e-05 -1.002945765489209572e-02 6.547958504988935424e-05 6.456075885174450911e-05 -1.426098877749689628e-13 5.511521614411500902e-01 3.475414238766908071e-10 -1.320921894986668461e-13 5.511521614147902870e-01 3.209665411206837040e-10 -1.123101594909046259e-13 5.511521613652671236e-01 2.715115181134816178e-10 -8.463062761270496658e-14 5.511521612960196270e-01 2.034657580607797225e-10 -5.535126492102893174e-14 5.511521612229358658e-01 1.324208826049501644e-10 -3.506099971958651147e-14 5.511521611722933756e-01 8.293567698182739019e-11 -1.849231877642635688e-14 5.511521611314073033e-01 4.199581709678307785e-11 1.772930712047402462e-16 5.511521610890652845e-01 -3.335942107773004525e-13 -2.238535038211716216e-15 5.511521610960595785e-01 6.684575267222625209e-12 -1.339282445131259646e-14 5.511521611238613394e-01 3.463057584800269050e-11 -3.529396899725199245e-14 5.511521611766948547e-01 8.777378273058947547e-11 -5.986719046956684354e-14 5.511521612345834376e-01 1.457157943700589480e-10 -7.893264298332067380e-14 5.511521612786011159e-01 1.895646971066138161e-10 -9.218918789089945512e-14 5.511521613088231630e-01 2.195963003662377120e-10 -1.008884457477245563e-13 5.511521613285653709e-01 2.392338730603222662e-10 -1.057194886646725717e-13 5.511521613395681252e-01 2.502036541336534931e-10 -1.409077674744445075e-13 3.475414238766908071e-10 5.511521614328048768e-01 -1.302987810057701414e-13 3.209665411206837040e-10 5.511521614060141960e-01 -1.105391644434757785e-13 2.715115181134816178e-10 5.511521613566340294e-01 -8.334127062186571575e-14 2.034657580607797225e-10 5.511521612897717359e-01 -5.488815399957808363e-14 1.324208826049501644e-10 5.511521612207108678e-01 -3.507472473785358565e-14 8.293567698182739019e-11 5.511521611723598779e-01 -1.848286527359958550e-14 4.199581709678307785e-11 5.511521611313643376e-01 1.819132850479378267e-16 -3.335942107773004525e-13 5.511521610890475209e-01 -2.243490806533228033e-15 6.684575267222625209e-12 5.511521610960897766e-01 -1.345533259438369492e-14 3.463057584800269050e-11 5.511521611241835261e-01 -3.548431676155173012e-14 8.777378273058947547e-11 5.511521611776375451e-01 -6.008304928116954753e-14 1.457157943700589480e-10 5.511521612356322652e-01 -7.908117933379183647e-14 1.895646971066138161e-10 5.511521612793136571e-01 -9.225875569644150163e-14 2.195963003662377120e-10 5.511521613091547867e-01 -1.009140294601478637e-13 2.392338730603222662e-10 5.511521613286870513e-01 -1.057308899933572344e-13 2.502036541336534931e-10 5.511521613396230812e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener new file mode 100644 index 000000000..e813a21b5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.10536570559224986 +1 0.10796937940537532 +2 0.11345960616975363 +3 0.1212624516109319 +4 0.13012394556425977 +5 0.13827782900531155 +6 0.14409064567424526 +7 0.1461902163768674 +8 0.14401559329086475 +9 0.1387049765671873 +10 0.1317616524444068 +11 0.12404435388233291 +12 0.11649826568505901 +13 0.11020034438699838 +14 0.10586150314813286 +15 0.10381457460636012 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz new file mode 100644 index 000000000..09c0da4a8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.2338795766224093 -9.185751638307675e-06 -9.170594808261747e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.24478871062029 -9.405715807785623e-06 -9.328311511138299e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.26843265725372 -9.694546100464719e-06 -9.519057200421615e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.3044024213512357 -9.688289515450733e-06 -9.46497554037383e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.35178958288926 -8.952562167125351e-06 -8.800440971467672e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4090217878182414 -7.265583994519626e-06 -7.2406448204059026e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.473765291436546 -4.82102199576491e-06 -4.8093632178294764e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.54280841527487 -1.6558231290973311e-06 -1.6426613404654877e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.612485481280858 2.008439605194964e-06 2.0085838049465735e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.679250280047245 5.721026671731593e-06 5.741302436633021e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.740116443143028 9.125784238663506e-06 9.155702353045912e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.7926940222652745 1.19825512684691e-05 1.1998672079359658e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.8353763556322398 1.4164426280512515e-05 1.4163913412556703e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.86731134260644 1.5672671201531046e-05 1.5658821371351862e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.8881333553815858 1.658675162646438e-05 1.656988716663592e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.89771729893857 1.7011046116345982e-05 1.6996213671995334e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener new file mode 100644 index 000000000..5820aa4d5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.1218827567373583 +1 0.12376633885695405 +2 0.1272969907469428 +3 0.13190915937202585 +4 0.13685949957851087 +5 0.14135193350855776 +6 0.14464774056006036 +7 0.14614388040422033 +8 0.14551668791135072 +9 0.14303144824806435 +10 0.13935284143118107 +11 0.13518027539170005 +12 0.1310216710169069 +13 0.12736166466603177 +14 0.1246476483143118 +15 0.12321605103328478 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz new file mode 100644 index 000000000..b792d0040 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.3074350985754792 -2.7549445591001885e-05 -2.7352321788586044e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.3168534649703165 -2.7260928517143696e-05 -2.6974934202558762e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.3355469623666747 -2.642582115050647e-05 -2.6021711310764623e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.3627851998948883 -2.4559776062448903e-05 -2.414989419429872e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.397472083680028 -2.120326802291498e-05 -2.0979659457108357e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4382415063512237 -1.6370401337991057e-05 -1.6352966160034544e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4835124163588627 -1.047798943323511e-05 -1.046722632809185e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.531489196698338 -3.559836390180045e-06 -3.543215189221622e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.58026448188705 4.0579951057478135e-06 4.0552552916313585e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.62790168507653 1.1727872727649345e-05 1.1761852754709526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.672529003922486 1.888166459121651e-05 1.89506807423656e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.7123277954572282 2.5099938374188027e-05 2.5148831092684477e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.7456996311400164 3.0094852780727954e-05 3.0106086573283223e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.771492611065614 3.375683321126147e-05 3.373742662541981e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7889712631403287 3.610981351920346e-05 3.607855987506698e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.79771729893857 3.7245504823328295e-05 3.721360291543399e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener new file mode 100644 index 000000000..36ef3dadc --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14507181525154492 +1 0.14517396274559144 +2 0.14536020010596862 +3 0.14559719728719883 +4 0.14584153592877977 +5 0.14604655231091665 +6 0.14616982161609277 +7 0.14618011947798115 +8 0.1460637857497645 +9 0.14583053706701643 +10 0.14550850210083763 +11 0.14513816768301444 +12 0.1447661137386723 +13 0.14443854893646796 +14 0.14419551128446056 +15 0.1440662831199471 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz new file mode 100644 index 000000000..6b6053094 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4921767953462934 -1.3276389746729271e-05 -1.324801755887069e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.494497114585103 -1.2759547064663646e-05 -1.272522095159673e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4990467736972333 -1.1744052734906709e-05 -1.1701948101932387e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5056472301255868 -1.0268051923100385e-05 -1.0224677958437996e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5140392262604623 -8.393785262540042e-06 -8.358809081030318e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5238930310716605 -6.211726529627295e-06 -6.186768006408851e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.53482187169405 -3.820271240190022e-06 -3.800476568943432e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5463980832822752 -1.2858885684741117e-06 -1.2788605237250551e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.558171191740101 1.308792148574084e-06 1.3002737348858843e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5696867327550046 3.877095658024553e-06 3.853930788802308e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.580504240525519 6.323072173381118e-06 6.288352976581608e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.590213910889867 8.547855163974295e-06 8.504365987738271e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5984514157282512 1.0455862728803362e-05 1.0406695256470188e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6049104261124336 1.196345037510925e-05 1.191124379427906e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6093526089185066 1.3004831922907856e-05 1.2951744118472913e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.611615033378179 1.3536150880341274e-05 1.34831404698838e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener new file mode 100644 index 000000000..99f382be3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14531323720381514 +1 0.14539501057208679 +2 0.1455438423654375 +3 0.14573259137473488 +4 0.1459259428647639 +5 0.14608600813779535 +6 0.14617843093734958 +7 0.14617805039150303 +8 0.1460740846473999 +9 0.1458745071982089 +10 0.14560224510858077 +11 0.14529055039961306 +12 0.14497793405448836 +13 0.14470283037066778 +14 0.14449871442730322 +15 0.14439016793831194 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz new file mode 100644 index 000000000..08def2ace --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4978555023581333 -1.2071018496214084e-05 -1.203923044164549e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.49995146175012 -1.159974886440837e-05 -1.1563146170658848e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.504061177182041 -1.0674312787077109e-05 -1.0631686822341612e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5100233895979915 -9.330312702677288e-06 -9.287672265204843e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.517604060487807 -7.625174315496494e-06 -7.591155216011376e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5265056888640256 -5.641359832505317e-06 -5.617393332533097e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.536379434307516 -3.46832568206946e-06 -3.4499738958467935e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.546839594093882 -1.1674862110622496e-06 -1.161037596283524e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5574797381760384 1.18620997085083e-06 1.1785208265130847e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5678894827351475 3.514678993818643e-06 3.4935318092411517e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.577670638152364 5.731756721937326e-06 5.699561223752687e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5864522703240316 7.748501196500922e-06 7.70741444267704e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.593904178618752 9.478622143726496e-06 9.431224555566321e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5997483789029516 1.0846228967869923e-05 1.0794926821529138e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.603768349252438 1.179132053602039e-05 1.1738298758559682e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.6058159391614715 1.2273668234503348e-05 1.2220204461951872e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener new file mode 100644 index 000000000..3550e922e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14550101339861735 +1 0.14556675210023756 +2 0.1456861697310506 +3 0.14583703672906578 +4 0.145990460893933 +5 0.14611549593391732 +6 0.14618415515819438 +7 0.14617604972762438 +8 0.1460826468388222 +9 0.1459105789285923 +10 0.14567871570277854 +11 0.14541457937245958 +12 0.14515021484922705 +13 0.14491776126564382 +14 0.14474533099623108 +15 0.14465363689020355 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz new file mode 100644 index 000000000..c5322fc3a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5028344185254014 -1.0998857461509992e-05 -1.0964989009268716e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5047339371603576 -1.0568391128665952e-05 -1.0530644802286103e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.508458483914699 -9.723480503540058e-06 -9.681130401288073e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.513861970972987 -8.497279064483644e-06 -8.455877207131806e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5207324587689746 -6.942764133383971e-06 -6.910045026918555e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5288006367668006 -5.135257690500479e-06 -5.112452162180002e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5377507914815913 -3.1562851274023217e-06 -3.1392897684000942e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5472338351114856 -1.0625004038976983e-06 -1.0565759409439783e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5568817751983746 1.0779378009300926e-06 1.0709773250782013e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5663227478104065 3.194409293559749e-06 3.1750913899470306e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.575195581335811 5.209202131829228e-06 5.179433754904148e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.583163459254346 7.042001563913517e-06 7.003466566123488e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5899262150302516 8.6146743912908e-06 8.569537838211026e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.59523087619049 9.85822848948752e-06 9.808670596465747e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5988802144393963 1.0717883450075976e-05 1.0666052909407505e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.600739179487716 1.115674053118084e-05 1.1104109729942373e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener new file mode 100644 index 000000000..04bc6d28b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14564842751143234 +1 0.14570141332180533 +2 0.14579745710500014 +3 0.14591827012574327 +4 0.14604010724900124 +5 0.1461375772861378 +6 0.14618778013720085 +7 0.14617412667941082 +8 0.14608985984227116 +9 0.1459405609456761 +10 0.1457418873591575 +11 0.14551676472400318 +12 0.1452919980213605 +13 0.14509457961024028 +14 0.14494820383507648 +15 0.14487037696387775 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz new file mode 100644 index 000000000..e3fad801b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.507238145205192 -1.0039596728063162e-05 -1.0004717858277204e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5089641612449 -9.645842953496683e-06 -9.607845582073404e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5123485324157397 -8.87330205483223e-06 -8.831830426322087e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.517258592047131 -7.752792367168526e-06 -7.712978793325162e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5235019240245604 -6.3331838743707035e-06 -6.301976425246004e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.530834087351979 -4.683394356581847e-06 -4.661835876327377e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5389685590181283 -2.877867992649277e-06 -2.862141783938421e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5475884965277293 -9.68819939041767e-07 -9.633720190439805e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.556359766856151 9.816351953312563e-07 9.753194399855342e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.564944479793461 2.909430850626571e-06 2.8917717977094113e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5730141719900153 4.74423769796953e-06 4.7167662405370145e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5802622364283145 6.413310974895875e-06 6.377351608392685e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.586415161513248 7.845730194260783e-06 7.803110931407914e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5912422234466983 8.97866880883221e-06 8.931359898617449e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5945633922587232 9.762066968886341e-06 9.712142709639232e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5962553148988246 1.0162077821842475e-05 1.0111116188322759e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener new file mode 100644 index 000000000..5e9148deb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14576493287455977 +1 0.14580769251267692 +2 0.14588501062246853 +3 0.14598178813813772 +4 0.14607844165879905 +5 0.14615406542689888 +6 0.14618985880914565 +7 0.14617228628322373 +8 0.14609600373935153 +9 0.1459657554081768 +10 0.1457946237623688 +11 0.14560180806316425 +12 0.1454098282194614 +13 0.1452414357007765 +14 0.14511666075804922 +15 0.1450503367677918 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz new file mode 100644 index 000000000..9301db52e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5111606798170047 -9.17716465201022e-06 -9.14209699398304e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.512732368612636 -8.816577868396755e-06 -8.779002960870806e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5158141698633125 -8.109353634134987e-06 -8.069194533296695e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.520285365072544 -7.08409947991164e-06 -7.0461012662288805e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.525970900784018 -5.785893776645757e-06 -5.756316663153289e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.532648428931612 -4.277880063268686e-06 -4.257600290609066e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.540057335642029 -2.6281451152008435e-06 -2.6136027364501277e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.547909388594844 -8.847882149724919e-07 -8.797751920618605e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5559005074643006 8.954870475966005e-07 8.897450771580096e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5637229909940498 2.6544170639033133e-06 2.6382637982080897e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5710774875741813 4.32817859546898e-06 4.302859819205327e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.577684328375182 5.850720214094866e-06 5.817285713819333e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5832938181144174 7.157537779143814e-06 7.117541342107683e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.587695151905635 8.191337616671355e-06 8.146558542657256e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.590723724972326 8.906336552771299e-06 8.85875252889686e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5922666906740184 9.271483047664874e-06 9.22271432125168e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener new file mode 100644 index 000000000..13a714d47 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14585742968318877 +1 0.145891937157076 +2 0.1459541591543073 +3 0.1460315965354697 +4 0.1461080550645742 +5 0.14616627709284385 +6 0.14619079018478412 +7 0.1461705308587385 +8 0.14610128567098943 +9 0.14598712295446123 +10 0.14583903975605428 +11 0.14567318811527613 +12 0.1455085575411223 +13 0.14536438269747914 +14 0.1452576384569077 +15 0.1452009197308146 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz new file mode 100644 index 000000000..4bf2ce396 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.514674653724253 -8.39865755125476e-06 -8.364013558493722e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.516108280977219 -8.068135746999766e-06 -8.0314748015058e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.518919407184956 -7.4200697244202336e-06 -7.381521127264969e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.522998005935406 -6.4809847053834766e-06 -6.444935451178229e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.528184548668528 -5.292459045693392e-06 -5.264565366422552e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.534276425503741 -3.912408013486879e-06 -3.893402865711144e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5410361558768186 -2.403184668353743e-06 -2.389744168663515e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5482010474481345 -8.090838370567383e-07 -8.044688204007217e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5554938583688744 8.180580447487112e-07 8.12829237991536e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.562633876668864 2.425150202622308e-06 2.4103654611660335e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5693478151015254 3.954144548228666e-06 3.930830819117997e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5753801633443465 5.344945341010591e-06 5.313941110176764e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5805026225785443 6.538785515546165e-06 6.501420455437681e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5845223140253974 7.483354024743117e-06 7.44123557359131e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5872885365407745 8.136749433453178e-06 8.091746728393349e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.588697925294315 8.470480065963727e-06 8.424211181622526e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener new file mode 100644 index 000000000..e0fcd9f41 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14593106259329333 +1 0.14595887867467452 +2 0.14600887285703046 +3 0.14607067729174922 +4 0.1461308736865991 +5 0.1461751888260367 +6 0.14619086815873902 +7 0.1461688610702842 +8 0.1461058623930108 +9 0.14600538807848898 +10 0.14587673126746956 +11 0.14573353408884454 +12 0.1455918594797743 +13 0.14546801044261723 +14 0.1453764026933027 +15 0.14532774930608364 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz new file mode 100644 index 000000000..0610d73e0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.517837351297163 -7.693557681738099e-06 -7.65978157136043e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5191468862314457 -7.390364970425837e-06 -7.354964567677565e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.521714726159168 -6.796035141959011e-06 -6.759289056756867e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5254404537010084 -5.935139664155653e-06 -5.9011033185232035e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.530178484065014 -4.84602590940882e-06 -4.819822787504635e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.535743924427901 -3.5818589458487313e-06 -3.564100898688256e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5419200498331627 -2.1998008250091734e-06 -2.187384316190748e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.548467081360569 -7.406360840098942e-07 -7.36386075477269e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.555131866109404 7.481939173454505e-07 7.434259394522509e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5616579408849867 2.218234569241501e-06 2.2046951623524977e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5677954671898977 3.616594321568272e-06 3.59514050566153e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.573310701115036 4.888504508967804e-06 4.859811291683616e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.577994651715873 5.9803497755125294e-06 5.9455626502972934e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5816706410529053 6.844319777815635e-06 6.80489224755034e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.584200550541177 7.442042295574501e-06 7.399729706863217e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5854896054640495 7.747370095026103e-06 7.703757656100504e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener new file mode 100644 index 000000000..6fcc384cd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14598973741002735 +1 0.14601210828441796 +2 0.14605216363214474 +3 0.14610129075562694 +4 0.14614835559959635 +5 0.14618153787961302 +6 0.14619031288778522 +7 0.1461672764641134 +8 0.1461098547743081 +9 0.1460211074781575 +10 0.1459089249914491 +11 0.1457848694949361 +12 0.14566256546387363 +13 0.14555586142969185 +14 0.1454770217211532 +15 0.14543517240934076 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz new file mode 100644 index 000000000..9fdc6474b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.520694797519738 -7.053174252077996e-06 -7.0205781154123785e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.521892363610902 -6.7748808218525835e-06 -6.7409747064577144e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.52424068517744 -6.2294792284398454e-06 -6.1946467671376885e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5276480112230924 -5.439713181387034e-06 -5.407702564909302e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.531981327034601 -4.440947231092299e-06 -4.416409847539191e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5370717042698536 -3.2820185989588404e-06 -3.265465010442283e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.542721115180289 -2.0153748000622902e-06 -2.003908754351896e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5487104225683987 -6.785647664080169e-07 -6.74650026074427e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.554808184260509 6.849517828777304e-07 6.80599055551547e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5607798124592698 2.030893776139899e-06 2.0184889466718176e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5663966476849414 3.3109961189352297e-06 3.2912627840369e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5714446316598942 4.475275678490811e-06 4.448761662494998e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5757322596510925 5.4747598370227585e-06 5.442458342815548e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.579097545637557 6.265714171047673e-06 6.228941068648433e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.58141379522039 6.8129799670672295e-06 6.773375946871023e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.58259404028119 7.092557601957448e-06 7.051654331632527e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener new file mode 100644 index 000000000..3a2e811d9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14603646512958915 +1 0.14605439378948806 +2 0.1460863515906229 +3 0.14612517657160506 +4 0.14616162130895852 +5 0.14618588913954697 +6 0.14618929153422708 +7 0.1461657758250755 +8 0.1461133576078558 +9 0.14603471600903162 +10 0.14593657907753424 +11 0.14582877642876602 +12 0.14572289203991054 +13 0.14563071208607467 +14 0.1455626868287929 +15 0.145526600516353 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz new file mode 100644 index 000000000..8b2bcd8d6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.523284584451226 -6.47023323319693e-06 -6.4390268806534315e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.524380797466942 -6.214668248711744e-06 -6.182403556526163e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5265304115002776 -5.713905244778648e-06 -5.6810366719330255e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5296495149164144 -4.988981976704162e-06 -4.9589729553182325e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.533616459651903 -4.0725091289968685e-06 -4.049590822640548e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.538276748882584 -3.0093719988153825e-06 -2.9939707999300376e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5434492539272147 -1.8477251095915333e-06 -1.8371404324609802e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5489334961943726 -6.221366261480392e-07 -6.18530194368931e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5545176677016523 6.275505231842509e-07 6.235730517543269e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5599869811897107 1.8608259450387533e-06 1.849455902294815e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5651319682364666 3.0335919678956673e-06 3.015447041766392e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5697564296726676 4.100180080736201e-06 4.075708611375547e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5736847439979718 5.015814391586227e-06 4.985882839789928e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5767682860357963 5.740459838167104e-06 5.706261023178329e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5788907613907677 6.241887573706787e-06 6.204949503891107e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.579972314504694 6.498065818503665e-06 6.45985324511668e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener new file mode 100644 index 000000000..b98dcf026 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.1460735971871513 +1 0.14608789614671538 +2 0.14611324715300134 +3 0.1461436909117923 +4 0.14617154286582434 +5 0.1461886807404172 +6 0.14618793236211292 +7 0.1461643573934218 +8 0.14611644634392668 +9 0.14604655825255256 +10 0.14596045242238306 +11 0.14586650885993263 +12 0.1457745978511565 +13 0.14569476746313498 +14 0.1456359344767502 +15 0.1456047461994885 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz new file mode 100644 index 000000000..e0d3da7d8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5256378739057546 -5.938574594729835e-06 -5.908889481380335e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5266421000577486 -5.703788758458451e-06 -5.673246880528651e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5286113670481285 -5.2438170855883446e-06 -5.2129175115151606e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5314688720740617 -4.578108004979984e-06 -4.550050229661182e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5351032719557587 -3.736729654294182e-06 -3.7153692237762658e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5393731505600194 -2.7609521147986166e-06 -2.7466457477416266e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.544112695358054 -1.6950123616966028e-06 -1.6852443346424786e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5491383414196433 -5.707333470162801e-07 -5.674106746568626e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5542560872367845 5.753347033394243e-07 5.716971655395702e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.559269117643049 1.7060982588058524e-06 1.6956728984135393e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.563985400341855 2.7812259951572505e-06 2.764545516129739e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.56822497954963 3.758951238064402e-06 3.7363857395284642e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.571826695865793 4.59830133176426e-06 4.570611087755387e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5746541022474894 5.262605091030425e-06 5.230872802877559e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.576600392415166 5.7223079571569885e-06 5.687952735042317e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5775922044085027 5.957181798528656e-06 5.921593408148685e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener new file mode 100644 index 000000000..b30ede3ad --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13215069260352774 +1 0.13328510893692233 +2 0.13537171624379446 +3 0.13807397493098747 +4 0.14095577438872078 +5 0.14354714187596584 +6 0.14540427362568062 +7 0.14618109793552514 +8 0.14570515432718495 +9 0.1441159919601345 +10 0.14176328813689582 +11 0.1390588814734445 +12 0.1363878226794033 +13 0.13405004067180762 +14 0.1323142173401438 +15 0.13138958915111779 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz new file mode 100644 index 000000000..4f36e38a9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.364323858992897 -3.21302890404229e-05 -3.175314716381922e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.371732200103478 -3.1199701014820686e-05 -3.080300747127244e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.3862532218151973 -2.9210080225181126e-05 -2.882046577736939e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.407302347150796 -2.6000751756865886e-05 -2.5717840765881742e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4340446487983325 -2.155840078508938e-05 -2.1463327430153236e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.465425594656004 -1.6144076871256915e-05 -1.6169971894384257e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5001954966012505 -1.0092185154133942e-05 -1.008591965354794e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.536967358603013 -3.4054648798906628e-06 -3.3960013603990644e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.574299236618819 3.6694180957604696e-06 3.6570839783610146e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6107522769358993 1.075195020401925e-05 1.0745134983323968e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6449471097364863 1.7442300096795135e-05 1.7476725846182658e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.675607563100251 2.342081851187232e-05 2.348266006265242e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.7015854291772983 2.8423387207892355e-05 2.8483746211964207e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.721912113759738 3.226358216224244e-05 3.2305154771168974e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7358556128588702 3.4841327445866185e-05 3.48661069562564e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.7429409318400273 3.612747322621849e-05 3.614435816544613e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener new file mode 100644 index 000000000..950b0691b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14610299004434638 +1 0.1461143209598003 +2 0.1461342783876785 +3 0.14615790239061627 +4 0.1461788061086883 +5 0.14619025589256793 +6 0.1461863345517825 +7 0.14616301901253184 +8 0.14611918183653605 +9 0.1460569107242362 +10 0.14598115347414642 +11 0.14589907256290216 +12 0.14581909458534859 +13 0.1457497990455623 +14 0.14569880371011887 +15 0.1456717908416544 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz new file mode 100644 index 000000000..b80f1ace6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5277808418497556 -5.452925524068329e-06 -5.42483363862466e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5287013982173656 -5.2371609529024105e-06 -5.208373910028507e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5305066216494785 -4.814514792107188e-06 -4.785556332805183e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.53312616912275 -4.20295704234877e-06 -4.176782056877412e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.536458059884827 -3.4302084192261946e-06 -3.4103354230298626e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5403727606321893 -2.5342269647285205e-06 -2.520955123512588e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.544718372378705 -1.5556684004871101e-06 -1.5466565488753794e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5493266981027154 -5.238277483652123e-07 -5.207664039120683e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5540199230508613 5.277479728753768e-07 5.244190003218137e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5586175818812276 1.5650691111766743e-06 1.5555069079532224e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.562943518832399 2.5512175767689772e-06 2.5358859085943824e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.566832582923334 3.4479642010519137e-06 3.427171289175369e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5701368089654286 4.217790380669289e-06 4.192206928982363e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5727308707494965 4.827088608811384e-06 4.7976986257294955e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.574516633425285 5.248747712360092e-06 5.216866304574428e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5754266734728652 5.464193183270067e-06 5.43113090463804e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener new file mode 100644 index 000000000..639fe4989 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14612612279116377 +1 0.1461350267093396 +2 0.1461505819585336 +3 0.14616866054111322 +4 0.14618395507536927 +5 0.14619088557470014 +6 0.14618457518693487 +7 0.14616175823119754 +8 0.1461216137483958 +9 0.14606599780158838 +10 0.14599917528797074 +11 0.1459272826323046 +12 0.14585752694622905 +13 0.1457972442301277 +14 0.14575294990845486 +15 0.14572950589787578 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz new file mode 100644 index 000000000..bb46c0468 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.52973573867271 -5.0087287787006606e-06 -4.9822574328182e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.53058005119123 -4.810394468681984e-06 -4.783357666260589e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5322357875234007 -4.421939911959253e-06 -4.394871053742768e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5346384848970596 -3.8599615838512295e-06 -3.8355889276088e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.537694684111002 -3.150013021798432e-06 -3.1315516323148965e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.541285666748163 -2.3270144144971515e-06 -2.3147159563690284e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5452721975666908 -1.4283429244929488e-06 -1.420030843153231e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5495000702842656 -4.809658507586134e-07 -4.781452830815349e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.553806213166685 4.843131636964261e-07 4.81264767554189e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.558025063045915 1.4363297927933545e-06 1.4275568451289175e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5619949468550884 2.34126627470156e-06 2.327176005143067e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5655642304934694 3.1641074797345885e-06 3.1449588857964234e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.568597005791832 3.870477428330999e-06 3.846865145413501e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5709781173404282 4.429562648566767e-06 4.402382072557114e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5726173666838354 4.816486256329617e-06 4.786954018590488e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5734527684351556 5.014190225610846e-06 4.983536204383933e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener new file mode 100644 index 000000000..7de805b43 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14614418278334312 +1 0.1461511035560609 +2 0.1461630693292825 +3 0.14617664564525049 +4 0.14618742430857115 +5 0.14619078503245037 +6 0.14618271433122174 +7 0.14616057237945188 +8 0.14612378303936388 +9 0.14607400335879525 +10 0.14601492117017711 +11 0.14595180562976995 +12 0.14589083135291916 +13 0.14583827944530695 +14 0.14579972847939024 +15 0.14577934216293614 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz new file mode 100644 index 000000000..fe2721f0f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5315216793696282 -4.602011240208584e-06 -4.577154591411419e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5322964091397244 -4.419662847648406e-06 -4.3943449658836e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5338157155731813 -4.062557173436959e-06 -4.037309955681831e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5360204965025828 -3.546016001788472e-06 -3.523357790763477e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.538825060726089 -2.89359224519452e-06 -2.8764640494584878e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.542120548223945 -2.137417112457624e-06 -2.126031386125557e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.545779268558212 -1.3118627806760578e-06 -1.3041979371296326e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.549659773218942 -4.4175320031170183e-07 -4.391545426149361e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5536124402712583 4.4461720572807357e-07 4.41824311576397e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.557485310575888 1.3186602512223475e-06 1.310609454980475e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5611299420944924 2.1493796890311382e-06 2.136431345200618e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.564407059213267 2.9046857864460114e-06 2.88705949071574e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.567191786247367 3.553066228186324e-06 3.5312915779178104e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.569378281266869 4.066258585751773e-06 4.041151261937213e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.570883617934708 4.421430526770461e-06 4.394114520208813e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5716507963235253 4.602915077930829e-06 4.574540090111892e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener new file mode 100644 index 000000000..38975a898 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14615812909106254 +1 0.14616343172038415 +2 0.14617247580050768 +3 0.1461824056338953 +4 0.1461895627721617 +5 0.1461901259896966 +6 0.14618079878596005 +7 0.14615945862716437 +8 0.14612572381364505 +9 0.14608107940432186 +10 0.14602872374740541 +11 0.14597319097959752 +12 0.1459197797372712 +13 0.14587387478245173 +14 0.14584025745137436 +15 0.14582249656697024 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz new file mode 100644 index 000000000..c649e6885 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.533155240853861 -4.229282179290134e-06 -4.206010178061339e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.533866386465488 -4.061605168717239e-06 -4.037955804953958e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5352610216228846 -3.7332629722343146e-06 -3.7097584755565822e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5372849371236734 -3.258395504358826e-06 -3.2373598556163697e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5398595319307926 -2.6587089932251337e-06 -2.642835019901316e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5428849444029606 -1.963772247285397e-06 -1.9532400063965197e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5462440230624956 -1.2052005703102147e-06 -1.19813409787814e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5498069687260685 -4.058443215955202e-07 -4.034502264481451e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5534364460172436 4.0829955070153903e-07 4.0573961723986964e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5569929309311856 1.2109951129995598e-06 1.203605444914069e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5603400839284802 1.973818026790387e-06 1.9619196886794158e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5633499419218846 2.667345271738591e-06 2.651126108086472e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5659077352082464 3.2626773914567663e-06 3.242611024805476e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5679161589040147 3.733883410277202e-06 3.7107136715848386e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.56929895639391 4.060003071619387e-06 4.034767229283991e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5700037022766216 4.226645679118118e-06 4.200415126068886e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener new file mode 100644 index 000000000..ffa263bcf --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14616874025221727 +1 0.1461727254172044 +2 0.1461793974084925 +3 0.14618638384830412 +4 0.14619065184196486 +5 0.14618904583456696 +6 0.14617886492060966 +7 0.14615841403139432 +8 0.14612746471130686 +9 0.14608735258981947 +10 0.14604085936079714 +11 0.1459918947094713 +12 0.14594501271606516 +13 0.1459048354288914 +14 0.1458754649902771 +15 0.14585996290783465 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz new file mode 100644 index 000000000..ea08080c4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5346509193829942 -3.887453674774563e-06 -3.8657189902232226e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.535303900839933 -3.733249119924355e-06 -3.7112046739105024e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5365844893286424 -3.4313138357341044e-06 -3.4094663567745863e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5384429464725558 -2.9946928173374698e-06 -2.975186392982657e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.540807149719152 -2.4433879145691504e-06 -2.4286900885055556e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5435854599504024 -1.804612330238178e-06 -1.7948763489608578e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5466703573547615 -1.107450169101976e-06 -1.1009366575163458e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5499426920644583 -3.729344934468321e-07 -3.707289917205797e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.553276365229327 3.750431841890309e-07 3.726958871258823e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5565432317894605 1.1123972845607282e-06 1.1056131779103886e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.559618033739103 1.8130510219760318e-06 1.8021178846221581e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.562383172981317 2.450015390435012e-06 2.4350952961157357e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5647331453127133 2.9967775801389704e-06 2.9782956680054374e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.566578477609787 3.4295391450468866e-06 3.408174362223273e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5678490351342225 3.7290548791470592e-06 3.705763622182854e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5684965929418655 3.882105285768668e-06 3.857883436314316e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener new file mode 100644 index 000000000..b24127a6a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.1461766507293472 +1 0.146179566395736 +2 0.14618431909114293 +3 0.14618894022920037 +4 0.1461909190369592 +5 0.14618765463214942 +6 0.14617694092210726 +7 0.14615743557583016 +8 0.14612902997047988 +9 0.14609292918179909 +10 0.14605155908052586 +11 0.14600829764961157 +12 0.14596706506110194 +13 0.14593183352281472 +14 0.14590612596563124 +15 0.14589257091101612 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz new file mode 100644 index 000000000..a26a5bfb6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.536021485178015 -3.573777717926147e-06 -3.5535210802891476e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5366212135342963 -3.4319502142174583e-06 -3.4114384018567856e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.537797382470495 -3.1542699230836596e-06 -3.133990131533218e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5395043423639603 -2.752768197649831e-06 -2.734698076880939e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.541675895655521 -2.245874070849589e-06 -2.2322762416932765e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.544227923836711 -1.6586342604108595e-06 -1.6496397335949948e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5470617179652018 -1.0178074350705e-06 -1.011804723333238e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.550067872608832 -3.427532676585266e-07 -3.407216461935098e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.553130574762637 3.4456756858726693e-07 3.4241453582850976e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5561321011478846 1.022037212335664e-06 1.0158080104582596e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5589573490002135 1.6657240813160248e-06 1.6556779969493021e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5614982244819515 2.250863196412341e-06 2.23714122464981e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5636577244432113 2.753123805802293e-06 2.736108833130909e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5653535652650445 3.150659418555622e-06 3.1309716933366696e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.566521234670779 3.425796732214583e-06 3.4043174617758943e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5671163668873884 3.566391209606492e-06 3.5440441645352604e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener new file mode 100644 index 000000000..2b368dd13 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14618237910356155 +1 0.14618442987650948 +2 0.1461876364679404 +3 0.14619036770110008 +4 0.14619054863757955 +5 0.1461860405496274 +6 0.14617504847183463 +7 0.14615652020452657 +8 0.14613044024849883 +9 0.14609789890702132 +10 0.14606101724055306 +11 0.1460227195597517 +12 0.14598638550157045 +13 0.14595543295165522 +14 0.14593289044274196 +15 0.14592101667920937 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz new file mode 100644 index 000000000..123813ca3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5372782604979167 -3.285795984739361e-06 -3.266950289034529e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5378291962716126 -3.155343259848787e-06 -3.1362865569717127e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.5389096897857013 -2.8999499351693045e-06 -2.881147242095078e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.540477833584269 -2.530709560241822e-06 -2.513984597901145e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5424728530963976 -2.064599979903166e-06 -2.05202863245128e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.544817513870714 -1.5246746689731614e-06 -1.5163694555426748e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5474211734408443 -9.355548458583541e-07 -9.30023819296776e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5501833499150903 -3.150593076775602e-07 -3.1318800161787926e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5529976532474845 3.16623041822788e-07 3.146476295757116e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.555755912365839 9.391764124431578e-07 9.334558881635222e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.558352337334431 1.5306313929103749e-06 1.5214004125435196e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.560687554902231 2.0682570225195394e-06 2.055639198318159e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.562672366166669 2.529719142226776e-06 2.514060323416191e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.564231090947336 2.8949590068551013e-06 2.876826248774337e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.565304383270155 3.1477445744580268e-06 3.1279493454026916e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.565851424573891 3.276918086601852e-06 3.256315808502098e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener new file mode 100644 index 000000000..57dd8f5c6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14618635013361636 +1 0.14618770484402785 +2 0.14618967287951382 +3 0.14619090499047527 +4 0.14618968999375448 +5 0.14618427410300944 +6 0.14617320389548485 +7 0.14615566485049944 +8 0.14613171326299673 +9 0.1461023379594032 +10 0.14606939812575723 +11 0.14603543021814674 +12 0.14600335229271724 +13 0.14597610887362863 +14 0.14595630613217556 +15 0.14594588669530625 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz new file mode 100644 index 000000000..1b6dc0c18 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.5384313403265324 -3.0212993287421566e-06 -3.0037927690519255e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.538937542993439 -2.901303231325987e-06 -2.883621482489473e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.53993031923794 -2.666394772466744e-06 -2.648979086875019e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.541371188767723 -2.3268003533173225e-06 -2.311332145242199e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5432043437873295 -1.8981590708775887e-06 -1.8865437970912612e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5453588554391344 -1.4016900657919814e-06 -1.3940248185490666e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.547751471205801 -8.600491356987235e-07 -8.549535305333467e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5502898864182515 -2.896362352161764e-07 -2.8791273258843257e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.552876349134074 2.909863231874774e-07 2.8917342493767116e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5554114488393234 8.631542494184115e-07 8.579001805097841e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5577979407606226 1.4066943341887998e-06 1.3982122605269146e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.55994445735569 1.9007373056600699e-06 1.8891363803349417e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5617689676686286 2.3247771315169712e-06 2.310370560648445e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.563201859252653 2.660393258248543e-06 2.64369981814146e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5641885351157097 2.892675557593884e-06 2.874442156078576e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.564691438318159 3.011372225757741e-06 2.9923898841104494e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener new file mode 100644 index 000000000..5348c7e5f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14618891219376745 +1 0.14618971008791523 +2 0.14619069285692718 +3 0.14619074675827123 +4 0.14618846409317182 +5 0.14618241151631267 +6 0.14617141921891547 +7 0.14615486646029333 +8 0.14613286429786435 +9 0.1461063113759214 +10 0.1460768412658764 +11 0.14604665821587223 +12 0.14601828558184748 +13 0.14599426324267784 +14 0.1459768362587751 +15 0.14596767693653578 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz new file mode 100644 index 000000000..2997257f5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.539489769388331 -2.778294786708683e-06 -2.7620532322187327e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.5399549397086063 -2.6679134056017637e-06 -2.651525781648829e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.540867253810237 -2.451837953321239e-06 -2.4357209647274565e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5421913717972884 -2.1394934218971788e-06 -2.1251969696172193e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.543876037350898 -1.745284095938837e-06 -1.7345578885411274e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5458561006146945 -1.288740699207388e-06 -1.2816689125315263e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.548055083072409 -7.907112501068292e-07 -7.860174682037419e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5503881775583714 -2.662892556584396e-07 -2.6470201249509634e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5527655550425323 2.6745687298069853e-07 2.6579275507732033e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5550958436025497 7.933772213693751e-07 7.885510138635856e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.557289642902563 1.2929439691975601e-06 1.2851499278869605e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5592629379497356 1.7469929280399153e-06 1.736328070915664e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5609402838161444 2.136692905306344e-06 2.1234415222088143e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5622576454300225 2.4451251556212313e-06 2.4297621411462015e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.5631647924890286 2.658592346747734e-06 2.6418049339364744e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.5636271678982587 2.7676745259933693e-06 2.7501933407670717e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener new file mode 100644 index 000000000..9226a811d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14619035118482168 +1 0.14619070699962955 +2 0.14619091286669983 +3 0.1461900516834462 +4 0.14618696880233711 +5 0.14618049740360584 +6 0.14616970302480536 +7 0.14615412201583527 +8 0.1461339066076566 +9 0.14610987493352684 +10 0.14608346566825425 +11 0.14605659799922505 +12 0.1460314573249148 +13 0.1460102372726762 +14 0.14599487391951996 +15 0.14598680823928564 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz new file mode 100644 index 000000000..c1495b71f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.540461685335739 -2.5549784228003915e-06 -2.5399272013561747e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.540889201874614 -2.4534391447011732e-06 -2.4382655931849438e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.541727677502115 -2.2546812873915327e-06 -2.239777382154798e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5429446512904574 -1.967389528172729e-06 -1.954183674554429e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.544493039798159 -1.604829398997112e-06 -1.5949288116853977e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5463129920858996 -1.184977307557958e-06 -1.1784553051410164e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5483342419943114 -7.270181088389714e-07 -7.226950406123698e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.550478859856288 -2.4484239066381697e-07 -2.433807543641649e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5526642868502076 2.4585391534848e-07 2.443260745761545e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.554806530261252 7.293101936704286e-07 7.248765463383169e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5568233936762144 1.188506726603352e-06 1.1813447597905433e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5586376170955685 1.605841851793353e-06 1.5960383058374792e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5601798087781122 1.9640195362154016e-06 1.9518329665617193e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5613910616601223 2.2474983314934323e-06 2.233363695994186e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.562225161548596 2.443693865256606e-06 2.4282433063293773e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.562650311001014 2.543950076112425e-06 2.527857795030063e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener new file mode 100644 index 000000000..9f2b4b6e4 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13730005931925504 +1 0.1380263193144624 +2 0.1393625420912121 +3 0.1410935303665471 +4 0.14293716379640234 +5 0.14458341448204173 +6 0.14574172573696764 +7 0.1461897719489444 +8 0.14582003550694525 +9 0.14471614537009053 +10 0.14309284388477816 +11 0.1412151846162187 +12 0.13935144743980363 +13 0.1377361662400586 +14 0.1365475347377668 +15 0.13591719426786755 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz new file mode 100644 index 000000000..ad1c76860 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4009608426328675 -2.8904657150706698e-05 -2.868143364165211e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.406903467268721 -2.7875295723634033e-05 -2.7659716158651015e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4185613652253113 -2.580148534367715e-05 -2.5613442592225842e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4354858070567995 -2.2693024412792684e-05 -2.257318915222118e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4570177815148266 -1.864543495098748e-05 -1.8614701027679715e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.482306753584194 -1.3878704557412737e-05 -1.3887232390480516e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5103404521592325 -8.614572871996745e-06 -8.594436618526293e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5399967096545355 -2.9013507939016763e-06 -2.889667543851606e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.570100048241808 3.0644119809364467e-06 3.0482615874032357e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.599477620286296 9.022352945822206e-06 8.994113891237364e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6270081717226104 1.4684831611597494e-05 1.4673629731984437e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6516641085675476 1.9794118555610665e-05 1.9808189702512577e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.672543755587326 2.413005768173983e-05 2.41596788632578e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6888916205073716 2.7515183754154874e-05 2.7547500590664236e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7001222861407768 2.9825165719030634e-05 2.9855533864465776e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.705837935326308 3.099247302498524e-05 3.1021310943403594e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener new file mode 100644 index 000000000..556bc6be1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14012532125120616 +1 0.140626954863258 +2 0.14154940993031565 +3 0.14274279732691947 +4 0.14400919179695326 +5 0.14513203307607322 +6 0.14591020433901125 +7 0.14619092247254367 +8 0.14590119314633332 +9 0.1450942228590483 +10 0.14391274217389113 +11 0.14254020802020273 +12 0.14116887538107245 +13 0.1399739292874756 +14 0.13909626148316284 +15 0.13863276345665468 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz new file mode 100644 index 000000000..8eb74a343 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4257239412264444 -2.5494602628807726e-05 -2.5413055981510076e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4306778163137257 -2.454126163066722e-05 -2.445895661313423e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4403961930089575 -2.264938940188235e-05 -2.257108318180708e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4545045975384263 -1.98650875665116e-05 -1.980877230413782e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4724528231310012 -1.6291177429746135e-05 -1.6268591835590522e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.493531330038712 -1.2102897505880344e-05 -1.2093638832877361e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.516900603954207 -7.486762530355334e-06 -7.460655021618994e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5416295172338623 -2.5198428232604326e-06 -2.507899226777324e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.56673936043896 2.6318656088017365e-06 2.6155652555991164e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5912505533001795 7.76660003321155e-06 7.731566331945259e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6142243454573175 1.265718805377277e-05 1.2624045980761357e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.634798608525713 1.7086294277400142e-05 1.7066968150502447e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.652217378499661 2.0860212055635625e-05 2.0857014989239654e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.665852654372874 2.382187802324463e-05 2.382966189870507e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6752188234096943 2.5854316828847134e-05 2.5868733971239862e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.679985437728454 2.6885985767812875e-05 2.690376779925973e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener new file mode 100644 index 000000000..3cb39cd44 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14186095700325374 +1 0.1422245723072115 +2 0.1428923768233226 +3 0.14375398748087362 +4 0.14466418806756076 +5 0.14546495780119817 +6 0.1460103114107636 +7 0.146190081464537 +8 0.14595236309497425 +9 0.14533364698494589 +10 0.14443465567724204 +11 0.1433889186155001 +12 0.14234009106122228 +13 0.1414223057874322 +14 0.1407457473380864 +15 0.1403876736568159 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz new file mode 100644 index 000000000..f9f4f59b1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4438887872435737 -2.256442473822189e-05 -2.2542048410747825e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4481243921507145 -2.1707400387203864e-05 -2.167714895860535e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.45643228450216 -2.0015115858108776e-05 -1.9974198412513763e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4684899062092254 -1.753820832738212e-05 -1.749751537278912e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4838246194765468 -1.4369394865396784e-05 -1.4342977923739563e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5018306576401033 -1.0661327398684874e-05 -1.064293807693066e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.521793514829252 -6.581367084899604e-06 -6.554475237527975e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5429210517181167 -2.2147906126130797e-06 -2.203668589794198e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.564380097960494 2.2939628889330877e-06 2.2790330292705258e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.585335197461291 6.779087636264441e-06 6.743887921550519e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6049837040493293 1.1053321960841031e-05 1.1012179461363124e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6225864031189676 1.4931339522322942e-05 1.4894727775748625e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6374932295276428 1.8242780671599406e-05 1.8216526194915964e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6491634473376284 2.0846673663446312e-05 2.083110250306828e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6571802497690458 2.2637390369739697e-05 2.2630517523418283e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.6612603231089462 2.3548067310400284e-05 2.354613029350873e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener new file mode 100644 index 000000000..92f1a53fd --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14299471108667383 +1 0.14326718277069492 +2 0.14376687644554512 +3 0.14440991683561794 +4 0.14508631706760527 +5 0.1456768082582106 +6 0.14607164376689302 +7 0.14618846607926103 +8 0.14598894195393086 +9 0.14549933015005198 +10 0.14479383634993914 +11 0.14397328994593528 +12 0.14314838669730912 +13 0.14242442763806792 +14 0.1418893690287784 +15 0.14160569574970738 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz new file mode 100644 index 000000000..bd9b5bb1b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4577759016511185 -2.0089600595352772e-05 -2.0082045223699492e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4614600121790113 -1.932128515330706e-05 -1.9303177568408475e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.468685004390671 -1.780656372481563e-05 -1.77732214974945e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4791687442734744 -1.5593717376448624e-05 -1.5554479394960527e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.492499637365905 -1.2768315878182564e-05 -1.27375604654154e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.508151688447839 -9.466141408434825e-06 -9.442988513947507e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5255055330938885 -5.836214728563187e-06 -5.810233616182793e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5438751134372652 -1.96401503111777e-06 -1.9538744380996838e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5625386472611393 2.023156222690062e-06 2.009830716151849e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5807712558339873 5.983790654526376e-06 5.950731977184681e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.597874925247827 9.758579539384151e-06 9.715879551066107e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.613205068829001 1.3187095623195786e-05 1.3142930712137036e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.626193189633324 1.611907740633869e-05 1.607941508303544e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.636365048455572 1.8427972727788205e-05 1.8395160570537605e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6433542850005005 2.0017796548255627e-05 1.9991871709330826e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.6469118563384204 2.0827031849996838e-05 2.0805462630372526e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener new file mode 100644 index 000000000..62db10435 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14377875551042651 +1 0.14398761054192102 +2 0.14437010837394207 +3 0.14486107396291503 +4 0.14537522169216768 +5 0.1458203195743522 +6 0.14611179126660812 +7 0.1461864899688813 +8 0.14601540777031038 +9 0.14561821691015167 +10 0.14505136708502023 +11 0.144393078764371 +12 0.14373059929391033 +13 0.14314812074876274 +14 0.14271686361712765 +15 0.14248794108248958 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz new file mode 100644 index 000000000..d103efae0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4688652684983596 -1.7995788720794388e-05 -1.7985470376468053e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.47210915165591 -1.730365418890276e-05 -1.728317883311388e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4784703032118096 -1.5940547997913913e-05 -1.5905593871264364e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.48769973095205 -1.3952372200641325e-05 -1.3911370325481488e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4994348223480203 -1.1418236002772119e-05 -1.138461493285238e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.51321298415292 -8.459981794908749e-06 -8.434782996020102e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5284902868922963 -5.211189425502463e-06 -5.186690122539128e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.544664681082524 -1.7537628735476904e-06 -1.7445478680424073e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5611026204674263 1.7990042510120013e-06 1.7871558638938058e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5771669861459845 5.323972677812135e-06 5.293545911590901e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.592243041989607 8.683135231544175e-06 8.641402928397508e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.605761770425662 1.1736099379345333e-05 1.1689299447288859e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.61722004812727 1.4349739564573503e-05 1.4303145908847323e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6261971093564545 1.6410394776107766e-05 1.636694918010539e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.632367160246647 1.7830824405050523e-05 1.7791659417682672e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.6355083317159504 1.855440219286576e-05 1.8518265750177555e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener new file mode 100644 index 000000000..394626853 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.1443415212514584 +1 0.14450429320192903 +2 0.14480197581564375 +3 0.1451830561143355 +4 0.14558024262510605 +5 0.1459209319827529 +6 0.14613875121468506 +7 0.14618438290008173 +8 0.14603549672164207 +9 0.1457072917786887 +10 0.14524375676267556 +11 0.14470680723254467 +12 0.14416638086222233 +13 0.14369073097424398 +14 0.1433381654975646 +15 0.14315085822533646 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz new file mode 100644 index 000000000..80c7ff6b9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4779733736532457 -1.6199128115022177e-05 -1.618210056259022e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.480855988851664 -1.5573139454345886e-05 -1.5547324168506138e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4865084425270276 -1.4341426185491592e-05 -1.4303360396389102e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.494709153787839 -1.2547345866982495e-05 -1.25047210494146e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5051358362347678 -1.0263962083165892e-05 -1.0228900390207792e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.517377890016099 -7.601154611766094e-06 -7.575308201253294e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5309530437755026 -4.679084794951699e-06 -4.6561827908489125e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5453277746773257 -1.5747801382078563e-06 -1.5663837043097211e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.559940491981288 1.6102670739087558e-06 1.5996974691515773e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.574225768131435 4.767436907947184e-06 4.739619444469484e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5876371020525366 7.775546888241825e-06 7.735843085281448e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.599667627935302 1.0510555061787517e-05 1.046370660420573e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.609868218286932 1.2853829441749569e-05 1.2804292809530049e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6178624686625933 1.4703026909016015e-05 1.4653802624564793e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6233583757441026 1.5978811402118406e-05 1.593162394552983e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.6261567784904654 1.6629125125270316e-05 1.6583725085174496e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener new file mode 100644 index 000000000..b1c4b55a8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14475752696215818 +1 0.14488591362315625 +2 0.14512036367388953 +3 0.145419641169109 +4 0.1457299591047261 +5 0.14599340301571234 +6 0.1461571777012834 +7 0.14618223982735462 +8 0.14605119452067217 +9 0.14577607558040856 +10 0.14539180283491723 +11 0.14494814472736822 +12 0.14450189142460493 +13 0.1441089683947489 +14 0.14381752705849982 +15 0.14366260976626766 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz new file mode 100644 index 000000000..d2f507f3a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4856288630682744 -1.4641108049347733e-05 -1.4617689817446023e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4882082336279727 -1.4073060171678857e-05 -1.4042341885938395e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4932659154258783 -1.2956221692278461e-05 -1.2915618671769397e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5006034838356146 -1.1331340030326807e-05 -1.1287916610159982e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.5099326070233756 -9.265861766431932e-06 -9.230454653045516e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5208863095035574 -6.859323149729073e-06 -6.833670848433326e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5330338963264767 -4.22027315102714e-06 -4.198955612506105e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5458990570455406 -1.4204478426098045e-06 -1.4127749648568141e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.558980259353228 1.4487604569802692e-06 1.4392908863007146e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5717720099747763 4.290650779012598e-06 4.265263977787478e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.583785013599074 6.997783499000428e-06 6.960513890766284e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.594564693637405 9.459744651843743e-06 9.414213541417848e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6037075318548175 1.1570280091178532e-05 1.1520202989004062e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6108747507863064 1.3236987496643801e-05 1.3185220092522197e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6158031201294785 1.4387660592986321e-05 1.4336229812797567e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.61831287719198 1.4974501663497568e-05 1.4923876263255433e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 new file mode 100644 index 000000000..9618462d8 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 @@ -0,0 +1 @@ +-1.084284095859499968e-02 1.007962075856828980e-07 4.029725098037312568e-08 -1.084014631477705007e-02 9.284686790711813411e-08 3.597176435166755601e-08 -1.083474698859391606e-02 7.815764173087119183e-08 2.812688640808025874e-08 -1.082664073607738850e-02 5.898851292852728707e-08 1.824931170370135060e-08 -1.081586538298754882e-02 3.834685046070548597e-08 8.273561788772440425e-09 -1.080254506387894921e-02 1.957295984016525322e-08 2.762893991249801198e-10 -1.078717014372265054e-02 5.915874074887245997e-09 -3.850069342421443526e-09 -1.077054482796756946e-02 -1.824446412487979138e-10 -2.737871396674359854e-09 -1.075329915410792869e-02 2.381444680552640775e-09 4.200025444090992507e-09 -1.073609644990415959e-02 1.337074778748020793e-08 1.667397634287409299e-08 -1.071963115199171639e-02 3.127445132286798301e-08 3.353776330315823309e-08 -1.070459695170799912e-02 5.355314855478380059e-08 5.293835040844515653e-08 -1.069165081589418080e-02 7.702930065636355187e-08 7.257306057740378169e-08 -1.068137570009095906e-02 9.835847905862783893e-08 9.001491014134276676e-08 -1.067424521429065874e-02 1.145116072054391498e-07 1.030574674552284286e-07 -1.067059354225899370e-02 1.232019355323211077e-07 1.100287082081263299e-07 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener new file mode 100644 index 000000000..9226a811d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.14619035118482168 +1 0.14619070699962955 +2 0.14619091286669983 +3 0.1461900516834462 +4 0.14618696880233711 +5 0.14618049740360584 +6 0.14616970302480536 +7 0.14615412201583527 +8 0.1461339066076566 +9 0.14610987493352684 +10 0.14608346566825425 +11 0.14605659799922505 +12 0.1460314573249148 +13 0.1460102372726762 +14 0.14599487391951996 +15 0.14598680823928564 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz new file mode 100644 index 000000000..c1495b71f --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.540461685335739 -2.5549784228003915e-06 -2.5399272013561747e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.540889201874614 -2.4534391447011732e-06 -2.4382655931849438e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.541727677502115 -2.2546812873915327e-06 -2.239777382154798e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.5429446512904574 -1.967389528172729e-06 -1.954183674554429e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.544493039798159 -1.604829398997112e-06 -1.5949288116853977e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.5463129920858996 -1.184977307557958e-06 -1.1784553051410164e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5483342419943114 -7.270181088389714e-07 -7.226950406123698e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.550478859856288 -2.4484239066381697e-07 -2.433807543641649e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5526642868502076 2.4585391534848e-07 2.443260745761545e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.554806530261252 7.293101936704286e-07 7.248765463383169e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.5568233936762144 1.188506726603352e-06 1.1813447597905433e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.5586376170955685 1.605841851793353e-06 1.5960383058374792e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.5601798087781122 1.9640195362154016e-06 1.9518329665617193e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.5613910616601223 2.2474983314934323e-06 2.233363695994186e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.562225161548596 2.443693865256606e-06 2.4282433063293773e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.562650311001014 2.543950076112425e-06 2.527857795030063e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz new file mode 100644 index 000000000..030b7b1a3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00011973230763163059 1.4081818792631968e-06 1.3998863660371818e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00011509625372325318 1.3522182867033563e-06 1.343855350993785e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00010600721269165184 1.2426724641136511e-06 1.2344581445337531e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -9.282377338216272e-05 1.0843309901570352e-06 1.0770525553962788e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -7.606524145895317e-05 8.84505191437045e-07 8.790484613441395e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -5.639016075929571e-05 6.531028039024552e-07 6.495081881757276e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -3.456892854567335e-05 4.006976018377204e-07 3.98314933442092e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.1451224759424999e-05 1.3494541274065538e-07 1.3413982873537544e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.2068249494091018e-05 -1.3550291675660268e-07 -1.3466084401313497e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 3.5084996643494734e-05 -4.019608893459782e-07 -3.9951727503737663e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 5.6719700124994184e-05 -6.550480508367141e-07 -6.511007173501841e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 7.615132062453702e-05 -8.850632069836942e-07 -8.796599614437753e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 9.264711211890754e-05 -1.0824736118069e-06 -1.0757569576060065e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00010558862380752233 -1.2387135624474032e-06 -1.230923227545783e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00011449302578724121 -1.346847154877063e-06 -1.3383315459342817e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00011902933909488406 -1.402103582152881e-06 -1.3932342866574796e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..030f567ed --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0028419991035877347 5.062746866683679e-06 5.054393147048601e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002793834979617636 5.183980594053684e-06 5.141319048678907e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0026688676902036977 5.343170034051847e-06 5.246448947545891e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002431842707736466 5.339721703700351e-06 5.2166417237352526e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00205276095335753 4.934223985698249e-06 4.850382059964017e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.001520616099574181 4.004442320155974e-06 3.990697040447411e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0008469331323838957 2.6571166916253136e-06 2.650690930970538e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -9.429910312659437e-05 9.126104959837899e-07 9.053563477355476e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006384043076482472 -1.1069558288207254e-06 -1.1070353048254536e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0012861757625815828 -3.1531562137749073e-06 -3.1643312454180697e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0018093472218503536 -5.029695704774884e-06 -5.046185138172467e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002182467057456169 -6.604209026981155e-06 -6.613094046741999e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0024153144993051038 -7.806754155095822e-06 -7.806471486813624e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002547283374935045 -8.638026602767284e-06 -8.630393238933302e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0026149170903637057 -9.141824004378798e-06 -9.132529120898736e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0026413497719772455 -9.375674829415361e-06 -9.367499895657264e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..e374031dc --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0024096189902823827 1.5183936474295252e-05 1.5075291264591607e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002338646530670779 1.5024919665527123e-05 1.486729328098436e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0021897912379574185 1.4564648435663347e-05 1.4341922424172144e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001956229162260046 1.353617365269018e-05 1.3310266375267851e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0016335881897426594 1.1686226992987147e-05 1.1562984648704727e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0012241041850990723 9.02258207533441e-06 9.0129726393247e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0007413108758320752 5.774966519999323e-06 5.769034411339583e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00021727972678136368 1.962011519572385e-06 1.9528507087442488e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0003055110062857292 -2.236572772223075e-06 -2.2350627177518076e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0007934074128259909 -6.463842398825255e-06 -6.4825705641733495e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0012239240923483557 -1.040667024441399e-05 -1.0444708645269884e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.001580575378050864 -1.383388527814424e-05 -1.3860832605605093e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.001852921740110504 -1.6586843147765253e-05 -1.6593034676809315e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0020425111591152872 -1.8605151575920847e-05 -1.8594455594194852e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002159008042864835 -1.9902001757643856e-05 -1.9884776244136116e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0022133357377163783 -2.0527940474242685e-05 -2.0510357668763867e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz new file mode 100644 index 000000000..2b3edabf2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0006469584070418139 7.317310900374855e-06 7.301673507721764e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0006216357515445657 7.03245193921115e-06 7.01353302781252e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005719331725159142 6.4727600447915925e-06 6.44955398533592e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0004997441005905709 5.6592590075948435e-06 5.635353353236153e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0004079077294620783 4.626252887169216e-06 4.606975689143477e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0003001580915122788 3.4236065009003804e-06 3.4098505568909346e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00018099615901557146 2.1055507499783745e-06 2.0946408741427624e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -5.54708784172378e-05 7.087202634346486e-07 7.048467413829733e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 7.115825393442633e-05 -7.213436211034323e-07 -7.166486789901275e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00019387202161374694 -2.1368696506705223e-06 -2.124102282937329e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.000308028838998208 -3.4849748930831883e-06 -3.465839332735851e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00040950453264166 -4.711168846303534e-06 -4.687199692837052e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0004948153006350525 -5.762771339033978e-06 -5.7356725804022475e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0005611824463089646 -6.593681528327137e-06 -6.564907758479488e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0006065489040327796 -7.167641218914951e-06 -7.138381760773142e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0006295652116164723 -7.46047881053214e-06 -7.4312620082482685e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz new file mode 100644 index 000000000..9da072536 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005849527791760563 6.65296793073839e-06 6.635447875766081e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.000562043395503843 6.39322665471287e-06 6.373053000951128e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0005170969400813506 5.8831705607416584e-06 5.859677168159168e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0004518548843910347 5.142422009720374e-06 5.118920640457638e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00036890684580645483 4.202631302669202e-06 4.183881602469664e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00027162863003553584 3.109247663168184e-06 3.0960384749147466e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00016405829682361822 1.911575195034415e-06 1.901460568397942e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -5.070192480995396e-05 6.434625482690225e-07 6.399083802976948e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 6.375284976245724e-05 -6.537821889402171e-07 -6.495443004215406e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0001747984114747149 -1.9371229229786275e-06 -1.925467606497787e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00027823531583167954 -3.1590701041343944e-06 -3.1413254857325813e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0003703067665882218 -4.270603179655206e-06 -4.247958126493026e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00044781319607434966 -5.224163078664604e-06 -5.198039795519698e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00050817945177643 -5.977922535311851e-06 -5.949647246487603e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0005494819060998364 -6.498811795525342e-06 -6.469588728293071e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0005704487369456588 -6.764658771940718e-06 -6.73519209815898e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz new file mode 100644 index 000000000..aea383272 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0005305165529754937 6.062044059425393e-06 6.043377388779862e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0005097366979459261 5.824791609802176e-06 5.803987640444737e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0004689809829134694 5.359117292836652e-06 5.3357759424581135e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0004098473365608618 4.68329371976979e-06 4.660474996617209e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.000334697117728535 3.826519456048481e-06 3.808486249811153e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0002465880763048142 2.8303083738702484e-06 2.817739057651632e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0001491566137819299 1.7395933689820901e-06 1.7302263401395222e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -4.644484236239546e-05 5.855993937665661e-07 5.823341132063293e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 5.734544326379536e-05 -5.941077485025651e-07 -5.902714671945847e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00015814702865143406 -1.760605585549487e-06 -1.7499584812256208e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00025214737274791406 -2.871063012509136e-06 -2.8546561072347544e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0003359161220468191 -3.881214380345799e-06 -3.859975733036249e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0004065118705842106 -4.74799640784135e-06 -4.723119299067306e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00046154983934345895 -5.4333839364940384e-06 -5.406069996656053e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0004992357948363227 -5.907184625813581e-06 -5.878618111313721e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.000518376185083123 -6.1490616544739075e-06 -6.120054074631461e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz new file mode 100644 index 000000000..74345482e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00048233560210906624 5.53334543313798e-06 5.514121868679095e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00046344698400184437 5.3163271893485605e-06 5.295384855972904e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00042640894958059783 4.890539603519708e-06 4.867682425842446e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00037268569514812677 4.27296826764226e-06 4.251024930377798e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00030443068895691296 3.4905479789358885e-06 3.4733479259087236e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00022441827309099707 2.5812629208639375e-06 2.5693809178818833e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0001359332086147518 1.5861431634786335e-06 1.5774756295619025e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -4.261618991669887e-05 5.339672031093609e-07 5.309645702291387e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 5.17494459744188e-05 -5.410303593082273e-07 -5.375494171005207e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00014348028989874767 -1.6035391008629768e-06 -1.593806275684892e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00022910566990879834 -2.614796859957659e-06 -2.5996559068254525e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0003054874228286244 -3.5347102035521635e-06 -3.5148911209925252e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00036991934421988764 -4.32419115189111e-06 -4.300701453065714e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00042019405226509626 -4.9486127176937714e-06 -4.922538309590121e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0004546410893646778 -5.380384306601057e-06 -5.352868443226226e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0004721437812978583 -5.60085115266704e-06 -5.572763538220003e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz new file mode 100644 index 000000000..6fd372a73 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00043940844593298 5.0580141306285915e-06 5.038686515122568e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00042220848605860453 4.859275945579758e-06 4.838566454094098e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.000388487129681147 4.469487780491596e-06 4.447354005277164e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0003395849821936595 3.904416737725524e-06 3.883473940136735e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002774665378915646 3.188907858831961e-06 3.1726063688118008e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00020465274121994804 2.3577628417517522e-06 2.3465856012240015e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00012411823057369715 1.4485078598994685e-06 1.4404927964236312e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -3.915293886803376e-05 4.876529367885126e-07 4.848899983777275e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 4.6824225803481386e-05 -4.935496215104239e-07 -4.90384922094283e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00013046765237429063 -1.4629877012028644e-06 -1.4540847939062907e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00020861109481144416 -2.385484986473569e-06 -2.3715304882197175e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00027837944973229913 -3.224637089927763e-06 -3.20620959284596e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0003372813664654398 -3.9448924150540655e-06 -3.922848292345726e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00038327442238268153 -4.5146734296412304e-06 -4.489993346226777e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00041480555628700536 -4.90874663844933e-06 -4.882520600857603e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00043083241188148516 -5.109997918224139e-06 -5.083118929267929e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz new file mode 100644 index 000000000..35895f264 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0004009548183899554 4.6289382596237845e-06 4.609844148144774e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0003852694393984675 4.446770452921481e-06 4.426564693584901e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.000354520959552341 4.089587464048166e-06 4.068341321419078e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0003099363188342583 3.5720087263593854e-06 3.552140101998503e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002533083551508387 2.9169502405110032e-06 2.9015765789001456e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00018693074130178564 2.1563321316967407e-06 2.1458574034283207e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00011350293981092548 1.3245204234600541e-06 1.317112663009664e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -3.6005894571996434e-05 4.4592830529631713e-07 4.433847288928901e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 4.246173323710321e-05 -4.50874459259813e-07 -4.4799259111567707e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00011885401560099262 -1.3366267751416568e-06 -1.3284781329368834e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00019027748321612866 -2.1793353130160586e-06 -2.166485900833661e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0002540949761226556 -2.9458781756026535e-06 -2.9287901267756753e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.000308011849995943 -3.603865767793269e-06 -3.5832719341652435e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00035013888778072974 -4.124466742934154e-06 -4.1012530675600964e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0003790337490961829 -4.484587034490588e-06 -4.459783696341995e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0003937251791150122 -4.668523393820506e-06 -4.643022198224658e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz new file mode 100644 index 000000000..c384fc9b1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00036635513991257123 4.24032094275583e-06 4.2217051665279845e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0003520333471401015 4.073215624689526e-06 4.05370461621138e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0003239600685832195 3.7456494553301473e-06 3.725396771059411e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002832580159346273 3.271165052266744e-06 3.252405846815834e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00023156410694801823 2.670897652665847e-06 2.656455745401067e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00017096760707927932 1.9741492987218925e-06 1.964361912652669e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00010392257166807846 1.2124249786700287e-06 1.205581593001568e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -3.313593434224535e-05 4.082031782828361e-07 4.058607768954314e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 3.857714965694062e-05 -4.1236869445888143e-07 -4.09740813139018e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00010843834686535922 -1.2225847766406453e-06 -1.2151225032739025e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00017379983853663163 -1.9932937761159697e-06 -1.9814694591153547e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0002322405010335472 -2.6943098246128324e-06 -2.6784954958980444e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0002816461151649669 -3.2960827028441783e-06 -3.276909703603714e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00032026964679492153 -3.7722616367299404e-06 -3.7505310682178056e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0003467727745315619 -4.101697694124531e-06 -4.07837701941502e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00036025178465370607 -4.269979770632949e-06 -4.245942680668726e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz new file mode 100644 index 000000000..5c8225897 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00033510883320539935 3.887372231572829e-06 3.869406800406409e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00032201858364892864 3.7339902060871135e-06 3.715302777313085e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0002963605676171618 3.433390939216086e-06 3.4141929528933395e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002591620937488119 2.9981096756279044e-06 2.9804669551783985e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00021191840612190213 2.4476376637004632e-06 2.434113831727688e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00015653447395928846 1.8088916435517363e-06 1.7997680974670515e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -9.524456342522268e-05 1.1107781764594284e-06 1.1044586405869948e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -3.0511273287376415e-05 3.7399243744489556e-07 3.718348198499338e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 3.5102752893514545e-05 -3.775126553750917e-07 -3.751136403026329e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 9.905938935552108e-05 -1.119331493662497e-06 -1.1124945450932185e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0001589329440790485 -1.8248626663097343e-06 -1.8139865961350194e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0002124990350289756 -2.4665578616709964e-06 -2.4519446044557454e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00025780918357575536 -3.0174257156204897e-06 -2.999622677281769e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00029324824389740484 -3.4533619061413405e-06 -3.4330943312840378e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0003175753427750489 -3.7549886323078235e-06 -3.733160790988857e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00032995059838944484 -3.909078449969829e-06 -3.886534524134625e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz new file mode 100644 index 000000000..2fc831be3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0003068051764132814 3.5660830292288783e-06 3.548883580584812e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00029483018417422117 3.4252278357310916e-06 3.407445080906125e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0002713587742745814 3.1492312239197517e-06 3.1311156389639626e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00023733102344392385 2.749688198096515e-06 2.7331486611074825e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00019411337895239853 2.244572207502893e-06 2.2319407334260983e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00014344428627055628 1.658621880668995e-06 1.6501334766199696e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -8.736046232015943e-05 1.0183776872505036e-06 1.0125439195755657e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -2.8105630253568423e-05 3.428919459943536e-07 3.409042533254767e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 3.198360853618852e-05 -3.4587582704577713e-07 -3.4368363507150326e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 9.058568797309145e-05 -1.0255982410193154e-06 -1.019331617389315e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0001454764399141629 -1.671970768969112e-06 -1.6619701537201546e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00019461109057378206 -2.259823112353427e-06 -2.2463356091302693e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0002361935960106102 -2.7644769415460123e-06 -2.747980102088723e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00026873110541702133 -3.1638668454526487e-06 -3.1450180946648893e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.000291073844640012 -3.4402298255255045e-06 -3.4198713285201213e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0003024420289277167 -3.58142301876939e-06 -3.5603620763663666e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz new file mode 100644 index 000000000..0b1b9411c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00028110245159870654 3.2730582216758963e-06 3.2566972073011365e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00027013968347326737 3.1436555006217434e-06 3.1268222785970058e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00024865246814137986 2.8901411190794824e-06 2.8731107520523057e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002175011694192386 2.5232341206453543e-06 2.507770017143035e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00017793507158341365 2.0595066243710477e-06 2.047733776929298e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00013154186911978625 1.5217047247355788e-06 1.513819739614781e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -8.018018276721527e-05 9.342097262223132e-07 9.288260570018531e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -2.589691252421566e-05 3.145609176138035e-07 3.1272961956231856e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.9174537547561275e-05 -3.1709696509524674e-07 -3.150921282758128e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 8.290853771121643e-05 -9.403197423716907e-07 -9.345737824613317e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00013326424777006558 -1.5328787177089077e-06 -1.5236852356448886e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0001783611835182684 -2.0717540982888335e-06 -2.0593170750046914e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00021654363132713695 -2.534363716342092e-06 -2.5191021785155087e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0002464321061885786 -2.900496168881444e-06 -2.883006849689681e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00026696185621710126 -3.153862397006086e-06 -3.134927442092879e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0002774095115166701 -3.2833136222614478e-06 -3.263699003993833e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..2b52e6396 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001942488736533234 1.7708678241055824e-05 1.7500815680728397e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0018755571302828315 1.7195782639661253e-05 1.6977144135844428e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0017407839313963798 1.6099198841703034e-05 1.5884461996799946e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001537596126726083 1.4330370520745385e-05 1.4174443516668533e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0012675650279661901 1.1881959182333212e-05 1.1829559297298138e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0009367218164458175 8.897842856386484e-06 8.91211495434458e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0005593753653598348 5.56232965781518e-06 5.558876413626898e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00015766836241444602 1.8769293280657584e-06 1.8717134888464523e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00024268500351367695 -2.022407713418897e-06 -2.0156097379590567e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0006207953003033021 -5.925960590870717e-06 -5.922204367256211e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0009611962948718237 -9.613361392718313e-06 -9.63233521889037e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0012525278190936209 -1.2908434737300818e-05 -1.294251884165839e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0014873394065651963 -1.5665611285110394e-05 -1.5698878280645796e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0016616006439549708 -1.778214303320501e-05 -1.7805055866456995e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0017755277393403477 -1.9202872917012223e-05 -1.9216530197714526e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0018314977913995085 -1.9911734943329393e-05 -1.9921041114074572e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz new file mode 100644 index 000000000..95a08269c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00025771278129141525 3.005391686849754e-06 2.9899087834783997e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002476704675618749 2.8864725771651322e-06 2.8706065362738073e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00022798729392492766 2.6535302322667117e-06 2.637569714840592e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0001994508034341319 2.316468856856395e-06 2.302042457047373e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00016320363055996208 1.8905667832435368e-06 1.8796137384426076e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0001206967704025343 1.3967446683011293e-06 1.3894298643333328e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -7.362787336075505e-05 8.574100008669454e-07 8.52443099375723e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -2.3866275633114933e-05 2.8870879555007587e-07 2.8702152893888655e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6637920270054808e-05 -2.9086943576080867e-07 -2.890346653437051e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 7.593688266967666e-05 -8.625912228792748e-07 -8.573209939078933e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00012215691558652484 -1.4061090808454584e-06 -1.3976589987979248e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0001635680496116411 -1.9003529207686137e-06 -1.8888928624525153e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00019864385333495776 -2.324644283327919e-06 -2.310543908642544e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00022610990161142498 -2.660460318516371e-06 -2.6442619658264075e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0002449806863823722 -2.892858644680256e-06 -2.8752871378806157e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0002545856725336847 -3.01160188156921e-06 -2.993379535250629e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz new file mode 100644 index 000000000..204b8c39c --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00023639091596852136 2.7605716906914896e-06 2.745981951201427e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002271869506258345 2.6512593071065235e-06 2.6363579150230242e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00020914672926884852 2.437161738683769e-06 2.422242678979531e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0001829912764002115 2.1274261686616295e-06 2.1139931265021256e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00014976608292601712 1.7361364844239252e-06 1.7259614497133617e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00011079800543266905 1.2825390234362664e-06 1.275760701660884e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -6.763888524996669e-05 7.87234289611028e-07 7.826530680174917e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -2.1997434105332816e-05 2.650853680558068e-07 2.635308060850861e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.4342084399095783e-05 -2.669302468153247e-07 -2.652501166936742e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 6.959356878417362e-05 -7.91636269335133e-07 -7.868010402707544e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00011203598772248051 -1.29039396698747e-06 -1.2826280844699746e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00015007744096860447 -1.7439046753748215e-06 -1.7333508864439786e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00018231066741164552 -2.133221999072334e-06 -2.120208038314101e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0002075585782059146 -2.4413630264384153e-06 -2.4263823932310407e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0002249094398706824 -2.6546168090334136e-06 -2.638340052381687e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00023374210493246595 -2.7635817789587133e-06 -2.7466867489134205e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz new file mode 100644 index 000000000..a2080731e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00021692582264259744 2.5364084403986244e-06 2.522708644696627e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00020848646151021483 2.435906729767906e-06 2.421952724519028e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00019194457375082917 2.2390871656889836e-06 2.2251721070617504e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00016796041941363166 1.954394382643274e-06 1.941906260670429e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00013749094845308374 1.5948096192504596e-06 1.5853693771549832e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00010175014111137444 1.178042060680463e-06 1.171766793006972e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -6.215751633924113e-05 7.230360066223457e-07 7.188115115373213e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -2.027615098227697e-05 2.434732310199486e-07 2.4204097521444466e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.226010054907552e-05 -2.4505173379455367e-07 -2.435124241471632e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 6.381254592628994e-05 -7.267824472038746e-07 -7.223452334566764e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00010279979901188739 -1.1846352606111528e-06 -1.177498752926433e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0001377567394944893 -1.6009238484853534e-06 -1.5912090775016137e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.000167386000472903 -1.95828013015862e-06 -1.946278984606163e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0001906006488779127 -2.241127207085376e-06 -2.22728925130581e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00020655756707602344 -2.436880989936139e-06 -2.4218257138873558e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00021468169942489836 -2.5369065925125142e-06 -2.521267656655222e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz new file mode 100644 index 000000000..464ac82f0 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00019913428807005328 2.3309780129726023e-06 2.318151599202477e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0001913930774397338 2.238562466230343e-06 2.2255280682838207e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00017621924712729096 2.057595955061942e-06 2.0446414009226913e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00015421754167710506 1.7958717239113192e-06 1.7842778806469975e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00012626416189529996 1.4653532073238285e-06 1.4566042326213311e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -9.347033634362213e-05 1.0823373179787145e-06 1.0765324506516957e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -5.713530850652855e-05 6.6424889887264e-07 6.603541973204235e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.868985411176576e-05 2.236819749132283e-07 2.2236246419889893e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.036886983821329e-05 -2.2503517974098012e-07 -2.2362426688133604e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 5.853674966501004e-05 -6.674425735983973e-07 -6.633697420633458e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 9.436028892365987e-05 -1.0878740710627176e-06 -1.081316276299483e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00012649087352458984 -1.4701131108902903e-06 -1.4611738837923626e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00015373250579760528 -1.7982316952388899e-06 -1.7871720738938195e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00017508173392019027 -2.057937910830101e-06 -2.0451678592779288e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00018975920326074684 -2.237679466952586e-06 -2.223770677912522e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00019723281560443348 -2.3295249002050828e-06 -2.315067874205429e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz new file mode 100644 index 000000000..86a039500 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0001828559924770512 2.142578493986891e-06 2.1305993756258235e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00017575287808721928 2.0575883203313716e-06 2.045438476270818e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00016182940565544446 1.8911760359407753e-06 1.8791347506978823e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00014163959003037709 1.65053141807442e-06 1.6397804101361384e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0001159859467506171 1.3466785294944848e-06 1.3385777908962188e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -8.588607616477934e-05 9.946159857393317e-07 9.892499786180107e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -5.252974570164826e-05 6.103735539993643e-07 6.067836180126635e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.7227344410214232e-05 2.0554365200799846e-07 2.0432808496528803e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8648423125042018e-05 -2.067058614676305e-07 -2.0541214361855735e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 5.371647616563443e-05 -6.131001673756144e-07 -6.093610923342188e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 8.66405566655992e-05 -9.99266988927417e-07 -9.932411666473423e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0001161791821392477 -1.3503312771405222e-06 -1.3421080349127957e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00014122987798703484 -1.651680439597826e-06 -1.641494093784365e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00016086647054514247 -1.8901979113332501e-06 -1.87842266510881e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00017436881287051544 -2.0552766554628355e-06 -2.0424396288525254e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00018124479559771716 -2.139630717827945e-06 -2.126280793155597e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz new file mode 100644 index 000000000..5d7136860 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00016794967023450668 1.9696953124881043e-06 1.9585308228780667e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00016143024884836724 1.8915267773171466e-06 1.880221647606702e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0001486505309750213 1.7384826847668228e-06 1.7273054338273545e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00013011816437542723 1.517194141112849e-06 1.5072347549999281e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00010656838908735511 1.2378183476833766e-06 1.2303238747577507e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -7.893341559552015e-05 9.14159857082347e-07 9.092025041898068e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -4.83032431035117e-05 5.60966767411955e-07 5.576583598655665e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.587857138161942e-05 1.8890920419044703e-07 1.8778947162948744e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.7081376105408368e-05 -1.8990916006818875e-07 -1.8872251141030352e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 4.930812007045217e-05 -5.632980182925768e-07 -5.598647802159833e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 7.957296198146117e-05 -9.180674271959658e-07 -9.125305060867602e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.00010673297801243678 -1.2405681150192337e-06 -1.2330052206279072e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00012977198695154438 -1.5173901353145795e-06 -1.5080122963558694e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00014783532955733734 -1.7364927473935718e-06 -1.725641815092212e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00016025779815232604 -1.8881352724130372e-06 -1.8762969260921307e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00016658447001652535 -1.965624222464822e-06 -1.95330760027985e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz new file mode 100644 index 000000000..937dc5c7e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00015429008413988886 1.8109735578879385e-06 1.8005867119729877e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00014830496901885947 1.7390742566444995e-06 1.7285711136705615e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00013657224579711317 1.5983136738195984e-06 1.587950528897438e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0001195571718844778 1.3948060432168599e-06 1.3855880440786571e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -9.793353313844745e-05 1.137908740708741e-06 1.1309800153928286e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -7.255560292753811e-05 8.403277387628081e-07 8.357503024322869e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -4.44223582995722e-05 5.156330751124829e-07 5.125846378700264e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.4634458669652642e-05 1.736456182978143e-07 1.726142439189615e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.5652500250267065e-05 -1.7450747375132588e-07 -1.734187210223073e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 4.5273182369224036e-05 -5.176291093622267e-07 -5.144762300429412e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 7.309763215399845e-05 -8.436108000338162e-07 -8.385231252556502e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 9.807363067299498e-05 -1.1399243276499512e-06 -1.1329699865731143e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00011926462259063699 -1.3942601721874853e-06 -1.3856297803599241e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0001358821089257375 -1.5955629128933832e-06 -1.5855690040906587e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00014731182773465977 -1.7348862247699437e-06 -1.7239760414968362e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00015313340500133053 -1.8060804851435191e-06 -1.7947254950454753e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz new file mode 100644 index 000000000..251e98086 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0001417656127074023 1.6651956543341626e-06 1.6555468761276515e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00013626989104104667 1.599059545920948e-06 1.5893142118378634e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0001254961763879581 1.469589241162498e-06 1.4599905484117654e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00010987096118387319 1.2824210431543982e-06 1.2738957068456136e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -9.001186841356518e-05 1.0461744740056116e-06 1.039772690756632e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -6.670198732216875e-05 7.725445089387797e-07 7.683197913555627e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -4.085717235131521e-05 4.7401793978341336e-07 4.712094859844578e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.3486766155481002e-05 1.596336369691905e-07 1.5868372477126622e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.4348382100804214e-05 -1.603777408722338e-07 -1.5937855808401794e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 4.157748278554364e-05 -4.757293299204477e-07 -4.728335384869452e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 6.716127630527174e-05 -7.753026222803575e-07 -7.706277090510901e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 9.013104339768651e-05 -1.047595473677772e-06 -1.041201598614191e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00010962370150619367 -1.2813059400867716e-06 -1.2733657274186958e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00012491193967025386 -1.466281493631328e-06 -1.457080868040293e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00013542871029727477 -1.5943043848983252e-06 -1.5842550062491527e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0001407857104609576 -1.659724310070945e-06 -1.6492621514495033e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz new file mode 100644 index 000000000..81e5d6086 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00013027630621939476 1.531263175837876e-06 1.522311607981289e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0001252290715268004 1.470426239096766e-06 1.4613941647399859e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00011533423264378396 1.3513357866139876e-06 1.3424528735202712e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00010098282272806282 1.179186423115164e-06 1.171306902545153e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -8.274111522235065e-05 9.61917101191632e-07 9.560053288040914e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -6.132714296317802e-05 7.102922214520033e-07 7.06394590942839e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -3.758078879854758e-05 4.35802214294072e-07 4.3321522625450323e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.2427979970945812e-05 1.4676589873103404e-07 1.4589108623138308e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.3157149704192617e-05 -1.4740943354152246e-07 -1.46492251362768e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 3.819052776986281e-05 -4.372715701168264e-07 -4.3461159542014466e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 6.171623367865153e-05 -7.126088627907289e-07 -7.083131600787719e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 8.284243003277869e-05 -9.628589276970803e-07 -9.569809686453397e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00010077382599899981 -1.1776429123439589e-06 -1.1703393839123319e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00011483968260038076 -1.3476360136546727e-06 -1.3391686550259122e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00012451668428226163 -1.4652889173657265e-06 -1.4560364985157007e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00012944627674919872 -1.5254097961932984e-06 -1.5157750031774206e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz new file mode 100644 index 000000000..030b7b1a3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00011973230763163059 1.4081818792631968e-06 1.3998863660371818e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00011509625372325318 1.3522182867033563e-06 1.343855350993785e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00010600721269165184 1.2426724641136511e-06 1.2344581445337531e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -9.282377338216272e-05 1.0843309901570352e-06 1.0770525553962788e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -7.606524145895317e-05 8.84505191437045e-07 8.790484613441395e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -5.639016075929571e-05 6.531028039024552e-07 6.495081881757276e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -3.456892854567335e-05 4.006976018377204e-07 3.98314933442092e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -1.1451224759424999e-05 1.3494541274065538e-07 1.3413982873537544e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.2068249494091018e-05 -1.3550291675660268e-07 -1.3466084401313497e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 3.5084996643494734e-05 -4.019608893459782e-07 -3.9951727503737663e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 5.6719700124994184e-05 -6.550480508367141e-07 -6.511007173501841e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 7.615132062453702e-05 -8.850632069836942e-07 -8.796599614437753e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 9.264711211890754e-05 -1.0824736118069e-06 -1.0757569576060065e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.00010558862380752233 -1.2387135624474032e-06 -1.230923227545783e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00011449302578724121 -1.346847154877063e-06 -1.3383315459342817e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00011902933909488406 -1.402103582152881e-06 -1.3932342866574796e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..79562e9b5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015997353295855248 1.5930864254159885e-05 1.580783413473849e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001541527266267262 1.5363529479086726e-05 1.5244712335959626e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0014254252116202358 1.4220544406483882e-05 1.4116904237644298e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0012526720705998582 1.2507309446764971e-05 1.2441261983926278e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.001026566716575589 1.0276471767688393e-05 1.0259532699438564e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007544092705801225 7.649278009939194e-06 7.65397814356391e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0004483849610588376 4.747940455263038e-06 4.736842315646555e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00012477592270326588 1.5990857601373261e-06 1.5926465116236819e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00019825417662815354 -1.688957285761341e-06 -1.6800559614630677e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.000505391052658601 -4.972689324201132e-06 -4.957125308239575e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0007845053898521544 -8.09357667796575e-06 -8.087402737808747e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.001026212836696366 -1.0909571218784411e-05 -1.0917326561808406e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0012240615123930085 -1.3299333438502542e-05 -1.3315659216710191e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0013741424545329409 -1.5165052988874129e-05 -1.518286448315584e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.001474453266401624 -1.6438204540892925e-05 -1.645494200987778e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0015245416535162861 -1.7081568485225238e-05 -1.7097462566282833e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..0bb6174e7 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001352897446106711 1.4051405334982619e-05 1.4006460724094925e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0013022290969887673 1.3525969383602364e-05 1.3480606795320555e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001201685464746267 1.2483259916202582e-05 1.2440101273781356e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0010532713923880883 1.0948685942512837e-05 1.0917647663953214e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0008611029761241688 8.978917647095275e-06 8.96646954806692e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0006321781372618436 6.6705381158093385e-06 6.665435178174924e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00037660167975875927 4.126345348168412e-06 4.1119561383077174e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00010707102223743735 1.388816817645577e-06 1.3822340786327324e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00016257700146894154 -1.45055841798792e-06 -1.4415744430937755e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00042028059695594565 -4.280578392621473e-06 -4.261269492457597e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0006560346391297529 -6.9760365491516715e-06 -6.957770223988448e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0008617694685882201 -9.417148015998365e-06 -9.406496379393212e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.001031539327170419 -1.1497150955246521e-05 -1.1495388885193234e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0011613806573221805 -1.3129479553719122e-05 -1.3133769653500796e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0012489242629694641 -1.4249662593708879e-05 -1.4257608632895365e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.001292939836436456 -1.4818269158948647e-05 -1.482806976400914e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..217b0589e --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0011651994476994086 1.2436431458209886e-05 1.242409869696531e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001120719268129897 1.1964080635040069e-05 1.194740749479196e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001032794679783166 1.1031374359651172e-05 1.1008822621085224e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0009038012503573595 9.666221421272592e-06 9.643793411407546e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0007379177093872525 7.919723033610221e-06 7.905163279126471e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0005414950253256717 5.876013635866692e-06 5.865878321440889e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00032309893969528715 3.6273346917649946e-06 3.6125131919704353e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -9.307932900071863e-05 1.2206866325021927e-06 1.2145567055898805e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00013746953299157422 -1.2643226036943314e-06 -1.2560939792765493e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0003586381138928681 -3.7363088009415104e-06 -3.716908402107203e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0005619326650862302 -6.092062285934348e-06 -6.06938650843448e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0007403007891600282 -8.22944004568771e-06 -8.209261402442017e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0008883064639514655 -1.0054547991431765e-05 -1.0040077779869414e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0010020831638114975 -1.1489689241133705e-05 -1.1481107162440682e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.001079118568021899 -1.2476646623706178e-05 -1.2472858639603295e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0011179614217618988 -1.2978568187605533e-05 -1.2977500596559688e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..2035b8776 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0010184967424853955 1.1072426783551374e-05 1.1068262624136835e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0009791900377285128 1.0648968067269532e-05 1.0638988032720566e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0009017023555525088 9.814126078508071e-06 9.7957494378645e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0007884590474024353 8.59451103144683e-06 8.572884933152881e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0006434362774554568 7.037284889732291e-06 7.020333977520473e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00047233842684876005 5.217284294436615e-06 5.2045235266044545e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00028254742190227073 3.216642360229328e-06 3.202322813993367e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -8.275111390696106e-05 1.0824711288126043e-06 1.076882119055958e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00011783804954294355 -1.1150669243570748e-06 -1.1077225426309278e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00031083223461712904 -3.2979791507487072e-06 -3.2797587892890757e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0004888690348186878 -5.378462202294279e-06 -5.354928011454296e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0006457046148057629 -7.268096251216791e-06 -7.243754665042442e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0007763767842706277 -8.884064347270727e-06 -8.862204372068315e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0008772079007673931 -1.015661699341681e-05 -1.0138532502038136e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0009456850645508932 -1.1032851827818818e-05 -1.101856329681952e-05 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0009802802737958304 -1.1478863613203312e-05 -1.1466975691194362e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..13c900b6b --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0008997627463000563 9.918417843973894e-06 9.912730866199571e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0008648110810106837 9.536946400957231e-06 9.525661364365115e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0007960289707608371 8.7856674779994e-06 8.76640243555751e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0006957573590033695 7.689880090706992e-06 7.667281818603931e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005676913722149911 6.293185448756531e-06 6.274655123412129e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0004169490448817828 4.662737249040853e-06 4.648848876576519e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00024997318112084354 2.8721583137118584e-06 2.8586554699384333e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -7.420860506282331e-05 9.66590197794148e-07 9.615113275954607e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0001025079625106135 -9.91525080754264e-07 -9.849948165886467e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00027293147576229953 -2.9343190469570247e-06 -2.9175492689992295e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.000430586963613739 -4.785728747896992e-06 -4.762727898830469e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0005698946839023279 -6.468376535686028e-06 -6.442582651994266e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0006863220870150119 -7.908889972084607e-06 -7.883209778038069e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0007764158999230311 -9.04462454518183e-06 -9.020679411055303e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.000837740705884535 -9.82749740484903e-06 -9.8059115374222e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0008687684069783927 -1.022629886631968e-05 -1.0206382187837991e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz new file mode 100644 index 000000000..16560eb14 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0008014128304263328 8.928184468358369e-06 8.918799696037431e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0007701588965992417 8.583169465209178e-06 8.56894131462946e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0007087266120328677 7.904308035237657e-06 7.883327993310245e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0006193207300967056 6.915496790523427e-06 6.89200403020484e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0005053395168560157 5.657004883476438e-06 5.637680555631129e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00037138075312716056 4.189392791049465e-06 4.175147486038933e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00022312189449646635 2.5788876966581334e-06 2.566265207603605e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -6.703800914890985e-05 8.679434764139081e-07 8.633157637255067e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 9.008864670563171e-05 -8.87502177715899e-07 -8.816767172121195e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0002419090833059637 -2.627583154672409e-06 -2.6122514995606497e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0003826691140738087 -4.285509471106363e-06 -4.263626634301284e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0005073479261658599 -5.792915136553217e-06 -5.767094507913309e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0006117996835296403 -7.084415875094702e-06 -7.057113653193823e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0006928028527195079 -8.10360505545963e-06 -8.07647498470626e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0007480361701971623 -8.806756435917344e-06 -8.780748967242239e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0007760134212092255 -9.165178249818607e-06 -9.14015591960625e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz new file mode 100644 index 000000000..0a5cb65b9 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0007182977580545463 8.069478342141267e-06 8.056571333019744e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.000690219311888673 7.756397526761822e-06 7.739467077191006e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0006350747943917446 7.140849585252506e-06 7.118471142752179e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0005549145619050528 6.245292545753333e-06 6.221359633886494e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00045284840586458375 5.106899736924511e-06 5.0873850298636505e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0003330152439561386 3.7805307775836593e-06 3.7663924562875925e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00020045544119329462 2.3260126675761376e-06 2.314263460151163e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -6.0862904931442946e-05 7.828828981691554e-07 7.7865397501382e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 7.981810559244398e-05 -7.984874567655275e-07 -7.932682824209022e-07 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00021596480138263145 -2.3648014493326674e-06 -2.350809458974296e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00034242409358652457 -3.856843498309758e-06 -3.8363022731885556e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0004546545639110861 -5.213758708217477e-06 -5.188664138309446e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0005488584148251506 -6.376984876662591e-06 -6.3493847735780384e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0006220407851281898 -7.295594265088463e-06 -7.2670625484328545e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0006720101581977793 -7.929790228845066e-06 -7.90144404319752e-06 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0006973435607920697 -8.253228953073352e-06 -8.225326654323882e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 b/drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 new file mode 100644 index 000000000..aa2c39b08 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_00 b/drivers/py/pes/friction/frictionH/120K/inst.raw_00 new file mode 100644 index 000000000..8004b6aaf --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_00 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 0 +{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} + #*EXTRAS*# Step: 1 Bead: 0 +{"friction": [[0.00012916430146574795, -3.645237368525803e-05, -3.615395576970892e-05], [-3.645237368525803e-05, 0.0001293313759649921, -3.6490431093944096e-05], [-3.615395576970892e-05, -3.6490431093944096e-05, 0.00012882075498913686]]} + #*EXTRAS*# Step: 2 Bead: 0 +{"friction": [[0.00012595089970628777, -4.0421501510817485e-05, -3.9866142920872695e-05], [-4.0421501510817485e-05, 0.00012602225450494825, -4.051358415297014e-05], [-3.9866142920872695e-05, -4.051358415297014e-05, 0.00012562674779050386]]} + #*EXTRAS*# Step: 3 Bead: 0 +{"friction": [[0.00012376434106479127, -4.2368012819481104e-05, -4.1979929741135886e-05], [-4.2368012819481104e-05, 0.00012383011512419038, -4.246604850431206e-05], [-4.1979929741135886e-05, -4.246604850431206e-05, 0.0001235400937041879]]} + #*EXTRAS*# Step: 4 Bead: 0 +{"friction": [[0.00012250611376514513, -4.316391112626397e-05, -4.300175727471778e-05], [-4.316391112626397e-05, 0.00012257064793810658, -4.3226410524069893e-05], [-4.300175727471778e-05, -4.3226410524069893e-05, 0.00012236317853948347]]} + #*EXTRAS*# Step: 5 Bead: 0 +{"friction": [[0.0001216515438771965, -4.357577689514659e-05, -4.353183200131704e-05], [-4.357577689514659e-05, 0.00012168486042063468, -4.358415522016535e-05], [-4.353183200131704e-05, -4.358415522016535e-05, 0.00012155889162865568]]} + #*EXTRAS*# Step: 6 Bead: 0 +{"friction": [[0.00012099722480741191, -4.3840515569208874e-05, -4.38347209370581e-05], [-4.3840515569208874e-05, 0.00012098097244879934, -4.3789364392777254e-05], [-4.38347209370581e-05, -4.3789364392777254e-05, 0.00012093478809575148]]} + #*EXTRAS*# Step: 7 Bead: 0 +{"friction": [[0.00012047513368860672, -4.402801098715234e-05, -4.401713798666564e-05], [-4.402801098715234e-05, 0.00012040444761002372, -4.392044529322349e-05], [-4.401713798666564e-05, -4.392044529322349e-05, 0.00012043092816211719]]} + #*EXTRAS*# Step: 8 Bead: 0 +{"friction": [[0.00012004676854326849, -4.416576891284262e-05, -4.413387426792877e-05], [-4.416576891284262e-05, 0.00011992563201858145, -4.400926794893067e-05], [-4.413387426792877e-05, -4.400926794893067e-05, 0.0001200144224083326]]} + #*EXTRAS*# Step: 9 Bead: 0 +{"friction": [[0.00011968882469468762, -4.4269135670842615e-05, -4.421152802475037e-05], [-4.4269135670842615e-05, 0.00011952363631048464, -4.407157997328812e-05], [-4.421152802475037e-05, -4.407157997328812e-05, 0.00011966466098936051]]} + #*EXTRAS*# Step: 10 Bead: 0 +{"friction": [[0.00011938455780870601, -4.4348150253567044e-05, -4.426464614037495e-05], [-4.4348150253567044e-05, 0.00011918167219130908, -4.4116465676835725e-05], [-4.426464614037495e-05, -4.4116465676835725e-05, 0.00011936631821480854]]} + #*EXTRAS*# Step: 11 Bead: 0 +{"friction": [[0.00011912235714428107, -4.440939882327652e-05, -4.4301615589291735e-05], [-4.440939882327652e-05, 0.00011888744133866298, -4.414939133140123e-05], [-4.4301615589291735e-05, -4.414939133140123e-05, 0.00011910857476612228]]} + #*EXTRAS*# Step: 12 Bead: 0 +{"friction": [[0.00011889383432569592, -4.445738420448903e-05, -4.4327576486406434e-05], [-4.445738420448903e-05, 0.00011863174482938656, -4.417384029431445e-05], [-4.4327576486406434e-05, -4.417384029431445e-05, 0.00011888351382008126]]} + #*EXTRAS*# Step: 13 Bead: 0 +{"friction": [[0.00011869282786796049, -4.4495266885301666e-05, -4.43458195385756e-05], [-4.4495266885301666e-05, 0.00011840766991069549, -4.419212187815734e-05], [-4.43458195385756e-05, -4.419212187815734e-05, 0.00011868526826213154]]} + #*EXTRAS*# Step: 14 Bead: 0 +{"friction": [[0.00011851468932455356, -4.4525329121196115e-05, -4.4358534692477954e-05], [-4.4525329121196115e-05, 0.0001182099178100371, -4.4205823870079256e-05], [-4.4358534692477954e-05, -4.4205823870079256e-05, 0.00011850938129380904]]} + #*EXTRAS*# Step: 15 Bead: 0 +{"friction": [[0.00011835584030688029, -4.454925714372388e-05, -4.436722539957501e-05], [-4.454925714372388e-05, 0.00011803436298363648, -4.421607025478889e-05], [-4.436722539957501e-05, -4.421607025478889e-05, 0.00011835240359100794]]} + #*EXTRAS*# Step: 16 Bead: 0 +{"friction": [[0.00011821347000711615, -4.4568322669551e-05, -4.4372951355663276e-05], [-4.4568322669551e-05, 0.00011787773849084485, -4.422367684526005e-05], [-4.4372951355663276e-05, -4.422367684526005e-05, 0.00011821161386157358]]} + #*EXTRAS*# Step: 17 Bead: 0 +{"friction": [[0.00011808533148585529, -4.4583501577174214e-05, -4.437647595046647e-05], [-4.4583501577174214e-05, 0.00011773741792728616, -4.422924823410091e-05], [-4.437647595046647e-05, -4.422924823410091e-05, 0.00011808482883534399]]} + #*EXTRAS*# Step: 18 Bead: 0 +{"friction": [[0.00011796959928200177, -4.4595553958497464e-05, -4.437835921057119e-05], [-4.4595553958497464e-05, 0.00011761125961548476, -4.423324040524595e-05], [-4.437835921057119e-05, -4.423324040524595e-05, 0.00011797026935441294]]} + #*EXTRAS*# Step: 19 Bead: 0 +{"friction": [[0.00011786476869850275, -4.4605079310303514e-05, -4.43790181741619e-05], [-4.4605079310303514e-05, 0.00011749749451946986, -4.423600231899259e-05], [-4.43790181741619e-05, -4.423600231899259e-05, 0.00011786646506783663]]} + #*EXTRAS*# Step: 20 Bead: 0 +{"friction": [[0.00011776958304677086, -4.461255547010909e-05, -4.437876720488774e-05], [-4.461255547010909e-05, 0.00011739464416134118, -4.423780427515735e-05], [-4.437876720488774e-05, -4.423780427515735e-05, 0.00011777218522480207]]} + #*EXTRAS*# Step: 21 Bead: 0 +{"friction": [[0.00011768298030370451, -4.46183666394908e-05, -4.437784557057352e-05], [-4.46183666394908e-05, 0.00011730145974318679, -4.423885771333731e-05], [-4.437784557057352e-05, -4.423885771333731e-05, 0.00011768638771591833]]} + #*EXTRAS*# Step: 22 Bead: 0 +{"friction": [[0.00011760405338609765, -4.462282393914277e-05, -4.437643672670115e-05], [-4.462282393914277e-05, 0.00011721687635453845, -4.423932933264973e-05], [-4.437643672670115e-05, -4.423932933264973e-05, 0.00011760818098397374]]} + #*EXTRAS*# Step: 23 Bead: 0 +{"friction": [[0.00011753202016186403, -4.46261807493954e-05, -4.437468206759167e-05], [-4.46261807493954e-05, 0.00011713997809113728, -4.423935135625017e-05], [-4.437468206759167e-05, -4.423935135625017e-05, 0.0001175367951791919]]} + #*EXTRAS*# Step: 24 Bead: 0 +{"friction": [[0.00011746620051475942, -4.46286443440893e-05, -4.4372690908424515e-05], [-4.46286443440893e-05, 0.00011706997115585587, -4.4239029125289767e-05], [-4.4372690908424515e-05, -4.4239029125289767e-05, 0.00011747156003702819]]} + #*EXTRAS*# Step: 25 Bead: 0 +{"friction": [[0.00011740599859012817, -4.463038484392481e-05, -4.437054784861467e-05], [-4.463038484392481e-05, 0.00011700616287359589, -4.4238446807377235e-05], [-4.437054784861467e-05, -4.4238446807377235e-05, 0.00011741188771020598]]} + #*EXTRAS*# Step: 26 Bead: 0 +{"friction": [[0.00011735088889163575, -4.463154219974536e-05, -4.436831828280235e-05], [-4.463154219974536e-05, 0.00011694794513704876, -4.423767175010732e-05], [-4.436831828280235e-05, -4.423767175010732e-05, 0.00011735725929369392]]} + #*EXTRAS*# Step: 27 Bead: 0 +{"friction": [[0.00011730040527518005, -4.463223170540547e-05, -4.436605257957682e-05], [-4.463223170540547e-05, 0.00011689478121102554, -4.4236757844754e-05], [-4.436605257957682e-05, -4.4236757844754e-05, 0.00011730721413502656]]} + #*EXTRAS*# Step: 28 Bead: 0 +{"friction": [[0.00011725413213554819, -4.463254839715351e-05, -4.436378928666611e-05], [-4.463254839715351e-05, 0.00011684619509870085, -4.423574815541906e-05], [-4.436378928666611e-05, -4.423574815541906e-05, 0.00011726134125725034]]} + #*EXTRAS*# Step: 29 Bead: 0 +{"friction": [[0.00011721169727724889, -4.4632570597751505e-05, -4.436155761466786e-05], [-4.4632570597751505e-05, 0.00011680176289032746, -4.423467699516372e-05], [-4.436155761466786e-05, -4.423467699516372e-05, 0.00011721927240789482]]} + #*EXTRAS*# Step: 30 Bead: 0 +{"friction": [[0.00011717276610196376, -4.463236279532042e-05, -4.435937937968362e-05], [-4.463236279532042e-05, 0.00011676110567197261, -4.423357158053323e-05], [-4.435937937968362e-05, -4.423357158053323e-05, 0.00011718067638181571]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_01 b/drivers/py/pes/friction/frictionH/120K/inst.raw_01 new file mode 100644 index 000000000..388b8cfb6 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_01 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 1 +{"friction": [[0.00013154835182754853, -3.2245612347009654e-05, -3.218171211344349e-05], [-3.2245612347009654e-05, 0.00013178701661774967, -3.222276035226155e-05], [-3.218171211344349e-05, -3.222276035226155e-05, 0.00013130290733224788]]} + #*EXTRAS*# Step: 1 Bead: 1 +{"friction": [[0.0001286893030419792, -3.713190846506013e-05, -3.6780546449829285e-05], [-3.713190846506013e-05, 0.00012883988334197165, -3.71800304546541e-05], [-3.6780546449829285e-05, -3.71800304546541e-05, 0.0001283395631744918]]} + #*EXTRAS*# Step: 2 Bead: 1 +{"friction": [[0.0001255595515977443, -4.0815699620643985e-05, -4.025919338060738e-05], [-4.0815699620643985e-05, 0.00012562459621110223, -4.09116300219017e-05], [-4.025919338060738e-05, -4.09116300219017e-05, 0.00012524752298817733]]} + #*EXTRAS*# Step: 3 Bead: 1 +{"friction": [[0.00012350571430261051, -4.255206510784103e-05, -4.220874106329722e-05], [-4.255206510784103e-05, 0.00012357346288949112, -4.264636647064302e-05], [-4.220874106329722e-05, -4.264636647064302e-05, 0.0001232977676889637]]} + #*EXTRAS*# Step: 4 Bead: 1 +{"friction": [[0.00012230328948442814, -4.3269924034515715e-05, -4.314105387634043e-05], [-4.3269924034515715e-05, 0.00012236342268980444, -4.332199011090386e-05], [-4.314105387634043e-05, -4.332199011090386e-05, 0.0001221730939406554]]} + #*EXTRAS*# Step: 5 Bead: 1 +{"friction": [[0.00012147618519366912, -4.365027247032027e-05, -4.3621756634808554e-05], [-4.365027247032027e-05, 0.00012149855954658759, -4.364421119871324e-05], [-4.3621756634808554e-05, -4.364421119871324e-05, 0.00012139246480726636]]} + #*EXTRAS*# Step: 6 Bead: 1 +{"friction": [[0.00012083987908020374, -4.389922015919029e-05, -4.389476232172296e-05], [-4.389922015919029e-05, 0.00012080832854013111, -4.3831668419567127e-05], [-4.389476232172296e-05, -4.3831668419567127e-05, 0.00012078343296628643]]} + #*EXTRAS*# Step: 7 Bead: 1 +{"friction": [[0.0001203338361525274, -4.407509549710837e-05, -4.405869414739484e-05], [-4.407509549710837e-05, 0.00012024692259340631, -4.395152391087184e-05], [-4.405869414739484e-05, -4.395152391087184e-05, 0.00012029381847057779]]} + #*EXTRAS*# Step: 8 Bead: 1 +{"friction": [[0.00011991985249526275, -4.420367424041907e-05, -4.416337261974183e-05], [-4.420367424041907e-05, 0.0001197832091927444, -4.403256592890761e-05], [-4.416337261974183e-05, -4.403256592890761e-05, 0.0001198905714885945]]} + #*EXTRAS*# Step: 9 Bead: 1 +{"friction": [[0.00011957458155028012, -4.429977958002725e-05, -4.4232805895842314e-05], [-4.429977958002725e-05, 0.00011939521727819696, -4.408928715038095e-05], [-4.4232805895842314e-05, -4.408928715038095e-05, 0.00011955274456049951]]} + #*EXTRAS*# Step: 10 Bead: 1 +{"friction": [[0.00011928146135970337, -4.4373005213093815e-05, -4.428012424228152e-05], [-4.4373005213093815e-05, 0.00011906590109778443, -4.413003933839957e-05], [-4.428012424228152e-05, -4.413003933839957e-05, 0.00011926504076207387]]} + #*EXTRAS*# Step: 11 Bead: 1 +{"friction": [[0.00011902909292312528, -4.442960188875862e-05, -4.431289703776373e-05], [-4.442960188875862e-05, 0.00011878298380230162, -4.4159843246860896e-05], [-4.431289703776373e-05, -4.4159843246860896e-05, 0.00011901676778594759]]} + #*EXTRAS*# Step: 12 Bead: 1 +{"friction": [[0.00011880927943212927, -4.447382236214496e-05, -4.433576335952819e-05], [-4.447382236214496e-05, 0.00011853737756075751, -4.418189630939627e-05], [-4.433576335952819e-05, -4.418189630939627e-05, 0.0001188001506608638]]} + #*EXTRAS*# Step: 13 Bead: 1 +{"friction": [[0.00011861602184271071, -4.4508640091453794e-05, -4.435169274499617e-05], [-4.4508640091453794e-05, 0.00011832230221041995, -4.4198316819653946e-05], [-4.435169274499617e-05, -4.4198316819653946e-05, 0.000118609454132268]]} + #*EXTRAS*# Step: 14 Bead: 1 +{"friction": [[0.00011844480650239423, -4.453619561321111e-05, -4.436266104439535e-05], [-4.453619561321111e-05, 0.00011813258775016587, -4.421056029868031e-05], [-4.436266104439535e-05, -4.421056029868031e-05, 0.00011844033661133822]]} + #*EXTRAS*# Step: 15 Bead: 1 +{"friction": [[0.00011829216637024726, -4.4558066334736826e-05, -4.437002438598791e-05], [-4.4558066334736826e-05, 0.00011796422506221574, -4.421965644943181e-05], [-4.437002438598791e-05, -4.421965644943181e-05, 0.00011828944716130923]]} + #*EXTRAS*# Step: 16 Bead: 1 +{"friction": [[0.00011815538288185508, -4.4575439256941875e-05, -4.437473831782914e-05], [-4.4575439256941875e-05, 0.00011781404940212054, -4.4226352186395634e-05], [-4.437473831782914e-05, -4.4226352186395634e-05, 0.0001181541479154643]]} + #*EXTRAS*# Step: 17 Bead: 1 +{"friction": [[0.00011803228599344999, -4.4589223481923176e-05, -4.437749092009111e-05], [-4.4589223481923176e-05, 0.0001176795229789203, -4.423120069005218e-05], [-4.437749092009111e-05, -4.423120069005218e-05, 0.00011803232635759161]]} + #*EXTRAS*# Step: 18 Bead: 1 +{"friction": [[0.00011792111484134104, -4.4600125869282194e-05, -4.437878670771937e-05], [-4.4600125869282194e-05, 0.00011755858064433288, -4.423461889270867e-05], [-4.437878670771937e-05, -4.423461889270867e-05, 0.0001179222635627531]]} + #*EXTRAS*# Step: 19 Bead: 1 +{"friction": [[0.00011782041943975717, -4.460870306046284e-05, -4.437900113112342e-05], [-4.460870306046284e-05, 0.00011744951946421967, -4.4236925642735836e-05], [-4.437900113112342e-05, -4.4236925642735836e-05, 0.00011782254073540414]]} + #*EXTRAS*# Step: 20 Bead: 1 +{"friction": [[0.00011772898981542528, -4.461539809738384e-05, -4.437841696682741e-05], [-4.461539809738384e-05, 0.00011735091818470088, -4.4238367724485585e-05], [-4.437841696682741e-05, -4.4238367724485585e-05, 0.00011773197152292492]]} + #*EXTRAS*# Step: 21 Bead: 1 +{"friction": [[0.00011764580414358632, -4.4620566725717444e-05, -4.437724921232335e-05], [-4.4620566725717444e-05, 0.00011726157770944987, -4.4239138016471056e-05], [-4.437724921232335e-05, -4.4239138016471056e-05, 0.0001176495522896419]]} + #*EXTRAS*# Step: 22 Bead: 1 +{"friction": [[0.00011756999018304595, -4.462449665429248e-05, -4.437566249340663e-05], [-4.462449665429248e-05, 0.00011718047645699442, -4.4239388436178474e-05], [-4.437566249340663e-05, -4.4239388436178474e-05, 0.00011757442502074185]]} + #*EXTRAS*# Step: 23 Bead: 1 +{"friction": [[0.00011750079620301943, -4.462742190588291e-05, -4.437378347823869e-05], [-4.462742190588291e-05, 0.00011710673644116104, -4.423923934798909e-05], [-4.437378347823869e-05, -4.423923934798909e-05, 0.00011750584927712997]]} + #*EXTRAS*# Step: 24 Bead: 1 +{"friction": [[0.00011743756877501353, -4.462953368486984e-05, -4.4371709889632625e-05], [-4.462953368486984e-05, 0.00011703959717177546, -4.4238786521853864e-05], [-4.4371709889632625e-05, -4.4238786521853864e-05, 0.0001174431807187092]]} + #*EXTRAS*# Step: 25 Bead: 1 +{"friction": [[0.00011737973560039088, -4.4630988729962166e-05, -4.436951715398817e-05], [-4.4630988729962166e-05, 0.00011697839533412392, -4.4238106363234706e-05], [-4.436951715398817e-05, -4.4238106363234706e-05, 0.00011738585445991506]]} + #*EXTRAS*# Step: 26 Bead: 1 +{"friction": [[0.00011732679207633813, -4.463191582118126e-05, -4.436726337839459e-05], [-4.463191582118126e-05, 0.00011692254878800253, -4.4237259901075464e-05], [-4.436726337839459e-05, -4.4237259901075464e-05, 0.0001173333720217664]]} + #*EXTRAS*# Step: 27 Bead: 1 +{"friction": [[0.00011727829067122374, -4.46324209110383e-05, -4.4364993125255296e-05], [-4.46324209110383e-05, 0.00011687154383424474, -4.423629586865712e-05], [-4.4364993125255296e-05, -4.423629586865712e-05, 0.00011728529099281853]]} + #*EXTRAS*# Step: 28 Bead: 1 +{"friction": [[0.00011723383242419078, -4.4632591215110264e-05, -4.4362740308075076e-05], [-4.4632591215110264e-05, 0.00011682492496913069, -4.423525311138311e-05], [-4.4362740308075076e-05, -4.423525311138311e-05, 0.00011724121674230699]]} + #*EXTRAS*# Step: 29 Bead: 1 +{"friction": [[0.00011719306007485499, -4.463249850424318e-05, -4.436053043585729e-05], [-4.463249850424318e-05, 0.00011678228656072049, -4.423416248789445e-05], [-4.436053043585729e-05, -4.423416248789445e-05, 0.00011720079571106209]]} + #*EXTRAS*# Step: 30 Bead: 1 +{"friction": [[0.00011715565246611227, -4.463220177642326e-05, -4.435838236889387e-05], [-4.463220177642326e-05, 0.00011674326603496645, -4.4233048384971744e-05], [-4.435838236889387e-05, -4.4233048384971744e-05, 0.00011716370993702515]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_02 b/drivers/py/pes/friction/frictionH/120K/inst.raw_02 new file mode 100644 index 000000000..47c2186b1 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_02 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 2 +{"friction": [[0.0001305169912654799, -3.426881693488592e-05, -3.4119381770048507e-05], [-3.426881693488592e-05, 0.0001307291042872236, -3.427459924542595e-05], [-3.4119381770048507e-05, -3.427459924542595e-05, 0.00013021252399325722]]} + #*EXTRAS*# Step: 1 Bead: 2 +{"friction": [[0.00012764551331568468, -3.850180210646839e-05, -3.8045061678663234e-05], [-3.850180210646839e-05, 0.00012776121411998785, -3.8569693883882985e-05], [-3.8045061678663234e-05, -3.8569693883882985e-05, 0.00012729360618623438]]} + #*EXTRAS*# Step: 2 Bead: 2 +{"friction": [[0.00012481705695948644, -4.1511877530974883e-05, -4.0988404850469854e-05], [-4.1511877530974883e-05, 0.00012487670267123975, -4.161268905104676e-05], [-4.0988404850469854e-05, -4.161268905104676e-05, 0.00012453487425264872]]} + #*EXTRAS*# Step: 3 Bead: 2 +{"friction": [[0.00012300687956360998, -4.287676646943353e-05, -4.2624874997748286e-05], [-4.287676646943353e-05, 0.0001230760677290978, -4.2959007241281915e-05], [-4.2624874997748286e-05, -4.2959007241281915e-05, 0.00012283141513291218]]} + #*EXTRAS*# Step: 4 Bead: 2 +{"friction": [[0.00012190186636446617, -4.346408483593067e-05, -4.339222385981733e-05], [-4.346408483593067e-05, 0.00012194796017468636, -4.349110183051057e-05], [-4.339222385981733e-05, -4.349110183051057e-05, 0.00012179552993034382]]} + #*EXTRAS*# Step: 5 Bead: 2 +{"friction": [[0.00012112560676830857, -4.3791243771149345e-05, -4.378223042535306e-05], [-4.3791243771149345e-05, 0.00012112095649036673, -4.375295540431018e-05], [-4.378223042535306e-05, -4.375295540431018e-05, 0.00012105792885398685]]} + #*EXTRAS*# Step: 6 Bead: 2 +{"friction": [[0.00012052639461504323, -4.401053703948868e-05, -4.400128207320046e-05], [-4.401053703948868e-05, 0.00012046146767696096, -4.390872352051814e-05], [-4.400128207320046e-05, -4.390872352051814e-05, 0.00012048059722912726]]} + #*EXTRAS*# Step: 7 Bead: 2 +{"friction": [[0.00012005380156402715, -4.416362877435841e-05, -4.413217436724489e-05], [-4.416362877435841e-05, 0.00011993351898855064, -4.40079375075526e-05], [-4.413217436724489e-05, -4.40079375075526e-05, 0.00012002127998685366]]} + #*EXTRAS*# Step: 8 Bead: 2 +{"friction": [[0.00011966916063008429, -4.427449267124667e-05, -4.421530742823892e-05], [-4.427449267124667e-05, 0.0001195015328371423, -4.407470176652937e-05], [-4.421530742823892e-05, -4.407470176652937e-05, 0.00011964540661617181]]} + #*EXTRAS*# Step: 9 Bead: 2 +{"friction": [[0.00011934943113081695, -4.43567297598357e-05, -4.427005924362731e-05], [-4.43567297598357e-05, 0.0001191422177601824, -4.412118236754615e-05], [-4.427005924362731e-05, -4.412118236754615e-05, 0.00011933182137279275]]} + #*EXTRAS*# Step: 10 Bead: 2 +{"friction": [[0.00011907860086704502, -4.441898261484874e-05, -4.430702783926561e-05], [-4.441898261484874e-05, 0.00011883841757471843, -4.415437669092292e-05], [-4.430702783926561e-05, -4.415437669092292e-05, 0.00011906551007536217]]} + #*EXTRAS*# Step: 11 Bead: 2 +{"friction": [[0.00011884578829501208, -4.446681343285873e-05, -4.4332320721245e-05], [-4.446681343285873e-05, 0.00011857810502867646, -4.417848320355585e-05], [-4.4332320721245e-05, -4.417848320355585e-05, 0.00011883615054201828]]} + #*EXTRAS*# Step: 12 Bead: 2 +{"friction": [[0.00011864323086319824, -4.450397333611357e-05, -4.434968044638086e-05], [-4.450397333611357e-05, 0.00011835252678921346, -4.419617207741108e-05], [-4.434968044638086e-05, -4.419617207741108e-05, 0.00011863631553761937]]} + #*EXTRAS*# Step: 13 Bead: 2 +{"friction": [[0.00011846528314414116, -4.453306647183387e-05, -4.4361501586671284e-05], [-4.453306647183387e-05, 0.00011815523110779781, -4.420920969114531e-05], [-4.4361501586671284e-05, -4.420920969114531e-05, 0.00011846057015737144]]} + #*EXTRAS*# Step: 14 Bead: 2 +{"friction": [[0.00011830771756915197, -4.4555956740591634e-05, -4.436937652725228e-05], [-4.4555956740591634e-05, 0.00011798134200712491, -4.4218808096644284e-05], [-4.436937652725228e-05, -4.4218808096644284e-05, 0.00011830482474949939]]} + #*EXTRAS*# Step: 15 Bead: 2 +{"friction": [[0.00011816729932766309, -4.457401099993811e-05, -4.437439741871986e-05], [-4.457401099993811e-05, 0.00011782710451191198, -4.4225823586214036e-05], [-4.437439741871986e-05, -4.4225823586214036e-05, 0.0001181659379849296]]} + #*EXTRAS*# Step: 16 Bead: 2 +{"friction": [[0.00011804149980024013, -4.458825349950427e-05, -4.4377333123307516e-05], [-4.458825349950427e-05, 0.00011768957066794128, -4.423087644393697e-05], [-4.4377333123307516e-05, -4.423087644393697e-05, 0.0001180414465300192]]} + #*EXTRAS*# Step: 17 Bead: 2 +{"friction": [[0.00011792830574901703, -4.459946579527583e-05, -4.4378736683151555e-05], [-4.459946579527583e-05, 0.0001175663869763385, -4.423442542449515e-05], [-4.4378736683151555e-05, -4.423442542449515e-05, 0.00011792938392434554]]} + #*EXTRAS*# Step: 18 Bead: 2 +{"friction": [[0.00011782608703211786, -4.460825356253272e-05, -4.43790130470396e-05], [-4.460825356253272e-05, 0.00011745564516092206, -4.4236815784285184e-05], [-4.43790130470396e-05, -4.4236815784285184e-05, 0.00011782815431267261]]} + #*EXTRAS*# Step: 19 Bead: 2 +{"friction": [[0.00011773350370017236, -4.4615092318952734e-05, -4.4378463057352886e-05], [-4.4615092318952734e-05, 0.00011735577630323227, -4.4238311140210803e-05], [-4.4378463057352886e-05, -4.4238311140210803e-05, 0.00011773644339208856]]} + #*EXTRAS*# Step: 20 Bead: 2 +{"friction": [[0.00011764943926422315, -4.46203594744731e-05, -4.437731281632646e-05], [-4.46203594744731e-05, 0.00011726547417565379, -4.423911517294183e-05], [-4.437731281632646e-05, -4.423911517294183e-05, 0.00011765315421502596]]} + #*EXTRAS*# Step: 21 Bead: 2 +{"friction": [[0.00011757295201057719, -4.4624357268589914e-05, -4.4375733773914075e-05], [-4.4624357268589914e-05, 0.00011718363890987785, -4.423938676174965e-05], [-4.4375733773914075e-05, -4.423938676174965e-05, 0.00011757736021312136]]} + #*EXTRAS*# Step: 22 Bead: 2 +{"friction": [[0.00011750323889718257, -4.4627329510400734e-05, -4.4373856773573614e-05], [-4.4627329510400734e-05, 0.00011710933495859636, -4.423925076714043e-05], [-4.4373856773573614e-05, -4.423925076714043e-05, 0.0001175082702705337]]} + #*EXTRAS*# Step: 23 Bead: 2 +{"friction": [[0.00011743960840133045, -4.462947401549749e-05, -4.437178206962282e-05], [-4.462947401549749e-05, 0.0001170417592943114, -4.4238805863108184e-05], [-4.437178206962282e-05, -4.4238805863108184e-05, 0.00011744520239732043]]} + #*EXTRAS*# Step: 24 Bead: 2 +{"friction": [[0.00011738145982342166, -4.463095199914259e-05, -4.43695866005868e-05], [-4.463095199914259e-05, 0.00011698021703486482, -4.423813032769555e-05], [-4.43695866005868e-05, -4.423813032769555e-05, 0.00011738756362206805]]} + #*EXTRAS*# Step: 25 Bead: 2 +{"friction": [[0.00011732826731505682, -4.46318952781318e-05, -4.436732935638911e-05], [-4.46318952781318e-05, 0.00011692410253229474, -4.4237286393370604e-05], [-4.436732935638911e-05, -4.4237286393370604e-05, 0.00011733483444611214]]} + #*EXTRAS*# Step: 26 Bead: 2 +{"friction": [[0.00011727956740685803, -4.463241186867728e-05, -4.436505539715684e-05], [-4.463241186867728e-05, 0.00011687288452932602, -4.4236323563278616e-05], [-4.436505539715684e-05, -4.4236323563278616e-05, 0.00011728655668376484]]} + #*EXTRAS*# Step: 27 Bead: 2 +{"friction": [[0.00011723494916119953, -4.463259039159929e-05, -4.4362798902123126e-05], [-4.463259039159929e-05, 0.00011682609438177876, -4.423528117251963e-05], [-4.4362798902123126e-05, -4.423528117251963e-05, 0.00011724232384675485]]} + #*EXTRAS*# Step: 28 Bead: 2 +{"friction": [[0.00011719404630623569, -4.4632503577400756e-05, -4.436058550945369e-05], [-4.4632503577400756e-05, 0.00011678331660793783, -4.4234190389388246e-05], [-4.436058550945369e-05, -4.4234190389388246e-05, 0.00011720177345200835]]} + #*EXTRAS*# Step: 29 Bead: 2 +{"friction": [[0.00011715653088795427, -4.4632211082204615e-05, -4.435843413034881e-05], [-4.4632211082204615e-05, 0.00011674418123021799, -4.4233075795137536e-05], [-4.435843413034881e-05, -4.4233075795137536e-05, 0.00011716458080527474]]} + #*EXTRAS*# Step: 30 Bead: 2 +{"friction": [[0.00011712210810572925, -4.463176176934067e-05, -4.435635836871432e-05], [-4.463176176934067e-05, 0.00011670835752050712, -4.423195664256965e-05], [-4.435635836871432e-05, -4.423195664256965e-05, 0.00011713045393714701]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_03 b/drivers/py/pes/friction/frictionH/120K/inst.raw_03 new file mode 100644 index 000000000..c79b19538 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_03 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 3 +{"friction": [[0.0001286764741586319, -3.714973769009648e-05, -3.679697296268993e-05], [-3.714973769009648e-05, 0.0001288266109833087, -3.7198122442431674e-05], [-3.679697296268993e-05, -3.7198122442431674e-05, 0.00012832661431276367]]} + #*EXTRAS*# Step: 1 Bead: 3 +{"friction": [[0.00012607892059406545, -4.0288583109172084e-05, -3.973582745361572e-05], [-4.0288583109172084e-05, 0.00012615275147890532, -4.037924424954023e-05], [-3.973582745361572e-05, -4.037924424954023e-05, 0.00012575129623192152]]} + #*EXTRAS*# Step: 2 Bead: 3 +{"friction": [[0.00012381853838111173, -4.23280851350682e-05, -4.193102726934131e-05], [-4.23280851350682e-05, 0.00012388385533028312, -4.242671454221878e-05], [-4.193102726934131e-05, -4.242671454221878e-05, 0.00012359095074737653]]} + #*EXTRAS*# Step: 3 Bead: 3 +{"friction": [[0.0001222896436444234, -4.3276857013088666e-05, -4.315013300660784e-05], [-4.3276857013088666e-05, 0.00012234941992498726, -4.332816833973328e-05], [-4.315013300660784e-05, -4.332816833973328e-05, 0.00012216029121227468]]} + #*EXTRAS*# Step: 4 Bead: 3 +{"friction": [[0.0001213039234894172, -4.372077094610197e-05, -4.370380020826626e-05], [-4.372077094610197e-05, 0.00012131388911362992, -4.3699427712531235e-05], [-4.370380020826626e-05, -4.3699427712531235e-05, 0.0001212284006399647]]} + #*EXTRAS*# Step: 5 Bead: 3 +{"friction": [[0.00012059967507318385, -4.3985198130420605e-05, -4.3977873114727344e-05], [-4.3985198130420605e-05, 0.00012054284808431733, -4.3891545632933004e-05], [-4.3977873114727344e-05, -4.3891545632933004e-05, 0.0001205515319716067]]} + #*EXTRAS*# Step: 6 Bead: 3 +{"friction": [[0.00012006141092944255, -4.416130859883897e-05, -4.413032734131131e-05], [-4.416130859883897e-05, 0.00011994205156798663, -4.400649334505393e-05], [-4.413032734131131e-05, -4.400649334505393e-05, 0.00012002869885638584]]} + #*EXTRAS*# Step: 7 Bead: 3 +{"friction": [[0.00011964150096950147, -4.428197006103948e-05, -4.4220540793822016e-05], [-4.428197006103948e-05, 0.00011947044103697907, -4.407904072328e-05], [-4.4220540793822016e-05, -4.407904072328e-05, 0.00011961831667836554]]} + #*EXTRAS*# Step: 8 Bead: 3 +{"friction": [[0.00011930180668763787, -4.436817874924817e-05, -4.427716773238298e-05], [-4.436817874924817e-05, 0.00011908874076224151, -4.412742539967289e-05], [-4.427716773238298e-05, -4.412742539967289e-05, 0.00011928503416732887]]} + #*EXTRAS*# Step: 9 Bead: 3 +{"friction": [[0.00011902056210380947, -4.4431407526848796e-05, -4.431388127964052e-05], [-4.4431407526848796e-05, 0.00011877343576385875, -4.4160766571658334e-05], [-4.431388127964052e-05, -4.4160766571658334e-05, 0.0001190083671277332]]} + #*EXTRAS*# Step: 10 Bead: 3 +{"friction": [[0.0001187829562549342, -4.447879166692809e-05, -4.4338159164083715e-05], [-4.447879166692809e-05, 0.00011850803065037355, -4.418429572086999e-05], [-4.4338159164083715e-05, -4.418429572086999e-05, 0.00011877418932181912]]} + #*EXTRAS*# Step: 11 Bead: 3 +{"friction": [[0.00011857907460137818, -4.451485186157124e-05, -4.435430608245401e-05], [-4.451485186157124e-05, 0.00011828129199036966, -4.4201141695240664e-05], [-4.435430608245401e-05, -4.4201141695240664e-05, 0.00011857297246829036]]} + #*EXTRAS*# Step: 12 Bead: 3 +{"friction": [[0.00011840190819559462, -4.454260251739774e-05, -4.436495761530357e-05], [-4.454260251739774e-05, 0.00011808519301113097, -4.4213289797498375e-05], [-4.436495761530357e-05, -4.4213289797498375e-05, 0.00011839794108275895]]} + #*EXTRAS*# Step: 13 Bead: 3 +{"friction": [[0.00011824639834974987, -4.456411672202455e-05, -4.43717978308197e-05], [-4.456411672202455e-05, 0.00011791389895421148, -4.42220500288845e-05], [-4.43717978308197e-05, -4.42220500288845e-05, 0.00011824418417021745]]} + #*EXTRAS*# Step: 14 Bead: 3 +{"friction": [[0.00011810877809847195, -4.458086684841404e-05, -4.437594489218746e-05], [-4.458086684841404e-05, 0.00011776304501892846, -4.422831914393404e-05], [-4.437594489218746e-05, -4.422831914393404e-05, 0.00011810803231540454]]} + #*EXTRAS*# Step: 15 Bead: 3 +{"friction": [[0.00011798617849466853, -4.459392547194097e-05, -4.437816429086111e-05], [-4.459392547194097e-05, 0.00011762929712663583, -4.4232729167385156e-05], [-4.437816429086111e-05, -4.4232729167385156e-05, 0.00011798668324320589]]} + #*EXTRAS*# Step: 16 Bead: 3 +{"friction": [[0.00011787636529271008, -4.460409167072655e-05, -4.437899374679194e-05], [-4.460409167072655e-05, 0.0001175100545879108, -4.4235736820400855e-05], [-4.437899374679194e-05, -4.4235736820400855e-05, 0.00011787794967890633]]} + #*EXTRAS*# Step: 17 Bead: 3 +{"friction": [[0.0001177775651701928, -4.461197202675179e-05, -4.43788190315069e-05], [-4.461197202675179e-05, 0.00011740325202641066, -4.423767903863494e-05], [-4.43788190315069e-05, -4.423767903863494e-05, 0.00011778009226273695]]} + #*EXTRAS*# Step: 18 Bead: 3 +{"friction": [[0.00011768834594466655, -4.461803440124803e-05, -4.437792172035237e-05], [-4.461803440124803e-05, 0.00011730722194018015, -4.4238808717332046e-05], [-4.437792172035237e-05, -4.4238808717332046e-05, 0.00011769170394502538]]} + #*EXTRAS*# Step: 19 Bead: 3 +{"friction": [[0.00011760753290939386, -4.462264450477936e-05, -4.437651019012073e-05], [-4.462264450477936e-05, 0.00011722059816574596, -4.423931838556963e-05], [-4.437651019012073e-05, -4.423931838556963e-05, 0.00011761162900741673]]} + #*EXTRAS*# Step: 20 Bead: 3 +{"friction": [[0.00011753414899389916, -4.4626091391096076e-05, -4.4374740302066454e-05], [-4.4626091391096076e-05, 0.00011714224652061415, -4.4239356311824285e-05], [-4.4374740302066454e-05, -4.4239356311824285e-05, 0.00011753890499964158]]} + #*EXTRAS*# Step: 21 Bead: 3 +{"friction": [[0.00011746737127410753, -4.4628605613976706e-05, -4.437272954423699e-05], [-4.4628605613976706e-05, 0.00011707121419007879, -4.423903772174218e-05], [-4.437272954423699e-05, -4.423903772174218e-05, 0.00011747272045239761]]} + #*EXTRAS*# Step: 22 Bead: 3 +{"friction": [[0.00011740649882682482, -4.4630372420903386e-05, -4.437056691697352e-05], [-4.4630372420903386e-05, 0.00011700669217711562, -4.423845278166325e-05], [-4.437056691697352e-05, -4.423845278166325e-05, 0.00011741238356383853]]} + #*EXTRAS*# Step: 23 Bead: 3 +{"friction": [[0.00011735092862537703, -4.4631541516824966e-05, -4.4368319982125235e-05], [-4.4631541516824966e-05, 0.00011694798704377899, -4.42376723925005e-05], [-4.4368319982125235e-05, -4.42376723925005e-05, 0.00011735729868149518]]} + #*EXTRAS*# Step: 24 Bead: 3 +{"friction": [[0.00011730013721534131, -4.463223441217138e-05, -4.4366039981301515e-05], [-4.463223441217138e-05, 0.0001168944993526933, -4.423675247011439e-05], [-4.4366039981301515e-05, -4.423675247011439e-05, 0.00011730694839800605]]} + #*EXTRAS*# Step: 25 Bead: 3 +{"friction": [[0.00011725366660772874, -4.4632550038359574e-05, -4.4363765613337175e-05], [-4.4632550038359574e-05, 0.00011684570701171363, -4.4235737159185784e-05], [-4.4363765613337175e-05, -4.4235737159185784e-05, 0.00011726087974960589]]} + #*EXTRAS*# Step: 26 Bead: 3 +{"friction": [[0.00011721111328823937, -4.4632569099606635e-05, -4.436152586353928e-05], [-4.4632569099606635e-05, 0.0001168011522521748, -4.423466128195034e-05], [-4.436152586353928e-05, -4.423466128195034e-05, 0.00011721869345024434]]} + #*EXTRAS*# Step: 27 Bead: 3 +{"friction": [[0.00011717211955808389, -4.4632357488128966e-05, -4.435934215093207e-05], [-4.4632357488128966e-05, 0.00011676043133430275, -4.423355222873854e-05], [-4.435934215093207e-05, -4.423355222873854e-05, 0.0001171800353999881]]} + #*EXTRAS*# Step: 28 Bead: 3 +{"friction": [[0.00011713636663086333, -4.463196899452722e-05, -4.435722997671107e-05], [-4.463196899452722e-05, 0.00011672318631448188, -4.423243143460344e-05], [-4.435722997671107e-05, -4.423243143460344e-05, 0.00011714458990820767]]} + #*EXTRAS*# Step: 29 Bead: 3 +{"friction": [[0.00011710356907232242, -4.463144748006077e-05, -4.4355200202751565e-05], [-4.463144748006077e-05, 0.0001166890983949936, -4.423131554456257e-05], [-4.4355200202751565e-05, -4.423131554456257e-05, 0.00011711207422949394]]} + #*EXTRAS*# Step: 30 Bead: 3 +{"friction": [[0.000117073470284729, -4.4630828632825386e-05, -4.4353260052509936e-05], [-4.4630828632825386e-05, 0.0001166578825084951, -4.423021734167244e-05], [-4.4353260052509936e-05, -4.423021734167244e-05, 0.00011708223412188392]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_04 b/drivers/py/pes/friction/frictionH/120K/inst.raw_04 new file mode 100644 index 000000000..aa904f7ce --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_04 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 4 +{"friction": [[0.000126076844382827, -4.029075427069417e-05, -3.973794837135237e-05], [-4.029075427069417e-05, 0.000126150633634249, -4.038143906978131e-05], [-3.973794837135237e-05, -4.038143906978131e-05, 0.00012574927445048358]]} + #*EXTRAS*# Step: 1 Bead: 4 +{"friction": [[0.0001242118005630554, -4.202450696574452e-05, -4.1567902994536414e-05], [-4.202450696574452e-05, 0.0001242738742018483, -4.212575489224792e-05], [-4.1567902994536414e-05, -4.212575489224792e-05, 0.00012396098561636316]]} + #*EXTRAS*# Step: 2 Bead: 4 +{"friction": [[0.000122624904103985, -4.309915312971374e-05, -4.291647728941369e-05], [-4.309915312971374e-05, 0.00012269127980020533, -4.316709253616962e-05], [-4.291647728941369e-05, -4.316709253616962e-05, 0.00012247435599409097]]} + #*EXTRAS*# Step: 3 Bead: 4 +{"friction": [[0.0001213557878445288, -4.3699808185378466e-05, -4.3679751608971045e-05], [-4.3699808185378466e-05, 0.00012136966506918443, -4.368317953126223e-05], [-4.3679751608971045e-05, -4.368317953126223e-05, 0.0001212778593567503]]} + #*EXTRAS*# Step: 4 Bead: 4 +{"friction": [[0.00012050407534820509, -4.4018170781963954e-05, -4.4008237789471113e-05], [-4.4018170781963954e-05, 0.00012043664988824233, -4.391385682831017e-05], [-4.4008237789471113e-05, -4.391385682831017e-05, 0.00012045897594746194]]} + #*EXTRAS*# Step: 5 Bead: 4 +{"friction": [[0.0001199063680743773, -4.4207621384405064e-05, -4.416637736622521e-05], [-4.4207621384405064e-05, 0.00011976806789360359, -4.4034962703691124e-05], [-4.416637736622521e-05, -4.4034962703691124e-05, 0.0001198774017644541]]} + #*EXTRAS*# Step: 6 Bead: 4 +{"friction": [[0.00011945651015345047, -4.433022140693853e-05, -4.4253101939380295e-05], [-4.433022140693853e-05, 0.0001192625132567544, -4.41065059131423e-05], [-4.4253101939380295e-05, -4.41065059131423e-05, 0.00011943694688636502]]} + #*EXTRAS*# Step: 7 Bead: 4 +{"friction": [[0.00011910939059299636, -4.44122581475971e-05, -4.4303241562306134e-05], [-4.44122581475971e-05, 0.00011887291103844794, -4.41508837543843e-05], [-4.4303241562306134e-05, -4.41508837543843e-05, 0.00011909581463524801]]} + #*EXTRAS*# Step: 8 Bead: 4 +{"friction": [[0.00011883013068512436, -4.446983593356149e-05, -4.433381427130158e-05], [-4.446983593356149e-05, 0.00011856063471019628, -4.417995912856348e-05], [-4.433381427130158e-05, -4.417995912856348e-05, 0.00011882071224498145]]} + #*EXTRAS*# Step: 9 Bead: 4 +{"friction": [[0.00011859976441216682, -4.4511391198934054e-05, -4.435285952476713e-05], [-4.4511391198934054e-05, 0.000118304252413566, -4.419957222291216e-05], [-4.435285952476713e-05, -4.419957222291216e-05, 0.00011859340246997805]]} + #*EXTRAS*# Step: 10 Bead: 4 +{"friction": [[0.00011840558516319614, -4.4542061272838076e-05, -4.436476777142602e-05], [-4.4542061272838076e-05, 0.00011808925307518387, -4.421306114628768e-05], [-4.436476777142602e-05, -4.421306114628768e-05, 0.0001184015752951598]]} + #*EXTRAS*# Step: 11 Bead: 4 +{"friction": [[0.00011823921633763981, -4.4565044615619234e-05, -4.437205813588116e-05], [-4.4565044615619234e-05, 0.00011790600856767983, -4.4222411653389576e-05], [-4.437205813588116e-05, -4.4222411653389576e-05, 0.00011823708062241249]]} + #*EXTRAS*# Step: 12 Bead: 4 +{"friction": [[0.000118094782357607, -4.4582447322553376e-05, -4.4376267989850055e-05], [-4.4582447322553376e-05, 0.00011774774501860025, -4.422887860792521e-05], [-4.4376267989850055e-05, -4.422887860792521e-05, 0.00011809418193975138]]} + #*EXTRAS*# Step: 13 Bead: 4 +{"friction": [[0.00011796807433135647, -4.4595702085058035e-05, -4.4378375889050864e-05], [-4.4595702085058035e-05, 0.0001176096011387571, -4.4233286408924316e-05], [-4.4378375889050864e-05, -4.4233286408924316e-05, 0.00011796875956720269]]} + #*EXTRAS*# Step: 14 Bead: 4 +{"friction": [[0.00011785597458622951, -4.4605817221714796e-05, -4.437902870206821e-05], [-4.4605817221714796e-05, 0.00011748797399318313, -4.4236197007858894e-05], [-4.437902870206821e-05, -4.4236197007858894e-05, 0.00011785775563162551]]} + #*EXTRAS*# Step: 15 Bead: 4 +{"friction": [[0.00011775611945899513, -4.46135213835161e-05, -4.4378667081409935e-05], [-4.46135213835161e-05, 0.0001173801323307823, -4.4238004764108554e-05], [-4.4378667081409935e-05, -4.4238004764108554e-05, 0.00011775884794083997]]} + #*EXTRAS*# Step: 16 Bead: 4 +{"friction": [[0.0001176666747877808, -4.4619353551771966e-05, -4.437759878678848e-05], [-4.4619353551771966e-05, 0.00011728395842060013, -4.4238993391320516e-05], [-4.437759878678848e-05, -4.4238993391320516e-05, 0.00011767023199038482]]} + #*EXTRAS*# Step: 17 Bead: 4 +{"friction": [[0.0001175861891453161, -4.462372019705838e-05, -4.43760431321599e-05], [-4.462372019705838e-05, 0.00011719777864942468, -4.423937121028195e-05], [-4.43760431321599e-05, -4.423937121028195e-05, 0.00011759047812570277]]} + #*EXTRAS*# Step: 18 Bead: 4 +{"friction": [[0.00011751349316684174, -4.4626932919655545e-05, -4.4374158915510944e-05], [-4.4626932919655545e-05, 0.00011712024712397131, -4.423929378205606e-05], [-4.4374158915510944e-05, -4.423929378205606e-05, 0.00011751843334693357]]} + #*EXTRAS*# Step: 19 Bead: 4 +{"friction": [[0.00011744762961992548, -4.4629233864394175e-05, -4.437206251793386e-05], [-4.4629233864394175e-05, 0.00011705026466374876, -4.423887886124528e-05], [-4.437206251793386e-05, -4.423887886124528e-05, 0.00011745315298356145]]} + #*EXTRAS*# Step: 20 Bead: 4 +{"friction": [[0.00011738780358845689, -4.463081332682e-05, -4.4369839957794265e-05], [-4.463081332682e-05, 0.00011698692101674914, -4.423821654497569e-05], [-4.4369839957794265e-05, -4.423821654497569e-05, 0.00011739385194900655]]} + #*EXTRAS*# Step: 21 Bead: 4 +{"friction": [[0.00011733334640478732, -4.4631822222405206e-05, -4.4367555120524354e-05], [-4.4631822222405206e-05, 0.00011692945296249422, -4.423737632767856e-05], [-4.4367555120524354e-05, -4.423737632767856e-05, 0.00011733986940355956]]} + #*EXTRAS*# Step: 22 Bead: 4 +{"friction": [[0.00011728368907584373, -4.463238110197935e-05, -4.436525550362457e-05], [-4.463238110197935e-05, 0.00011687721340009478, -4.423641211304196e-05], [-4.436525550362457e-05, -4.423641211304196e-05, 0.00011729064269009751]]} + #*EXTRAS*# Step: 23 Bead: 4 +{"friction": [[0.0001172383424156295, -4.4632586793431197e-05, -4.43629763092775e-05], [-4.4632586793431197e-05, 0.00011682964820160394, -4.4235365846045575e-05], [-4.43629763092775e-05, -4.4235365846045575e-05, 0.00011724568782849715]]} + #*EXTRAS*# Step: 24 Bead: 4 +{"friction": [[0.0001171968819823881, -4.463251737978226e-05, -4.436074341381048e-05], [-4.463251737978226e-05, 0.00011678627863353075, -4.423427019304463e-05], [-4.436074341381048e-05, -4.423427019304463e-05, 0.00011720458471408661]]} + #*EXTRAS*# Step: 25 Bead: 4 +{"friction": [[0.00011715893651165148, -4.4632235989489705e-05, -4.435857555840678e-05], [-4.4632235989489705e-05, 0.00011674668783343752, -4.423315055222995e-05], [-4.435857555840678e-05, -4.423315055222995e-05, 0.000117166965742108]]} + #*EXTRAS*# Step: 26 Bead: 4 +{"friction": [[0.00011712417892549652, -4.4631793723902244e-05, -4.4356485989657975e-05], [-4.4631793723902244e-05, 0.0001167105102783188, -4.423202658437022e-05], [-4.4356485989657975e-05, -4.423202658437022e-05, 0.00011713250695906716]]} + #*EXTRAS*# Step: 27 Bead: 4 +{"friction": [[0.00011709231926477995, -4.4631231947573914e-05, -4.4354483704705436e-05], [-4.4631231947573914e-05, 0.00011667742348925151, -4.423091339399117e-05], [-4.4354483704705436e-05, -4.423091339399117e-05, 0.00011710092110171828]]} + #*EXTRAS*# Step: 28 Bead: 4 +{"friction": [[0.00011706309906640859, -4.463058410065597e-05, -4.435257440712073e-05], [-4.463058410065597e-05, 0.00011664714142023798, -4.4229822451473455e-05], [-4.435257440712073e-05, -4.4229822451473455e-05, 0.00011707195205547787]]} + #*EXTRAS*# Step: 29 Bead: 4 +{"friction": [[0.00011703628684358028, -4.4629877147541886e-05, -4.435076124822384e-05], [-4.4629877147541886e-05, 0.00011661940913523149, -4.4228762320351386e-05], [-4.435076124822384e-05, -4.4228762320351386e-05, 0.00011704537039699232]]} + #*EXTRAS*# Step: 30 Bead: 4 +{"friction": [[0.00011701167442199444, -4.462913274511881e-05, -4.434904540742788e-05], [-4.462913274511881e-05, 0.00011659399848647701, -4.4227739236348115e-05], [-4.434904540742788e-05, -4.4227739236348115e-05, 0.00011702096977865009]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_05 b/drivers/py/pes/friction/frictionH/120K/inst.raw_05 new file mode 100644 index 000000000..203c3e8ed --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_05 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 5 +{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} + #*EXTRAS*# Step: 1 Bead: 5 +{"friction": [[0.00012223076292839058, -4.3306492543579546e-05, -4.318887864472367e-05], [-4.3306492543579546e-05, 0.0001222889067552836, -4.335446989368814e-05], [-4.318887864472367e-05, -4.335446989368814e-05, 0.00012210502556903082]]} + #*EXTRAS*# Step: 2 Bead: 5 +{"friction": [[0.00012120416686832614, -4.376049141196621e-05, -4.3748484396564264e-05], [-4.376049141196621e-05, 0.00012120617916689671, -4.3729807756148584e-05], [-4.3748484396564264e-05, -4.3729807756148584e-05, 0.00012113311512355723]]} + #*EXTRAS*# Step: 3 Bead: 5 +{"friction": [[0.00012018059087079129, -4.4124341688729956e-05, -4.410032428342652e-05], [-4.4124341688729956e-05, 0.00012007558350951433, -4.3983233205862365e-05], [-4.410032428342652e-05, -4.3983233205862365e-05, 0.0001201448014243005]]} + #*EXTRAS*# Step: 4 Bead: 5 +{"friction": [[0.00011951693113786782, -4.431480077689574e-05, -4.424292799197493e-05], [-4.431480077689574e-05, 0.00011933041712524518, -4.4097831004381743e-05], [-4.424292799197493e-05, -4.4097831004381743e-05, 0.00011949622047533918]]} + #*EXTRAS*# Step: 5 Bead: 5 +{"friction": [[0.00011906793206063026, -4.442129122581269e-05, -4.430831538246247e-05], [-4.442129122581269e-05, 0.00011882646861551708, -4.4155570323284035e-05], [-4.430831538246247e-05, -4.4155570323284035e-05, 0.00011905500776047484]]} + #*EXTRAS*# Step: 6 Bead: 5 +{"friction": [[0.00011873339050609555, -4.448795593295757e-05, -4.434247540317718e-05], [-4.448795593295757e-05, 0.00011845281388286366, -4.4188674172580735e-05], [-4.434247540317718e-05, -4.4188674172580735e-05, 0.00011872529348725702]]} + #*EXTRAS*# Step: 7 Bead: 5 +{"friction": [[0.0001184777052830482, -4.453114595287143e-05, -4.436077820099795e-05], [-4.453114595287143e-05, 0.00011816897398214691, -4.420837530855102e-05], [-4.436077820099795e-05, -4.420837530855102e-05, 0.0001184728438256015]]} + #*EXTRAS*# Step: 8 Bead: 5 +{"friction": [[0.00011827269359676414, -4.456066951770743e-05, -4.437080319116576e-05], [-4.456066951770743e-05, 0.00011794280377335238, -4.422069366187113e-05], [-4.437080319116576e-05, -4.422069366187113e-05, 0.00011827019032966963]]} + #*EXTRAS*# Step: 9 Bead: 5 +{"friction": [[0.0001181039450017804, -4.458141521990199e-05, -4.4376058509997604e-05], [-4.458141521990199e-05, 0.0001177577606307272, -4.422851397244622e-05], [-4.4376058509997604e-05, -4.422851397244622e-05, 0.00011810324949618356]]} + #*EXTRAS*# Step: 10 Bead: 5 +{"friction": [[0.00011796184485516009, -4.4596304275584707e-05, -4.437844183633171e-05], [-4.4596304275584707e-05, 0.00011760282727274567, -4.423347255073492e-05], [-4.437844183633171e-05, -4.423347255073492e-05, 0.0001179625919596174]]} + #*EXTRAS*# Step: 11 Bead: 5 +{"friction": [[0.00011784015093051801, -4.460712090861291e-05, -4.437903030350969e-05], [-4.460712090861291e-05, 0.00011747085250779493, -4.4236532871513734e-05], [-4.437903030350969e-05, -4.4236532871513734e-05, 0.00011784208381409806]]} + #*EXTRAS*# Step: 12 Bead: 5 +{"friction": [[0.00011773450289261969, -4.4615024282045496e-05, -4.4378473018638704e-05], [-4.4615024282045496e-05, 0.00011735685183552438, -4.423829840929034e-05], [-4.4378473018638704e-05, -4.423829840929034e-05, 0.00011773743327775395]]} + #*EXTRAS*# Step: 13 Bead: 5 +{"friction": [[0.00011764179745355345, -4.462079317746615e-05, -4.437717778039293e-05], [-4.462079317746615e-05, 0.00011725728377924701, -4.423916204777161e-05], [-4.437717778039293e-05, -4.423916204777161e-05, 0.00011764558215806325]]} + #*EXTRAS*# Step: 14 Bead: 5 +{"friction": [[0.00011755974442911601, -4.4624969895579986e-05, -4.437541010775329e-05], [-4.4624969895579986e-05, 0.00011716954046617503, -4.423938913400873e-05], [-4.437541010775329e-05, -4.423938913400873e-05, 0.0001175642712914766]]} + #*EXTRAS*# Step: 15 Bead: 5 +{"friction": [[0.0001174866137319667, -4.462794253432514e-05, -4.4373347884613664e-05], [-4.462794253432514e-05, 0.00011709165608981416, -4.42391641283876e-05], [-4.4373347884613664e-05, -4.42391641283876e-05, 0.00011749179263426363]]} + #*EXTRAS*# Step: 16 Bead: 5 +{"friction": [[0.00011742106633542397, -4.4629995603466744e-05, -4.4371112958437565e-05], [-4.4629995603466744e-05, 0.00011702211281080716, -4.423861840402645e-05], [-4.4371112958437565e-05, -4.423861840402645e-05, 0.00011742682330927183]]} + #*EXTRAS*# Step: 17 Bead: 5 +{"friction": [[0.00011736204491655979, -4.463134183752252e-05, -4.4368790205124e-05], [-4.463134183752252e-05, 0.00011695971514772929, -4.4237847371808724e-05], [-4.4368790205124e-05, -4.4237847371808724e-05, 0.00011736831813230383]]} + #*EXTRAS*# Step: 18 Bead: 5 +{"friction": [[0.00011730869901499813, -4.463214295930265e-05, -4.43664394095985e-05], [-4.463214295930265e-05, 0.00011690350415360935, -4.423692140779459e-05], [-4.43664394095985e-05, -4.423692140779459e-05, 0.00011731543598114691]]} + #*EXTRAS*# Step: 19 Bead: 5 +{"friction": [[0.0001172603333071181, -4.4632523589881964e-05, -4.436410291813146e-05], [-4.4632523589881964e-05, 0.00011685269813369067, -4.42358930385164e-05], [-4.436410291813146e-05, -4.42358930385164e-05, 0.00011726748886554383]]} + #*EXTRAS*# Step: 20 Bead: 5 +{"friction": [[0.00011721637086547228, -4.463258081740697e-05, -4.436181070001666e-05], [-4.463258081740697e-05, 0.00011680665057338299, -4.4234801794245246e-05], [-4.436181070001666e-05, -4.4234801794245246e-05, 0.0001172239057258324]]} + #*EXTRAS*# Step: 21 Bead: 5 +{"friction": [[0.00011717632664400384, -4.463239093234793e-05, -4.435958378351939e-05], [-4.463239093234793e-05, 0.00011676481978848138, -4.4233677569179584e-05], [-4.435958378351939e-05, -4.4233677569179584e-05, 0.0001171842062914663]]} + #*EXTRAS*# Step: 22 Bead: 5 +{"friction": [[0.00011713978799389308, -4.463201427050411e-05, -4.435743664149997e-05], [-4.463201427050411e-05, 0.0001167267466286236, -4.423254300019232e-05], [-4.435743664149997e-05, -4.423254300019232e-05, 0.00011714798186080167]]} + #*EXTRAS*# Step: 23 Bead: 5 +{"friction": [[0.00011710640013374706, -4.463149876366196e-05, -4.435537888325825e-05], [-4.463149876366196e-05, 0.0001166920378493255, -4.4231415185762524e-05], [-4.435537888325825e-05, -4.4231415185762524e-05, 0.00011711488096121253]]} + #*EXTRAS*# Step: 24 Bead: 5 +{"friction": [[0.0001170758551593119, -4.463088258954916e-05, -4.435341647746978e-05], [-4.463088258954916e-05, 0.00011666035353100688, -4.423030695152644e-05], [-4.435341647746978e-05, -4.423030695152644e-05, 0.00011708459849769093]]} + #*EXTRAS*# Step: 25 Bead: 5 +{"friction": [[0.0001170478836227872, -4.463019618196321e-05, -4.435155265173285e-05], [-4.463019618196321e-05, 0.00011663139743449313, -4.422922779805797e-05], [-4.435155265173285e-05, -4.422922779805797e-05, 0.00011705686743519111]]} + #*EXTRAS*# Step: 26 Bead: 5 +{"friction": [[0.00011702224800154225, -4.4629463778173874e-05, -4.434978856463429e-05], [-4.4629463778173874e-05, 0.00011660490951536063, -4.422818462164849e-05], [-4.434978856463429e-05, -4.422818462164849e-05, 0.0001170314523447866]]} + #*EXTRAS*# Step: 27 Bead: 5 +{"friction": [[0.00011699873757420249, -4.4628704625996236e-05, -4.434812381488574e-05], [-4.4628704625996236e-05, 0.00011658066004658321, -4.422718227004636e-05], [-4.434812381488574e-05, -4.422718227004636e-05, 0.00011700814433866793]]} + #*EXTRAS*# Step: 28 Bead: 5 +{"friction": [[0.00011697716435204287, -4.462793393636416e-05, -4.434655683136418e-05], [-4.462793393636416e-05, 0.000116558444948328, -4.422622397595371e-05], [-4.434655683136418e-05, -4.422622397595371e-05, 0.0001169867570468995]]} + #*EXTRAS*# Step: 29 Bead: 5 +{"friction": [[0.00011695735981473897, -4.46271636427991e-05, -4.4345085174945564e-05], [-4.46271636427991e-05, 0.0001165380820385937, -4.422531169869854e-05], [-4.4345085174945564e-05, -4.422531169869854e-05, 0.00011696712338847653]]} + #*EXTRAS*# Step: 30 Bead: 5 +{"friction": [[0.00011693917226886894, -4.4626403012481605e-05, -4.434370577429959e-05], [-4.4626403012481605e-05, 0.00011651940799717335, -4.422444639609778e-05], [-4.434370577429959e-05, -4.422444639609778e-05, 0.00011694909295755758]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_06 b/drivers/py/pes/friction/frictionH/120K/inst.raw_06 new file mode 100644 index 000000000..f55e71a07 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_06 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 6 +{"friction": [[0.00012028748904337296, -4.4090190695074945e-05, -4.407165498061319e-05], [-4.4090190695074945e-05, 0.00012019515217934021, -4.396133059277882e-05], [-4.407165498061319e-05, -4.396133059277882e-05, 0.00012024878352738596]]} + #*EXTRAS*# Step: 1 Bead: 6 +{"friction": [[0.0001198548064858176, -4.422257112080887e-05, -4.417764172601042e-05], [-4.422257112080887e-05, 0.00011971015746790889, -4.404398961956702e-05], [-4.417764172601042e-05, -4.404398961956702e-05, 0.00011982702469475154]]} + #*EXTRAS*# Step: 2 Bead: 6 +{"friction": [[0.0001194689463364501, -4.43270745688243e-05, -4.425104392503369e-05], [-4.43270745688243e-05, 0.0001192764884432658, -4.410474369105259e-05], [-4.425104392503369e-05, -4.410474369105259e-05, 0.00011944914962116194]]} + #*EXTRAS*# Step: 3 Bead: 6 +{"friction": [[0.00011879942837598193, -4.447569033330348e-05, -4.433666840123911e-05], [-4.447569033330348e-05, 0.00011852639312732992, -4.41828002795822e-05], [-4.433666840123911e-05, -4.41828002795822e-05, 0.00011879043551673835]]} + #*EXTRAS*# Step: 4 Bead: 6 +{"friction": [[0.00011838906579207015, -4.4544481216329614e-05, -4.436561040598471e-05], [-4.4544481216329614e-05, 0.00011807101603000202, -4.421408059771616e-05], [-4.436561040598471e-05, -4.421408059771616e-05, 0.00011838524751619824]]} + #*EXTRAS*# Step: 5 Bead: 6 +{"friction": [[0.00011812328152236298, -4.457920488123231e-05, -4.4375590980226725e-05], [-4.457920488123231e-05, 0.00011777890834419397, -4.4227724165082204e-05], [-4.4375590980226725e-05, -4.4227724165082204e-05, 0.00011812238435852369]]} + #*EXTRAS*# Step: 6 Bead: 6 +{"friction": [[0.00011792511627966524, -4.45997593420968e-05, -4.437875944497409e-05], [-4.45997593420968e-05, 0.00011756292425060756, -4.4234511707933374e-05], [-4.437875944497409e-05, -4.4234511707933374e-05, 0.00011792622576389648]]} + #*EXTRAS*# Step: 7 Bead: 6 +{"friction": [[0.0001177749338028414, -4.4612165249048866e-05, -4.4378802566602044e-05], [-4.4612165249048866e-05, 0.0001174004140284537, -4.423772084784118e-05], [-4.4378802566602044e-05, -4.423772084784118e-05, 0.00011777748566482419]]} + #*EXTRAS*# Step: 8 Bead: 6 +{"friction": [[0.0001176543282831259, -4.46200780362073e-05, -4.437739655338743e-05], [-4.46200780362073e-05, 0.00011727071580110775, -4.423908288866641e-05], [-4.437739655338743e-05, -4.423908288866641e-05, 0.00011765799854730069]]} + #*EXTRAS*# Step: 9 Bead: 6 +{"friction": [[0.00011755494720907587, -4.4625186704846266e-05, -4.437528884218614e-05], [-4.4625186704846266e-05, 0.00011716442208890498, -4.423938674290609e-05], [-4.437528884218614e-05, -4.423938674290609e-05, 0.00011755951709906983]]} + #*EXTRAS*# Step: 10 Bead: 6 +{"friction": [[0.00011747108737750134, -4.462848145340952e-05, -4.4372851407657126e-05], [-4.462848145340952e-05, 0.00011707516023593863, -4.4239064319350594e-05], [-4.4372851407657126e-05, -4.4239064319350594e-05, 0.00011747640371098227]]} + #*EXTRAS*# Step: 11 Bead: 6 +{"friction": [[0.00011739912166735163, -4.463055214413687e-05, -4.437028357263012e-05], [-4.463055214413687e-05, 0.00011699888790535713, -4.423836274440028e-05], [-4.437028357263012e-05, -4.423836274440028e-05, 0.00011740507101514014]]} + #*EXTRAS*# Step: 12 Bead: 6 +{"friction": [[0.00011733650530765713, -4.463177496743265e-05, -4.4367694445107935e-05], [-4.463177496743265e-05, 0.00011693278144625965, -4.423743126460891e-05], [-4.4367694445107935e-05, -4.423743126460891e-05, 0.00011734300084776743]]} + #*EXTRAS*# Step: 13 Bead: 6 +{"friction": [[0.00011728143723398357, -4.463239820916022e-05, -4.436514635208854e-05], [-4.463239820916022e-05, 0.00011687484821853032, -4.423636389661547e-05], [-4.436514635208854e-05, -4.423636389661547e-05, 0.0001172884103336274]]} + #*EXTRAS*# Step: 14 Bead: 6 +{"friction": [[0.00011723258891014006, -4.463259192183014e-05, -4.4362674940704685e-05], [-4.463259192183014e-05, 0.00011682362289701377, -4.423522175116332e-05], [-4.4362674940704685e-05, -4.423522175116332e-05, 0.00011723998395364425]]} + #*EXTRAS*# Step: 15 Bead: 6 +{"friction": [[0.0001171889585994066, -4.4632475895211614e-05, -4.436030053926903e-05], [-4.4632475895211614e-05, 0.00011677800357496698, -4.423404564307429e-05], [-4.436030053926903e-05, -4.423404564307429e-05, 0.00011719672954166438]]} + #*EXTRAS*# Step: 16 Bead: 6 +{"friction": [[0.00011714977143171659, -4.463213656706563e-05, -4.435803419334234e-05], [-4.463213656706563e-05, 0.00011673714017734707, -4.423286332517414e-05], [-4.435803419334234e-05, -4.423286332517414e-05, 0.0001171578794701899]]} + #*EXTRAS*# Step: 17 Bead: 6 +{"friction": [[0.00011711441581450753, -4.463163752987774e-05, -4.435588123170152e-05], [-4.463163752987774e-05, 0.00011670036350199838, -4.423169389987634e-05], [-4.435588123170152e-05, -4.423169389987634e-05, 0.00011712282775561857]]} + #*EXTRAS*# Step: 18 Bead: 6 +{"friction": [[0.0001170823997381476, -4.463102629730139e-05, -4.435384335577709e-05], [-4.463102629730139e-05, 0.0001166671366157721, -4.4230550563920194e-05], [-4.435384335577709e-05, -4.4230550563920194e-05, 0.00011709108682652692]]} + #*EXTRAS*# Step: 19 Bead: 6 +{"friction": [[0.000117053320737941, -4.463033879214942e-05, -4.435191993185581e-05], [-4.463033879214942e-05, 0.00011663702148968597, -4.4229442385850947e-05], [-4.435191993185581e-05, -4.4229442385850947e-05, 0.00011706225779692236]]} + #*EXTRAS*# Step: 20 Bead: 6 +{"friction": [[0.00011702684457383589, -4.462960240342753e-05, -4.435010880166702e-05], [-4.462960240342753e-05, 0.00011660965535874563, -4.4228375484561925e-05], [-4.435010880166702e-05, -4.4228375484561925e-05, 0.00011703600936226446]]} + #*EXTRAS*# Step: 21 Bead: 6 +{"friction": [[0.00011700268988415533, -4.462883812119166e-05, -4.434840680802213e-05], [-4.462883812119166e-05, 0.00011658473372508604, -4.4227353833745014e-05], [-4.434840680802213e-05, -4.4227353833745014e-05, 0.00011701206260611028]]} + #*EXTRAS*# Step: 22 Bead: 6 +{"friction": [[0.00011698061692714172, -4.462806206107202e-05, -4.434681014303348e-05], [-4.462806206107202e-05, 0.00011656199790045469, -4.4226379823907074e-05], [-4.434681014303348e-05, -4.4226379823907074e-05, 0.00011699017985198396]]} + #*EXTRAS*# Step: 23 Bead: 6 +{"friction": [[0.00011696041920220626, -4.462728657595344e-05, -4.4345314584923794e-05], [-4.462728657595344e-05, 0.0001165412257406137, -4.42254546644035e-05], [-4.4345314584923794e-05, -4.42254546644035e-05, 0.00011697015636548172]]} + #*EXTRAS*# Step: 24 Bead: 6 +{"friction": [[0.00011694191712405422, -4.462652108216246e-05, -4.4343915662737736e-05], [-4.462652108216246e-05, 0.00011652222465235028, -4.422457867712795e-05], [-4.4343915662737736e-05, -4.422457867712795e-05, 0.00011695181408856141]]} + #*EXTRAS*# Step: 25 Bead: 6 +{"friction": [[0.00011692495318472664, -4.4625772685412006e-05, -4.434260877322443e-05], [-4.4625772685412006e-05, 0.00011650482624477993, -4.4223751515349625e-05], [-4.434260877322443e-05, -4.4223751515349625e-05, 0.0001169349968468792]]} + #*EXTRAS*# Step: 26 Bead: 6 +{"friction": [[0.00011690938817540727, -4.4625046732035465e-05, -4.434138924825843e-05], [-4.4625046732035465e-05, 0.00011648888208337185, -4.422297233210126e-05], [-4.434138924825843e-05, -4.422297233210126e-05, 0.00011691956660147006]]} + #*EXTRAS*# Step: 27 Bead: 6 +{"friction": [[0.00011689509825383158, -4.462434718331205e-05, -4.4340252417437815e-05], [-4.462434718331205e-05, 0.00011647426044718899, -4.4222239907871954e-05], [-4.4340252417437815e-05, -4.4222239907871954e-05, 0.00011690540054290346]]} + #*EXTRAS*# Step: 28 Bead: 6 +{"friction": [[0.0001168819726834083, -4.462367677411842e-05, -4.433919368824602e-05], [-4.462367677411842e-05, 0.00011646084396151559, -4.422155274519579e-05], [-4.433919368824602e-05, -4.422155274519579e-05, 0.00011689238886047363]]} + #*EXTRAS*# Step: 29 Bead: 6 +{"friction": [[0.00011686991196662621, -4.462303725875829e-05, -4.433820857833586e-05], [-4.462303725875829e-05, 0.00011644852752266723, -4.4220909147309025e-05], [-4.433820857833586e-05, -4.4220909147309025e-05, 0.00011688043289142464]]} + #*EXTRAS*# Step: 30 Bead: 6 +{"friction": [[0.00011685882633253899, -4.462242961819965e-05, -4.433729273748883e-05], [-4.462242961819965e-05, 0.00011643721660690309, -4.4220307281025854e-05], [-4.433729273748883e-05, -4.4220307281025854e-05, 0.00011686944362041007]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_07 b/drivers/py/pes/friction/frictionH/120K/inst.raw_07 new file mode 100644 index 000000000..c5dab43d3 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_07 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 7 +{"friction": [[0.00011665083949596382, -4.4607528816683966e-05, -4.431825914901668e-05], [-4.4607528816683966e-05, 0.0001162267076263409, -4.4207173972077276e-05], [-4.431825914901668e-05, -4.4207173972077276e-05, 0.00011666327977368902]]} + #*EXTRAS*# Step: 1 Bead: 7 +{"friction": [[0.00011707891217668889, -4.46309505115423e-05, -4.4353616310137535e-05], [-4.46309505115423e-05, 0.0001166635215736113, -4.4230421163181805e-05], [-4.4353616310137535e-05, -4.4230421163181805e-05, 0.00011708762923983617]]} + #*EXTRAS*# Step: 2 Bead: 7 +{"friction": [[0.00011753332963488428, -4.4626125855306844e-05, -4.437471793425248e-05], [-4.4626125855306844e-05, 0.0001171413734018756, -4.4239354444974335e-05], [-4.437471793425248e-05, -4.4239354444974335e-05, 0.00011753809295876609]]} + #*EXTRAS*# Step: 3 Bead: 7 +{"friction": [[0.00011731288927327987, -4.4632094443179e-05, -4.4366632667408705e-05], [-4.4632094443179e-05, 0.0001169079129339023, -4.42370020363133e-05], [-4.4366632667408705e-05, -4.42370020363133e-05, 0.00011731958989693389]]} + #*EXTRAS*# Step: 4 Bead: 7 +{"friction": [[0.00011719138693096597, -4.4632489575470356e-05, -4.436043681996216e-05], [-4.4632489575470356e-05, 0.00011678053923410327, -4.423411498026411e-05], [-4.436043681996216e-05, -4.423411498026411e-05, 0.00011719913697047943]]} + #*EXTRAS*# Step: 5 Bead: 7 +{"friction": [[0.00011712603374402624, -4.463182180872578e-05, -4.435660000061163e-05], [-4.463182180872578e-05, 0.00011671243874371549, -4.423208894619376e-05], [-4.435660000061163e-05, -4.423208894619376e-05, 0.00011713434583590743]]} + #*EXTRAS*# Step: 6 Bead: 7 +{"friction": [[0.00011707441290608794, -4.463085006072258e-05, -4.435332193488867e-05], [-4.463085006072258e-05, 0.00011665885913092833, -4.423025281336454e-05], [-4.435332193488867e-05, -4.423025281336454e-05, 0.00011708316864103276]]} + #*EXTRAS*# Step: 7 Bead: 7 +{"friction": [[0.00011703632371085136, -4.46298781938961e-05, -4.435076378149751e-05], [-4.46298781938961e-05, 0.00011661944723159962, -4.422876381695637e-05], [-4.435076378149751e-05, -4.422876381695637e-05, 0.00011704540694712734]]} + #*EXTRAS*# Step: 8 Bead: 7 +{"friction": [[0.00011700483048355072, -4.462890943033354e-05, -4.434855955059436e-05], [-4.462890943033354e-05, 0.00011658694054429899, -4.4227446237300544e-05], [-4.434855955059436e-05, -4.4227446237300544e-05, 0.00011701418477029538]]} + #*EXTRAS*# Step: 9 Bead: 7 +{"friction": [[0.00011697840261655181, -4.462798009826642e-05, -4.434664779238195e-05], [-4.462798009826642e-05, 0.00011655971910974103, -4.4226279979647125e-05], [-4.434664779238195e-05, -4.4226279979647125e-05, 0.00011698798463376871]]} + #*EXTRAS*# Step: 10 Bead: 7 +{"friction": [[0.00011695564944126729, -4.462709428763521e-05, -4.434495659216609e-05], [-4.462709428763521e-05, 0.00011653632483881043, -4.422523144784585e-05], [-4.434495659216609e-05, -4.422523144784585e-05, 0.00011696542778219125]]} + #*EXTRAS*# Step: 11 Bead: 7 +{"friction": [[0.00011693578607542971, -4.462625574815559e-05, -4.4343446008158735e-05], [-4.462625574815559e-05, 0.00011651593402460488, -4.422428237901223e-05], [-4.4343446008158735e-05, -4.422428237901223e-05, 0.00011694573603787239]]} + #*EXTRAS*# Step: 12 Bead: 7 +{"friction": [[0.00011691822152100408, -4.462546333134982e-05, -4.434208374213752e-05], [-4.462546333134982e-05, 0.00011649792831626166, -4.422341690668108e-05], [-4.434208374213752e-05, -4.422341690668108e-05, 0.00011692832344743819]]} + #*EXTRAS*# Step: 13 Bead: 7 +{"friction": [[0.00011690254503178857, -4.4624715680254065e-05, -4.434084690038066e-05], [-4.4624715680254065e-05, 0.0001164818781355021, -4.422262362996951e-05], [-4.434084690038066e-05, -4.422262362996951e-05, 0.00011691278275663289]]} + #*EXTRAS*# Step: 14 Bead: 7 +{"friction": [[0.0001168884484460412, -4.462401086619195e-05, -4.433971777275251e-05], [-4.462401086619195e-05, 0.00011646746160751188, -4.4221893496913e-05], [-4.433971777275251e-05, -4.4221893496913e-05, 0.00011689880842012539]]} + #*EXTRAS*# Step: 15 Bead: 7 +{"friction": [[0.00011687569902777843, -4.462334692248588e-05, -4.433868272845587e-05], [-4.462334692248588e-05, 0.00011645443590274963, -4.422121942010463e-05], [-4.433868272845587e-05, -4.422121942010463e-05, 0.0001168861696798821]]} + #*EXTRAS*# Step: 16 Bead: 7 +{"friction": [[0.00011686411515599825, -4.4622721884362746e-05, -4.4337730914267064e-05], [-4.4622721884362746e-05, 0.00011644261174423125, -4.4220595655743385e-05], [-4.4337730914267064e-05, -4.4220595655743385e-05, 0.00011687468646016041]]} + #*EXTRAS*# Step: 17 Bead: 7 +{"friction": [[0.00011685355241787298, -4.462213387474316e-05, -4.433685354194385e-05], [-4.462213387474316e-05, 0.00011643183879295039, -4.422001748050363e-05], [-4.433685354194385e-05, -4.422001748050363e-05, 0.00011686421557808133]]} + #*EXTRAS*# Step: 18 Bead: 7 +{"friction": [[0.00011684389350604696, -4.462158110454959e-05, -4.433604333899582e-05], [-4.462158110454959e-05, 0.00011642199506244531, -4.421948092561562e-05], [-4.433604333899582e-05, -4.421948092561562e-05, 0.00011685464072645085]]} + #*EXTRAS*# Step: 19 Bead: 7 +{"friction": [[0.00011683504144196802, -4.4621061871740944e-05, -4.433529417986437e-05], [-4.4621061871740944e-05, 0.00011641297981910889, -4.421898259812338e-05], [-4.433529417986437e-05, -4.421898259812338e-05, 0.00011684586575446165]]} + #*EXTRAS*# Step: 20 Bead: 7 +{"friction": [[0.00011682691471676164, -4.4620574550224356e-05, -4.433460081623793e-05], [-4.4620574550224356e-05, 0.00011640470849677822, -4.421851954756836e-05], [-4.433460081623793e-05, -4.421851954756836e-05, 0.00011683780984974542]]} + #*EXTRAS*# Step: 21 Bead: 7 +{"friction": [[0.00011681944381806568, -4.462011757992904e-05, -4.433395868335107e-05], [-4.462011757992904e-05, 0.0001163971090629232, -4.421808916978723e-05], [-4.433395868335107e-05, -4.421808916978723e-05, 0.00011683040409464775]]} + #*EXTRAS*# Step: 22 Bead: 7 +{"friction": [[0.00011681256868396455, -4.461968945787736e-05, -4.43333637572059e-05], [-4.461968945787736e-05, 0.0001163901193557121, -4.421768913562653e-05], [-4.43333637572059e-05, -4.421768913562653e-05, 0.00011682358894175012]]} + #*EXTRAS*# Step: 23 Bead: 7 +{"friction": [[0.0001168062368173602, -4.461928873153732e-05, -4.433281244886693e-05], [-4.461928873153732e-05, 0.00011638368511190247, -4.4217317338196004e-05], [-4.433281244886693e-05, -4.4217317338196004e-05, 0.0001168173123442282]]} + #*EXTRAS*# Step: 24 Bead: 7 +{"friction": [[0.00011680040186858627, -4.461891399420118e-05, -4.433230152524436e-05], [-4.461891399420118e-05, 0.00011637775848430873, -4.421697185346533e-05], [-4.433230152524436e-05, -4.421697185346533e-05, 0.00011681152835048164]]} + #*EXTRAS*# Step: 25 Bead: 7 +{"friction": [[0.00011679502255772284, -4.461856388217167e-05, -4.433182804926244e-05], [-4.461856388217167e-05, 0.00011637229691427216, -4.42166509107074e-05], [-4.433182804926244e-05, -4.42166509107074e-05, 0.00011680619603558084]]} + #*EXTRAS*# Step: 26 Bead: 7 +{"friction": [[0.0001167900618453171, -4.4618237073354815e-05, -4.433138933424305e-05], [-4.4618237073354815e-05, 0.00011636726226368093, -4.421635287018044e-05], [-4.433138933424305e-05, -4.421635287018044e-05, 0.0001168012786790117]]} + #*EXTRAS*# Step: 27 Bead: 7 +{"friction": [[0.00011678548628789152, -4.461793228695133e-05, -4.433098290888733e-05], [-4.461793228695133e-05, 0.00011636262014003678, -4.421607620621752e-05], [-4.433098290888733e-05, -4.421607620621752e-05, 0.00011679674312563878]]} + #*EXTRAS*# Step: 28 Bead: 7 +{"friction": [[0.00011678126552844322, -4.461764828369676e-05, -4.43306064898648e-05], [-4.461764828369676e-05, 0.00011635833936267074, -4.421581949413249e-05], [-4.43306064898648e-05, -4.421581949413249e-05, 0.00011679255928051496]]} + #*EXTRAS*# Step: 29 Bead: 7 +{"friction": [[0.00011677737189005628, -4.4617383866497443e-05, -4.43302579601986e-05], [-4.4617383866497443e-05, 0.00011635439153678354, -4.421558140002578e-05], [-4.43302579601986e-05, -4.421558140002578e-05, 0.00011678869970592958]]} + #*EXTRAS*# Step: 30 Bead: 7 +{"friction": [[0.00011677378005168247, -4.4617137881513786e-05, -4.432993535233617e-05], [-4.4617137881513786e-05, 0.00011635075071334173, -4.421536067296672e-05], [-4.432993535233617e-05, -4.421536067296672e-05, 0.00011678513929992788]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_08 b/drivers/py/pes/friction/frictionH/120K/inst.raw_08 new file mode 100644 index 000000000..7d256ee81 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_08 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 8 +{"friction": [[0.00011321589094004546, -4.351814646398022e-05, -4.345964836559014e-05], [-4.351814646398022e-05, 0.00011306154132995574, -4.343115956369095e-05], [-4.345964836559014e-05, -4.343115956369095e-05, 0.00011326318332248197]]} + #*EXTRAS*# Step: 1 Bead: 8 +{"friction": [[0.00011440034439429883, -4.405360655166109e-05, -4.3876723047773454e-05], [-4.405360655166109e-05, 0.00011411195530043661, -4.382567914108882e-05], [-4.3876723047773454e-05, -4.382567914108882e-05, 0.00011443451617624293]]} + #*EXTRAS*# Step: 2 Bead: 8 +{"friction": [[0.00011561365087447448, -4.4437517560348225e-05, -4.416959012099159e-05], [-4.4437517560348225e-05, 0.00011522036883705721, -4.408764020899972e-05], [-4.416959012099159e-05, -4.408764020899972e-05, 0.0001156356292036104]]} + #*EXTRAS*# Step: 3 Bead: 8 +{"friction": [[0.0001158429220620997, -4.448838680624022e-05, -4.4210312868082447e-05], [-4.448838680624022e-05, 0.00011543719029533046, -4.412203162566874e-05], [-4.4210312868082447e-05, -4.412203162566874e-05, 0.00011586272539859846]]} + #*EXTRAS*# Step: 4 Bead: 8 +{"friction": [[0.00011600522173201786, -4.4519939115628516e-05, -4.423641116309736e-05], [-4.4519939115628516e-05, 0.00011559247235171704, -4.4143595305645986e-05], [-4.423641116309736e-05, -4.4143595305645986e-05, 0.00011602350880121933]]} + #*EXTRAS*# Step: 5 Bead: 8 +{"friction": [[0.00011613565918578713, -4.4542567861116895e-05, -4.42557619975353e-05], [-4.4542567861116895e-05, 0.00011571841657673697, -4.4159277670253444e-05], [-4.42557619975353e-05, -4.4159277670253444e-05, 0.0001161527414463372]]} + #*EXTRAS*# Step: 6 Bead: 8 +{"friction": [[0.00011622752125911485, -4.455702551339066e-05, -4.426852781173778e-05], [-4.455702551339066e-05, 0.00011580775344866896, -4.416944996074423e-05], [-4.426852781173778e-05, -4.416944996074423e-05, 0.00011624376228949846]]} + #*EXTRAS*# Step: 7 Bead: 8 +{"friction": [[0.00011629939032091089, -4.4567476162497495e-05, -4.427802116232141e-05], [-4.4567476162497495e-05, 0.00011587802639901048, -4.4176909766542346e-05], [-4.427802116232141e-05, -4.4176909766542346e-05, 0.00011631497735151933]]} + #*EXTRAS*# Step: 8 Bead: 8 +{"friction": [[0.00011635553958831559, -4.457511170038498e-05, -4.428513748744425e-05], [-4.457511170038498e-05, 0.00011593316550007308, -4.418243517112752e-05], [-4.428513748744425e-05, -4.418243517112752e-05, 0.00011637061817791127]]} + #*EXTRAS*# Step: 9 Bead: 8 +{"friction": [[0.00011640104584294787, -4.4580957499726665e-05, -4.4290712135749456e-05], [-4.4580957499726665e-05, 0.00011597800798573457, -4.418671934421949e-05], [-4.4290712135749456e-05, -4.418671934421949e-05, 0.00011641571397100911]]} + #*EXTRAS*# Step: 10 Bead: 8 +{"friction": [[0.00011643869137132552, -4.458556080421623e-05, -4.429519371480964e-05], [-4.458556080421623e-05, 0.00011601521058417094, -4.419013276534553e-05], [-4.429519371480964e-05, -4.419013276534553e-05, 0.00011645302102132379]]} + #*EXTRAS*# Step: 11 Bead: 8 +{"friction": [[0.00011647044226095271, -4.4589278957904075e-05, -4.4298882176155864e-05], [-4.4589278957904075e-05, 0.00011604666341394956, -4.419291999075e-05], [-4.4298882176155864e-05, -4.419291999075e-05, 0.0001164844871900325]]} + #*EXTRAS*# Step: 12 Bead: 8 +{"friction": [[0.00011649760057183907, -4.459233962852725e-05, -4.430197089623492e-05], [-4.459233962852725e-05, 0.00011607362207808758, -4.4195237645098335e-05], [-4.430197089623492e-05, -4.4195237645098335e-05, 0.00011651140251110558]]} + #*EXTRAS*# Step: 13 Bead: 8 +{"friction": [[0.00011652110399713297, -4.459489912123446e-05, -4.4304594733541665e-05], [-4.459489912123446e-05, 0.00011609699417891634, -4.41971940781963e-05], [-4.4304594733541665e-05, -4.41971940781963e-05, 0.00011653469605396405]]} + #*EXTRAS*# Step: 14 Bead: 8 +{"friction": [[0.00011654163499285293, -4.459706699323447e-05, -4.430684942628757e-05], [-4.459706699323447e-05, 0.00011611744212656427, -4.4198865713418594e-05], [-4.430684942628757e-05, -4.4198865713418594e-05, 0.0001165550440184781]]} + #*EXTRAS*# Step: 15 Bead: 8 +{"friction": [[0.00011655970808107098, -4.459892282047363e-05, -4.43088054331317e-05], [-4.459892282047363e-05, 0.0001161354666775947, -4.4200308434240344e-05], [-4.43088054331317e-05, -4.4200308434240344e-05, 0.00011657295622442934]]} + #*EXTRAS*# Step: 16 Bead: 8 +{"friction": [[0.00011657571868130707, -4.4600525725037505e-05, -4.4310515750297864e-05], [-4.4600525725037505e-05, 0.00011615145358469009, -4.420156402765112e-05], [-4.4310515750297864e-05, -4.420156402765112e-05, 0.00011658882448716252]]} + #*EXTRAS*# Step: 17 Bead: 8 +{"friction": [[0.00011658997727537349, -4.460192064756414e-05, -4.4312021154897514e-05], [-4.460192064756414e-05, 0.00011616570640859802, -4.420266446432044e-05], [-4.4312021154897514e-05, -4.420266446432044e-05, 0.0001166029564654644]]} + #*EXTRAS*# Step: 18 Bead: 8 +{"friction": [[0.00011660273182153701, -4.4603142389315595e-05, -4.431335360119967e-05], [-4.4603142389315595e-05, 0.0001161784680751581, -4.420363466229619e-05], [-4.431335360119967e-05, -4.420363466229619e-05, 0.00011661559786814936]]} + #*EXTRAS*# Step: 19 Bead: 8 +{"friction": [[0.00011661418350222212, -4.4604218358757286e-05, -4.4314538553061436e-05], [-4.4604218358757286e-05, 0.00011618993606180516, -4.420449437449366e-05], [-4.4314538553061436e-05, -4.420449437449366e-05, 0.0001166269480563745]]} + #*EXTRAS*# Step: 20 Bead: 8 +{"friction": [[0.0001166244978089904, -4.4605170462104105e-05, -4.43155966008996e-05], [-4.4605170462104105e-05, 0.00011620027310611618, -4.420525949219757e-05], [-4.43155966008996e-05, -4.420525949219757e-05, 0.00011663717102648823]]} + #*EXTRAS*# Step: 21 Bead: 8 +{"friction": [[0.00011663381257164465, -4.460601644019453e-05, -4.4316544614206814e-05], [-4.460601644019453e-05, 0.00011620961497655201, -4.420594297034978e-05], [-4.4316544614206814e-05, -4.420594297034978e-05, 0.0001166464033653154]]} + #*EXTRAS*# Step: 22 Bead: 8 +{"friction": [[0.00011664224385316955, -4.460677083015247e-05, -4.4317396576287755e-05], [-4.460677083015247e-05, 0.00011621807618644159, -4.420655549534652e-05], [-4.4317396576287755e-05, -4.420655549534652e-05, 0.00011665476009099646]]} + #*EXTRAS*# Step: 23 Bead: 8 +{"friction": [[0.00011664989035485446, -4.4607445670059886e-05, -4.4318164200031045e-05], [-4.4607445670059886e-05, 0.00011622575427004272, -4.420710597599047e-05], [-4.4318164200031045e-05, -4.420710597599047e-05, 0.00011666233901774869]]} + #*EXTRAS*# Step: 24 Bead: 8 +{"friction": [[0.00011665683675385242, -4.460805102333174e-05, -4.4318857388996035e-05], [-4.460805102333174e-05, 0.00011623273302653051, -4.4207601909959875e-05], [-4.4318857388996035e-05, -4.4207601909959875e-05, 0.00011666922406289098]]} + #*EXTRAS*# Step: 25 Bead: 8 +{"friction": [[0.00011666315626687374, -4.460859537466756e-05, -4.431948458768202e-05], [-4.460859537466756e-05, 0.00011623908501485188, -4.420804966136658e-05], [-4.431948458768202e-05, -4.420804966136658e-05, 0.00011667548778711555]]} + #*EXTRAS*# Step: 26 Bead: 8 +{"friction": [[0.00011666891264392731, -4.4609085932984916e-05, -4.43200530510818e-05], [-4.4609085932984916e-05, 0.00011624487349615581, -4.4208454673741115e-05], [-4.43200530510818e-05, -4.4208454673741115e-05, 0.00011668119337003838]]} + #*EXTRAS*# Step: 27 Bead: 8 +{"friction": [[0.00011667416173841158, -4.460952886613504e-05, -4.432056905477376e-05], [-4.460952886613504e-05, 0.00011625015396519832, -4.420882163556085e-05], [-4.432056905477376e-05, -4.420882163556085e-05, 0.000116686396165983]]} + #*EXTRAS*# Step: 28 Bead: 8 +{"friction": [[0.00011667895275401717, -4.4609929484540624e-05, -4.4321038060200666e-05], [-4.4609929484540624e-05, 0.00011625497536776117, -4.420915461012703e-05], [-4.4321038060200666e-05, -4.420915461012703e-05, 0.0001166911449395338]]} + #*EXTRAS*# Step: 29 Bead: 8 +{"friction": [[0.00011668332924602711, -4.461029238643615e-05, -4.432146484613645e-05], [-4.461029238643615e-05, 0.0001162593810792788, -4.420945713859487e-05], [-4.432146484613645e-05, -4.420945713859487e-05, 0.00011669548285773304]]} + #*EXTRAS*# Step: 30 Bead: 8 +{"friction": [[0.00011668732993809322, -4.461062157424355e-05, -4.432185361475086e-05], [-4.461062157424355e-05, 0.00011626340970407677, -4.42097323228364e-05], [-4.432185361475086e-05, -4.42097323228364e-05, 0.00011669944829944141]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_09 b/drivers/py/pes/friction/frictionH/120K/inst.raw_09 new file mode 100644 index 000000000..dc18d7be5 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_09 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 9 +{"friction": [[0.00011023000206976872, -4.1719099977050135e-05, -4.179519325177442e-05], [-4.1719099977050135e-05, 0.00011025478793267088, -4.1768623177242506e-05], [-4.179519325177442e-05, -4.1768623177242506e-05, 0.00011030747133180427]]} + #*EXTRAS*# Step: 1 Bead: 9 +{"friction": [[0.0001120073975097586, -4.2852245848480316e-05, -4.289328022843257e-05], [-4.2852245848480316e-05, 0.00011196977894012911, -4.2874611323661373e-05], [-4.289328022843257e-05, -4.2874611323661373e-05, 0.0001120694699104753]]} + #*EXTRAS*# Step: 2 Bead: 9 +{"friction": [[0.00011383403760730907, -4.3815018267426756e-05, -4.369393643517858e-05], [-4.3815018267426756e-05, 0.00011360872331669778, -4.3654920490220314e-05], [-4.369393643517858e-05, -4.3654920490220314e-05, 0.0001138743232405381]]} + #*EXTRAS*# Step: 3 Bead: 9 +{"friction": [[0.00011446456981832135, -4.407844389125281e-05, -4.3895566097042505e-05], [-4.407844389125281e-05, 0.00011416939046917575, -4.3843039969113373e-05], [-4.3895566097042505e-05, -4.3843039969113373e-05, 0.00011449806588679258]]} + #*EXTRAS*# Step: 4 Bead: 9 +{"friction": [[0.00011488519249740362, -4.422912706448435e-05, -4.4009628341838655e-05], [-4.422912706448435e-05, 0.00011454834212274395, -4.394690312347593e-05], [-4.4009628341838655e-05, -4.394690312347593e-05, 0.00011491434898528704]]} + #*EXTRAS*# Step: 5 Bead: 9 +{"friction": [[0.00011519528225452894, -4.432628466105797e-05, -4.4083471767382156e-05], [-4.432628466105797e-05, 0.00011483158915350017, -4.401276357632711e-05], [-4.4083471767382156e-05, -4.401276357632711e-05, 0.00011522133221385813]]} + #*EXTRAS*# Step: 6 Bead: 9 +{"friction": [[0.00011541993154577386, -4.4388917357314456e-05, -4.413162537140607e-05], [-4.4388917357314456e-05, 0.00011503931432179354, -4.405493826495506e-05], [-4.413162537140607e-05, -4.405493826495506e-05, 0.00011544377842369428]]} + #*EXTRAS*# Step: 7 Bead: 9 +{"friction": [[0.00011559424220464159, -4.443287799769209e-05, -4.41659339538479e-05], [-4.443287799769209e-05, 0.00011520214349742901, -4.4084515237877984e-05], [-4.41659339538479e-05, -4.4084515237877984e-05, 0.00011561640645895223]]} + #*EXTRAS*# Step: 8 Bead: 9 +{"friction": [[0.0001157325142430018, -4.446480133204771e-05, -4.41912688126215e-05], [-4.446480133204771e-05, 0.00011533241944828726, -4.4106048754205006e-05], [-4.41912688126215e-05, -4.4106048754205006e-05, 0.00011575336008890156]]} + #*EXTRAS*# Step: 9 Bead: 9 +{"friction": [[0.00011584575516743248, -4.4488969546810477e-05, -4.421078775817225e-05], [-4.4488969546810477e-05, 0.00011543988777458822, -4.4122427693728e-05], [-4.421078775817225e-05, -4.4122427693728e-05, 0.00011586553187104084]]} + #*EXTRAS*# Step: 10 Bead: 9 +{"friction": [[0.0001159405096017899, -4.450780688553114e-05, -4.422627480243371e-05], [-4.450780688553114e-05, 0.00011553037276569203, -4.413527143188702e-05], [-4.422627480243371e-05, -4.413527143188702e-05, 0.00011595939894010257]]} + #*EXTRAS*# Step: 11 Bead: 9 +{"friction": [[0.00011602123734048728, -4.4522849357801144e-05, -4.423886480844434e-05], [-4.4522849357801144e-05, 0.00011560788014043383, -4.414559955548052e-05], [-4.423886480844434e-05, -4.414559955548052e-05, 0.00011603937582126426]]} + #*EXTRAS*# Step: 12 Bead: 9 +{"friction": [[0.00011609096484203325, -4.453509040273595e-05, -4.4249293666561855e-05], [-4.453509040273595e-05, 0.00011567514358786254, -4.415406840074309e-05], [-4.4249293666561855e-05, -4.415406840074309e-05, 0.00011610845855855039]]} + #*EXTRAS*# Step: 13 Bead: 9 +{"friction": [[0.00011615186312587815, -4.454520732434268e-05, -4.4258065434256845e-05], [-4.454520732434268e-05, 0.00011573413612688788, -4.416112415652501e-05], [-4.4258065434256845e-05, -4.416112415652501e-05, 0.00011616879656419277]]} + #*EXTRAS*# Step: 14 Bead: 9 +{"friction": [[0.00011620552397863365, -4.45536755210519e-05, -4.426553555633415e-05], [-4.45536755210519e-05, 0.00011578631174915651, -4.4167079387366444e-05], [-4.426553555633415e-05, -4.4167079387366444e-05, 0.00011622196590681415]]} + #*EXTRAS*# Step: 15 Bead: 9 +{"friction": [[0.00011625315011976243, -4.4560839244442916e-05, -4.427196283651981e-05], [-4.4560839244442916e-05, 0.00011583277446479393, -4.417216021445205e-05], [-4.427196283651981e-05, -4.417216021445205e-05, 0.00011626915751512446]]} + #*EXTRAS*# Step: 16 Bead: 9 +{"friction": [[0.00011629567001525927, -4.4566953816928685e-05, -4.4277540351813475e-05], [-4.4566953816928685e-05, 0.00011587438041054757, -4.417653430451256e-05], [-4.4277540351813475e-05, -4.417653430451256e-05, 0.00011631129081145187]]} + #*EXTRAS*# Step: 17 Bead: 9 +{"friction": [[0.00011633381556057052, -4.457221277349927e-05, -4.42824154040179e-05], [-4.457221277349927e-05, 0.00011591180741430548, -4.418032880877613e-05], [-4.42824154040179e-05, -4.418032880877613e-05, 0.00011634909060471281]]} + #*EXTRAS*# Step: 18 Bead: 9 +{"friction": [[0.00011636817402154336, -4.4576765545811356e-05, -4.428670252779166e-05], [-4.4576765545811356e-05, 0.00011594560164594516, -4.418364201146586e-05], [-4.428670252779166e-05, -4.418364201146586e-05, 0.00011638313850616208]]} + #*EXTRAS*# Step: 19 Bead: 9 +{"friction": [[0.00011639922428803086, -4.458072940840643e-05, -4.42904922999065e-05], [-4.458072940840643e-05, 0.00011597621031109923, -4.418655118070438e-05], [-4.42904922999065e-05, -4.418655118070438e-05, 0.00011641390881881277]]} + #*EXTRAS*# Step: 20 Bead: 9 +{"friction": [[0.00011642736250627663, -4.458419771783323e-05, -4.42938574245781e-05], [-4.458419771783323e-05, 0.0001160040048337319, -4.418911797098415e-05], [-4.42938574245781e-05, -4.418911797098415e-05, 0.00011644179391360331]]} + #*EXTRAS*# Step: 21 Bead: 9 +{"friction": [[0.00011645292062233236, -4.458724573066234e-05, -4.429685703873108e-05], [-4.458724573066234e-05, 0.00011602929767471124, -4.4191392231022114e-05], [-4.429685703873108e-05, -4.4191392231022114e-05, 0.00011646712258831828]]} + #*EXTRAS*# Step: 22 Bead: 9 +{"friction": [[0.00011647618000517811, -4.4589934790329666e-05, -4.429953981497139e-05], [-4.4589934790329666e-05, 0.00011605235471649696, -4.4193414739152955e-05], [-4.429953981497139e-05, -4.4193414739152955e-05, 0.00011649017355569753]]} + #*EXTRAS*# Step: 23 Bead: 9 +{"friction": [[0.00011649738161897188, -4.4592315395081555e-05, -4.4301946238573e-05], [-4.4592315395081555e-05, 0.00011607340452986138, -4.4195219204415585e-05], [-4.4301946238573e-05, -4.4195219204415585e-05, 0.00011651118551522964]]} + #*EXTRAS*# Step: 24 Bead: 9 +{"friction": [[0.000116516733724583, -4.4594429482251846e-05, -4.4304110304889e-05], [-4.4594429482251846e-05, 0.0001160926454023666, -4.4196833754107314e-05], [-4.4304110304889e-05, -4.4196833754107314e-05, 0.00011653036477886384]]} + #*EXTRAS*# Step: 25 Bead: 9 +{"friction": [[0.00011653441778836367, -4.459631215429695e-05, -4.430606080332941e-05], [-4.459631215429695e-05, 0.00011611025073933215, -4.4198282056079054e-05], [-4.430606080332941e-05, -4.4198282056079054e-05, 0.00011654789112177313]]} + #*EXTRAS*# Step: 26 Bead: 9 +{"friction": [[0.00011655059307127204, -4.459799300059555e-05, -4.430782230160922e-05], [-4.459799300059555e-05, 0.00011612637326461201, -4.4199584176928776e-05], [-4.430782230160922e-05, -4.4199584176928776e-05, 0.00011656392232653962]]} + #*EXTRAS*# Step: 27 Bead: 9 +{"friction": [[0.00011656540023642417, -4.459949712235913e-05, -4.430941590974105e-05], [-4.459949712235913e-05, 0.00011614114832750222, -4.4200757246549344e-05], [-4.430941590974105e-05, -4.4200757246549344e-05, 0.00011657859775546678]]} + #*EXTRAS*# Step: 28 Bead: 9 +{"friction": [[0.00011657896421307934, -4.460084593595999e-05, -4.431085987945202e-05], [-4.460084593595999e-05, 0.00011615469653142538, -4.420181597833952e-05], [-4.431085987945202e-05, -4.420181597833952e-05, 0.00011659204118665177]]} + #*EXTRAS*# Step: 29 Bead: 9 +{"friction": [[0.00011659139649489952, -4.460205780915855e-05, -4.431217007949892e-05], [-4.460205780915855e-05, 0.00011616712584621018, -4.420277308076444e-05], [-4.431217007949892e-05, -4.420277308076444e-05, 0.00011660436308989604]]} + #*EXTRAS*# Step: 30 Bead: 9 +{"friction": [[0.0001166027970087331, -4.4603148570308243e-05, -4.4313360376864236e-05], [-4.4603148570308243e-05, 0.0001161785333286023, -4.4203639586559004e-05], [-4.4313360376864236e-05, -4.4203639586559004e-05, 0.00011661566247736258]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_10 b/drivers/py/pes/friction/frictionH/120K/inst.raw_10 new file mode 100644 index 000000000..58abe1164 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_10 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 10 +{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} + #*EXTRAS*# Step: 1 Bead: 10 +{"friction": [[0.00010994070331190677, -4.1515923212077605e-05, -4.158738609491027e-05], [-4.1515923212077605e-05, 0.00010996587746853609, -4.1559657141601646e-05], [-4.158738609491027e-05, -4.1559657141601646e-05, 0.00011001762387994532]]} + #*EXTRAS*# Step: 2 Bead: 10 +{"friction": [[0.0001122416337676336, -4.2988313952896364e-05, -4.30144746611767e-05], [-4.2988313952896364e-05, 0.00011218576231652864, -4.299522399437862e-05], [-4.30144746611767e-05, -4.299522399437862e-05, 0.0001123007274820805]]} + #*EXTRAS*# Step: 3 Bead: 10 +{"friction": [[0.00011321787911832415, -4.351915599685663e-05, -4.346046109431979e-05], [-4.351915599685663e-05, 0.00011306330514334234, -4.343194355760015e-05], [-4.346046109431979e-05, -4.343194355760015e-05, 0.00011326514838475347]]} + #*EXTRAS*# Step: 4 Bead: 10 +{"friction": [[0.00011386662136821714, -4.3829659077936924e-05, -4.370527136779423e-05], [-4.3829659077936924e-05, 0.00011363757120179098, -4.366561927527114e-05], [-4.370527136779423e-05, -4.366561927527114e-05, 0.00011390654748464366]]} + #*EXTRAS*# Step: 5 Bead: 10 +{"friction": [[0.0001143360240024973, -4.402826312081935e-05, -4.385746991642737e-05], [-4.402826312081935e-05, 0.0001140545285929471, -4.380788834149783e-05], [-4.385746991642737e-05, -4.380788834149783e-05, 0.00011437087604157181]]} + #*EXTRAS*# Step: 6 Bead: 10 +{"friction": [[0.00011467915984424482, -4.415795911661266e-05, -4.395577392716699e-05], [-4.415795911661266e-05, 0.0001143620604311086, -4.389814537663849e-05], [-4.395577392716699e-05, -4.389814537663849e-05, 0.00011471042356415885]]} + #*EXTRAS*# Step: 7 Bead: 10 +{"friction": [[0.00011494538832515696, -4.424893635428884e-05, -4.4024637736642186e-05], [-4.424893635428884e-05, 0.00011460303963966819, -4.396039039939615e-05], [-4.4024637736642186e-05, -4.396039039939615e-05, 0.00011497393571329889]]} + #*EXTRAS*# Step: 8 Bead: 10 +{"friction": [[0.00011515772977844747, -4.431517105089904e-05, -4.4074986498576565e-05], [-4.431517105089904e-05, 0.00011479708303707918, -4.400526286861805e-05], [-4.4074986498576565e-05, -4.400526286861805e-05, 0.00011518415186040586]]} + #*EXTRAS*# Step: 9 Bead: 10 +{"friction": [[0.00011533234131953108, -4.436528838858742e-05, -4.4113380218554005e-05], [-4.436528838858742e-05, 0.00011495804973649112, -4.4039041533526255e-05], [-4.4113380218554005e-05, -4.4039041533526255e-05, 0.0001153570425035311]]} + #*EXTRAS*# Step: 10 Bead: 10 +{"friction": [[0.00011547904088130318, -4.440428425480747e-05, -4.414355714646095e-05], [-4.440428425480747e-05, 0.00011509436141309667, -4.406527379082173e-05], [-4.414355714646095e-05, -4.406527379082173e-05, 0.00011550231457867276]]} + #*EXTRAS*# Step: 11 Bead: 10 +{"friction": [[0.00011560446714637382, -4.443532865130998e-05, -4.4167864188932856e-05], [-4.443532865130998e-05, 0.0001152117425952739, -4.4086165728219205e-05], [-4.4167864188932856e-05, -4.4086165728219205e-05, 0.00011562653341554738]]} + #*EXTRAS*# Step: 12 Bead: 10 +{"friction": [[0.00011571315962829314, -4.4460491737441325e-05, -4.4187822173071014e-05], [-4.4460491737441325e-05, 0.00011531412245632432, -4.410313649357994e-05], [-4.4187822173071014e-05, -4.410313649357994e-05, 0.00011573418915775181]]} + #*EXTRAS*# Step: 13 Bead: 10 +{"friction": [[0.00011580837551996515, -4.4481190232852206e-05, -4.420446669831853e-05], [-4.4481190232852206e-05, 0.00011540433421013385, -4.4117145549554835e-05], [-4.420446669831853e-05, -4.4117145549554835e-05, 0.00011582850408947181]]} + #*EXTRAS*# Step: 14 Bead: 10 +{"friction": [[0.00011589251010532, -4.44984231956536e-05, -4.421852555969295e-05], [-4.44984231956536e-05, 0.00011548447093774284, -4.4128862874726845e-05], [-4.421852555969295e-05, -4.4128862874726845e-05, 0.00011591184813424328]]} + #*EXTRAS*# Step: 15 Bead: 10 +{"friction": [[0.0001159673760482947, -4.4512916307967616e-05, -4.423052640100533e-05], [-4.4512916307967616e-05, 0.0001155561242680459, -4.413877121057319e-05], [-4.423052640100533e-05, -4.413877121057319e-05, 0.0001159860149752213]]} + #*EXTRAS*# Step: 16 Bead: 10 +{"friction": [[0.00011603437558828352, -4.4525209293654095e-05, -4.424086136597787e-05], [-4.4525209293654095e-05, 0.0001156205313718501, -4.414722722543254e-05], [-4.424086136597787e-05, -4.414722722543254e-05, 0.00011605239231392712]]} + #*EXTRAS*# Step: 17 Bead: 10 +{"friction": [[0.00011609461618347797, -4.453571211631032e-05, -4.4249828435484305e-05], [-4.453571211631032e-05, 0.00011567867414237503, -4.4154500385270814e-05], [-4.4249828435484305e-05, -4.4154500385270814e-05, 0.00011611207623231274]]} + #*EXTRAS*# Step: 18 Bead: 10 +{"friction": [[0.00011614898827703445, -4.45447418210519e-05, -4.425765838209436e-05], [-4.45447418210519e-05, 0.00011573134600888, -4.41607981927127e-05], [-4.425765838209436e-05, -4.41607981927127e-05, 0.00011616594810528464]]} + #*EXTRAS*# Step: 19 Bead: 10 +{"friction": [[0.00011619821952687713, -4.455254748270171e-05, -4.426453295093187e-05], [-4.455254748270171e-05, 0.00011577919866604918, -4.4166283134799443e-05], [-4.426453295093187e-05, -4.4166283134799443e-05, 0.0001162147282409548]]} + #*EXTRAS*# Step: 20 Bead: 10 +{"friction": [[0.00011624291321593945, -4.4559327474411505e-05, -4.427059739720875e-05], [-4.4559327474411505e-05, 0.00011582277523915037, -4.41710843260536e-05], [-4.427059739720875e-05, -4.41710843260536e-05, 0.00011625901387648784]]} + #*EXTRAS*# Step: 21 Bead: 10 +{"friction": [[0.0001162835760462778, -4.456524169540128e-05, -4.427596933536378e-05], [-4.456524169540128e-05, 0.00011586253433113894, -4.417530569690603e-05], [-4.427596933536378e-05, -4.417530569690603e-05, 0.00011629930667443367]]} + #*EXTRAS*# Step: 22 Bead: 10 +{"friction": [[0.00011632063857106015, -4.457042039654621e-05, -4.428074510630205e-05], [-4.457042039654621e-05, 0.00011589886772760401, -4.4179031866684034e-05], [-4.428074510630205e-05, -4.4179031866684034e-05, 0.00011633603293710135]]} + #*EXTRAS*# Step: 23 Bead: 10 +{"friction": [[0.00011635447045375835, -4.457497066556595e-05, -4.428500444231657e-05], [-4.457497066556595e-05, 0.00011593211363640091, -4.418233243373006e-05], [-4.428500444231657e-05, -4.418233243373006e-05, 0.00011636955870407648]]} + #*EXTRAS*# Step: 24 Bead: 10 +{"friction": [[0.00011638539202259604, -4.457898126956909e-05, -4.4288813940233484e-05], [-4.457898126956909e-05, 0.0001159625667226676, -4.418526516088908e-05], [-4.4288813940233484e-05, -4.418526516088908e-05, 0.00011640020118480342]]} + #*EXTRAS*# Step: 25 Bead: 10 +{"friction": [[0.00011641368313495058, -4.458252632473814e-05, -4.4292229685779804e-05], [-4.458252632473814e-05, 0.00011599048581338536, -4.418787837649857e-05], [-4.4292229685779804e-05, -4.418787837649857e-05, 0.00011642823752987342]]} + #*EXTRAS*# Step: 26 Bead: 10 +{"friction": [[0.0001164395900611906, -4.4585668114817086e-05, -4.429529926352362e-05], [-4.4585668114817086e-05, 0.00011601609988412703, -4.419021280893684e-05], [-4.429529926352362e-05, -4.419021280893684e-05, 0.00011645391164281808]]} + #*EXTRAS*# Step: 27 Bead: 10 +{"friction": [[0.00011646333089469213, -4.4588459282820604e-05, -4.4298063315672626e-05], [-4.4588459282820604e-05, 0.00011603961276687251, -4.419230300616769e-05], [-4.4298063315672626e-05, -4.419230300616769e-05, 0.00011647743953370307]]} + #*EXTRAS*# Step: 28 Bead: 10 +{"friction": [[0.0001164850998472225, -4.4590944554100244e-05, -4.4300556764417406e-05], [-4.4590944554100244e-05, 0.00011606120688987146, -4.419417844647579e-05], [-4.4300556764417406e-05, -4.419417844647579e-05, 0.00011649901356985895]]} + #*EXTRAS*# Step: 29 Bead: 10 +{"friction": [[0.00011650507069591507, -4.459316210491671e-05, -4.430280978058162e-05], [-4.459316210491671e-05, 0.00011608104628090328, -4.419586441676021e-05], [-4.430280978058162e-05, -4.419586441676021e-05, 0.00011651880588713797]]} + #*EXTRAS*# Step: 30 Bead: 10 +{"friction": [[0.0001165233995843945, -4.4595144660284005e-05, -4.430484855940996e-05], [-4.4595144660284005e-05, 0.00011609927901095163, -4.4197382714271126e-05], [-4.430484855940996e-05, -4.4197382714271126e-05, 0.00011653697116211853]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_11 b/drivers/py/pes/friction/frictionH/120K/inst.raw_11 new file mode 100644 index 000000000..ea4f84ce2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_11 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 11 +{"friction": [[0.00010562036954718544, -3.769046910141249e-05, -3.763042875179934e-05], [-3.769046910141249e-05, 0.00010561870141779494, -3.7770470863789636e-05], [-3.763042875179934e-05, -3.7770470863789636e-05, 0.0001054411173289977]]} + #*EXTRAS*# Step: 1 Bead: 11 +{"friction": [[0.00010821236836118526, -4.017525929535722e-05, -4.01892366340863e-05], [-4.017525929535722e-05, 0.0001082163039907463, -4.01788382840068e-05], [-4.01892366340863e-05, -4.01788382840068e-05, 0.00010824877993734805]]} + #*EXTRAS*# Step: 2 Bead: 11 +{"friction": [[0.00011087321121944126, -4.2151091695803704e-05, -4.2228522571900055e-05], [-4.2151091695803704e-05, 0.00011088889095304024, -4.220578815264125e-05], [-4.2228522571900055e-05, -4.220578815264125e-05, 0.00011094788651397632]]} + #*EXTRAS*# Step: 3 Bead: 11 +{"friction": [[0.00011213417529862159, -4.292623993049148e-05, -4.295956406562726e-05], [-4.292623993049148e-05, 0.00011208701598576566, -4.29406649174682e-05], [-4.295956406562726e-05, -4.29406649174682e-05, 0.00011219463053401914]]} + #*EXTRAS*# Step: 4 Bead: 11 +{"friction": [[0.00011297783363293415, -4.339494572357907e-05, -4.335954244420975e-05], [-4.339494572357907e-05, 0.00011284990220887222, -4.3334227938776024e-05], [-4.335954244420975e-05, -4.3334227938776024e-05, 0.00011302792165266635]]} + #*EXTRAS*# Step: 5 Bead: 11 +{"friction": [[0.00011358349355306288, -4.369895560824174e-05, -4.360340221378703e-05], [-4.369895560824174e-05, 0.00011338705590697053, -4.3569019915907095e-05], [-4.360340221378703e-05, -4.3569019915907095e-05, 0.00011362657605572488]]} + #*EXTRAS*# Step: 6 Bead: 11 +{"friction": [[0.00011402829830315826, -4.390070302550329e-05, -4.376002852900331e-05], [-4.390070302550329e-05, 0.00011378084754233082, -4.37171130581761e-05], [-4.376002852900331e-05, -4.37171130581761e-05, 0.0001140664546972499]]} + #*EXTRAS*# Step: 7 Bead: 11 +{"friction": [[0.00011437371302471472, -4.404316993724665e-05, -4.386879790222642e-05], [-4.404316993724665e-05, 0.00011408816728461423, -4.3818362187299696e-05], [-4.386879790222642e-05, -4.3818362187299696e-05, 0.00011440816603031544]]} + #*EXTRAS*# Step: 8 Bead: 11 +{"friction": [[0.00011465014086711433, -4.414752353410407e-05, -4.394787858877758e-05], [-4.414752353410407e-05, 0.00011433593069042934, -4.3890952908600004e-05], [-4.394787858877758e-05, -4.3890952908600004e-05, 0.00011468170420575605]]} + #*EXTRAS*# Step: 9 Bead: 11 +{"friction": [[0.00011487806272146681, -4.4226751012235514e-05, -4.400782893916518e-05], [-4.4226751012235514e-05, 0.00011454187213681023, -4.394528305835716e-05], [-4.400782893916518e-05, -4.394528305835716e-05, 0.00011490729154815703]]} + #*EXTRAS*# Step: 10 Bead: 11 +{"friction": [[0.00011507004143281612, -4.428851335394793e-05, -4.405468348940537e-05], [-4.428851335394793e-05, 0.00011471673560688194, -4.3987240669324866e-05], [-4.405468348940537e-05, -4.3987240669324866e-05, 0.00011509733680744573]]} + #*EXTRAS*# Step: 11 Bead: 11 +{"friction": [[0.00011523454798143413, -4.433770974457707e-05, -4.4092210192543e-05], [-4.433770974457707e-05, 0.00011486773394562937, -4.4020467728222156e-05], [-4.4092210192543e-05, -4.4020467728222156e-05, 0.00011526021002952367]]} + #*EXTRAS*# Step: 12 Bead: 11 +{"friction": [[0.00011537739839639266, -4.4377570674422355e-05, -4.412284996939199e-05], [-4.4377570674422355e-05, 0.000114999807939624, -4.404730584767392e-05], [-4.412284996939199e-05, -4.404730584767392e-05, 0.0001154016593782393]]} + #*EXTRAS*# Step: 13 Bead: 11 +{"friction": [[0.00011550276899845874, -4.441032076947214e-05, -4.4148260840333685e-05], [-4.441032076947214e-05, 0.00011511650690458263, -4.40693342501867e-05], [-4.4148260840333685e-05, -4.40693342501867e-05, 0.00011552581335752506]]} + #*EXTRAS*# Step: 14 Bead: 11 +{"friction": [[0.00011561373689600929, -4.443753800868773e-05, -4.416960625269821e-05], [-4.443753800868773e-05, 0.0001152204496575237, -4.408765398457129e-05], [-4.416960625269821e-05, -4.408765398457129e-05, 0.00011563571440173471]]} + #*EXTRAS*# Step: 15 Bead: 11 +{"friction": [[0.0001157126336821658, -4.446037390257119e-05, -4.418772806188175e-05], [-4.446037390257119e-05, 0.00011531362553462515, -4.41030568938101e-05], [-4.418772806188175e-05, -4.41030568938101e-05, 0.00011573366820697028]]} + #*EXTRAS*# Step: 16 Bead: 11 +{"friction": [[0.00011580126567183418, -4.4479688373543245e-05, -4.4203250807266947e-05], [-4.4479688373543245e-05, 0.00011539758062629221, -4.411612700399723e-05], [-4.4203250807266947e-05, -4.411612700399723e-05, 0.00011582146128496173]]} + #*EXTRAS*# Step: 17 Bead: 11 +{"friction": [[0.00011588106140119909, -4.449613683692962e-05, -4.42166481411486e-05], [-4.449613683692962e-05, 0.000115473542386068, -4.412730473444839e-05], [-4.42166481411486e-05, -4.412730473444839e-05, 0.00011590050669878025]]} + #*EXTRAS*# Step: 18 Bead: 11 +{"friction": [[0.00011595317111282038, -4.451022763468408e-05, -4.422828614534523e-05], [-4.451022763468408e-05, 0.00011554250350248416, -4.413692858179606e-05], [-4.422828614534523e-05, -4.413692858179606e-05, 0.00011597194237301501]]} + #*EXTRAS*# Step: 19 Bead: 11 +{"friction": [[0.00011601853613128384, -4.452236108962481e-05, -4.423845250186793e-05], [-4.452236108962481e-05, 0.00011560528035920046, -4.414526306626239e-05], [-4.423845250186793e-05, -4.414526306626239e-05, 0.00011603669966018084]]} + #*EXTRAS*# Step: 20 Bead: 11 +{"friction": [[0.00011607793805666355, -4.453285665344483e-05, -4.4247376595304723e-05], [-4.453285665344483e-05, 0.00011566255445718895, -4.415251791607359e-05], [-4.4247376595304723e-05, -4.415251791607359e-05, 0.00011609555196604801]]} + #*EXTRAS*# Step: 21 Bead: 11 +{"friction": [[0.00011613203437581162, -4.4541972200792865e-05, -4.4255243688486256e-05], [-4.4541972200792865e-05, 0.00011571490238636489, -4.4158861546996105e-05], [-4.4255243688486256e-05, -4.4158861546996105e-05, 0.00011614914995333076]]} + #*EXTRAS*# Step: 22 Bead: 11 +{"friction": [[0.00011618138465452555, -4.4549918004864376e-05, -4.426220511615592e-05], [-4.4549918004864376e-05, 0.00011576281785484028, -4.4164430723894424e-05], [-4.426220511615592e-05, -4.4164430723894424e-05, 0.00011619804743634081]]} + #*EXTRAS*# Step: 23 Bead: 11 +{"friction": [[0.00011622647010410126, -4.455686704151943e-05, -4.426838574932557e-05], [-4.455686704151943e-05, 0.00011580672813257594, -4.4169337614234824e-05], [-4.426838574932557e-05, -4.4169337614234824e-05, 0.00011624272072676866]]} + #*EXTRAS*# Step: 24 Bead: 11 +{"friction": [[0.00011626770840058649, -4.45629627087815e-05, -4.427388955062027e-05], [-4.45629627087815e-05, 0.00011584700649291977, -4.4173675023210626e-05], [-4.427388955062027e-05, -4.4173675023210626e-05, 0.00011628358328669974]]} + #*EXTRAS*# Step: 25 Bead: 11 +{"friction": [[0.00011630546505509871, -4.45683246954817e-05, -4.4278803770893984e-05], [-4.45683246954817e-05, 0.0001158839817475781, -4.417752033834332e-05], [-4.4278803770893984e-05, -4.417752033834332e-05, 0.00011632099697204031]]} + #*EXTRAS*# Step: 26 Bead: 11 +{"friction": [[0.00011634006224412026, -4.457305350289396e-05, -4.4283202162798454e-05], [-4.457305350289396e-05, 0.00011591794564235315, -4.418093854281077e-05], [-4.4283202162798454e-05, -4.418093854281077e-05, 0.00011635528076472381]]} + #*EXTRAS*# Step: 27 Bead: 11 +{"friction": [[0.00011637178574903721, -4.4577233971660795e-05, -4.4287147472712066e-05], [-4.4577233971660795e-05, 0.00011594915866253105, -4.4183984546682e-05], [-4.4287147472712066e-05, -4.4183984546682e-05, 0.00011638671763550077]]} + #*EXTRAS*# Step: 28 Bead: 11 +{"friction": [[0.00011640089046666198, -4.458093806307912e-05, -4.429069339479454e-05], [-4.458093806307912e-05, 0.00011597785463761974, -4.4186705010896505e-05], [-4.429069339479454e-05, -4.4186705010896505e-05, 0.0001164155599937648]]} + #*EXTRAS*# Step: 29 Bead: 11 +{"friction": [[0.00011642760483178894, -4.458422707467639e-05, -4.429388611940742e-05], [-4.458422707467639e-05, 0.00011600424443387224, -4.4189139789407405e-05], [-4.429388611940742e-05, -4.4189139789407405e-05, 0.00011644203406159262]]} + #*EXTRAS*# Step: 30 Bead: 11 +{"friction": [[0.00011645213441051987, -4.458715342220104e-05, -4.429676557278342e-05], [-4.458715342220104e-05, 0.00011602851895441478, -4.419132308101357e-05], [-4.429676557278342e-05, -4.419132308101357e-05, 0.00011646634342782935]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_12 b/drivers/py/pes/friction/frictionH/120K/inst.raw_12 new file mode 100644 index 000000000..f4b4d0d88 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_12 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 12 +{"friction": [[0.00010410059478635681, -3.587758594138993e-05, -3.5810247906280144e-05], [-3.587758594138993e-05, 0.00010409721165943899, -3.604130532787345e-05], [-3.5810247906280144e-05, -3.604130532787345e-05, 0.00010376542350754372]]} + #*EXTRAS*# Step: 1 Bead: 12 +{"friction": [[0.0001068327151359019, -3.893184247074491e-05, -3.889866598949092e-05], [-3.893184247074491e-05, 0.00010682771546644247, -3.89544635257768e-05], [-3.889866598949092e-05, -3.89544635257768e-05, 0.00010677313268688233]]} + #*EXTRAS*# Step: 2 Bead: 12 +{"friction": [[0.00010975520545054818, -4.1382615441172184e-05, -4.145001846751924e-05], [-4.1382615441172184e-05, 0.00010977966461402201, -4.142190567266487e-05], [-4.145001846751924e-05, -4.142190567266487e-05, 0.00010983104042364265]]} + #*EXTRAS*# Step: 3 Bead: 12 +{"friction": [[0.00011123838468290335, -4.238488746171244e-05, -4.24565520519884e-05], [-4.238488746171244e-05, 0.00011124270384435449, -4.243595453504287e-05], [-4.24565520519884e-05, -4.243595453504287e-05, 0.00011130968920532037]]} + #*EXTRAS*# Step: 4 Bead: 12 +{"friction": [[0.000112241118158019, -4.298801753934856e-05, -4.301421397383399e-05], [-4.298801753934856e-05, 0.00011218528985869091, -4.299496534312935e-05], [-4.301421397383399e-05, -4.299496534312935e-05, 0.00011230021837633124]]} + #*EXTRAS*# Step: 5 Bead: 12 +{"friction": [[0.00011295812906910908, -4.3384548065145496e-05, -4.335100737757962e-05], [-4.3384548065145496e-05, 0.00011283233725818939, -4.33259311902522e-05], [-4.335100737757962e-05, -4.33259311902522e-05, 0.00011300845098280771]]} + #*EXTRAS*# Step: 6 Bead: 12 +{"friction": [[0.00011348606564890072, -4.3652212445027466e-05, -4.3566573533822705e-05], [-4.3652212445027466e-05, 0.00011330086329487549, -4.353386303118347e-05], [-4.3566573533822705e-05, -4.353386303118347e-05, 0.00011353025146975719]]} + #*EXTRAS*# Step: 7 Bead: 12 +{"friction": [[0.00011389636660104093, -4.384293089401598e-05, -4.3715530997318114e-05], [-4.384293089401598e-05, 0.00011366391285594257, -4.3675291739595756e-05], [-4.3715530997318114e-05, -4.3675291739595756e-05, 0.00011393596535945519]]} + #*EXTRAS*# Step: 8 Bead: 12 +{"friction": [[0.0001142254810941062, -4.398362711642463e-05, -4.3823483921327296e-05], [-4.398362711642463e-05, 0.000113956030633264, -4.377636169502792e-05], [-4.3823483921327296e-05, -4.377636169502792e-05, 0.00011426151059840706]]} + #*EXTRAS*# Step: 9 Bead: 12 +{"friction": [[0.00011449737357560288, -4.40909472237156e-05, -4.390504360787269e-05], [-4.40909472237156e-05, 0.00011419876430255276, -4.385175216648622e-05], [-4.390504360787269e-05, -4.385175216648622e-05, 0.0001145305258737652]]} + #*EXTRAS*# Step: 10 Bead: 12 +{"friction": [[0.00011472680733037341, -4.417487517031147e-05, -4.3968571086911244e-05], [-4.417487517031147e-05, 0.00011440501900121447, -4.3909780178080244e-05], [-4.3968571086911244e-05, -4.3909780178080244e-05, 0.00011475758061362871]]} + #*EXTRAS*# Step: 11 Bead: 12 +{"friction": [[0.00011492372411565602, -4.424185899278311e-05, -4.4019273533566274e-05], [-4.424185899278311e-05, 0.00011458333921575277, -4.3955575629645575e-05], [-4.4019273533566274e-05, -4.3955575629645575e-05, 0.00011495249037718288]]} + #*EXTRAS*# Step: 12 Bead: 12 +{"friction": [[0.00011509496688030585, -4.429619095664406e-05, -4.40605244292057e-05], [-4.429619095664406e-05, 0.00011473954262543702, -4.39924359520136e-05], [-4.40605244292057e-05, -4.39924359520136e-05, 0.0001151220133987645]]} + #*EXTRAS*# Step: 13 Bead: 12 +{"friction": [[0.00011524545300301727, -4.434084714220448e-05, -4.409461279801186e-05], [-4.434084714220448e-05, 0.00011487778407972865, -4.402258224244548e-05], [-4.409461279801186e-05, -4.402258224244548e-05, 0.00011527100753390562]]} + #*EXTRAS*# Step: 14 Bead: 12 +{"friction": [[0.00011537881051006066, -4.437795125486582e-05, -4.412314386780297e-05], [-4.437795125486582e-05, 0.0001150011181925357, -4.404756187657773e-05], [-4.412314386780297e-05, -4.404756187657773e-05, 0.00011540305772112605]]} + #*EXTRAS*# Step: 15 Bead: 12 +{"friction": [[0.00011549779116329254, -4.4409060688524696e-05, -4.414727814993491e-05], [-4.4409060688524696e-05, 0.0001151118587730749, -4.4068486615272564e-05], [-4.414727814993491e-05, -4.4068486615272564e-05, 0.00011552088359878881]]} + #*EXTRAS*# Step: 16 Bead: 12 +{"friction": [[0.00011560452911225125, -4.443534345933797e-05, -4.416787585896807e-05], [-4.443534345933797e-05, 0.00011521180078489779, -4.408617570223349e-05], [-4.416787585896807e-05, -4.408617570223349e-05, 0.00011562659478784912]]} + #*EXTRAS*# Step: 17 Bead: 12 +{"friction": [[0.00011570071390717125, -4.445769307823169e-05, -4.4185588763936975e-05], [-4.445769307823169e-05, 0.00011530236757253213, -4.410124633298001e-05], [-4.4185588763936975e-05, -4.410124633298001e-05, 0.00011572186169923649]]} + #*EXTRAS*# Step: 18 Bead: 12 +{"friction": [[0.00011578770740543426, -4.447680476269851e-05, -4.42009200917125e-05], [-4.447680476269851e-05, 0.00011538470960130434, -4.411417238115771e-05], [-4.42009200917125e-05, -4.411417238115771e-05, 0.0001158080309721356]]} + #*EXTRAS*# Step: 19 Bead: 12 +{"friction": [[0.00011586662531246567, -4.4493227497859536e-05, -4.421426484172417e-05], [-4.4493227497859536e-05, 0.00011545977296558404, -4.412532374055468e-05], [-4.421426484172417e-05, -4.412532374055468e-05, 0.0001158862060056764]]} + #*EXTRAS*# Step: 20 Bead: 12 +{"friction": [[0.00011593839504655627, -4.4507400383041e-05, -4.422593756242792e-05], [-4.4507400383041e-05, 0.0001155283477757352, -4.413499332295562e-05], [-4.422593756242792e-05, -4.413499332295562e-05, 0.00011595730411603433]]} + #*EXTRAS*# Step: 21 Bead: 12 +{"friction": [[0.00011600379764257343, -4.451967856208787e-05, -4.4236191932462926e-05], [-4.451967856208787e-05, 0.00011559110305868992, -4.414341601952192e-05], [-4.4236191932462926e-05, -4.414341601952192e-05, 0.0001160220979330397]]} + #*EXTRAS*# Step: 22 Bead: 12 +{"friction": [[0.00011606349858452001, -4.45303520734083e-05, -4.4245234839166275e-05], [-4.45303520734083e-05, 0.00011564861233963841, -4.41507822876659e-05], [-4.4245234839166275e-05, -4.41507822876659e-05, 0.00011608124586296825]]} + #*EXTRAS*# Step: 23 Bead: 12 +{"friction": [[0.00011611807084429713, -4.4539659794748494e-05, -4.425323668645334e-05], [-4.4539659794748494e-05, 0.00011570137268677369, -4.415724806795969e-05], [-4.425323668645334e-05, -4.415724806795969e-05, 0.00011613531485317723]]} + #*EXTRAS*# Step: 24 Bead: 12 +{"friction": [[0.00011616801233402253, -4.454779992380627e-05, -4.426033906628171e-05], [-4.454779992380627e-05, 0.00011574981908445137, -4.4162942143420715e-05], [-4.426033906628171e-05, -4.4162942143420715e-05, 0.00011618479763818467]]} + #*EXTRAS*# Step: 25 Bead: 12 +{"friction": [[0.00011621375929808845, -4.4554937970685396e-05, -4.426666055405615e-05], [-4.4554937970685396e-05, 0.00011579433542124454, -4.416797168418527e-05], [-4.426666055405615e-05, -4.416797168418527e-05, 0.00011623012597442388]]} + #*EXTRAS*# Step: 26 Bead: 12 +{"friction": [[0.00011625569671425065, -4.456121293438177e-05, -4.427230114690497e-05], [-4.456121293438177e-05, 0.00011583526299218641, -4.417242648304509e-05], [-4.427230114690497e-05, -4.417242648304509e-05, 0.00011627168091982291]]} + #*EXTRAS*# Step: 27 Bead: 12 +{"friction": [[0.0001162941664677594, -4.456674213450042e-05, -4.427734570568556e-05], [-4.456674213450042e-05, 0.00011587290715701099, -4.4176382232223756e-05], [-4.427734570568556e-05, -4.4176382232223756e-05, 0.000116309800912928]]} + #*EXTRAS*# Step: 28 Bead: 12 +{"friction": [[0.00011632947384293495, -4.45716250323032e-05, -4.428186665452228e-05], [-4.45716250323032e-05, 0.0001159075426100518, -4.417990308730539e-05], [-4.428186665452228e-05, -4.417990308730539e-05, 0.00011634478818938673]]} + #*EXTRAS*# Step: 29 Bead: 12 +{"friction": [[0.00011636189273357148, -4.4575946282837156e-05, -4.428592612027846e-05], [-4.4575946282837156e-05, 0.00011593941759766081, -4.418304369450968e-05], [-4.428592612027846e-05, -4.418304369450968e-05, 0.00011637691393236536]]} + #*EXTRAS*# Step: 30 Bead: 12 +{"friction": [[0.00011639166987622474, -4.457977819593182e-05, -4.428957764538481e-05], [-4.457977819593182e-05, 0.00011596875733822666, -4.418585080971323e-05], [-4.428957764538481e-05, -4.418585080971323e-05, 0.00011640642245735647]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_13 b/drivers/py/pes/friction/frictionH/120K/inst.raw_13 new file mode 100644 index 000000000..2fc11cdf2 --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_13 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 13 +{"friction": [[0.00010310461147450481, -3.446489117457354e-05, -3.44165270104119e-05], [-3.446489117457354e-05, 0.00010307920642357731, -3.4657347226921115e-05], [-3.44165270104119e-05, -3.4657347226921115e-05, 0.00010269639584043074]]} + #*EXTRAS*# Step: 1 Bead: 13 +{"friction": [[0.00010582671403554583, -3.7912901255851164e-05, -3.7856307578776025e-05], [-3.7912901255851164e-05, 0.0001058242814256422, -3.798157672066333e-05], [-3.7856307578776025e-05, -3.798157672066333e-05, 0.00010566907242795302]]} + #*EXTRAS*# Step: 2 Bead: 13 +{"friction": [[0.00010890484522279301, -4.0739678150744975e-05, -4.078040507024623e-05], [-4.0739678150744975e-05, 0.00010891949857258055, -4.0756279501326e-05], [-4.078040507024623e-05, -4.0756279501326e-05, 0.00010896660145634423]]} + #*EXTRAS*# Step: 3 Bead: 13 +{"friction": [[0.00011054972099373442, -4.193714718026962e-05, -4.201558912948856e-05], [-4.193714718026962e-05, 0.0001105715549370078, -4.199081787307331e-05], [-4.201558912948856e-05, -4.199081787307331e-05, 0.00011062640262796619]]} + #*EXTRAS*# Step: 4 Bead: 13 +{"friction": [[0.00011167373558125277, -4.26534658442672e-05, -4.271108016930257e-05], [-4.26534658442672e-05, 0.0001116575473293728, -4.2692179113977573e-05], [-4.271108016930257e-05, -4.2692179113977573e-05, 0.00011174001845452613]]} + #*EXTRAS*# Step: 5 Bead: 13 +{"friction": [[0.00011247568658637595, -4.3121336579496224e-05, -4.313004578132801e-05], [-4.3121336579496224e-05, 0.00011239900052642074, -4.310953434255642e-05], [-4.313004578132801e-05, -4.310953434255642e-05, 0.00011253185682476278]]} + #*EXTRAS*# Step: 6 Bead: 13 +{"friction": [[0.0001130670218367398, -4.344163292317609e-05, -4.33976973064958e-05], [-4.344163292317609e-05, 0.00011292930775780671, -4.337125657025158e-05], [-4.33976973064958e-05, -4.337125657025158e-05, 0.00011311605597761532]]} + #*EXTRAS*# Step: 7 Bead: 13 +{"friction": [[0.00011352682554249325, -4.367187449585796e-05, -4.358209223127699e-05], [-4.367187449585796e-05, 0.00011333692604758067, -4.3548691559485286e-05], [-4.358209223127699e-05, -4.3548691559485286e-05, 0.00011357054869820459]]} + #*EXTRAS*# Step: 8 Bead: 13 +{"friction": [[0.00011389622348109768, -4.384286725123632e-05, -4.371548183344317e-05], [-4.384286725123632e-05, 0.00011366378609545335, -4.367524541545088e-05], [-4.371548183344317e-05, -4.367524541545088e-05, 0.00011393582381268883]]} + #*EXTRAS*# Step: 9 Bead: 13 +{"friction": [[0.00011420181934117877, -4.397389772462523e-05, -4.381606138306165e-05], [-4.397389772462523e-05, 0.00011393497660502943, -4.3769456425915896e-05], [-4.381606138306165e-05, -4.3769456425915896e-05, 0.0001142381022644138]]} + #*EXTRAS*# Step: 10 Bead: 13 +{"friction": [[0.00011446002767836162, -4.407670286225753e-05, -4.38942459890099e-05], [-4.407670286225753e-05, 0.00011416532533488921, -4.384182539436e-05], [-4.38942459890099e-05, -4.384182539436e-05, 0.00011449357141881446]]} + #*EXTRAS*# Step: 11 Bead: 13 +{"friction": [[0.00011468189405087364, -4.415893718984814e-05, -4.395651387558936e-05], [-4.415893718984814e-05, 0.0001143645237014826, -4.38988189009581e-05], [-4.395651387558936e-05, -4.38988189009581e-05, 0.00011471312957649538]]} + #*EXTRAS*# Step: 12 Bead: 13 +{"friction": [[0.00011487503308454692, -4.422573946021489e-05, -4.4007062934188094e-05], [-4.422573946021489e-05, 0.00011453912340221844, -4.394459319713776e-05], [-4.4007062934188094e-05, -4.394459319713776e-05, 0.00011490429266252298]]} + #*EXTRAS*# Step: 13 Bead: 13 +{"friction": [[0.00011504491984739898, -4.428069530147123e-05, -4.4048740380350584e-05], [-4.428069530147123e-05, 0.00011469377408783648, -4.3981946095619455e-05], [-4.4048740380350584e-05, -4.3981946095619455e-05, 0.00011507246653865287]]} + #*EXTRAS*# Step: 14 Bead: 13 +{"friction": [[0.00011519559759727089, -4.432637721358142e-05, -4.408354249076434e-05], [-4.432637721358142e-05, 0.00011483187916794359, -4.401282601279096e-05], [-4.408354249076434e-05, -4.401282601279096e-05, 0.00011522164443645417]]} + #*EXTRAS*# Step: 15 Bead: 13 +{"friction": [[0.00011533013526401523, -4.4364680129311266e-05, -4.411291197265244e-05], [-4.4364680129311266e-05, 0.00011495600760655756, -4.403863216160053e-05], [-4.411291197265244e-05, -4.403863216160053e-05, 0.00011535485804133444]]} + #*EXTRAS*# Step: 16 Bead: 13 +{"friction": [[0.00011545091484349607, -4.439703068600205e-05, -4.413791782680746e-05], [-4.439703068600205e-05, 0.00011506814717146045, -4.4060395122933384e-05], [-4.413791782680746e-05, -4.4060395122933384e-05, 0.00011547446094367727]]} + #*EXTRAS*# Step: 17 Bead: 13 +{"friction": [[0.00011555982351716945, -4.4424523851076944e-05, -4.415936965502208e-05], [-4.4424523851076944e-05, 0.00011516987108592353, -4.407889090359397e-05], [-4.415936965502208e-05, -4.407889090359397e-05, 0.00011558231818457514]]} + #*EXTRAS*# Step: 18 Bead: 13 +{"friction": [[0.00011565838361758527, -4.444801404528341e-05, -4.41778922252533e-05], [-4.444801404528341e-05, 0.0001152624493084045, -4.409471497490848e-05], [-4.41778922252533e-05, -4.409471497490848e-05, 0.00011567993450939103]]} + #*EXTRAS*# Step: 19 Bead: 13 +{"friction": [[0.00011574784329626794, -4.4468177655739154e-05, -4.419397564232528e-05], [-4.4468177655739154e-05, 0.00011534692537950514, -4.4108331854304194e-05], [-4.419397564232528e-05, -4.4108331854304194e-05, 0.00011576854386057148]]} + #*EXTRAS*# Step: 20 Bead: 13 +{"friction": [[0.00011582924089926089, -4.448555684975521e-05, -4.420800991531217e-05], [-4.448555684975521e-05, 0.00011542417050392197, -4.412010912483631e-05], [-4.420800991531217e-05, -4.412010912483631e-05, 0.00011584917292990527]]} + #*EXTRAS*# Step: 21 Bead: 13 +{"friction": [[0.00011590345159842897, -4.4500590940188836e-05, -4.422030932464491e-05], [-4.4500590940188836e-05, 0.00011549492242682979, -4.4130341323568685e-05], [-4.422030932464491e-05, -4.4130341323568685e-05, 0.00011592268720048554]]} + #*EXTRAS*# Step: 22 Bead: 13 +{"friction": [[0.00011597122171221414, -4.451363925922771e-05, -4.4231129942102445e-05], [-4.451363925922771e-05, 0.00011555981384470958, -4.4139267057065886e-05], [-4.4231129942102445e-05, -4.4139267057065886e-05, 0.00011598982483806489]]} + #*EXTRAS*# Step: 23 Bead: 13 +{"friction": [[0.00011603319435547614, -4.452499812996451e-05, -4.424068245910179e-05], [-4.452499812996451e-05, 0.00011561939349653067, -4.4147081492826656e-05], [-4.424068245910179e-05, -4.4147081492826656e-05, 0.00011605122202279234]]} + #*EXTRAS*# Step: 24 Bead: 13 +{"friction": [[0.00011608992887239284, -4.4534913657689345e-05, -4.4249141734914816e-05], [-4.4534913657689345e-05, 0.00011567414203879047, -4.415394562886166e-05], [-4.4249141734914816e-05, -4.415394562886166e-05, 0.00011610743214294139]]} + #*EXTRAS*# Step: 25 Bead: 13 +{"friction": [[0.00011614191574952336, -4.4543591510566036e-05, -4.425665401086803e-05], [-4.4543591510566036e-05, 0.000115724484150297, -4.4159993277701105e-05], [-4.425665401086803e-05, -4.4159993277701105e-05, 0.00011615894052565837]]} + #*EXTRAS*# Step: 26 Bead: 13 +{"friction": [[0.00011618958819876309, -4.455120449747471e-05, -4.4263342436119065e-05], [-4.455120449747471e-05, 0.00011577079787497754, -4.4165336401661865e-05], [-4.4263342436119065e-05, -4.4165336401661865e-05, 0.00011620617587916405]]} + #*EXTRAS*# Step: 27 Bead: 13 +{"friction": [[0.00011623333126044384, -4.455789851061065e-05, -4.4269311353823196e-05], [-4.455789851061065e-05, 0.00011581342192051826, -4.417006924065452e-05], [-4.4269311353823196e-05, -4.417006924065452e-05, 0.00011624951928585755]]} + #*EXTRAS*# Step: 28 Bead: 13 +{"friction": [[0.0001162734890331635, -4.456379723627706e-05, -4.427464966345945e-05], [-4.456379723627706e-05, 0.00011585266142198939, -4.4174271542296306e-05], [-4.427464966345945e-05, -4.4174271542296306e-05, 0.00011628931134524612]]} + #*EXTRAS*# Step: 29 Bead: 13 +{"friction": [[0.00011631037047712337, -4.4569005926295173e-05, -4.427943348610479e-05], [-4.4569005926295173e-05, 0.00011588879254445702, -4.4178011116136335e-05], [-4.427943348610479e-05, -4.4178011116136335e-05, 0.00011632585790789502]]} + #*EXTRAS*# Step: 30 Bead: 13 +{"friction": [[0.00011634425412913697, -4.45736144454399e-05, -4.4283728298414045e-05], [-4.45736144454399e-05, 0.0001159220662077576, -4.41813458735139e-05], [-4.4283728298414045e-05, -4.41813458735139e-05, 0.00011635943473439066]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_14 b/drivers/py/pes/friction/frictionH/120K/inst.raw_14 new file mode 100644 index 000000000..9d10e6d9a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_14 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 14 +{"friction": [[0.0001025334360101724, -3.35409127376559e-05, -3.351447758652769e-05], [-3.35409127376559e-05, 0.00010248196407672836, -3.372632209749448e-05], [-3.351447758652769e-05, -3.372632209749448e-05, 0.00010210975134216749]]} + #*EXTRAS*# Step: 1 Bead: 14 +{"friction": [[0.00010519168232281083, -3.7211976697797746e-05, -3.714645580679814e-05], [-3.7211976697797746e-05, 0.00010519130228864114, -3.7316436674238246e-05], [-3.714645580679814e-05, -3.7316436674238246e-05, 0.00010496699170022938]]} + #*EXTRAS*# Step: 2 Bead: 14 +{"friction": [[0.00010833362238078242, -4.027685149614361e-05, -4.0295575796002505e-05], [-4.027685149614361e-05, 0.000108339326029239, -4.028190415799287e-05], [-4.0295575796002505e-05, -4.028190415799287e-05, 0.00010837552412981438]]} + #*EXTRAS*# Step: 3 Bead: 14 +{"friction": [[0.00011008265454679817, -4.161632741533034e-05, -4.169033744061508e-05], [-4.161632741533034e-05, 0.00011010788472364582, -4.1663104162240184e-05], [-4.169033744061508e-05, -4.1663104162240184e-05, 0.00011016000841955724]]} + #*EXTRAS*# Step: 4 Bead: 14 +{"friction": [[0.0001112883467890681, -4.241625972818069e-05, -4.2486723402319566e-05], [-4.241625972818069e-05, 0.00011129071388823947, -4.24663800515419e-05], [-4.2486723402319566e-05, -4.24663800515419e-05, 0.00011135911985226815]]} + #*EXTRAS*# Step: 5 Bead: 14 +{"friction": [[0.00011214772838297943, -4.293410147886103e-05, -4.296655395403621e-05], [-4.293410147886103e-05, 0.00011209950196090243, -4.2947618564056564e-05], [-4.296655395403621e-05, -4.2947618564056564e-05, 0.00011220801125498411]]} + #*EXTRAS*# Step: 6 Bead: 14 +{"friction": [[0.00011278183154961537, -4.329023337108696e-05, -4.327293990660613e-05], [-4.329023337108696e-05, 0.00011267477709142058, -4.324982107078609e-05], [-4.327293990660613e-05, -4.324982107078609e-05, 0.00011283426331533821]]} + #*EXTRAS*# Step: 7 Bead: 14 +{"friction": [[0.00011327502683945429, -4.354803158052156e-05, -4.348365746667777e-05], [-4.354803158052156e-05, 0.00011311398293648072, -4.345429880390739e-05], [-4.348365746667777e-05, -4.345429880390739e-05, 0.00011332163329382059]]} + #*EXTRAS*# Step: 8 Bead: 14 +{"friction": [[0.00011367162651694423, -4.374047405346169e-05, -4.363593254015711e-05], [-4.374047405346169e-05, 0.00011346501477663194, -4.359997377988664e-05], [-4.363593254015711e-05, -4.359997377988664e-05, 0.00011371371858201674]]} + #*EXTRAS*# Step: 9 Bead: 14 +{"friction": [[0.00011400002041220176, -4.388847216906664e-05, -4.375062927157147e-05], [-4.388847216906664e-05, 0.0001137557685304746, -4.370829709395565e-05], [-4.375062927157147e-05, -4.370829709395565e-05, 0.00011403848464612836]]} + #*EXTRAS*# Step: 10 Bead: 14 +{"friction": [[0.0001142777243456353, -4.4004891132398966e-05, -4.383968752253089e-05], [-4.4004891132398966e-05, 0.00011400255200345484, -4.37914116610628e-05], [-4.383968752253089e-05, -4.37914116610628e-05, 0.00011431319605058983]]} + #*EXTRAS*# Step: 11 Bead: 14 +{"friction": [[0.00011451651952939906, -4.409818733423324e-05, -4.391052939444478e-05], [-4.409818733423324e-05, 0.00011421592085069752, -4.385678875238935e-05], [-4.391052939444478e-05, -4.385678875238935e-05, 0.0001145494716078967]]} + #*EXTRAS*# Step: 12 Bead: 14 +{"friction": [[0.00011472453519537842, -4.417407470068416e-05, -4.396796553123765e-05], [-4.417407470068416e-05, 0.00011440296887710529, -4.3909230281361765e-05], [-4.396796553123765e-05, -4.3909230281361765e-05, 0.00011475533182298323]]} + #*EXTRAS*# Step: 13 Bead: 14 +{"friction": [[0.00011490761863731029, -4.423655970779449e-05, -4.401525831223124e-05], [-4.423655970779449e-05, 0.00011456870465346151, -4.3951967683383266e-05], [-4.401525831223124e-05, -4.3951967683383266e-05, 0.00011493654785915102]]} + #*EXTRAS*# Step: 14 Bead: 14 +{"friction": [[0.00011507009052491487, -4.428852855326548e-05, -4.4054695048043976e-05], [-4.428852855326548e-05, 0.00011471678050223818, -4.398725095843072e-05], [-4.4054695048043976e-05, -4.398725095843072e-05, 0.0001150973854089206]]} + #*EXTRAS*# Step: 15 Bead: 14 +{"friction": [[0.00011521523189894976, -4.4332114427759526e-05, -4.408792857579159e-05], [-4.4332114427759526e-05, 0.0001148499448369494, -4.401669550695885e-05], [-4.408792857579159e-05, -4.401669550695885e-05, 0.00011524108462159225]]} + #*EXTRAS*# Step: 16 Bead: 14 +{"friction": [[0.00011534559067896935, -4.4368927999911615e-05, -4.411618343112335e-05], [-4.4368927999911615e-05, 0.00011497031927949368, -4.404149086546815e-05], [-4.411618343112335e-05, -4.404149086546815e-05, 0.00011537016225503557]]} + #*EXTRAS*# Step: 17 Bead: 14 +{"friction": [[0.00011546318649434041, -4.440020856432753e-05, -4.414038683301374e-05], [-4.440020856432753e-05, 0.0001150795799358324, -4.406253249351644e-05], [-4.414038683301374e-05, -4.406253249351644e-05, 0.00011548661366817549]]} + #*EXTRAS*# Step: 18 Bead: 14 +{"friction": [[0.00011556964934227437, -4.4426925257663114e-05, -4.416125414460787e-05], [-4.4426925257663114e-05, 0.00011517907799780986, -4.4080507323137e-05], [-4.416125414460787e-05, -4.4080507323137e-05, 0.00011559204959216378]]} + #*EXTRAS*# Step: 19 Bead: 14 +{"friction": [[0.00011566631633386957, -4.444984672508419e-05, -4.417934637200958e-05], [-4.444984672508419e-05, 0.00011526992271742914, -4.4095951038870774e-05], [-4.417934637200958e-05, -4.4095951038870774e-05, 0.00011568779158251992]]} + #*EXTRAS*# Step: 20 Bead: 14 +{"friction": [[0.00011575430040742481, -4.446959009239209e-05, -4.419510978345115e-05], [-4.446959009239209e-05, 0.00011535303962791814, -4.4109287377334705e-05], [-4.419510978345115e-05, -4.4109287377334705e-05, 0.00011577493982647148]]} + #*EXTRAS*# Step: 21 Bead: 14 +{"friction": [[0.00011583454011065565, -4.4486656115805784e-05, -4.420890383843134e-05], [-4.4486656115805784e-05, 0.00011542921228004529, -4.412085572113952e-05], [-4.420890383843134e-05, -4.412085572113952e-05, 0.00011585442227705705]]} + #*EXTRAS*# Step: 22 Bead: 14 +{"friction": [[0.00011590783624697304, -4.4501454877078116e-05, -4.422102127034339e-05], [-4.4501454877078116e-05, 0.00011549911266803255, -4.413093086869774e-05], [-4.422102127034339e-05, -4.413093086869774e-05, 0.00011592703082743166]]} + #*EXTRAS*# Step: 23 Bead: 14 +{"friction": [[0.00011597487926643055, -4.451432489063061e-05, -4.4231702792463545e-05], [-4.451432489063061e-05, 0.00011556332376443181, -4.4139737462657e-05], [-4.4231702792463545e-05, -4.4139737462657e-05, 0.0001159934483523425]]} + #*EXTRAS*# Step: 24 Bead: 14 +{"friction": [[0.00011603627001945651, -4.452554753438608e-05, -4.4241148045036806e-05], [-4.452554753438608e-05, 0.00011562235644471546, -4.414746069702863e-05], [-4.4241148045036806e-05, -4.414746069702863e-05, 0.00011605426919921828]]} + #*EXTRAS*# Step: 25 Bead: 14 +{"friction": [[0.00011609253568430965, -4.4535358105882756e-05, -4.4249523867531355e-05], [-4.4535358105882756e-05, 0.00011567666236509574, -4.4154254384577616e-05], [-4.4249523867531355e-05, -4.4154254384577616e-05, 0.000116110014915498]]} + #*EXTRAS*# Step: 26 Bead: 14 +{"friction": [[0.00011614414213824473, -4.454395440444776e-05, -4.425697063582144e-05], [-4.454395440444776e-05, 0.00011572664388163542, -4.4160247120047005e-05], [-4.425697063582144e-05, -4.4160247120047005e-05, 0.00011616114646534827]]} + #*EXTRAS*# Step: 27 Bead: 14 +{"friction": [[0.00011619150368014531, -4.455150347352646e-05, -4.4263607178518685e-05], [-4.455150347352646e-05, 0.00011577266178366082, -4.4165547048834103e-05], [-4.4263607178518685e-05, -4.4165547048834103e-05, 0.00011620807383163987]]} + #*EXTRAS*# Step: 28 Bead: 14 +{"friction": [[0.00011623499075269259, -4.455814695469795e-05, -4.4269534634316696e-05], [-4.455814695469795e-05, 0.00011581504138924509, -4.417024559889495e-05], [-4.4269534634316696e-05, -4.417024559889495e-05, 0.00011625116364282444]]} + #*EXTRAS*# Step: 29 Bead: 14 +{"friction": [[0.00011627493614113685, -4.456400538111324e-05, -4.427483951016366e-05], [-4.456400538111324e-05, 0.00011585407740411557, -4.417442043197761e-05], [-4.427483951016366e-05, -4.417442043197761e-05, 0.00011629074529564047]]} + #*EXTRAS*# Step: 30 Bead: 14 +{"friction": [[0.00011631164000959571, -4.456918165209777e-05, -4.4279596130081314e-05], [-4.456918165209777e-05, 0.00011589003784716062, -4.4178137800607205e-05], [-4.4279596130081314e-05, -4.4178137800607205e-05, 0.00011632711592999599]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_15 b/drivers/py/pes/friction/frictionH/120K/inst.raw_15 new file mode 100644 index 000000000..3ebf65bdb --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst.raw_15 @@ -0,0 +1,62 @@ + #*EXTRAS*# Step: 0 Bead: 15 +{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} + #*EXTRAS*# Step: 1 Bead: 15 +{"friction": [[0.00010490646196707843, -3.688040445238592e-05, -3.681260326094125e-05], [-3.688040445238592e-05, 0.00010490644633441923, -3.700130613295973e-05], [-3.681260326094125e-05, -3.700130613295973e-05, 0.00010465164772604607]]} + #*EXTRAS*# Step: 2 Bead: 15 +{"friction": [[0.00010804894795674986, -4.003644136708558e-05, -4.0044088080650715e-05], [-4.003644136708558e-05, 0.00010805069246089233, -4.0038763003397624e-05], [-4.0044088080650715e-05, -4.0038763003397624e-05, 0.00010807719179759272]]} + #*EXTRAS*# Step: 3 Bead: 15 +{"friction": [[0.000109846791122782, -4.144873373250682e-05, -4.1518239960726356e-05], [-4.144873373250682e-05, 0.00010987168889267842, -4.1490275622346016e-05], [-4.1518239960726356e-05, -4.1490275622346016e-05, 0.00010992323866299621]]} + #*EXTRAS*# Step: 4 Bead: 15 +{"friction": [[0.0001110934841185232, -4.229307267970011e-05, -4.236764724312105e-05], [-4.229307267970011e-05, 0.00011110290985240808, -4.234625069845896e-05], [-4.236764724312105e-05, -4.234625069845896e-05, 0.00011116624268365842]]} + #*EXTRAS*# Step: 5 Bead: 15 +{"friction": [[0.00011198186004245606, -4.283724029820972e-05, -4.287973185865863e-05], [-4.283724029820972e-05, 0.00011194606798587027, -4.286108643611016e-05], [-4.287973185865863e-05, -4.286108643611016e-05, 0.00011204425848994699]]} + #*EXTRAS*# Step: 6 Bead: 15 +{"friction": [[0.00011263749862161975, -4.321137648770671e-05, -4.320673529490046e-05], [-4.321137648770671e-05, 0.00011254514892545843, -4.318497538875252e-05], [-4.320673529490046e-05, -4.318497538875252e-05, 0.00011269168097625769]]} + #*EXTRAS*# Step: 7 Bead: 15 +{"friction": [[0.00011314750693072298, -4.348322371012179e-05, -4.34314596515937e-05], [-4.348322371012179e-05, 0.00011300084137030593, -4.34039372313655e-05], [-4.34314596515937e-05, -4.34039372313655e-05, 0.00011319559672456412]]} + #*EXTRAS*# Step: 8 Bead: 15 +{"friction": [[0.000113557807659321, -4.368671754246975e-05, -4.3593781271739395e-05], [-4.368671754246975e-05, 0.00011336433438059563, -4.355984706866713e-05], [-4.3593781271739395e-05, -4.355984706866713e-05, 0.00011360118017890116]]} + #*EXTRAS*# Step: 9 Bead: 15 +{"friction": [[0.00011389769609939838, -4.384352199767221e-05, -4.371598760754804e-05], [-4.384352199767221e-05, 0.0001136650903929266, -4.367572196373652e-05], [-4.371598760754804e-05, -4.367572196373652e-05, 0.00011393728024482742]]} + #*EXTRAS*# Step: 10 Bead: 15 +{"friction": [[0.00011418523901234777, -4.396704372646741e-05, -4.381082910801568e-05], [-4.396704372646741e-05, 0.00011392022929805612, -4.376458463996789e-05], [-4.381082910801568e-05, -4.376458463996789e-05, 0.0001142216998038932]]} + #*EXTRAS*# Step: 11 Bead: 15 +{"friction": [[0.0001144325852997188, -4.406613370435628e-05, -4.3886229780003875e-05], [-4.406613370435628e-05, 0.00011414077542752546, -4.383444451041036e-05], [-4.3886229780003875e-05, -4.383444451041036e-05, 0.00011446641743561044]]} + #*EXTRAS*# Step: 12 Bead: 15 +{"friction": [[0.0001146481214505214, -4.414679359375208e-05, -4.3947326294855004e-05], [-4.414679359375208e-05, 0.00011433411325762788, -4.3890449382639175e-05], [-4.3947326294855004e-05, -4.3890449382639175e-05, 0.00011467970566563867]]} + #*EXTRAS*# Step: 13 Bead: 15 +{"friction": [[0.00011483788091673104, -4.4213242853602196e-05, -4.399760203492852e-05], [-4.4213242853602196e-05, 0.00011450544178743952, -4.393606301890881e-05], [-4.399760203492852e-05, -4.393606301890881e-05, 0.00011486751820456193]]} + #*EXTRAS*# Step: 14 Bead: 15 +{"friction": [[0.0001150063231797754, -4.426852782517029e-05, -4.403949930587289e-05], [-4.426852782517029e-05, 0.00011465854409739665, -4.397369702421923e-05], [-4.403949930587289e-05, -4.397369702421923e-05, 0.00011503425697800367]]} + #*EXTRAS*# Step: 15 Bead: 15 +{"friction": [[0.00011515683547669439, -4.431490416238581e-05, -4.4074782895117636e-05], [-4.431490416238581e-05, 0.0001147962620072534, -4.400508265642352e-05], [-4.4074782895117636e-05, -4.400508265642352e-05, 0.00011518326643423707]]} + #*EXTRAS*# Step: 16 Bead: 15 +{"friction": [[0.00011529204884873972, -4.4354077649540466e-05, -4.410476022893306e-05], [-4.4354077649540466e-05, 0.00011492078622842417, -4.4031494645731336e-05], [-4.410476022893306e-05, -4.4031494645731336e-05, 0.00011531714502044951]]} + #*EXTRAS*# Step: 17 Bead: 15 +{"friction": [[0.00011541404931829606, -4.438736251917914e-05, -4.4130421225672194e-05], [-4.438736251917914e-05, 0.00011503384556929901, -4.405389247735868e-05], [-4.4130421225672194e-05, -4.405389247735868e-05, 0.00011543795338267569]]} + #*EXTRAS*# Step: 18 Bead: 15 +{"friction": [[0.00011552452088742819, -4.4415787702466094e-05, -4.4152529553054e-05], [-4.4415787702466094e-05, 0.00011513683255631027, -4.407301210706523e-05], [-4.4152529553054e-05, -4.407301210706523e-05, 0.00011554735538607565]]} + #*EXTRAS*# Step: 19 Bead: 15 +{"friction": [[0.00011562484531966278, -4.4440170092856075e-05, -4.4171684026850306e-05], [-4.4440170092856075e-05, 0.00011523088968546649, -4.408942736555049e-05], [-4.4171684026850306e-05, -4.408942736555049e-05, 0.00011564671654077228]]} + #*EXTRAS*# Step: 20 Bead: 15 +{"friction": [[0.00011571617302025789, -4.4461166129520405e-05, -4.4188360919499634e-05], [-4.4461166129520405e-05, 0.0001153169698431867, -4.4103592087117034e-05], [-4.4188360919499634e-05, -4.4103592087117034e-05, 0.00011573717393301113]]} + #*EXTRAS*# Step: 21 Bead: 15 +{"friction": [[0.00011579947439274807, -4.447930887375212e-05, -4.4202943786216355e-05], [-4.447930887375212e-05, 0.00011539587955328829, -4.4115869689297385e-05], [-4.4202943786216355e-05, -4.4115869689297385e-05, 0.00011581968690295247]]} + #*EXTRAS*# Step: 22 Bead: 15 +{"friction": [[0.00011587557764730116, -4.449503514742408e-05, -4.421574491281106e-05], [-4.449503514742408e-05, 0.00011546831046100785, -4.412655436523581e-05], [-4.421574491281106e-05, -4.412655436523581e-05, 0.00011589507435887457]]} + #*EXTRAS*# Step: 23 Bead: 15 +{"friction": [[0.00011594519706177471, -4.450870573735675e-05, -4.422702102231156e-05], [-4.450870573735675e-05, 0.0001155348626215392, -4.4135886550394264e-05], [-4.422702102231156e-05, -4.4135886550394264e-05, 0.0001159640426724252]]} + #*EXTRAS*# Step: 24 Bead: 15 +{"friction": [[0.00011600895439554875, -4.4520620671803464e-05, -4.423698496775611e-05], [-4.4520620671803464e-05, 0.00011559606196934362, -4.41440644003494e-05], [-4.423698496775611e-05, -4.41440644003494e-05, 0.00011602720681759612]]} + #*EXTRAS*# Step: 25 Bead: 15 +{"friction": [[0.00011606739532393004, -4.4531030936743826e-05, -4.4245814568660354e-05], [-4.4531030936743826e-05, 0.00011565237359480983, -4.415125243906922e-05], [-4.4245814568660354e-05, -4.415125243906922e-05, 0.00011608510659573453]]} + #*EXTRAS*# Step: 26 Bead: 15 +{"friction": [[0.00011612100220321597, -4.454014757959801e-05, -4.425365938102953e-05], [-4.454014757959801e-05, 0.00011570421195889767, -4.415758816613875e-05], [-4.425365938102953e-05, -4.415758816613875e-05, 0.00011613821923903676]]} + #*EXTRAS*# Step: 27 Bead: 15 +{"friction": [[0.00011617020410291505, -4.454814886809761e-05, -4.426064594994927e-05], [-4.454814886809761e-05, 0.0001157519488481037, -4.4163187169163425e-05], [-4.426064594994927e-05, -4.4163187169163425e-05, 0.00011618696931657183]]} + #*EXTRAS*# Step: 28 Bead: 15 +{"friction": [[0.00011621538477393464, -4.455518598025975e-05, -4.42668819311607e-05], [-4.455518598025975e-05, 0.00011579591963794912, -4.4168147124848764e-05], [-4.42668819311607e-05, -4.4168147124848764e-05, 0.00011623173660281609]]} + #*EXTRAS*# Step: 29 Bead: 15 +{"friction": [[0.0001162568890449437, -4.4561387571187995e-05, -4.427245935901929e-05], [-4.4561387571187995e-05, 0.00011583642828076177, -4.417255096323238e-05], [-4.427245935901929e-05, -4.417255096323238e-05, 0.00011627286239448222]]} + #*EXTRAS*# Step: 30 Bead: 15 +{"friction": [[0.00011629502801921822, -4.456686347189924e-05, -4.427745726346961e-05], [-4.456686347189924e-05, 0.00011587375133142305, -4.417646939483376e-05], [-4.427745726346961e-05, -4.417646939483376e-05, 0.00011631065464316028]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst1D.dat b/drivers/py/pes/friction/frictionH/120K/inst1D.dat new file mode 100644 index 000000000..1f3d8435a --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/inst1D.dat @@ -0,0 +1,16 @@ +2.540461685335739 0.14619035118482168 +2.540889201874614 0.14619070699962955 +2.541727677502115 0.14619091286669983 +2.5429446512904574 0.1461900516834462 +2.544493039798159 0.14618696880233711 +2.5463129920858996 0.14618049740360584 +2.5483342419943114 0.14616970302480536 +2.550478859856288 0.14615412201583527 +2.5526642868502076 0.1461339066076566 +2.554806530261252 0.14610987493352684 +2.5568233936762144 0.14608346566825425 +2.5586376170955685 0.14605659799922505 +2.5601798087781122 0.1460314573249148 +2.5613910616601223 0.1460102372726762 +2.562225161548596 0.14599487391951996 +2.562650311001014 0.14598680823928564 diff --git a/drivers/py/pes/friction/frictionH/120K/z_friction.dat b/drivers/py/pes/friction/frictionH/120K/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/drivers/py/pes/friction/frictionH/120K/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/drivers/py/pes/friction/onheH/060K/RESTART b/drivers/py/pes/friction/onheH/060K/RESTART new file mode 100644 index 000000000..3817a4203 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/RESTART @@ -0,0 +1,309 @@ + + + [ step, potential{electronvolt} ] + + 13 + 30 + + + + + + + + + 1.90008912e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 1.52256720e-03, 1.52268542e-03, 1.52293023e-03, 1.52331896e-03, 1.52387900e-03, + 1.52464951e-03, 1.52568398e-03, 1.52705357e-03, 1.52885149e-03, 1.53119871e-03, + 1.53425120e-03, 1.53820897e-03, 1.54332745e-03, 1.54993143e-03, 1.55843219e-03, + 1.56934802e-03, 1.58332877e-03, 1.60118429e-03, 1.62391688e-03, 1.65275689e-03, + 1.68919994e-03, 1.73504302e-03, 1.79241455e-03, 1.86379141e-03, 1.95199218e-03, + 2.06013228e-03, 2.19152155e-03, 2.34948106e-03, 2.53705233e-03, 2.75657290e-03, + 3.00909908e-03, 3.29367501e-03, 3.60625489e-03, 3.93773549e-03, 4.27354625e-03, + 4.59357104e-03, 4.87414452e-03, 5.10037162e-03, 5.26315169e-03, 5.35451351e-03, + 5.36798774e-03, 5.30515468e-03, 5.18087393e-03, 5.01208619e-03, 4.80667438e-03, + 4.56612240e-03, 4.29436737e-03, 4.00433381e-03, 3.71080420e-03, 3.42522528e-03, + 3.15579863e-03, 2.90710471e-03, 2.68132833e-03, 2.47940514e-03, 2.30133650e-03, + 2.14645873e-03, 2.01366321e-03, 1.90144267e-03, 1.80821862e-03, 1.73262306e-03, + 1.67351407e-03, 1.62997883e-03, 1.60133407e-03, 1.58712517e-03 ] + + + [ -2.13437291e-04, -1.70577631e-19, 6.06271585e-19, -2.16987992e-04, 7.87229546e-20, + 2.89359302e-19, -2.24142320e-04, -3.66086552e-20, 5.98871333e-20, -2.35006485e-04, + -8.96834346e-20, -1.84211791e-20, -2.49740673e-04, -2.29736508e-19, -3.05350296e-19, + -2.68560001e-04, -4.91468908e-19, -4.86174340e-19, -2.91735639e-04, -3.11592161e-19, + -3.30100319e-19, -3.19595949e-04, -1.97233829e-19, -1.65439430e-19, -3.52527429e-04, + -9.83494451e-20, -1.64554222e-19, -3.90975181e-04, -6.61421875e-20, -3.37654475e-20, + -4.35442511e-04, -6.64537826e-20, 6.47995202e-20, -4.86489151e-04, 1.60811506e-20, + 2.51332780e-19, -5.44727431e-04, -5.77516252e-20, 1.48759351e-19, -6.10815507e-04, + 6.42678112e-21, 9.57592509e-21, -6.85446509e-04, -1.31459848e-19, -3.51287341e-19, + -7.69332124e-04, -1.87478298e-19, -2.66980784e-19, -8.63178768e-04, -1.31292977e-19, + -2.93731553e-19, -9.67653978e-04, 1.15299762e-20, -1.72570698e-19, -1.08334012e-03, + -1.97864347e-21, 3.07200274e-20, -1.21067187e-03, -1.32216466e-19, 5.60802786e-20, + -1.34985321e-03, -2.38390128e-19, -2.99436676e-20, -1.50074904e-03, -1.22081864e-19, + -1.71458943e-21, -1.66274584e-03, -7.09982051e-20, -5.79473987e-21, -1.83457564e-03, + -5.02637871e-20, 1.91694974e-21, -2.01409773e-03, -2.71744661e-20, -9.60643548e-22, + -2.19803373e-03, -1.42422932e-21, 1.04678372e-20, -2.38165474e-03, 1.21815240e-21, + 5.45670496e-21, -2.55842459e-03, 1.99736338e-20, 1.12835564e-20, -2.71961216e-03, + -2.45022652e-21, 3.93950869e-21, -2.85390023e-03, 1.14998741e-20, 1.58389026e-21, + -2.94703878e-03, -4.45746460e-21, -5.25383913e-21, -2.98161892e-03, -4.09091164e-21, + -2.92321870e-21, -2.93907123e-03, -5.27510312e-23, 3.04498267e-21, -2.80972632e-03, + -1.98899146e-20, -2.61236673e-21, -2.59148181e-03, 3.34679419e-21, 4.12826901e-21, + -2.28923378e-03, -1.69605097e-20, 1.18238279e-21, -1.91457146e-03, 4.09268719e-21, + 5.50249023e-21, -1.47689125e-03, -5.49945712e-21, 2.55152535e-21, -9.86477095e-04, + -2.96308545e-21, -8.19942104e-21, -4.62601649e-04, 2.13529661e-20, -3.70546584e-21, + 6.64580154e-05, -6.69150933e-21, -9.44013190e-21, 5.76051562e-04, 2.45152488e-20, + 7.03827879e-21, 1.05315514e-03, -1.63317756e-20, -2.91631869e-21, 1.48750084e-03, + 7.89054108e-21, 5.25953928e-21, 1.86581711e-03, -1.01974911e-20, 2.04403444e-21, + 2.17454475e-03, -8.73724795e-21, -1.24264401e-21, 2.40638442e-03, 1.00863013e-20, + 1.06661591e-20, 2.56828152e-03, -2.29080297e-20, -1.43979877e-20, 2.67280351e-03, + 3.22884062e-20, 1.02627370e-20, 2.73153608e-03, -2.97893807e-20, -1.98107526e-20, + 2.75472265e-03, 3.58826849e-20, 2.12385986e-20, 2.75084135e-03, -3.27701674e-20, + -1.74397334e-20, 2.72695497e-03, 2.82355269e-20, 2.04973663e-20, 2.68909369e-03, + -2.88220081e-20, -1.76532065e-20, 2.64233152e-03, 2.09702896e-20, 1.46048521e-20, + 2.59087975e-03, -1.50386257e-20, -1.19729461e-20, 2.53819672e-03, 1.20417583e-20, + 9.72401358e-21, 2.48718989e-03, -8.02469731e-21, -9.70236653e-21, 2.44019193e-03, + 5.56859120e-21, 4.94244574e-21, 2.39893512e-03, -3.13122347e-21, -2.30305139e-21, + 2.36467732e-03, 1.08433355e-21, 4.64181643e-21, 2.33830678e-03, -3.18702951e-21, + -1.25426281e-21, 2.32042267e-03, -6.06611391e-22, -3.65539553e-22, 2.31139318e-03, + 2.33856944e-21, -8.26903829e-22 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] + + + [ 1.80810675e-02, 0.00000000e+00, 0.00000000e+00, 1.80707858e-02, 0.00000000e+00, + 0.00000000e+00, 1.80500435e-02, 0.00000000e+00, 0.00000000e+00, 1.80184794e-02, + 0.00000000e+00, 0.00000000e+00, 1.79755436e-02, 0.00000000e+00, 0.00000000e+00, + 1.79204879e-02, 0.00000000e+00, 0.00000000e+00, 1.78523516e-02, 0.00000000e+00, + 0.00000000e+00, 1.77699453e-02, 0.00000000e+00, 0.00000000e+00, 1.76718282e-02, + 0.00000000e+00, 0.00000000e+00, 1.75562830e-02, 0.00000000e+00, 0.00000000e+00, + 1.74212844e-02, 0.00000000e+00, 0.00000000e+00, 1.72644625e-02, 0.00000000e+00, + 0.00000000e+00, 1.70830596e-02, 0.00000000e+00, 0.00000000e+00, 1.68738805e-02, + 0.00000000e+00, 0.00000000e+00, 1.66332348e-02, 0.00000000e+00, 0.00000000e+00, + 1.63568704e-02, 0.00000000e+00, 0.00000000e+00, 1.60398981e-02, 0.00000000e+00, + 0.00000000e+00, 1.56767056e-02, 0.00000000e+00, 0.00000000e+00, 1.52608612e-02, + 0.00000000e+00, 0.00000000e+00, 1.47850068e-02, 0.00000000e+00, 0.00000000e+00, + 1.42407405e-02, 0.00000000e+00, 0.00000000e+00, 1.36184913e-02, 0.00000000e+00, + 0.00000000e+00, 1.29073882e-02, 0.00000000e+00, 0.00000000e+00, 1.20951310e-02, + 0.00000000e+00, 0.00000000e+00, 1.11678717e-02, 0.00000000e+00, 0.00000000e+00, + 1.01101212e-02, 0.00000000e+00, 0.00000000e+00, 8.90470512e-03, 0.00000000e+00, + 0.00000000e+00, 7.53279817e-03, 0.00000000e+00, 0.00000000e+00, 5.97408355e-03, + 0.00000000e+00, 0.00000000e+00, 4.20709454e-03, 0.00000000e+00, 0.00000000e+00, + 2.20981495e-03, 0.00000000e+00, 0.00000000e+00, -3.93694185e-05, 0.00000000e+00, + 0.00000000e+00, -2.37611224e-03, 0.00000000e+00, 0.00000000e+00, -4.52252479e-03, + 0.00000000e+00, 0.00000000e+00, -6.38799128e-03, 0.00000000e+00, 0.00000000e+00, + -7.87971916e-03, 0.00000000e+00, 0.00000000e+00, -9.02101367e-03, 0.00000000e+00, + 0.00000000e+00, -9.97227014e-03, 0.00000000e+00, 0.00000000e+00, -1.06817925e-02, + 0.00000000e+00, 0.00000000e+00, -1.09437948e-02, 0.00000000e+00, 0.00000000e+00, + -1.07106928e-02, 0.00000000e+00, 0.00000000e+00, -1.02216120e-02, 0.00000000e+00, + 0.00000000e+00, -9.59048387e-03, 0.00000000e+00, 0.00000000e+00, -8.79186846e-03, + 0.00000000e+00, 0.00000000e+00, -7.68096592e-03, 0.00000000e+00, 0.00000000e+00, + -6.28048728e-03, 0.00000000e+00, 0.00000000e+00, -4.75182024e-03, 0.00000000e+00, + 0.00000000e+00, -3.39119240e-03, 0.00000000e+00, 0.00000000e+00, -2.20045228e-03, + 0.00000000e+00, 0.00000000e+00, -1.16598512e-03, 0.00000000e+00, 0.00000000e+00, + -2.68370833e-04, 0.00000000e+00, 0.00000000e+00, 5.21465381e-04, 0.00000000e+00, + 0.00000000e+00, 1.21401114e-03, 0.00000000e+00, 0.00000000e+00, 1.81788565e-03, + 0.00000000e+00, 0.00000000e+00, 2.34117920e-03, 0.00000000e+00, 0.00000000e+00, + 2.79132140e-03, 0.00000000e+00, 0.00000000e+00, 3.17264015e-03, 0.00000000e+00, + 0.00000000e+00, 3.48148896e-03, 0.00000000e+00, 0.00000000e+00, 3.72684914e-03, + 0.00000000e+00, 0.00000000e+00, 3.91787688e-03, 0.00000000e+00, 0.00000000e+00, + 4.06202700e-03, 0.00000000e+00, 0.00000000e+00, 4.16514097e-03, 0.00000000e+00, + 0.00000000e+00, 4.23152531e-03, 0.00000000e+00, 0.00000000e+00, 4.26401446e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, + 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -4.81482486e-32, 5.51152161e-01, 0.00000000e+00, 2.40741243e-32, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.80555932e-32, + 5.51152161e-01, 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, + -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -7.52316385e-33, 5.51152161e-01, + 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -6.39468927e-33, + 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, + -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, -8.27548023e-33, 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.00926554e-33, + 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, + -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, 5.51152161e-01, + 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, + 5.51152161e-01, 0.00000000e+00, -6.77084746e-33, 5.51152161e-01, 0.00000000e+00, + -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, 5.51152161e-01, + 0.00000000e+00, -3.31783281e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, + 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, 5.51152161e-01, 0.00000000e+00, + -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, + 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, + 5.51152161e-01, 0.00000000e+00, -1.50463277e-33, 5.51152161e-01, 0.00000000e+00, + -6.77084746e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, + 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, + 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, + -5.26621469e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, + 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, + 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, + -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, + 0.00000000e+00, -9.02779661e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, + -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, + 0.00000000e+00, -3.76158192e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, + 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, 5.51152161e-01, 0.00000000e+00, + -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, 5.51152161e-01, + 0.00000000e+00, -3.33840396e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, + 5.51152161e-01 ] + + True + + + + + [ 1.87833334e+00, 3.09492810e-19, -1.10000763e-18, 1.87852977e+00, -1.42833432e-19, + -5.25008014e-19, 1.87892591e+00, 6.64220477e-20, -1.08658076e-19, 1.87952833e+00, + 1.62719918e-19, 3.34230370e-20, 1.88034703e+00, 4.16829551e-19, 5.54021771e-19, + 1.88139557e+00, 8.91711840e-19, 8.82105478e-19, 1.88269128e+00, 5.65346892e-19, + 5.98927742e-19, 1.88425549e+00, 3.57857309e-19, 3.00170156e-19, 1.88611383e+00, + 1.78443363e-19, 2.98564051e-19, 1.88829661e+00, 1.20007127e-19, 6.12633858e-20, + 1.89083922e+00, 1.20572479e-19, -1.17571017e-19, 1.89378259e+00, -2.91773338e-20, + -4.56013416e-19, 1.89717369e+00, 1.04783451e-19, -2.69906138e-19, 1.90106614e+00, + -1.16606295e-20, -1.73743764e-20, 1.90552074e+00, 2.38518247e-19, 6.37369071e-19, + 1.91060619e+00, 3.40157059e-19, 4.84404857e-19, 1.91639970e+00, 2.38215480e-19, + 5.32940944e-19, 1.92298764e+00, -2.09197696e-20, 3.13108993e-19, 1.93046617e+00, + 3.59001308e-21, -5.57378336e-20, 1.93894176e+00, 2.39891042e-19, -1.01750991e-19, + 1.94853161e+00, 4.32530515e-19, 5.43292211e-20, 1.95936382e+00, 2.21503012e-19, + 3.11091845e-21, 1.97157728e+00, 1.28817793e-19, 1.05138658e-20, 1.98532110e+00, + 9.11976595e-20, -3.47807716e-21, 2.00075343e+00, 4.93048344e-20, 1.74297339e-21, + 2.01803953e+00, 2.58409460e-21, -1.89926448e-20, 2.03734870e+00, -2.21019255e-21, + -9.90054170e-21, 2.05884997e+00, -3.62397814e-20, -2.04726702e-20, 2.08270609e+00, + 4.44564440e-21, -7.14776966e-21, 2.10906544e+00, -2.08651528e-20, -2.87378037e-21, + 2.13805170e+00, 8.08753900e-21, 9.53246582e-21, 2.16975066e+00, 7.42247228e-21, + 5.30383242e-21, 2.20419426e+00, 9.57104679e-23, -5.52475866e-21, 2.24134346e+00, + 3.60878829e-20, 4.73982851e-21, 2.28107934e+00, -6.07235974e-21, -7.49025279e-21, + 2.32320120e+00, 3.07728263e-20, -2.14529284e-21, 2.36743104e+00, -7.42569381e-21, + -9.98361363e-21, 2.41342420e+00, 9.97811042e-21, -4.62943908e-21, 2.46077805e+00, + 5.37616590e-21, 1.48768736e-20, 2.50904140e+00, -3.87424155e-20, 6.72312676e-21, + 2.55773228e+00, 1.21409473e-20, 1.71279958e-20, 2.60636390e+00, -4.44800013e-20, + -1.27701192e-20, 2.65446740e+00, 2.96320631e-20, 5.29131317e-21, 2.70160379e+00, + -1.43164477e-20, -9.54280805e-21, 2.74737339e+00, 1.85021340e-20, -3.70865722e-21, + 2.79142808e+00, 1.58526965e-20, 2.25462966e-21, 2.83348374e+00, -1.83003932e-20, + -1.93524762e-20, 2.87332701e+00, 4.15638934e-20, 2.61234351e-20, 2.91080887e+00, + -5.85834702e-20, -1.86205149e-20, 2.94583309e+00, 5.40492859e-20, 3.59442527e-20, + 2.97834557e+00, -6.51048611e-20, -3.85349094e-20, 3.00832493e+00, 5.94575685e-20, + 3.16423207e-20, 3.03577466e+00, -5.12300030e-20, -3.71900317e-20, 3.06071670e+00, + 5.22941034e-20, 3.20296422e-20, 3.08318583e+00, -3.80480947e-20, -2.64987659e-20, + 3.10322501e+00, 2.72857966e-20, 2.17234856e-20, 3.12088156e+00, -2.18483372e-20, + -1.76430653e-20, 3.13620389e+00, 1.45598582e-20, 1.76037893e-20, 3.14923890e+00, + -1.01035460e-20, -8.96747956e-21, 3.16002982e+00, 5.68123231e-21, 4.17861264e-21, + 3.16861456e+00, -1.96739418e-21, -8.42202345e-21, 3.17502463e+00, 5.78248573e-21, + 2.27571058e-21, 3.17928429e+00, 1.10062417e-21, 6.63228014e-22, 3.18140996e+00, + -4.24305591e-21, 1.50031858e-21 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/onheH/060K/clean.sh b/drivers/py/pes/friction/onheH/060K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/onheH/060K/control.in b/drivers/py/pes/friction/onheH/060K/control.in new file mode 100644 index 000000000..687e6ee90 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/control.in @@ -0,0 +1,181 @@ +# Physical settings +xc pbe +spin none +relativistic atomic_zora scalar +charge 0.0 +#vdw_correction_hirshfeld + +# k-grid settings (to be adjusted) +k_grid 12 12 12 + +# accuracy requirements +sc_iter_limit 200 +sc_init_iter 200 + +#Mixing settings + mixer pulay + n_max_pulay 10 + charge_mix_param 0.05 + + +# occupation gaussian broadening +occupation_type gaussian 0.1 + +final_forces_cleaned .true. +compute_forces .true. + + +# IPI + output_level MD_light +# use_pimd_wrapper localhost 41000 + use_pimd_wrapper drag092 41111 + +#=============================================================================== + +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for Pd atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species Pd +# global species definitions + nucleus 46 + mass 106.42 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 62 5.0 + radial_multiplier 2 + angular_grids specified + division 0.5211 50 + division 0.9161 110 + division 1.2296 194 + division 1.5678 302 +# division 1.9785 434 +# division 2.0474 590 +# division 2.1195 770 +# division 2.1568 974 +# division 2.7392 1202 +# outer_grid 974 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 5 s 1. + valence 4 p 6. + valence 4 d 9. +# ion occupancy + ion_occ 5 s 0. + ion_occ 4 p 6. + ion_occ 4 d 8. +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A +# +################################################################################ +# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV + ionic 5 p auto + hydro 4 f 8 +# hydro 5 g 10 + hydro 3 s 2.6 + hydro 3 d 2.5 +# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV +# hydro 5 f 17.2 +# hydro 6 h 14 +# hydro 4 d 4 +# hydro 5 f 7.6 +# hydro 3 p 3.3 +# hydro 4 s 9.4 +# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV +# hydro 4 f 20 +# hydro 5 g 12.8 +# hydro 5 d 9.8 +# hydro 6 h 15.2 +# hydro 5 s 10 +# hydro 6 p 9.8 +# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV +# hydro 5 f 9.2 +# hydro 2 s 5.6 +# hydro 5 f 43.2 +# hydro 5 d 13.2 +# hydro 5 g 14 +# hydro 4 p 4.7 +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for H atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species H +# global species definitions + nucleus 1 + mass 1.00794 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 24 5.0 + radial_multiplier 2 + angular_grids specified + division 0.2421 50 + division 0.3822 110 + division 0.4799 194 + division 0.5341 302 +# division 0.5626 434 +# division 0.5922 590 +# division 0.6542 770 +# division 0.6868 1202 +# outer_grid 770 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 1 s 1. +# ion occupancy + ion_occ 1 s 0.5 +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A +# +################################################################################ +# "First tier" - improvements: -1014.90 meV to -62.69 meV + hydro 2 s 2.1 + hydro 2 p 3.5 +# "Second tier" - improvements: -12.89 meV to -1.83 meV +# hydro 1 s 0.85 +# hydro 2 p 3.7 +# hydro 2 s 1.2 +# hydro 3 d 7 +# "Third tier" - improvements: -0.25 meV to -0.12 meV +# hydro 4 f 11.2 +# hydro 3 p 4.8 +# hydro 4 d 9 +# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/060K/geometry.in b/drivers/py/pes/friction/onheH/060K/geometry.in new file mode 100644 index 000000000..cd6ad1f1f --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/geometry.in @@ -0,0 +1,11 @@ +#=======================================# +# iterations/iteration0105/aims-chain-node-0.56500/geometry.in +#=======================================# +lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 +lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 +lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 +atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd +atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd +atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd +atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd +atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/060K/get1D.sh b/drivers/py/pes/friction/onheH/060K/get1D.sh new file mode 100755 index 000000000..152292560 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/get1D.sh @@ -0,0 +1,5 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 diff --git a/drivers/py/pes/friction/onheH/060K/hessian.dat b/drivers/py/pes/friction/onheH/060K/hessian.dat new file mode 100644 index 000000000..b7c4a075c --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/hessian.dat @@ -0,0 +1 @@ +1.378510022033408410e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.374149649158943470e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.365386164323188767e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.352133750286003099e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.334262841121765589e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.311599136371373493e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.283922326557654890e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.250964570367895864e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.212408781770814986e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.167886809118204652e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.116977619527808295e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.059205642513455330e-02 0.000000000000000000e+00 0.000000000000000000e+00 9.940394789238792342e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.208912470912980139e-03 0.000000000000000000e+00 0.000000000000000000e+00 8.391169197007053437e-03 0.000000000000000000e+00 0.000000000000000000e+00 7.480181041022698069e-03 0.000000000000000000e+00 0.000000000000000000e+00 6.468458364070799396e-03 0.000000000000000000e+00 0.000000000000000000e+00 5.348070950090709139e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.110748886856484957e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.748029305969009600e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.251460587409648079e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.856572806540479320e-04 0.000000000000000000e+00 0.000000000000000000e+00 -2.045253061764250313e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.624265238991826107e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.087272944572949693e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.397147251201249635e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.516221353232781580e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.419755849999087730e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.205605456844467155e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.891765945738735868e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.046411621116077016e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.083438326205651663e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094271005320850837e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.078186079621248905e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.045852056796305746e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.005739908480898434e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.582470944891540929e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.027644602088387427e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.311261768819506665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.429950574283877666e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.402668266896000340e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.280878871200076624e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.235299504634637557e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.285322439935869226e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.425974145285831121e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.651787645496867810e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.570280415647277467e-04 0.000000000000000000e+00 0.000000000000000000e+00 -3.319806470703911411e-04 0.000000000000000000e+00 0.000000000000000000e+00 2.354599461292655738e-04 0.000000000000000000e+00 0.000000000000000000e+00 7.490319701981655587e-04 0.000000000000000000e+00 0.000000000000000000e+00 1.212168733365171988e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.628156766571992042e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.000098758112630465e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.330887030369986276e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.623185465408864325e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.879418048553359158e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.100817716734189863e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.286142250638482767e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.438452727564343669e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.560803084098245266e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.655709148902988939e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.725163518119613271e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.770648486958304985e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.793146312772643566e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -3.761581922631320025e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.394689268473244043e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/init.xyz b/drivers/py/pes/friction/onheH/060K/init.xyz new file mode 100644 index 000000000..68ce56e03 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/init.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9564769528235888 -4.081266917441785e-20 2.7908590995563204e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9572334263205735 5.793139237674196e-19 2.4185003162589166e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.958751763695091 -1.1359567387731722e-19 3.155591492681714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9610427325580506 4.263983379745125e-19 5.047032241637723e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.964122449291171 -3.0677902327976046e-19 -4.650172702221773e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9680123308996569 -7.45538526892937e-20 -6.970257247008592e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9727390204616129 -3.808551907426885e-19 -1.0826990762924036e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9783342769467933 -3.0348861952035195e-19 -1.2358742897106272e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9848348174402097 -4.584095695768042e-19 -9.271971209596813e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.992282096803991 -1.5086226825266906e-19 -6.183559315633063e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0007220065116598 -6.156031683827155e-19 -4.634132022778111e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.010204470788343 -1.0480581203642447e-18 4.266881407114594e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0207829143103897 -1.3140177167600518e-18 7.245521823821627e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.032513571624667 -5.258368060764154e-19 9.405987362224346e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0454546042753683 -5.640551456381032e-19 1.6491301631013408e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.059664987584168 4.983155605782578e-19 -3.4250313702765564e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0752031254526586 4.67436026454736e-19 -2.845095461161012e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0921251489161405 9.110050220091565e-19 -6.180607952836432e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.110482853138887 6.3557012491399515e-19 -5.077314010018871e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1303212289824893 3.306162067628708e-19 -8.972585851203428e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1516755503443252 3.06529810397258e-19 1.0230296390897176e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.174567988550856 3.1634112764565127e-20 3.211158236815306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.1990037421619237 7.938725892671158e-20 4.764275669257918e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2249673020424345 -6.359958136967343e-20 -1.3487347900221808e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.2524204022209573 4.0368983843111056e-20 4.247511852849374e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.2813009397482813 -8.223640698136658e-20 -2.385478682073356e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3115228265771175 7.151344222945072e-20 2.265934918916512e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.342976946334549 -2.2465718725286376e-20 -6.026096826208427e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.3755333115441912 1.365798958746426e-19 -1.0922892997824771e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4090432941993125 1.5421807062298458e-20 -7.603164867851816e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4433411330757084 1.2263465489498636e-19 -1.4644186229431397e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4782459771560252 -1.3111974826278987e-20 -5.459195156603685e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5135650638013027 8.593769432463794e-20 1.8351203506167365e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.5490989536591657 -1.376732419270732e-20 -1.17665121469279e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.5846474722769193 6.89376852033929e-20 4.485389457303741e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6200151047052884 -2.974868320905954e-20 -7.041753229592538e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.6550139581737247 1.7207084550365028e-20 8.204738077442038e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.689466031649674 -5.0994329962374406e-20 -1.3743625254957537e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7232052107021776 -1.915821745618279e-20 9.992582484315834e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7560798156790374 -3.508406739959154e-20 -1.232616938052844e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.7879556560926417 -2.6694536815958284e-21 -1.3907961273724353e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8187183738450803 1.0055554470722832e-21 -1.6001873827387636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.848274886621655 1.2119052308771354e-20 1.1243050791743687e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8765524574110763 1.2822923481728442e-20 3.1870319452721283e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9034960916674586 -1.1583124770536357e-20 2.3594503082335707e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9290659974092295 -7.968957792852064e-21 1.5564002084628535e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9532352140127287 -3.729091858099146e-21 -1.6708185489246323e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9759874394174197 -1.5155235662274669e-21 -2.0160886778735562e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.997315082213753 1.2243512419222811e-20 -7.785392353887547e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0172176036086396 3.3528726826537933e-21 3.079652244187743e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0357000656683986 8.646308670597711e-21 9.952897799961877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.052771838413057 -9.995445386668589e-21 -7.35603676816985e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0684454585289456 8.897607318654096e-21 -2.2618389133440714e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0827356301736373 -1.7577403791920215e-20 -2.6072419043289368e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0956583569753633 9.135256775001372e-21 1.7420561007689692e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.107230193751229 -7.915614285908413e-21 8.11223834059773e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1174676064867515 1.0705356297191669e-20 5.7106549073573374e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1263864287271423 -4.738709226491207e-21 -1.3325369170643531e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1340013932700996 8.819486705005479e-21 -5.913187693657786e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1403257436809935 -5.116068399802934e-21 -6.03541893106877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1453709279398856 4.66690879611828e-21 1.4256347447713127e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.149146361861662 -4.713953894693887e-21 -5.082605521005283e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1516592519153455 -2.4143343021733654e-21 4.162980272149272e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.15291446930372 1.702097554911546e-22 4.571800149560974e-21 diff --git a/drivers/py/pes/friction/onheH/060K/input.xml b/drivers/py/pes/friction/onheH/060K/input.xml new file mode 100644 index 000000000..dbb51f72f --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/input.xml @@ -0,0 +1,37 @@ + + + [ step, potential{electronvolt}] + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + + + 60 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + true + 0.1 + + + +
diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 new file mode 100644 index 000000000..5c2737e3d --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 @@ -0,0 +1 @@ +1.506227006934168430e-02 -3.425936022842994169e-32 1.370374409137197668e-31 1.502767670138223030e-02 3.401686353053557653e-32 -1.823960511020674335e-34 1.495810121059897545e-02 0.000000000000000000e+00 -3.354228097608541053e-32 1.485276099866961533e-02 -1.715690642156499444e-34 -1.647063016470239398e-32 1.471046941194160268e-02 -2.575080792162824633e-31 3.214760963532369835e-32 1.452962034275445680e-02 3.088365813366071594e-34 -1.930228633353794746e-35 1.430816756398415462e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.404359872097630559e-02 -2.913997943048781120e-32 -1.339769169217830286e-34 1.373290394037445829e-02 0.000000000000000000e+00 -1.391806197733385137e-32 1.337253909596743638e-02 -1.130995630957285661e-34 -2.657839732749621187e-32 1.295838391687817448e-02 -2.063558310876674737e-34 -5.117624610974152937e-32 1.248569535866733173e-02 -4.861124450080682964e-32 9.384410135290893443e-35 1.194905701734108421e-02 -4.260512473609739461e-35 -4.652479621181835266e-32 1.134232589454333556e-02 -7.734167019506621626e-35 3.093666807802648650e-34 1.065857857656206907e-02 -1.405329041396741492e-34 -4.230040414604191704e-32 9.890059942571405999e-03 -2.002733963911398812e-32 1.599627766702395199e-35 9.028138956149914240e-03 -2.339181047300820208e-34 -3.836256917573345004e-32 8.063278020693778400e-03 0.000000000000000000e+00 -2.309995188448496655e-33 6.985024904269959527e-03 0.000000000000000000e+00 8.892026910113234684e-33 5.782039468999978712e-03 -3.445799978918764312e-32 -3.705161267654585562e-34 4.442171450410847475e-03 3.488990675909715679e-34 0.000000000000000000e+00 2.952624329058926422e-03 0.000000000000000000e+00 1.612490047844318588e-32 1.312344508970641251e-03 -3.180915037563134205e-32 8.032613731220035353e-35 -4.381717768554087809e-04 7.890519662171125457e-35 0.000000000000000000e+00 -2.230703661009506358e-03 3.948123075355810602e-33 9.870307688389526025e-36 -3.966035024629116154e-03 -1.008583304500015817e-35 3.104545484164111282e-35 -5.550567176402747618e-03 -8.143758935879853827e-33 -2.041214189239315418e-33 -6.928750979738668679e-03 1.055855394199086599e-33 0.000000000000000000e+00 -8.073784189370946524e-03 -2.501959195243057480e-35 2.220488785778213453e-33 -9.014653348233103020e-03 -4.744697981254628996e-33 3.570126396730345581e-36 -9.810373894349215182e-03 0.000000000000000000e+00 -1.295118217920219888e-33 -1.044993019304902432e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.084155897170733726e-02 -1.646147591016451566e-33 -1.074228394033184229e-37 -1.090039892658436864e-02 -1.562052545041772714e-32 -3.905735498025626725e-33 -1.064447307719057143e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.023251204423378247e-02 -3.357307061109203154e-36 1.627034934490047644e-33 -9.720712298700280932e-03 1.988467846443171235e-32 9.785766960842378581e-37 -9.109679760563109754e-03 4.374272417570274520e-36 -6.568243427007865426e-34 -8.300584906976833655e-03 0.000000000000000000e+00 -1.694127082748360209e-33 -7.269569097051605498e-03 -1.298026380528296206e-35 2.262622234558386403e-33 -6.043448758650506875e-03 0.000000000000000000e+00 3.683864272723515900e-36 -4.766978636912596289e-03 -2.674039966316875204e-32 3.342549957896094005e-33 -3.610983712974477101e-03 -1.713106407937711159e-35 -2.676728762402673686e-37 -2.574576607046632007e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.650144039495938294e-03 -2.197541465015040773e-36 -2.329393952915943086e-34 -8.277487326243680764e-04 6.618517316167119220e-33 1.656369212668532299e-33 -9.145350364914422037e-05 1.206076294130375192e-32 4.711235523946778094e-35 5.710604402621225189e-04 -1.967607902828418533e-35 2.459509878535523166e-36 1.166518357509653894e-03 0.000000000000000000e+00 1.306090230549346235e-33 1.700025733985569129e-03 3.097276987432112332e-35 1.235039198738554800e-33 2.176432038955953760e-03 1.888036838019580200e-32 0.000000000000000000e+00 2.598490483436719650e-03 1.813613839154938619e-32 5.675721520443395122e-34 2.966872718701811344e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.284070774204726414e-03 -2.323035862692772347e-35 0.000000000000000000e+00 3.553850267842143321e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.780570836528641520e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.968768429152299757e-03 -5.174324058341501658e-36 -3.233952536463438536e-37 4.123080034052132962e-03 -5.041147939460656966e-36 -1.246108756285431235e-34 4.247772627206324557e-03 1.976666357603309228e-33 -7.711713317740750984e-38 4.346420792367636926e-03 0.000000000000000000e+00 -4.889410545885136790e-34 4.421938339607826493e-03 -1.197612235187371759e-36 1.214079403421198123e-34 4.476613052322547283e-03 4.834405809294092505e-34 4.840337595563164884e-34 4.512135239064637461e-03 7.369203729012634514e-38 0.000000000000000000e+00 4.529619522664536137e-03 0.000000000000000000e+00 9.615543789726310105e-34 -3.425936022842994169e-32 5.511521610893899137e-01 7.034880654628458492e-34 3.401686353053557653e-32 5.511521610893899137e-01 6.022463092658234147e-34 0.000000000000000000e+00 5.511521610893899137e-01 5.272711987855515804e-34 -1.715690642156499444e-34 5.511521610893899137e-01 -1.553724899105315985e-34 -2.575080792162824633e-31 5.511521610893899137e-01 8.684328578386033194e-34 3.088365813366071594e-34 5.511521610893899137e-01 1.592196964609921784e-34 0.000000000000000000e+00 5.511521610893899137e-01 1.363280259728783207e-33 -2.913997943048781120e-32 5.511521610893899137e-01 -2.580929346232268245e-34 0.000000000000000000e+00 5.511521610893899137e-01 -5.595253927394622821e-36 -1.130995630957285661e-34 5.511521610893899137e-01 1.898820418319370078e-34 -2.063558310876674737e-34 5.511521610893899137e-01 -4.966807357747377228e-34 -4.861124450080682964e-32 5.511521610893899137e-01 2.885063682391402880e-34 -4.260512473609739461e-35 5.511521610893899137e-01 -1.728168662566742781e-34 -7.734167019506621626e-35 5.511521610893899137e-01 4.158769826582580269e-34 -1.405329041396741492e-34 5.511521610893899137e-01 -5.093362408750378646e-34 -2.002733963911398812e-32 5.511521610893899137e-01 -1.694644554233883970e-35 -2.339181047300820208e-34 5.511521610893899137e-01 5.760081881009954932e-34 0.000000000000000000e+00 5.511521610893899137e-01 8.343692044762322778e-35 0.000000000000000000e+00 5.511521610893899137e-01 -2.928085215119096584e-35 -3.445799978918764312e-32 5.511521610893899137e-01 -7.412021787651107749e-34 3.488990675909715679e-34 5.511521610893899137e-01 9.409280717399915955e-34 0.000000000000000000e+00 5.511521610893899137e-01 5.173677025347640048e-34 -3.180915037563134205e-32 5.511521610893899137e-01 1.558102331723709920e-34 7.890519662171125457e-35 5.511521610893899137e-01 2.903126592608412800e-35 3.948123075355810602e-33 5.511521610893899137e-01 5.248973699356195156e-36 -1.008583304500015817e-35 5.511521610893899137e-01 -1.748397566974016790e-38 -8.143758935879853827e-33 5.511521610893899137e-01 -2.763384442020469118e-36 1.055855394199086599e-33 5.511521610893899137e-01 -7.304638524574063352e-37 -2.501959195243057480e-35 5.511521610893899137e-01 -3.581690987099461043e-36 -4.744697981254628996e-33 5.511521610893899137e-01 -7.324051961639652751e-37 0.000000000000000000e+00 5.511521610893899137e-01 -8.974131286115321801e-37 0.000000000000000000e+00 5.511521610893899137e-01 -3.081907946609472917e-37 -1.646147591016451566e-33 5.511521610893899137e-01 1.813017515127337424e-38 -1.562052545041772714e-32 5.511521610893899137e-01 -4.280018714947023860e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.639044046427557461e-37 -3.357307061109203154e-36 5.511521610893899137e-01 -4.370620437321199212e-37 1.988467846443171235e-32 5.511521610893899137e-01 -7.992799118463532479e-37 4.374272417570274520e-36 5.511521610893899137e-01 1.545765674080682600e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.947678798218874966e-37 -1.298026380528296206e-35 5.511521610893899137e-01 2.670429232782507366e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.116237809925155111e-35 -2.674039966316875204e-32 5.511521610893899137e-01 3.920738665697954181e-36 -1.713106407937711159e-35 5.511521610893899137e-01 -2.783967620646281251e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.125424220083700766e-36 -2.197541465015040773e-36 5.511521610893899137e-01 6.308962015599689956e-38 6.618517316167119220e-33 5.511521610893899137e-01 7.086274291962006260e-37 1.206076294130375192e-32 5.511521610893899137e-01 5.635743381882329130e-38 -1.967607902828418533e-35 5.511521610893899137e-01 2.359624974774508700e-36 0.000000000000000000e+00 5.511521610893899137e-01 3.788139762956023868e-36 3.097276987432112332e-35 5.511521610893899137e-01 3.480337289587597326e-36 1.888036838019580200e-32 5.511521610893899137e-01 3.492997718346034772e-36 1.813613839154938619e-32 5.511521610893899137e-01 1.519472190048699872e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.583351468789963563e-36 -2.323035862692772347e-35 5.511521610893899137e-01 1.878795810963495899e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.092505530570360165e-36 0.000000000000000000e+00 5.511521610893899137e-01 -8.284462195105786532e-38 -5.174324058341501658e-36 5.511521610893899137e-01 1.244997923489414768e-37 -5.041147939460656966e-36 5.511521610893899137e-01 4.388095839287971764e-38 1.976666357603309228e-33 5.511521610893899137e-01 1.333451384229864514e-38 0.000000000000000000e+00 5.511521610893899137e-01 7.221152015534320527e-38 -1.197612235187371759e-36 5.511521610893899137e-01 -7.029920874323088627e-39 4.834405809294092505e-34 5.511521610893899137e-01 -2.182287488826882183e-38 7.369203729012634514e-38 5.511521610893899137e-01 2.057188518507853134e-39 0.000000000000000000e+00 5.511521610893899137e-01 -1.244729013371577066e-38 1.370374409137197668e-31 -5.315043010747265935e-33 5.511521610893899137e-01 -1.823960511020674335e-34 -4.754600230041507171e-32 5.511521610893899137e-01 -3.354228097608541053e-32 -5.491259877424560204e-33 5.511521610893899137e-01 -1.647063016470239398e-32 -1.553724899105315985e-34 5.511521610893899137e-01 3.214760963532369835e-32 8.684328578386033194e-34 5.511521610893899137e-01 -1.930228633353794746e-35 -5.859311379749120162e-33 5.511521610893899137e-01 0.000000000000000000e+00 1.363280259728783207e-33 5.511521610893899137e-01 -1.339769169217830286e-34 -2.580929346232268245e-34 5.511521610893899137e-01 -1.391806197733385137e-32 -5.595253927394622821e-36 5.511521610893899137e-01 -2.657839732749621187e-32 1.898820418319370078e-34 5.511521610893899137e-01 -5.117624610974152937e-32 -2.457080504061518537e-32 5.511521610893899137e-01 9.384410135290893443e-35 2.885063682391402880e-34 5.511521610893899137e-01 -4.652479621181835266e-32 -1.728168662566742781e-34 5.511521610893899137e-01 3.093666807802648650e-34 4.158769826582580269e-34 5.511521610893899137e-01 -4.230040414604191704e-32 -2.458346054571548671e-32 5.511521610893899137e-01 1.599627766702395199e-35 -4.816519505522323298e-32 5.511521610893899137e-01 -3.836256917573345004e-32 -4.757224042157990331e-32 5.511521610893899137e-01 -2.309995188448496655e-33 8.343692044762322778e-35 5.511521610893899137e-01 8.892026910113234684e-33 2.404484345268925835e-32 5.511521610893899137e-01 -3.705161267654585562e-34 1.129585997365511331e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.297799022416021636e-32 5.511521610893899137e-01 1.612490047844318588e-32 -9.872650665177640909e-34 5.511521610893899137e-01 8.032613731220035353e-35 -2.853455304932685007e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.989499810284027779e-33 5.511521610893899137e-01 9.870307688389526025e-36 -4.508649333458227785e-33 5.511521610893899137e-01 3.104545484164111282e-35 -3.009283022080725843e-33 5.511521610893899137e-01 -2.041214189239315418e-33 -3.012028922547076381e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.505363232904985390e-33 5.511521610893899137e-01 2.220488785778213453e-33 -1.204064384340732409e-32 5.511521610893899137e-01 3.570126396730345581e-36 -3.762314327827483788e-33 5.511521610893899137e-01 -1.295118217920219888e-33 -1.203795956554883561e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.514206497952244782e-33 5.511521610893899137e-01 -1.074228394033184229e-37 -6.018512946034960550e-33 5.511521610893899137e-01 -3.905735498025626725e-33 -5.266642693555342602e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009101633700413357e-33 5.511521610893899137e-01 1.627034934490047644e-33 -1.505069831096260175e-33 5.511521610893899137e-01 9.785766960842378581e-37 -5.267013971595694290e-33 5.511521610893899137e-01 -6.568243427007865426e-34 -3.009110961537647872e-33 5.511521610893899137e-01 -1.694127082748360209e-33 -5.266019923804026256e-33 5.511521610893899137e-01 2.262622234558386403e-33 -4.511227877924801483e-33 5.511521610893899137e-01 3.683864272723515900e-36 -3.280221804203153303e-33 5.511521610893899137e-01 3.342549957896094005e-33 -3.287463443636707164e-33 5.511521610893899137e-01 -2.676728762402673686e-37 -6.394967665235309304e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.265089267463764460e-33 5.511521610893899137e-01 -2.329393952915943086e-34 -4.889993409800559745e-33 5.511521610893899137e-01 1.656369212668532299e-33 -3.384715102938991710e-33 5.511521610893899137e-01 4.711235523946778094e-35 -3.197288276802803183e-33 5.511521610893899137e-01 2.459509878535523166e-36 -3.289024557327630401e-33 5.511521610893899137e-01 1.306090230549346235e-33 -6.767059320973420383e-33 5.511521610893899137e-01 1.235039198738554800e-33 -3.193864296947034472e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.886563501702369887e-33 5.511521610893899137e-01 5.675721520443395122e-34 -4.888537027230667298e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.888473147951925948e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.007386742294092587e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.888963993890145432e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890139344042667412e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.385299230575839311e-33 5.511521610893899137e-01 -1.246108756285431235e-34 -6.770803579777983743e-33 5.511521610893899137e-01 -7.711713317740750984e-38 -4.890043164906873414e-33 5.511521610893899137e-01 -4.889410545885136790e-34 -3.197272422716466807e-33 5.511521610893899137e-01 1.214079403421198123e-34 -3.385430760289062257e-33 5.511521610893899137e-01 4.840337595563164884e-34 -6.582790187479697990e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291382125113886581e-33 5.511521610893899137e-01 9.615543789726310105e-34 -3.314906516608984654e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 new file mode 100644 index 000000000..1cd035ee4 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 @@ -0,0 +1 @@ +1.728120619390645374e-02 -3.542738869274355092e-32 -2.063629275944806903e-31 1.726190828369338071e-02 3.401686353053557653e-32 -1.823960511020674335e-34 1.722299240960656341e-02 -3.375035431197975981e-31 5.083360480386398351e-32 1.716381173905208099e-02 -1.243199416152717293e-31 -1.647063016470239398e-32 1.708337905923526523e-02 2.270655704591035201e-31 3.214760963532369835e-32 1.698034599777839548e-02 -3.914555591392588862e-32 -9.934848170807599477e-34 1.685297461084935347e-02 7.584282830077568691e-32 3.020068245380212957e-31 1.669910073242517751e-02 -1.015540585470740966e-31 -7.254805603350806548e-32 1.651608832957153841e-02 0.000000000000000000e+00 2.108009668548692463e-32 1.630077396930475556e-02 -1.342045419382843246e-31 3.993801553493286858e-32 1.604940038411482167e-02 3.181384509744293486e-32 1.222375172874906666e-32 1.575753804399471908e-02 1.155374385689681745e-32 -7.462936287325012831e-33 1.541999363254347062e-02 1.427948362909960750e-32 1.256006704479162178e-31 1.503070442905433089e-02 1.565211922236584275e-34 1.088217348430684805e-31 1.458261788575629381e-02 2.789384104313185699e-34 3.164452352567590235e-32 1.406755626047747829e-02 4.415570276478289644e-33 6.173729352556617726e-33 1.347606716419970721e-02 -4.644592117609538137e-32 5.372412307596528467e-32 1.279726251341044285e-02 6.061104415617773346e-34 4.132995660399947178e-32 1.201865091559647589e-02 0.000000000000000000e+00 -3.314871614980337452e-32 1.112597232812429990e-02 -1.134415308057596725e-31 -2.345104402179759659e-33 1.010304937573192584e-02 3.488990675909715679e-34 8.970013099046606808e-34 8.931677532289853533e-03 0.000000000000000000e+00 1.612490047844318588e-32 7.591591555858014095e-03 2.929500813919224937e-33 8.032613731220035353e-35 6.060952442666531562e-03 -9.659518447048637078e-35 0.000000000000000000e+00 4.317062163020816447e-03 1.203381764684610519e-32 -8.075824263801903757e-33 2.338509408897714199e-03 -1.008583304500015817e-35 3.104545484164111282e-35 1.546067783415620497e-04 7.328078595823150219e-33 -1.358154784384526569e-34 -2.114438086211452641e-03 -2.780958166884859142e-33 3.874429380310258942e-33 -4.283305343024701797e-03 -6.292370407290400383e-35 2.684270115738322081e-34 -6.181183632586233212e-03 -7.995050266326074964e-34 3.929232422827554127e-33 -7.724840751389351959e-03 0.000000000000000000e+00 9.656319980370172886e-34 -8.935143516086353765e-03 -2.097290439145297018e-33 2.623707546707065725e-33 -9.903979045288509309e-03 -1.658600071468264730e-33 2.817171747158474427e-37 -1.060849997745690228e-02 3.393254932848490570e-33 8.468145789440409533e-34 -1.089402305441272180e-02 4.260663671260588839e-36 -1.065165917815147210e-36 -1.070037223650031032e-02 -3.357307061109203154e-36 1.849795887944143741e-34 -1.021385585321613575e-02 -3.046708926272669735e-33 3.276891061082424354e-33 -9.574406308410530336e-03 7.645184831520068991e-33 -4.477229622252036282e-33 -8.747242064948817716e-03 0.000000000000000000e+00 3.269586879210648575e-35 -7.595928811011507138e-03 -1.298026380528296206e-35 5.160718709323466272e-33 -6.129162338357456268e-03 0.000000000000000000e+00 -1.554413684609571447e-32 -4.550480677541271328e-03 -1.197339955402505454e-31 3.342549957896094005e-33 -3.142324311591399542e-03 -8.810722339412769790e-32 -1.946778018444609176e-35 -1.904651036943976567e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.245578081357268080e-04 1.727255188071653879e-32 -2.804627774709108475e-34 1.264071584710107663e-04 6.700546260675067372e-33 -1.446231838314319496e-32 9.724840589708151238e-04 1.206076294130375192e-32 2.162076698056672865e-32 1.722589814379883255e-03 6.656060198206126988e-32 -4.100020164959082116e-35 2.385452976668203922e-03 1.186440986346068982e-34 1.246768181232042828e-33 2.968247540530983934e-03 -1.462804315209311135e-34 1.279352499087367786e-33 3.463483364020931293e-03 1.873954462970553758e-32 3.520593762256636289e-35 3.869420800861308844e-03 9.500179401581342541e-32 5.383234246378463570e-34 4.198701782568560296e-03 0.000000000000000000e+00 -1.779611191907839282e-32 4.463598035149346152e-03 -1.119522922310912564e-34 0.000000000000000000e+00 4.674828526784226279e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.841667455245108123e-03 3.667870844758556595e-35 -9.169677111896391488e-36 4.972061408482619967e-03 -5.174324058341501658e-36 -3.233952536463438536e-37 5.072649649892250513e-03 -2.113138846585561356e-35 3.439377400967939512e-33 5.148730287624611428e-03 -1.511491206001795706e-33 3.756023046608422268e-36 5.204891056665827097e-03 0.000000000000000000e+00 -4.889410545885136790e-34 5.245050063922449164e-03 5.961872011150859766e-36 -2.996592268956474661e-34 5.272378926540109700e-03 4.843162144919647471e-34 -7.628684335226933339e-34 5.289268068113470340e-03 5.053045552096236127e-37 -1.726450071677988945e-36 5.297313545334941809e-03 0.000000000000000000e+00 -6.841801237134676918e-34 -3.542738869274355092e-32 5.511521610893899137e-01 2.845974148209923387e-32 3.401686353053557653e-32 5.511521610893899137e-01 1.183807063212349168e-32 -3.375035431197975981e-31 5.511521610893899137e-01 9.808970414423777389e-33 -1.243199416152717293e-31 5.511521610893899137e-01 5.086845686046830215e-34 2.270655704591035201e-31 5.511521610893899137e-01 6.406765915486485673e-33 -3.914555591392588862e-32 5.511521610893899137e-01 -2.310055997093402660e-33 7.584282830077568691e-32 5.511521610893899137e-01 2.711043080274167995e-33 -1.015540585470740966e-31 5.511521610893899137e-01 -1.555839978484002212e-33 0.000000000000000000e+00 5.511521610893899137e-01 -3.310983082790151904e-34 -1.342045419382843246e-31 5.511521610893899137e-01 -1.481596832967081230e-33 3.181384509744293486e-32 5.511521610893899137e-01 9.805988219435624130e-34 1.155374385689681745e-32 5.511521610893899137e-01 2.001781829487448464e-34 1.427948362909960750e-32 5.511521610893899137e-01 -6.580166507506179208e-34 1.565211922236584275e-34 5.511521610893899137e-01 2.696988908566534161e-33 2.789384104313185699e-34 5.511521610893899137e-01 -4.064959508186727256e-34 4.415570276478289644e-33 5.511521610893899137e-01 -7.249958804972652658e-35 -4.644592117609538137e-32 5.511521610893899137e-01 3.576679181544805411e-34 6.061104415617773346e-34 5.511521610893899137e-01 -2.437915145419918380e-33 0.000000000000000000e+00 5.511521610893899137e-01 3.031155048292435097e-33 -1.134415308057596725e-31 5.511521610893899137e-01 5.911842207738938141e-33 3.488990675909715679e-34 5.511521610893899137e-01 1.258439885868115363e-32 0.000000000000000000e+00 5.511521610893899137e-01 4.404268178175266599e-33 2.929500813919224937e-33 5.511521610893899137e-01 1.393843602264355920e-33 -9.659518447048637078e-35 5.511521610893899137e-01 3.053499287626638697e-34 1.203381764684610519e-32 5.511521610893899137e-01 6.539085139435131510e-35 -1.008583304500015817e-35 5.511521610893899137e-01 -3.691597531308812644e-36 7.328078595823150219e-33 5.511521610893899137e-01 -2.097641747006767341e-35 -2.780958166884859142e-33 5.511521610893899137e-01 1.126561099554825961e-35 -6.292370407290400383e-35 5.511521610893899137e-01 -1.031718664242702187e-35 -7.995050266326074964e-34 5.511521610893899137e-01 4.635630054135295272e-36 0.000000000000000000e+00 5.511521610893899137e-01 -8.929239576824547324e-37 -2.097290439145297018e-33 5.511521610893899137e-01 -4.796431318285689994e-37 -1.658600071468264730e-33 5.511521610893899137e-01 2.011818038456673966e-37 3.393254932848490570e-33 5.511521610893899137e-01 -5.213400928487227977e-38 4.260663671260588839e-36 5.511521610893899137e-01 -8.667351589518109023e-37 -3.357307061109203154e-36 5.511521610893899137e-01 -1.522176210570282207e-36 -3.046708926272669735e-33 5.511521610893899137e-01 -1.637885368649847761e-36 7.645184831520068991e-33 5.511521610893899137e-01 1.282352124838609119e-36 0.000000000000000000e+00 5.511521610893899137e-01 4.761811945169089374e-37 -1.298026380528296206e-35 5.511521610893899137e-01 -2.477074469114290914e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.074528240036378698e-36 -1.197339955402505454e-31 5.511521610893899137e-01 1.530342359834450166e-35 -8.810722339412769790e-32 5.511521610893899137e-01 1.395017083016023053e-34 0.000000000000000000e+00 5.511521610893899137e-01 8.656802974935791080e-33 1.727255188071653879e-32 5.511521610893899137e-01 -3.490939748843842644e-35 6.700546260675067372e-33 5.511521610893899137e-01 6.083862849624305299e-35 1.206076294130375192e-32 5.511521610893899137e-01 1.563043018266323453e-34 6.656060198206126988e-32 5.511521610893899137e-01 2.246345322342294802e-34 1.186440986346068982e-34 5.511521610893899137e-01 2.418713794591359511e-34 -1.462804315209311135e-34 5.511521610893899137e-01 2.604463121916524957e-34 1.873954462970553758e-32 5.511521610893899137e-01 2.091269583398447926e-34 9.500179401581342541e-32 5.511521610893899137e-01 1.503751390040286969e-34 0.000000000000000000e+00 5.511521610893899137e-01 1.150909755925890029e-34 -1.119522922310912564e-34 5.511521610893899137e-01 7.606216786905653783e-35 0.000000000000000000e+00 5.511521610893899137e-01 3.868287627436741770e-35 3.667870844758556595e-35 5.511521610893899137e-01 1.854525477146529574e-35 -5.174324058341501658e-36 5.511521610893899137e-01 1.399529440311034911e-35 -2.113138846585561356e-35 5.511521610893899137e-01 3.477894856789226509e-36 -1.511491206001795706e-33 5.511521610893899137e-01 8.457691109422172818e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.735818218614457499e-36 5.961872011150859766e-36 5.511521610893899137e-01 8.612245989066594577e-38 4.843162144919647471e-34 5.511521610893899137e-01 1.227138284483865207e-39 5.053045552096236127e-37 5.511521610893899137e-01 4.114837214437934287e-38 0.000000000000000000e+00 5.511521610893899137e-01 6.527259308142098534e-38 -2.063629275944806903e-31 2.244121040588912456e-32 5.511521610893899137e-01 -1.823960511020674335e-34 -3.631017797755740464e-32 5.511521610893899137e-01 5.083360480386398351e-32 3.790439338213665348e-33 5.511521610893899137e-01 -1.647063016470239398e-32 5.086845686046830215e-34 5.511521610893899137e-01 3.214760963532369835e-32 6.406765915486485673e-33 5.511521610893899137e-01 -9.934848170807599477e-34 -8.328587073303515043e-33 5.511521610893899137e-01 3.020068245380212957e-31 2.711043080274167995e-33 5.511521610893899137e-01 -7.254805603350806548e-32 -1.555839978484002212e-33 5.511521610893899137e-01 2.108009668548692463e-32 -3.310983082790151904e-34 5.511521610893899137e-01 3.993801553493286858e-32 -1.481596832967081230e-33 5.511521610893899137e-01 1.222375172874906666e-32 -2.309352548289688507e-32 5.511521610893899137e-01 -7.462936287325012831e-33 2.001781829487448464e-34 5.511521610893899137e-01 1.256006704479162178e-31 -6.580166507506179208e-34 5.511521610893899137e-01 1.088217348430684805e-31 2.696988908566534161e-33 5.511521610893899137e-01 3.164452352567590235e-32 -2.448062025565912063e-32 5.511521610893899137e-01 6.173729352556617726e-33 -4.822074819773062061e-32 5.511521610893899137e-01 5.372412307596528467e-32 -4.779058069152641899e-32 5.511521610893899137e-01 4.132995660399947178e-32 -2.437915145419918380e-33 5.511521610893899137e-01 -3.314871614980337452e-32 2.710527935313288189e-32 5.511521610893899137e-01 -2.345104402179759659e-33 1.794890436015916359e-32 5.511521610893899137e-01 8.970013099046606808e-34 2.462146101110138045e-32 5.511521610893899137e-01 1.612490047844318588e-32 2.899635409122738589e-33 5.511521610893899137e-01 8.032613731220035353e-35 -1.615421935840700100e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.713181147447448043e-33 5.511521610893899137e-01 -8.075824263801903757e-33 -4.448507455763232854e-33 5.511521610893899137e-01 3.104545484164111282e-35 -3.012957135636364800e-33 5.511521610893899137e-01 -1.358154784384526569e-34 -3.030241955575123721e-33 5.511521610893899137e-01 3.874429380310258942e-33 -1.493367158056979788e-33 5.511521610893899137e-01 2.684270115738322081e-34 -1.204737933906265137e-32 5.511521610893899137e-01 3.929232422827554127e-33 -3.756946292577184782e-33 5.511521610893899137e-01 9.656319980370172886e-34 -1.203795507637790592e-32 5.511521610893899137e-01 2.623707546707065725e-33 -4.514377950289412616e-33 5.511521610893899137e-01 2.817171747158474427e-37 -6.018329894406266118e-33 5.511521610893899137e-01 8.468145789440409533e-34 -5.266266825693132590e-33 5.511521610893899137e-01 -1.065165917815147210e-36 -3.010132273264007946e-33 5.511521610893899137e-01 1.849795887944143741e-34 -1.506154945263098384e-33 5.511521610893899137e-01 3.276891061082424354e-33 -5.267852577052497827e-33 5.511521610893899137e-01 -4.477229622252036282e-33 -3.007983185980217336e-33 5.511521610893899137e-01 3.269586879210648575e-35 -5.265738510489331570e-33 5.511521610893899137e-01 5.160718709323466272e-33 -4.514146014604495384e-33 5.511521610893899137e-01 -1.554413684609571447e-32 -3.290309654062368275e-33 5.511521610893899137e-01 3.342549957896094005e-33 -3.276080758704060430e-33 5.511521610893899137e-01 -1.946778018444609176e-35 -6.255187560171642957e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.390588283251943044e-33 5.511521610893899137e-01 -2.804627774709108475e-34 -4.924965896909154411e-33 5.511521610893899137e-01 -1.446231838314319496e-32 -3.324585101871944799e-33 5.511521610893899137e-01 2.162076698056672865e-32 -3.041040332409989548e-33 5.511521610893899137e-01 -4.100020164959082116e-35 -3.066749650068175457e-33 5.511521610893899137e-01 1.246768181232042828e-33 -6.528976081277240993e-33 5.511521610893899137e-01 1.279352499087367786e-33 -2.936898322044969611e-33 5.511521610893899137e-01 3.520593762256636289e-35 -4.680929541080871027e-33 5.511521610893899137e-01 5.383234246378463570e-34 -4.739681360416687379e-33 5.511521610893899137e-01 -1.779611191907839282e-32 -4.774965523828126902e-33 5.511521610893899137e-01 0.000000000000000000e+00 -2.933203370235999568e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.851373623146348423e-33 5.511521610893899137e-01 -9.169677111896391488e-36 -4.871511244649250922e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.371428435965078219e-33 5.511521610893899137e-01 3.439377400967939512e-33 -6.767369565879586943e-33 5.511521610893899137e-01 3.756023046608422268e-36 -4.889210730309773783e-33 5.511521610893899137e-01 -4.889410545885136790e-34 -3.195608816018007455e-33 5.511521610893899137e-01 -2.996592268956474661e-34 -3.385337607908297476e-33 5.511521610893899137e-01 -7.628684335226933339e-34 -6.582767137466525564e-33 5.511521610893899137e-01 -1.726450071677988945e-36 -3.291343033930260993e-33 5.511521610893899137e-01 -6.841801237134676918e-34 -3.314828796725769578e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 new file mode 100644 index 000000000..e9cc9e8ad --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 @@ -0,0 +1 @@ +1.807662116346134967e-02 3.164087156628939504e-31 -1.633434488660336739e-30 1.806625868490087383e-02 -1.085177402730688066e-30 -3.226443523490898253e-30 1.804535322851988713e-02 3.543751496778853165e-31 1.872996459437099683e-31 1.801354055310852922e-02 -2.688696798746614423e-30 3.927707757456414859e-30 1.797026613278851145e-02 -7.008030484572618691e-32 1.115107960831865645e-31 1.791477518303168787e-02 5.503944078191396923e-31 4.120484283053314901e-31 1.784609906784695443e-02 -8.514420401935630375e-31 -1.476804827316818698e-30 1.776303783039119913e-02 1.794332681167508319e-31 2.247206098713937892e-31 1.766413851358830320e-02 -5.681895945623271615e-32 7.849521353568395954e-33 1.754766886655685643e-02 2.386405059475222744e-31 1.325538945151555855e-32 1.741158595133916395e-02 -1.287141234869270892e-31 -8.066475638589354568e-32 1.725349908068764954e-02 -1.721020222363038698e-31 2.349298806889960130e-31 1.707062644091276310e-02 -1.593607132994180941e-30 7.020652028459235777e-31 1.685974467252692940e-02 -6.128475234436036736e-32 -4.200343067810369111e-31 1.661713062326950624e-02 -9.265647227757254475e-31 9.240359461569142922e-31 1.633849445088169164e-02 -2.962330518146786986e-32 4.663521481165233462e-31 1.601890326888725721e-02 -2.025209179592617023e-32 -1.681391503196031743e-31 1.565269462199747955e-02 1.192254554813799353e-30 -8.769109520231000651e-33 1.523337930290643953e-02 -2.196649816182515576e-31 -1.797211333297436084e-31 1.475353344194707365e-02 7.182646886513290429e-33 6.213757404568850101e-31 1.420468051919606539e-02 5.760457034663925865e-31 -2.471986719052780083e-32 1.357716509835260772e-02 8.886840178566166225e-32 2.796153290459943396e-31 1.286002185300457595e-02 4.250487804384383034e-32 -1.789690272568214350e-32 1.204084609213827185e-02 2.389923208440380923e-33 1.643402474908239138e-32 1.110567581212736250e-02 -1.343346034488042710e-33 -9.716741310014274257e-35 1.003890068287666658e-02 3.580908177937360760e-33 -3.070865982252067423e-33 8.823220746538041129e-03 -4.231153308533512797e-33 -7.368300405582650670e-34 7.439687378049326602e-03 -2.615634003300615308e-32 1.804036459908213617e-34 5.867871510747562497e-03 -1.145697898623915686e-32 -1.429969374971154658e-32 4.086219201034677062e-03 -2.586770821341835067e-33 -5.793325363106860298e-33 2.072671522343479990e-03 -2.714472459481445071e-33 -5.983234717341650964e-35 -1.943301428610652538e-04 4.364828264905785795e-33 -6.379949195047204859e-33 -2.522900199108353298e-03 5.058170564180594619e-33 1.523114619859653715e-34 -4.654628855234116229e-03 -7.563361636010057075e-34 -1.738589300108749537e-33 -6.499151941018628358e-03 2.027358810256903635e-33 5.535739266042202676e-34 -7.963541136812359381e-03 -4.453577401150869010e-34 -4.183270911100182673e-34 -9.091014769496964104e-03 3.625286767107592387e-33 2.119924900926689598e-33 -1.002912314298475688e-02 8.117848115817957424e-33 -2.717898365592131047e-33 -1.071535521933834369e-02 -1.489711957138894375e-33 1.527523580936962022e-33 -1.094340768136065414e-02 -2.260998548010460752e-33 -2.000405003634025794e-33 -1.068139216269998158e-02 2.202525955196679834e-33 -5.259197251956479527e-34 -1.018162866523230140e-02 2.717541467462236649e-33 -2.459378625932372757e-33 -9.540234830633593024e-03 -1.609377956175339294e-33 -1.300110261878807407e-33 -8.722009664728382766e-03 -1.134677965359366717e-32 1.029429459866732799e-33 -7.586964263465604229e-03 1.622107356915102752e-33 4.858616868190341274e-34 -6.164876687500073921e-03 2.227444846913826618e-34 4.326676239137077823e-34 -4.641006316885080279e-03 -6.974255266373161154e-34 -3.640728615636350653e-33 -3.291456588225678565e-03 1.220862751365442332e-33 5.208516986718054924e-33 -2.111041386981096172e-03 -3.070621989745760526e-33 -5.660787037112491821e-34 -1.086039395631184946e-03 -3.990061490866478591e-33 4.559203738450610561e-33 -1.956182906113430376e-04 7.236292230237556541e-34 -7.458223354219071687e-33 5.882818317652856220e-04 -4.548845259825297636e-33 3.829379978604814926e-33 1.275495760500583052e-03 8.840782518357675480e-33 7.844439867260642662e-34 1.874629561658635235e-03 2.592600399940473664e-33 -1.735572245668321533e-32 2.393750128099486358e-03 -1.317025969628458420e-32 7.642477992654330315e-33 2.840257706827205384e-03 -8.951878579547795097e-34 2.366366155393414663e-34 3.217232157070671131e-03 1.024008328502186040e-33 4.733625503408135770e-34 3.521710645887283705e-03 2.814435943849740853e-35 1.307272369824395214e-33 3.763489673766458061e-03 -5.830181313208050816e-33 1.089590271795947122e-33 3.951650395040713810e-03 1.533383441508987127e-36 -6.457978647149066464e-34 4.093584046955925197e-03 1.419060325234624282e-33 -2.503974908514965981e-34 4.195080777651336024e-03 -4.986826270073553557e-33 1.271011556946934550e-34 4.260408451665708557e-03 1.424401468998474442e-34 1.328261862783616291e-34 4.292375711879439261e-03 -2.846866755351295910e-33 2.406196339113465262e-33 3.164087156628939504e-31 5.511521610893899137e-01 4.109099409034863354e-29 -1.085177402730688066e-30 5.511521610893899137e-01 2.884516053272865121e-29 3.543751496778853165e-31 5.511521610893899137e-01 -3.470970858216986142e-28 -2.688696798746614423e-30 5.511521610893899137e-01 -2.481093667383957773e-29 -7.008030484572618691e-32 5.511521610893899137e-01 -4.762632913372167944e-29 5.503944078191396923e-31 5.511521610893899137e-01 -1.223719799011351399e-30 -8.514420401935630375e-31 5.511521610893899137e-01 -2.349250725256108953e-31 1.794332681167508319e-31 5.511521610893899137e-01 -2.632295029854413973e-31 -5.681895945623271615e-32 5.511521610893899137e-01 -6.853875300571520784e-32 2.386405059475222744e-31 5.511521610893899137e-01 5.042636366005646363e-32 -1.287141234869270892e-31 5.511521610893899137e-01 6.659160334961256299e-33 -1.721020222363038698e-31 5.511521610893899137e-01 -4.952225321441334376e-32 -1.593607132994180941e-30 5.511521610893899137e-01 -2.274496159051381277e-31 -6.128475234436036736e-32 5.511521610893899137e-01 -2.934756400891602520e-32 -9.265647227757254475e-31 5.511521610893899137e-01 -4.597268208559428753e-32 -2.962330518146786986e-32 5.511521610893899137e-01 -3.059256171910973785e-32 -2.025209179592617023e-32 5.511521610893899137e-01 8.182649255080780921e-32 1.192254554813799353e-30 5.511521610893899137e-01 -4.423114634736851793e-34 -2.196649816182515576e-31 5.511521610893899137e-01 6.276196472814834536e-32 7.182646886513290429e-33 5.511521610893899137e-01 2.297253242164015091e-31 5.760457034663925865e-31 5.511521610893899137e-01 3.951560921186745574e-31 8.886840178566166225e-32 5.511521610893899137e-01 1.700032004436945594e-31 4.250487804384383034e-32 5.511521610893899137e-01 1.108494471384979388e-30 2.389923208440380923e-33 5.511521610893899137e-01 4.836273720504902666e-32 -1.343346034488042710e-33 5.511521610893899137e-01 7.626666602919988734e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.338390184150765363e-33 -4.231153308533512797e-33 5.511521610893899137e-01 -7.610496118856242256e-34 -2.615634003300615308e-32 5.511521610893899137e-01 3.799637646121936530e-34 -1.145697898623915686e-32 5.511521610893899137e-01 -6.894616178699667280e-35 -2.586770821341835067e-33 5.511521610893899137e-01 1.979372363168888232e-34 -2.714472459481445071e-33 5.511521610893899137e-01 -3.213086025265911031e-37 4.364828264905785795e-33 5.511521610893899137e-01 -3.836623248938668840e-36 5.058170564180594619e-33 5.511521610893899137e-01 1.024661732475899459e-36 -7.563361636010057075e-34 5.511521610893899137e-01 -6.807464439994498325e-36 2.027358810256903635e-33 5.511521610893899137e-01 4.627783997385413790e-36 -4.453577401150869010e-34 5.511521610893899137e-01 -2.103444186160364319e-36 3.625286767107592387e-33 5.511521610893899137e-01 -1.942304565660424427e-36 8.117848115817957424e-33 5.511521610893899137e-01 7.781665070946366210e-37 -1.489711957138894375e-33 5.511521610893899137e-01 -1.052205865854580907e-36 -2.260998548010460752e-33 5.511521610893899137e-01 -1.004959322465592115e-36 2.202525955196679834e-33 5.511521610893899137e-01 -1.873117496633209190e-35 2.717541467462236649e-33 5.511521610893899137e-01 -5.530421987235179704e-36 -1.609377956175339294e-33 5.511521610893899137e-01 1.273250780154655654e-34 -1.134677965359366717e-32 5.511521610893899137e-01 8.634172227514183218e-33 1.622107356915102752e-33 5.511521610893899137e-01 -3.510223057793875360e-35 2.227444846913826618e-34 5.511521610893899137e-01 6.116654138661856436e-35 -6.974255266373161154e-34 5.511521610893899137e-01 1.491778143599704412e-34 1.220862751365442332e-33 5.511521610893899137e-01 1.813544644578465992e-34 -3.070621989745760526e-33 5.511521610893899137e-01 2.014139643065488961e-34 -3.990061490866478591e-33 5.511521610893899137e-01 1.891346900461419465e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.103436512901035678e-34 -4.548845259825297636e-33 5.511521610893899137e-01 6.840215552815010651e-35 8.840782518357675480e-33 5.511521610893899137e-01 3.994529136422151354e-35 2.592600399940473664e-33 5.511521610893899137e-01 1.217128198741814571e-35 -1.317025969628458420e-32 5.511521610893899137e-01 -5.014994547500942282e-36 -8.951878579547795097e-34 5.511521610893899137e-01 -6.269868642228042143e-36 1.024008328502186040e-33 5.511521610893899137e-01 -3.577806068910826536e-36 2.814435943849740853e-35 5.511521610893899137e-01 -5.447816640424803865e-36 -5.830181313208050816e-33 5.511521610893899137e-01 -2.839984405307110264e-36 1.533383441508987127e-36 5.511521610893899137e-01 1.090474688602002585e-37 1.419060325234624282e-33 5.511521610893899137e-01 -9.755592473335495052e-37 -4.986826270073553557e-33 5.511521610893899137e-01 1.350119804441656505e-37 1.424401468998474442e-34 5.511521610893899137e-01 -1.279882245548657912e-37 -2.846866755351295910e-33 5.511521610893899137e-01 1.806043725779841565e-37 -1.633434488660336739e-30 4.108497555927242343e-29 5.511521610893899137e-01 -3.226443523490898253e-30 2.879701228411897031e-29 5.511521610893899137e-01 1.872996459437099683e-31 -3.471031043527748243e-28 5.511521610893899137e-01 3.927707757456414859e-30 -2.481093667383957773e-29 5.511521610893899137e-01 1.115107960831865645e-31 -4.762632913372167944e-29 5.511521610893899137e-01 4.120484283053314901e-31 -1.229738330087561511e-30 5.511521610893899137e-01 -1.476804827316818698e-30 -2.349250725256108953e-31 5.511521610893899137e-01 2.247206098713937892e-31 -2.632295029854413973e-31 5.511521610893899137e-01 7.849521353568395954e-33 -6.853875300571520784e-32 5.511521610893899137e-01 1.325538945151555855e-32 5.042636366005646363e-32 5.511521610893899137e-01 -8.066475638589354568e-32 -1.741496396987918913e-32 5.511521610893899137e-01 2.349298806889960130e-31 -4.952225321441334376e-32 5.511521610893899137e-01 7.020652028459235777e-31 -2.274496159051381277e-31 5.511521610893899137e-01 -4.200343067810369111e-31 -2.934756400891602520e-32 5.511521610893899137e-01 9.240359461569142922e-31 -7.004680639043472474e-32 5.511521610893899137e-01 4.663521481165233462e-31 -7.874081032879063418e-32 5.511521610893899137e-01 -1.681391503196031743e-31 3.367824394112691835e-32 5.511521610893899137e-01 -8.769109520231000651e-33 -4.423114634736851793e-34 5.511521610893899137e-01 -1.797211333297436084e-31 8.683608903298879352e-32 5.511521610893899137e-01 6.213757404568850101e-31 2.417623863688217332e-31 5.511521610893899137e-01 -2.471986719052780083e-32 4.071931542710947815e-31 5.511521610893899137e-01 2.796153290459943396e-31 1.684985676746420314e-31 5.511521610893899137e-01 -1.789690272568214350e-32 1.105485205846874332e-30 5.511521610893899137e-01 1.643402474908239138e-32 4.234420612883892009e-32 5.511521610893899137e-01 -9.716741310014274257e-35 -3.751231646865585072e-33 5.511521610893899137e-01 -3.070865982252067423e-33 -4.347655722255821212e-33 5.511521610893899137e-01 -7.368300405582650670e-34 -3.770315149990679562e-33 5.511521610893899137e-01 1.804036459908213617e-34 -1.124669004440334571e-33 5.511521610893899137e-01 -1.429969374971154658e-32 -1.210600831420722146e-32 5.511521610893899137e-01 -5.793325363106860298e-33 -3.563644686314430433e-33 5.511521610893899137e-01 -5.983234717341650964e-35 -1.203738346102274991e-32 5.511521610893899137e-01 -6.379949195047204859e-33 -4.517734930406522923e-33 5.511521610893899137e-01 1.523114619859653715e-34 -6.017506414477635352e-33 5.511521610893899137e-01 -1.738589300108749537e-33 -5.273022156123841947e-33 5.511521610893899137e-01 5.535739266042202676e-34 -3.004637754107670971e-33 5.511521610893899137e-01 -4.183270911100182673e-34 -1.506736213238688689e-33 5.511521610893899137e-01 2.119924900926689598e-33 -5.268156996249509145e-33 5.511521610893899137e-01 -2.717898365592131047e-33 -3.008487371597961645e-33 5.511521610893899137e-01 1.527523580936962022e-33 -5.267266897549702856e-33 5.511521610893899137e-01 -2.000405003634025794e-33 -4.514903266480049337e-33 5.511521610893899137e-01 -5.259197251956479527e-34 -3.310115357268737133e-33 5.511521610893899137e-01 -2.459378625932372757e-33 -3.296914604289640174e-33 5.511521610893899137e-01 -1.300110261878807407e-33 -6.267364190457779761e-33 5.511521610893899137e-01 1.029429459866732799e-33 3.367957535830335866e-33 5.511521610893899137e-01 4.858616868190341274e-34 -4.925158729998654530e-33 5.511521610893899137e-01 4.326676239137077823e-34 -3.324257188981569779e-33 5.511521610893899137e-01 -3.640728615636350653e-33 -3.048166819876651089e-33 5.511521610893899137e-01 5.208516986718054924e-33 -3.110029717844558316e-33 5.511521610893899137e-01 -5.660787037112491821e-34 -6.569433496429826637e-33 5.511521610893899137e-01 4.559203738450610561e-33 -3.008209944190480268e-33 5.511521610893899137e-01 -7.458223354219071687e-33 -4.779712848130612850e-33 5.511521610893899137e-01 3.829379978604814926e-33 -4.821654343892565552e-33 5.511521610893899137e-01 7.844439867260642662e-34 -4.850111208056493643e-33 5.511521610893899137e-01 -1.735572245668321533e-32 -2.997094256117638043e-33 5.511521610893899137e-01 7.642477992654330315e-33 -4.895071493968217538e-33 5.511521610893899137e-01 2.366366155393414663e-34 -4.896326368062944781e-33 5.511521610893899137e-01 4.733625503408135770e-34 -3.389001536437099113e-33 5.511521610893899137e-01 1.307272369824395214e-33 -6.776295277376799899e-33 5.511521610893899137e-01 1.089590271795947122e-33 -4.892896483826023436e-33 5.511521610893899137e-01 -6.457978647149066464e-34 -3.197235586767761803e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386399289615522745e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582633352624366177e-33 5.511521610893899137e-01 1.328261862783616291e-34 -3.291512170526960564e-33 5.511521610893899137e-01 2.406196339113465262e-33 -3.314713464946271998e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 new file mode 100644 index 000000000..0ea30ab3b --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 @@ -0,0 +1 @@ +1.807898350714676888e-02 3.164087156628939504e-31 -1.633416496230578585e-30 1.806866389922883245e-02 -1.085177402730688066e-30 7.494088202208559875e-30 1.804784499167345208e-02 2.943044193935160955e-30 1.872996459437099683e-31 1.801616417618827001e-02 -2.278206731471931115e-31 -3.454891334876421243e-30 1.797306941594462026e-02 -7.008030484572618691e-32 1.115099924708597682e-31 1.791780932057515999e-02 5.503833975358133052e-31 4.120484283053314901e-31 1.784941962268379173e-02 3.695619536574259089e-31 4.768020242409573290e-31 1.776670579353104712e-02 1.794294696845283279e-31 2.247187106552825263e-31 1.766822147182208619e-02 -2.101806029569568146e-33 2.074234920256048739e-31 1.755224230196259991e-02 -1.187850347705862894e-31 1.325044731024847447e-32 1.741673469743295136e-02 -1.287101969013600634e-31 -8.066475638589354568e-32 1.725931896381768457e-02 -1.721020222363038698e-31 -4.804142943019735722e-32 1.707722613804758816e-02 4.116877284934018868e-31 -3.005530599726098366e-31 1.686724782032753694e-02 8.251569118972100076e-31 2.447893419825505980e-31 1.662567821338048132e-02 7.609687442100940499e-31 1.414146485298581983e-31 1.634824755155716430e-02 1.005944810315200055e-30 -9.143991931157246912e-31 1.603004610967478927e-02 -2.025567551320680311e-32 -7.768693676076753072e-31 1.566543807725627457e-02 2.530543625126067272e-31 -8.769109520231000651e-33 1.524796480067974573e-02 -2.196476517008808955e-31 -2.245449536730418452e-33 1.477023730992070051e-02 -2.015985131611327998e-31 -4.964367134765074798e-33 1.422381875179584004e-02 2.300798361201171004e-32 -2.470934956624849824e-32 1.359909848579154978e-02 8.888483632181468455e-32 -4.627330560025812967e-32 1.288516134240549546e-02 4.250165951709050658e-32 -1.789851198905880538e-32 1.206965814923045659e-02 6.631065550615756620e-32 1.643402474908239138e-32 1.113868739941329539e-02 -1.343346034488042710e-33 -9.616964867105549433e-35 1.007670325726365765e-02 3.580908177937360760e-33 -3.070865982252067423e-33 8.866472384362347747e-03 -4.229893178473325927e-33 -7.361999755281718030e-34 7.489111744779660372e-03 1.619718331321312422e-33 1.805299369667113984e-34 5.924251894328687665e-03 6.696194665165440143e-33 -6.844055379998046559e-34 4.150385225814744866e-03 -2.586770821341835067e-33 2.398552610057406280e-33 2.145475490328964049e-03 5.357086373903222994e-34 -9.884652779971463384e-34 -1.120783082218002215e-04 4.368465893632683552e-33 2.089587240147885982e-33 -2.445235779882755194e-03 5.058170564180594619e-33 -1.402848117749616632e-33 -4.584788167742536238e-03 6.825148071867091987e-34 -1.738753346508337810e-33 -6.440457486830632357e-03 1.276574816793747093e-32 5.535739266042202676e-34 -7.919385956839759474e-03 -4.453577401150869010e-34 3.372078172375365935e-33 -9.054011913773633846e-03 -1.174948634616024770e-33 2.120153114076909274e-33 -9.999107882856590052e-03 -1.029060331883910940e-32 -7.044674351065770787e-34 -1.069785569919829045e-02 -1.489711957138894375e-33 -4.039535033038970226e-33 -1.094393474885496653e-02 2.089652448082430309e-33 7.187547979216128924e-34 -1.069703533453243531e-02 2.202525955196679834e-33 -5.258286148275195376e-34 -1.020294051514731085e-02 2.716820413326428725e-33 2.873582828387489556e-33 -9.566992572270992604e-03 -1.608652823422668247e-33 -1.299928978690639645e-33 -8.759327159946159527e-03 5.946702174264974085e-33 -3.294218693997060108e-33 -7.637082461672707774e-03 -2.778551053935280230e-33 -6.412473127051169994e-35 -6.226448781884301106e-03 7.861099026261541842e-34 4.322652918887588653e-34 -4.699717127279229648e-03 -9.976743568455591432e-33 1.000210075867870935e-33 -3.344295178355856726e-03 1.220862751365442332e-33 -7.986782734950020645e-33 -2.158407565926498579e-03 -3.070621989745760526e-33 1.922579448072465519e-33 -1.128389263014817215e-03 -2.468750614516272360e-32 4.559203738450610561e-33 -2.341799836408455827e-04 7.236292230237556541e-34 1.678038997592667629e-32 5.528662103220083465e-04 -4.546350488607981187e-33 -1.781984181944427226e-33 1.242905872204948551e-03 8.838074892674237372e-33 7.841055335156345027e-34 1.844552064814121038e-03 2.591133048841808798e-33 1.307493830297766321e-32 2.365884115890789108e-03 3.745365848506935549e-32 -5.013699835248945461e-33 2.814317849649910098e-03 -8.943337308632567126e-34 1.008685729852643024e-32 3.193632196235244268e-03 1.024008328502186040e-33 4.733625503408135770e-34 3.500425995620083490e-03 2.765695988467439920e-35 1.307028670047483771e-33 3.744102214241160857e-03 -5.830181313208050816e-33 3.795026811194313807e-33 3.933781778921634567e-03 1.398170179618489839e-36 -6.458654713458518731e-34 4.076889628583571686e-03 1.419200972308698315e-33 1.633921684055722715e-33 4.179243107111789077e-03 -1.161109502551565378e-33 -3.511043810920364783e-34 4.245130555095284579e-03 1.424401468998474442e-34 -2.294988601259996621e-34 4.277374284242677592e-03 1.037791607864249507e-33 -2.935218250943761834e-33 3.164087156628939504e-31 5.511521610893899137e-01 4.109657743165264764e-29 -1.085177402730688066e-30 5.511521610893899137e-01 2.885145373872302969e-29 2.943044193935160955e-30 5.511521610893899137e-01 -3.470945509031821367e-28 -2.278206731471931115e-31 5.511521610893899137e-01 -2.480857242293348698e-29 -7.008030484572618691e-32 5.511521610893899137e-01 -4.762611114854708221e-29 5.503833975358133052e-31 5.511521610893899137e-01 -1.223087042232672510e-30 3.695619536574259089e-31 5.511521610893899137e-01 -2.349192607244107049e-31 1.794294696845283279e-31 5.511521610893899137e-01 -2.633386978933868415e-31 -2.101806029569568146e-33 5.511521610893899137e-01 -6.853875663589955556e-32 -1.187850347705862894e-31 5.511521610893899137e-01 5.020390860180797741e-32 -1.287101969013600634e-31 5.511521610893899137e-01 6.705522407871147028e-33 -1.721020222363038698e-31 5.511521610893899137e-01 -4.946977979766468472e-32 4.116877284934018868e-31 5.511521610893899137e-01 -2.285123633122857078e-31 8.251569118972100076e-31 5.511521610893899137e-01 -2.932005168519828988e-32 7.609687442100940499e-31 5.511521610893899137e-01 -4.595746991405747641e-32 1.005944810315200055e-30 5.511521610893899137e-01 -3.103556214498266342e-32 -2.025567551320680311e-32 5.511521610893899137e-01 8.200659092102597744e-32 2.530543625126067272e-31 5.511521610893899137e-01 -5.648955651447502683e-34 -2.196476517008808955e-31 5.511521610893899137e-01 6.277576031198777625e-32 -2.015985131611327998e-31 5.511521610893899137e-01 2.297416258213689087e-31 2.300798361201171004e-32 5.511521610893899137e-01 3.950100225522453649e-31 8.888483632181468455e-32 5.511521610893899137e-01 1.699388288588661400e-31 4.250165951709050658e-32 5.511521610893899137e-01 1.108483037972520292e-30 6.631065550615756620e-32 5.511521610893899137e-01 4.835133363197374688e-32 -1.343346034488042710e-33 5.511521610893899137e-01 7.614278649692538268e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.340520585744010067e-33 -4.229893178473325927e-33 5.511521610893899137e-01 -7.620634576702095600e-34 1.619718331321312422e-33 5.511521610893899137e-01 3.799501454021552274e-34 6.696194665165440143e-33 5.511521610893899137e-01 -6.844469744338379922e-35 -2.586770821341835067e-33 5.511521610893899137e-01 1.972319209519752623e-34 5.357086373903222994e-34 5.511521610893899137e-01 -3.187551514779025548e-37 4.368465893632683552e-33 5.511521610893899137e-01 -3.559780924178211243e-36 5.058170564180594619e-33 5.511521610893899137e-01 1.185501001400141567e-36 6.825148071867091987e-34 5.511521610893899137e-01 -6.782731506363316528e-36 1.276574816793747093e-32 5.511521610893899137e-01 4.057262763278559551e-36 -4.453577401150869010e-34 5.511521610893899137e-01 -2.066384445995679206e-36 -1.174948634616024770e-33 5.511521610893899137e-01 -2.016992308839736954e-36 -1.029060331883910940e-32 5.511521610893899137e-01 7.897034933096438817e-37 -1.489711957138894375e-33 5.511521610893899137e-01 -1.043001572900672219e-36 2.089652448082430309e-33 5.511521610893899137e-01 -1.005124041821692210e-36 2.202525955196679834e-33 5.511521610893899137e-01 -1.864850531132053407e-35 2.716820413326428725e-33 5.511521610893899137e-01 -5.558882078715272679e-36 -1.608652823422668247e-33 5.511521610893899137e-01 1.275054062324360197e-34 5.946702174264974085e-33 5.511521610893899137e-01 8.634235909547083279e-33 -2.778551053935280230e-33 5.511521610893899137e-01 -3.513139224067612572e-35 7.861099026261541842e-34 5.511521610893899137e-01 6.116757199542155306e-35 -9.976743568455591432e-33 5.511521610893899137e-01 1.493682528374880229e-34 1.220862751365442332e-33 5.511521610893899137e-01 1.814495738953533586e-34 -3.070621989745760526e-33 5.511521610893899137e-01 2.019104036917194080e-34 -2.468750614516272360e-32 5.511521610893899137e-01 1.900263619891314077e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.108566490758971427e-34 -4.546350488607981187e-33 5.511521610893899137e-01 6.929884466890864023e-35 8.838074892674237372e-33 5.511521610893899137e-01 4.071152385272870367e-35 2.591133048841808798e-33 5.511521610893899137e-01 1.280970066895145672e-35 3.745365848506935549e-32 5.511521610893899137e-01 -4.466079480629635055e-36 -8.943337308632567126e-34 5.511521610893899137e-01 -5.987062872395923697e-36 1.024008328502186040e-33 5.511521610893899137e-01 -3.487730966093527857e-36 2.765695988467439920e-35 5.511521610893899137e-01 -5.314315827064846505e-36 -5.830181313208050816e-33 5.511521610893899137e-01 -2.815436833467863152e-36 1.398170179618489839e-36 5.511521610893899137e-01 1.226775310931167321e-37 1.419200972308698315e-33 5.511521610893899137e-01 -9.607600860769337638e-37 -1.161109502551565378e-33 5.511521610893899137e-01 1.318364315615816114e-37 1.424401468998474442e-34 5.511521610893899137e-01 -1.281081110800922931e-37 1.037791607864249507e-33 5.511521610893899137e-01 1.803045135776986878e-37 -1.633416496230578585e-30 4.109055890057643752e-29 5.511521610893899137e-01 7.494088202208559875e-30 2.880330549011334879e-29 5.511521610893899137e-01 1.872996459437099683e-31 -3.471005694342583469e-28 5.511521610893899137e-01 -3.454891334876421243e-30 -2.480857242293348698e-29 5.511521610893899137e-01 1.115099924708597682e-31 -4.762611114854708221e-29 5.511521610893899137e-01 4.120484283053314901e-31 -1.229105573308882622e-30 5.511521610893899137e-01 4.768020242409573290e-31 -2.349192607244107049e-31 5.511521610893899137e-01 2.247187106552825263e-31 -2.633386978933868415e-31 5.511521610893899137e-01 2.074234920256048739e-31 -6.853875663589955556e-32 5.511521610893899137e-01 1.325044731024847447e-32 5.020390860180797741e-32 5.511521610893899137e-01 -8.066475638589354568e-32 -1.736860189696929840e-32 5.511521610893899137e-01 -4.804142943019735722e-32 -4.946977979766468472e-32 5.511521610893899137e-01 -3.005530599726098366e-31 -2.285123633122857078e-31 5.511521610893899137e-01 2.447893419825505980e-31 -2.932005168519828988e-32 5.511521610893899137e-01 1.414146485298581983e-31 -7.003159421889791910e-32 5.511521610893899137e-01 -9.143991931157246912e-31 -7.918381075466355974e-32 5.511521610893899137e-01 -7.768693676076753072e-31 3.385834231134508659e-32 5.511521610893899137e-01 -8.769109520231000651e-33 -5.648955651447502683e-34 5.511521610893899137e-01 -2.245449536730418452e-33 8.684988461682822442e-32 5.511521610893899137e-01 -4.964367134765074798e-33 2.417786879737891327e-31 5.511521610893899137e-01 -2.470934956624849824e-32 4.070470847046655890e-31 5.511521610893899137e-01 -4.627330560025812967e-32 1.684341960898136120e-31 5.511521610893899137e-01 -1.789851198905880538e-32 1.105473772434415236e-30 5.511521610893899137e-01 1.643402474908239138e-32 4.233280255576364031e-32 5.511521610893899137e-01 -9.616964867105549433e-35 -3.752470442188330289e-33 5.511521610893899137e-01 -3.070865982252067423e-33 -4.349786123849065575e-33 5.511521610893899137e-01 -7.361999755281718030e-34 -3.771328995775264554e-33 5.511521610893899137e-01 1.805299369667113984e-34 -1.124682623650372954e-33 5.511521610893899137e-01 -6.844055379998046559e-34 -1.210550684986360809e-32 5.511521610893899137e-01 2.398552610057406280e-33 -3.564350001679344122e-33 5.511521610893899137e-01 -9.884652779971463384e-34 -1.203738090757170156e-32 5.511521610893899137e-01 2.089587240147885982e-33 -4.517458088081762399e-33 5.511521610893899137e-01 -1.402848117749616632e-33 -6.017345575208711032e-33 5.511521610893899137e-01 -1.738753346508337810e-33 -5.272997423190210744e-33 5.511521610893899137e-01 5.535739266042202676e-34 -3.005208275341777679e-33 5.511521610893899137e-01 3.372078172375365935e-33 -1.506699153498524000e-33 5.511521610893899137e-01 2.120153114076909274e-33 -5.268231683992688379e-33 5.511521610893899137e-01 -7.044674351065770787e-34 -3.008475834611746704e-33 5.511521610893899137e-01 -4.039535033038970226e-33 -5.267257693256748681e-33 5.511521610893899137e-01 7.187547979216128924e-34 -4.514903431199405683e-33 5.511521610893899137e-01 -5.258286148275195376e-34 -3.310032687613725556e-33 5.511521610893899137e-01 2.873582828387489556e-33 -3.296943064381120443e-33 5.511521610893899137e-01 -1.299928978690639645e-33 -6.267183862240808815e-33 5.511521610893899137e-01 -3.294218693997060108e-33 3.368021217863236612e-33 5.511521610893899137e-01 -6.412473127051169994e-35 -4.925187891661391929e-33 5.511521610893899137e-01 4.322652918887588653e-34 -3.324256158372766801e-33 5.511521610893899137e-01 1.000210075867870935e-33 -3.047976381399133336e-33 5.511521610893899137e-01 -7.986782734950020645e-33 -3.109934608407051386e-33 5.511521610893899137e-01 1.922579448072465519e-33 -6.568937057044656296e-33 5.511521610893899137e-01 4.559203738450610561e-33 -3.007318272247490892e-33 5.511521610893899137e-01 1.678038997592667629e-32 -4.779199850344819575e-33 5.511521610893899137e-01 -1.781984181944427226e-33 -4.820757654751807318e-33 5.511521610893899137e-01 7.841055335156345027e-34 -4.849344975567986720e-33 5.511521610893899137e-01 1.307493830297766321e-32 -2.996455837436104780e-33 5.511521610893899137e-01 -5.013699835248945461e-33 -4.894522578901346243e-33 5.511521610893899137e-01 1.008685729852643024e-32 -4.896043562293112846e-33 5.511521610893899137e-01 4.733625503408135770e-34 -3.388911461334281973e-33 5.511521610893899137e-01 1.307028670047483771e-33 -6.776161776563440342e-33 5.511521610893899137e-01 3.795026811194313807e-33 -4.892871936254183886e-33 5.511521610893899137e-01 -6.458654713458518731e-34 -3.197221956705529112e-33 5.511521610893899137e-01 1.633921684055722715e-33 -3.386384490454265902e-33 5.511521610893899137e-01 -3.511043810920364783e-34 -6.582636528173249226e-33 5.511521610893899137e-01 -2.294988601259996621e-34 -3.291512290413485851e-33 5.511521610893899137e-01 -2.935218250943761834e-33 -3.314713764805272361e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 new file mode 100644 index 000000000..8353ca88d --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 @@ -0,0 +1 @@ +1.808049300835544090e-02 -8.599641799148956268e-31 -2.171187442256295323e-30 1.807020072673284211e-02 -5.568486383432259574e-31 -9.591720279908338638e-31 1.804943698591649978e-02 1.366267224799299344e-31 -8.332161415958349168e-31 1.801784021813360864e-02 -2.278206731471931115e-31 -5.979171609110400104e-32 1.797485996999861196e-02 -1.887837580472879059e-30 1.115020033298263228e-31 1.791974701224428868e-02 5.503833975358133052e-31 4.120484283053314901e-31 1.785153985879996130e-02 -5.925964068023183471e-31 4.767905640314831142e-31 1.776904743545236823e-02 1.794306486146191807e-31 -1.171837159237190224e-30 1.767082757938890497e-02 -2.103718332580223764e-33 2.074234920256048739e-31 1.755516096108914598e-02 9.234921404436402118e-32 -5.497726832929538147e-31 1.742001994464114148e-02 3.730663299175025575e-31 4.211142054966477855e-31 1.726303183194934782e-02 -1.721020222363038698e-31 -4.803374769736571476e-32 1.708143583723383332e-02 -1.167001346883324908e-30 -3.005651120462601188e-31 1.687203307842673194e-02 -1.965929531133735490e-30 2.447893419825505980e-31 1.663112880039913435e-02 7.609540655960419366e-31 -1.398540769601704723e-30 1.635446600905215292e-02 1.005944810315200055e-30 7.155411897022206758e-31 1.603714971144631907e-02 -1.400065657134950680e-31 4.206461915989356279e-31 1.567356104324097929e-02 -1.692244500116344924e-31 -4.310341256901685359e-31 1.525726078036251585e-02 -3.348129764458791701e-32 -4.878770846635657439e-32 1.478088214333261527e-02 -2.016152101684308155e-31 7.715673257175165246e-32 1.423601349773071650e-02 2.300798361201171004e-32 -2.470934956624849824e-32 1.361307267816807588e-02 -1.674523423958381644e-31 1.780717635338882441e-32 1.290117639479585951e-02 -7.092867443543458901e-32 1.045807607701798291e-32 1.208801075793203283e-02 6.630752679570818016e-32 -2.418020063675367683e-33 1.115971270291740182e-02 -1.250665132973134301e-32 1.106651865075644844e-32 1.010077737207093658e-02 3.580908177937360760e-33 -3.071843828424299543e-33 8.894013751669977222e-03 -2.196826422691738474e-32 1.480999027557153089e-33 7.520580473713100664e-03 1.620030586559512797e-33 1.805299369667113984e-34 5.960145971441407377e-03 3.128081550439510515e-33 -6.839012466967552953e-34 4.191232078798090045e-03 -2.586360155762359490e-33 -1.626366365362976753e-35 2.191816967794502601e-03 5.358774965240956296e-34 -9.884652779971463384e-34 -5.970989411820957278e-05 -9.573720071873773816e-34 2.089587240147885982e-33 -2.395531108363500687e-03 1.685903287053252669e-34 8.377259487386970603e-33 -4.540029186260710094e-03 -1.579085590581463009e-33 -1.738753346508337810e-33 -6.402758975146515333e-03 1.068778850751994032e-34 5.532212823642319418e-34 -7.890909337164631054e-03 1.540155012718818776e-33 -4.570441350474050560e-33 -9.030288366418117232e-03 -4.946695938107116112e-33 -5.423341492905273067e-33 -9.979822077998657184e-03 2.815828623373947060e-33 -7.047263589159705411e-34 -1.068636538433350575e-02 2.595763068918823541e-34 2.957739242581670439e-33 -1.094391114107849845e-02 3.809592675781491216e-34 -1.355917358566239833e-34 -1.070689125123828501e-02 2.202525955196679834e-33 1.158718970346610369e-33 -1.021640625938967546e-02 -4.243473683035807763e-34 2.873360467457380368e-33 -9.583927954247995623e-03 5.110750436635113920e-33 3.799497835324140372e-34 -8.782814920058321095e-03 -4.237947510922356087e-33 -3.294218693997060108e-33 -7.668733745893299876e-03 6.762875586055641711e-34 3.390418358490274939e-33 -6.265408296724456726e-03 4.324234081320919057e-33 -6.644478983109389781e-33 -4.737204971693676978e-03 9.512731866155993410e-34 1.910878138790470166e-33 -3.378035675202108786e-03 -2.545461970618675541e-33 -7.986220848522751409e-33 -2.188655240270969641e-03 -6.976508122184772554e-33 1.922579448072465519e-33 -1.155434781506194932e-03 3.215537096979999750e-32 -1.168077866204217208e-32 -2.587810852476532032e-04 7.236292230237556541e-34 -1.261164683041430576e-34 5.302733598160939629e-04 4.259037289682987288e-33 -1.781984181944427226e-33 1.222116873000205850e-03 8.838074892674237372e-33 7.836889095571482092e-34 1.825366943555350096e-03 1.213947785353023409e-32 -6.022654265858707436e-33 2.348110809334531292e-03 -2.254589050892284361e-33 1.484060692398300465e-32 2.797774220140504618e-03 -6.044554382815318951e-33 -2.138467114223242564e-34 3.178543277687884659e-03 -9.637833410583793140e-33 4.730810941559429197e-34 3.486815834211615898e-03 -2.723023173744822966e-33 1.307028670047483771e-33 3.731703777774010404e-03 -1.731176813553256759e-34 -1.862195290702442877e-33 3.922353425706458750e-03 1.439733535640175535e-36 -1.931807769454129713e-34 4.066211236036011180e-03 -5.813563553716515512e-35 1.633921684055722715e-33 4.169111920063873697e-03 7.134942201190782385e-34 -1.850738357405418545e-33 4.235356895868877362e-03 1.424401468998474442e-34 -2.295215902285943341e-34 4.267777205671297210e-03 -4.849344729846970522e-34 3.155731999946545439e-33 -8.599641799148956268e-31 5.511521610893899137e-01 4.109657377430108723e-29 -5.568486383432259574e-31 5.511521610893899137e-01 2.885100398704818831e-29 1.366267224799299344e-31 5.511521610893899137e-01 -3.470945271411379413e-28 -2.278206731471931115e-31 5.511521610893899137e-01 -2.480876765937088468e-29 -1.887837580472879059e-30 5.511521610893899137e-01 -4.762672524644159012e-29 5.503833975358133052e-31 5.511521610893899137e-01 -1.225489263839405105e-30 -5.925964068023183471e-31 5.511521610893899137e-01 -2.351251394254347108e-31 1.794306486146191807e-31 5.511521610893899137e-01 -2.634432424339563338e-31 -2.103718332580223764e-33 5.511521610893899137e-01 -6.863125289067424982e-32 9.234921404436402118e-32 5.511521610893899137e-01 5.019022658768176772e-32 3.730663299175025575e-31 5.511521610893899137e-01 6.757962030077996172e-33 -1.721020222363038698e-31 5.511521610893899137e-01 -4.981690596607500101e-32 -1.167001346883324908e-30 5.511521610893899137e-01 -2.280319271643018501e-31 -1.965929531133735490e-30 5.511521610893899137e-01 -2.857908166246436197e-32 7.609540655960419366e-31 5.511521610893899137e-01 -4.552035108546792752e-32 1.005944810315200055e-30 5.511521610893899137e-01 -3.046164362969508274e-32 -1.400065657134950680e-31 5.511521610893899137e-01 8.198338919343348862e-32 -1.692244500116344924e-31 5.511521610893899137e-01 -8.062741753608699670e-34 -3.348129764458791701e-32 5.511521610893899137e-01 6.279054914775583248e-32 -2.016152101684308155e-31 5.511521610893899137e-01 2.298040587565372493e-31 2.300798361201171004e-32 5.511521610893899137e-01 3.949305773339509325e-31 -1.674523423958381644e-31 5.511521610893899137e-01 1.698935637602325669e-31 -7.092867443543458901e-32 5.511521610893899137e-01 1.108475974110627382e-30 6.630752679570818016e-32 5.511521610893899137e-01 4.835219933365242761e-32 -1.250665132973134301e-32 5.511521610893899137e-01 7.617299082421310695e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.341055609562289724e-33 -2.196826422691738474e-32 5.511521610893899137e-01 -7.621895919763526682e-34 1.620030586559512797e-33 5.511521610893899137e-01 3.798530281652419897e-34 3.128081550439510515e-33 5.511521610893899137e-01 -6.823140351494685930e-35 -2.586360155762359490e-33 5.511521610893899137e-01 1.972015208087545774e-34 5.358774965240956296e-34 5.511521610893899137e-01 -3.456816830640966395e-37 -9.573720071873773816e-34 5.511521610893899137e-01 -3.401145554541274151e-36 1.685903287053252669e-34 5.511521610893899137e-01 1.343103788274969003e-36 -1.579085590581463009e-33 5.511521610893899137e-01 -6.746788727172931583e-36 1.068778850751994032e-34 5.511521610893899137e-01 4.201856183642599110e-36 1.540155012718818776e-33 5.511521610893899137e-01 -2.079391535760816513e-36 -4.946695938107116112e-33 5.511521610893899137e-01 -2.058949375060042808e-36 2.815828623373947060e-33 5.511521610893899137e-01 8.004613669090264608e-37 2.595763068918823541e-34 5.511521610893899137e-01 -1.025774173730979307e-36 3.809592675781491216e-34 5.511521610893899137e-01 -1.005127651228756316e-36 2.202525955196679834e-33 5.511521610893899137e-01 -1.865784038041425504e-35 -4.243473683035807763e-34 5.511521610893899137e-01 -5.554513729021185886e-36 5.110750436635113920e-33 5.511521610893899137e-01 1.275131824024549165e-34 -4.237947510922356087e-33 5.511521610893899137e-01 8.634193228327318161e-33 6.762875586055641711e-34 5.511521610893899137e-01 -3.511568506160065083e-35 4.324234081320919057e-33 5.511521610893899137e-01 6.130209384222094880e-35 9.512731866155993410e-34 5.511521610893899137e-01 1.493488194050706158e-34 -2.545461970618675541e-33 5.511521610893899137e-01 1.812659198859070774e-34 -6.976508122184772554e-33 5.511521610893899137e-01 2.018043766276871302e-34 3.215537096979999750e-32 5.511521610893899137e-01 1.897659006442553832e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.103884412602426144e-34 4.259037289682987288e-33 5.511521610893899137e-01 6.896391779800071623e-35 8.838074892674237372e-33 5.511521610893899137e-01 4.041030714485907757e-35 1.213947785353023409e-32 5.511521610893899137e-01 1.246584563798026085e-35 -2.254589050892284361e-33 5.511521610893899137e-01 -4.589478324265958347e-36 -6.044554382815318951e-33 5.511521610893899137e-01 -6.155605437541054197e-36 -9.637833410583793140e-33 5.511521610893899137e-01 -3.586280290213180093e-36 -2.723023173744822966e-33 5.511521610893899137e-01 -5.334956423506742484e-36 -1.731176813553256759e-34 5.511521610893899137e-01 -2.847473582909621120e-36 1.439733535640175535e-36 5.511521610893899137e-01 1.224824418993808297e-37 -5.813563553716515512e-35 5.511521610893899137e-01 -9.669854168175094939e-37 7.134942201190782385e-34 5.511521610893899137e-01 1.330156366588775914e-37 1.424401468998474442e-34 5.511521610893899137e-01 -1.265837804008855066e-37 -4.849344729846970522e-34 5.511521610893899137e-01 1.752197238202174692e-37 -2.171187442256295323e-30 4.109055524322487712e-29 5.511521610893899137e-01 -9.591720279908338638e-31 2.880285573843850741e-29 5.511521610893899137e-01 -8.332161415958349168e-31 -3.471005456722141514e-28 5.511521610893899137e-01 -5.979171609110400104e-32 -2.480876765937088468e-29 5.511521610893899137e-01 1.115020033298263228e-31 -4.762672524644159012e-29 5.511521610893899137e-01 4.120484283053314901e-31 -1.231507794915615217e-30 5.511521610893899137e-01 4.767905640314831142e-31 -2.351251394254347108e-31 5.511521610893899137e-01 -1.171837159237190224e-30 -2.634432424339563338e-31 5.511521610893899137e-01 2.074234920256048739e-31 -6.863125289067424982e-32 5.511521610893899137e-01 -5.497726832929538147e-31 5.019022658768176772e-32 5.511521610893899137e-01 4.211142054966477855e-31 -1.731616227476244925e-32 5.511521610893899137e-01 -4.803374769736571476e-32 -4.981690596607500101e-32 5.511521610893899137e-01 -3.005651120462601188e-31 -2.280319271643018501e-31 5.511521610893899137e-01 2.447893419825505980e-31 -2.857908166246436197e-32 5.511521610893899137e-01 -1.398540769601704723e-30 -6.959447539030837021e-32 5.511521610893899137e-01 7.155411897022206758e-31 -7.860989223937597359e-32 5.511521610893899137e-01 4.206461915989356279e-31 3.383514058375259230e-32 5.511521610893899137e-01 -4.310341256901685359e-31 -8.062741753608699670e-34 5.511521610893899137e-01 -4.878770846635657439e-32 8.686467345259628065e-32 5.511521610893899137e-01 7.715673257175165246e-32 2.418411209089574734e-31 5.511521610893899137e-01 -2.470934956624849824e-32 4.069676394863711565e-31 5.511521610893899137e-01 1.780717635338882441e-32 1.683889309911800389e-31 5.511521610893899137e-01 1.045807607701798291e-32 1.105466708572522326e-30 5.511521610893899137e-01 -2.418020063675367683e-33 4.233366825744232104e-32 5.511521610893899137e-01 1.106651865075644844e-32 -3.752168398915452961e-33 5.511521610893899137e-01 -3.071843828424299543e-33 -4.350321147667345402e-33 5.511521610893899137e-01 1.480999027557153089e-33 -3.771455130081407833e-33 5.511521610893899137e-01 1.805299369667113984e-34 -1.124779740887286192e-33 5.511521610893899137e-01 -6.839012466967552953e-34 -1.210529355593517070e-32 5.511521610893899137e-01 -1.626366365362976753e-35 -3.564380401822564721e-33 5.511521610893899137e-01 -9.884652779971463384e-34 -1.203740783410328717e-32 5.511521610893899137e-01 2.089587240147885982e-33 -4.517299452712125446e-33 5.511521610893899137e-01 8.377259487386970603e-33 -6.017187972421836528e-33 5.511521610893899137e-01 -1.738753346508337810e-33 -5.272961480411020339e-33 5.511521610893899137e-01 5.532212823642319418e-34 -3.005063681921413516e-33 5.511521610893899137e-01 -4.570441350474050560e-33 -1.506712160588289200e-33 5.511521610893899137e-01 -5.423341492905273067e-33 -5.268273641058908974e-33 5.511521610893899137e-01 -7.047263589159705411e-34 -3.008465076738147456e-33 5.511521610893899137e-01 2.957739242581670439e-33 -5.267240465857579302e-33 5.511521610893899137e-01 -1.355917358566239833e-34 -4.514903434808812519e-33 5.511521610893899137e-01 1.158718970346610369e-33 -3.310042022682819229e-33 5.511521610893899137e-01 2.873360467457380368e-33 -3.296938696031426590e-33 5.511521610893899137e-01 3.799497835324140372e-34 -6.267176086070790453e-33 5.511521610893899137e-01 -3.294218693997060108e-33 3.367978536643471494e-33 5.511521610893899137e-01 3.390418358490274939e-33 -4.925172184482316219e-33 5.511521610893899137e-01 -6.644478983109389781e-33 -3.324121636525967470e-33 5.511521610893899137e-01 1.910878138790470166e-33 -3.047995814831550743e-33 5.511521610893899137e-01 -7.986220848522751409e-33 -3.110118262416497581e-33 5.511521610893899137e-01 1.922579448072465519e-33 -6.569043084108688189e-33 5.511521610893899137e-01 -1.168077866204217208e-32 -3.007578733592366767e-33 5.511521610893899137e-01 -1.261164683041430576e-34 -4.779668058160473953e-33 5.511521610893899137e-01 -1.781984181944427226e-33 -4.821092581622715210e-33 5.511521610893899137e-01 7.836889095571482092e-34 -4.849646192275856426e-33 5.511521610893899137e-01 -6.022654265858707436e-33 -2.996799692467076064e-33 5.511521610893899137e-01 1.484060692398300465e-32 -4.894645977744982411e-33 5.511521610893899137e-01 -2.138467114223242564e-34 -4.896212104858258278e-33 5.511521610893899137e-01 4.730810941559429197e-34 -3.389010010658401813e-33 5.511521610893899137e-01 1.307028670047483771e-33 -6.776182417159882705e-33 5.511521610893899137e-01 -1.862195290702442877e-33 -4.892903973003625720e-33 5.511521610893899137e-01 -1.931807769454129713e-34 -3.197222151794722800e-33 5.511521610893899137e-01 1.633921684055722715e-33 -3.386390715785006288e-33 5.511521610893899137e-01 -1.850738357405418545e-33 -6.582635348968152236e-33 5.511521610893899137e-01 -2.295215902285943341e-34 -3.291510766082806982e-33 5.511521610893899137e-01 3.155731999946545439e-33 -3.314718849595029814e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 new file mode 100644 index 000000000..57f24b9c9 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 @@ -0,0 +1 @@ +1.798183811423135353e-02 6.122348544044080192e-31 -2.063629275944806903e-31 1.796797785409042988e-02 -6.101898276721323203e-31 -1.612340688517690275e-31 1.793998761800792013e-02 -3.385170637274411837e-31 5.070691472790853531e-32 1.789732230596942711e-02 -1.223327315013582227e-31 -6.493970514461556998e-31 1.783914996705431716e-02 1.489584030680479503e-31 3.263199516953179408e-32 1.776433427249787117e-02 8.847229865814432269e-31 4.611758674846738442e-31 1.767141052974850746e-02 9.860191375349637258e-31 9.078813092456368596e-31 1.755855469600759930e-02 -3.993663668192157022e-31 -3.707996154977914111e-31 1.742354469980607334e-02 -4.241218514648545116e-34 2.108009668548692463e-32 1.726371322276509107e-02 -1.333839942311332102e-31 3.993801553493286858e-32 1.707589093379265066e-02 -7.454605185168855880e-32 1.062959870656067884e-32 1.685633901119188219e-02 1.116391988804065522e-32 -6.006480808485334302e-32 1.660066964731259781e-02 4.923740116643441041e-32 1.256006704479162178e-31 1.630375312757224859e-02 1.399321707781484506e-31 -4.518253458164972514e-31 1.595961004695052587e-02 2.789384104313185699e-34 5.967450787270980854e-31 1.556128733010373605e-02 5.815928248263278141e-31 6.173729352556617726e-33 1.510071704414081561e-02 -4.284405479207655328e-32 3.544799661415376388e-31 1.456855766894174162e-02 6.061104415617773346e-34 3.644749446659820287e-31 1.395401871329038021e-02 0.000000000000000000e+00 -2.126442401779329327e-31 1.324467161496615045e-02 -1.134415308057596725e-31 -2.345104402179759659e-33 1.242625312571369461e-02 3.488990675909715679e-34 1.082847778143033712e-30 1.148247237661566798e-02 7.332611161745850011e-33 1.612490047844318588e-32 1.039484053574663003e-02 2.929500813919224937e-33 8.234413684688681770e-31 9.142607594014176900e-03 -6.631357895429931702e-31 0.000000000000000000e+00 7.702913748454134207e-03 1.082115334335678803e-32 -8.000032744833821776e-33 6.051207372212138134e-03 3.918769778285902730e-34 3.104545484164111282e-35 4.162060342863257295e-03 7.328078595823150219e-33 -2.416545279417239897e-32 2.010272330948578018e-03 -2.878824290464192714e-33 -3.135737510824985075e-32 -4.168044749976156788e-04 -3.341285563626358694e-35 3.864704053203938971e-34 -2.866776619648636788e-03 2.123622996929380622e-32 2.612014865111965016e-32 -5.073764788738598444e-03 -4.642320850000695198e-33 3.273138538184421415e-33 -6.928542448036343476e-03 5.914329158110691341e-33 6.208026473930686349e-34 -8.351255126143436111e-03 -1.626846619618110428e-33 -1.702873565918794262e-36 -9.470803741030937861e-03 9.982341035939150454e-34 7.216310297474077933e-33 -1.035472846679208470e-02 1.173308150297919173e-32 -1.065165917815147210e-36 -1.084926458569601682e-02 5.479425983855504195e-33 1.849795887944143741e-34 -1.081013237403952859e-02 1.501138946694587754e-33 -6.208055981355432556e-34 -1.037323237556274369e-02 -1.231280023802430984e-32 -7.338738634976246674e-34 -9.743963813557748530e-03 -9.693570785691527172e-33 3.455715350518089336e-35 -8.918588907511007177e-03 -1.298026380528296206e-35 -1.971908283206304609e-33 -7.777493995230210649e-03 -9.387860452234622834e-33 3.259607522410052804e-33 -6.301489311212999343e-03 1.995824295780086024e-33 -6.025559036107633817e-33 -4.697553134891576353e-03 9.927091983699431391e-34 -1.946778018444609176e-35 -3.220713035295743806e-03 0.000000000000000000e+00 -4.737407014413756140e-33 -1.929302204997196011e-03 -5.738844034805634475e-34 -2.804627774709108475e-34 -8.053299490783354803e-04 -1.723178377449637606e-33 -1.221626287900307221e-33 1.791819796332395909e-04 2.311903151836662979e-33 2.100410730294778288e-33 1.048160720869014025e-03 7.156865239912921430e-33 -4.100020164959082116e-35 1.814359597779304986e-03 1.186440986346068982e-34 1.246768181232042828e-33 2.487087492642727198e-03 -1.628371341703527747e-34 1.149483803378053866e-32 3.067872393967137692e-03 -2.281006205946655939e-32 4.375523941046185762e-35 3.555551866091283871e-03 -3.163210759461825720e-32 1.108452960098921929e-32 3.953748886483041472e-03 0.000000000000000000e+00 3.638178048489731707e-33 4.273574150943893271e-03 -1.166391929881695717e-34 0.000000000000000000e+00 4.528128328414583910e-03 0.000000000000000000e+00 -2.409378201690617302e-36 4.728779898374679998e-03 1.120582123131089114e-32 -6.697534012546389907e-36 4.885261569205448517e-03 -3.908947354900799352e-36 -3.233952536463438536e-37 5.005736890203004406e-03 -2.113138846585561356e-35 -2.272528782731722383e-33 5.096806488930366412e-03 -7.054039988462939767e-35 -2.877816604985414113e-33 5.164061913162622947e-03 0.000000000000000000e+00 -4.889410545885136790e-34 5.212196062226516144e-03 -2.916353354825908871e-33 -2.996592268956474661e-34 5.244981725402745806e-03 4.843162144919647471e-34 7.050516753101862712e-34 5.265257889180871044e-03 4.838256186334363906e-37 -1.726450071677988945e-36 5.274921237608814692e-03 -7.375181793003856945e-34 5.333266878240635817e-35 6.122348544044080192e-31 5.511521610893899137e-01 7.290301753470531539e-32 -6.101898276721323203e-31 5.511521610893899137e-01 2.052075703451992891e-32 -3.385170637274411837e-31 5.511521610893899137e-01 -7.936379925821067502e-35 -1.223327315013582227e-31 5.511521610893899137e-01 -3.257828496583015078e-32 1.489584030680479503e-31 5.511521610893899137e-01 3.350929661161666969e-33 8.847229865814432269e-31 5.511521610893899137e-01 -5.405481763327431915e-33 9.860191375349637258e-31 5.511521610893899137e-01 -2.427143490458209002e-32 -3.993663668192157022e-31 5.511521610893899137e-01 -1.005214785246823979e-32 -4.241218514648545116e-34 5.511521610893899137e-01 -5.565508141517109443e-33 -1.333839942311332102e-31 5.511521610893899137e-01 -2.281701216058222731e-32 -7.454605185168855880e-32 5.511521610893899137e-01 3.404451926431939346e-33 1.116391988804065522e-32 5.511521610893899137e-01 6.054374322309786519e-34 4.923740116643441041e-32 5.511521610893899137e-01 1.846752820246126828e-33 1.399321707781484506e-31 5.511521610893899137e-01 -1.185676347230074322e-32 2.789384104313185699e-34 5.511521610893899137e-01 -1.880252533982346097e-32 5.815928248263278141e-31 5.511521610893899137e-01 -4.949444060748510347e-32 -4.284405479207655328e-32 5.511521610893899137e-01 6.825816436612319595e-32 6.061104415617773346e-34 5.511521610893899137e-01 6.844193557718299278e-32 0.000000000000000000e+00 5.511521610893899137e-01 6.946519394136355429e-32 -1.134415308057596725e-31 5.511521610893899137e-01 2.540984558187787890e-31 3.488990675909715679e-34 5.511521610893899137e-01 4.002915002779924867e-31 7.332611161745850011e-33 5.511521610893899137e-01 1.721097688083060774e-31 2.929500813919224937e-33 5.511521610893899137e-01 1.108866946010025268e-30 -6.631357895429931702e-31 5.511521610893899137e-01 4.857711625976752462e-32 1.082115334335678803e-32 5.511521610893899137e-01 8.021691665423144045e-34 3.918769778285902730e-34 5.511521610893899137e-01 -1.319434053035366988e-33 7.328078595823150219e-33 5.511521610893899137e-01 -7.528807982620396284e-34 -2.878824290464192714e-33 5.511521610893899137e-01 3.929443716179735526e-34 -3.341285563626358694e-35 5.511521610893899137e-01 -5.336005019238102634e-35 2.123622996929380622e-32 5.511521610893899137e-01 2.029877435441140654e-34 -4.642320850000695198e-33 5.511521610893899137e-01 3.161835591885279779e-36 5.914329158110691341e-33 5.511521610893899137e-01 -3.711075044493321503e-36 -1.626846619618110428e-33 5.511521610893899137e-01 -2.088540278529872865e-36 9.982341035939150454e-34 5.511521610893899137e-01 -7.143048618917842010e-37 1.173308150297919173e-32 5.511521610893899137e-01 1.943163719901402791e-36 5.479425983855504195e-33 5.511521610893899137e-01 -2.186475693165983751e-36 1.501138946694587754e-33 5.511521610893899137e-01 -1.721787781994624412e-36 -1.231280023802430984e-32 5.511521610893899137e-01 1.402821250299783532e-36 -9.693570785691527172e-33 5.511521610893899137e-01 -5.853808892982871024e-37 -1.298026380528296206e-35 5.511521610893899137e-01 -9.626762060567784589e-37 -9.387860452234622834e-33 5.511521610893899137e-01 -1.275712957278488923e-35 1.995824295780086024e-33 5.511521610893899137e-01 5.147487893496827138e-36 9.927091983699431391e-34 5.511521610893899137e-01 1.344845322093598052e-34 0.000000000000000000e+00 5.511521610893899137e-01 8.647974044815551686e-33 -5.738844034805634475e-34 5.511521610893899137e-01 -3.482558806060697687e-35 -1.723178377449637606e-33 5.511521610893899137e-01 6.062497003572582331e-35 2.311903151836662979e-33 5.511521610893899137e-01 1.520020306126427064e-34 7.156865239912921430e-33 5.511521610893899137e-01 2.126297112416656041e-34 1.186440986346068982e-34 5.511521610893899137e-01 2.301683372987477540e-34 -1.628371341703527747e-34 5.511521610893899137e-01 2.419576327104729841e-34 -2.281006205946655939e-32 5.511521610893899137e-01 1.921641454400174397e-34 -3.163210759461825720e-32 5.511521610893899137e-01 1.376550661506089195e-34 0.000000000000000000e+00 5.511521610893899137e-01 1.053295417120417522e-34 -1.166391929881695717e-34 5.511521610893899137e-01 7.048877150877689228e-35 0.000000000000000000e+00 5.511521610893899137e-01 3.578289971096288554e-35 1.120582123131089114e-32 5.511521610893899137e-01 1.702721348131158905e-35 -3.908947354900799352e-36 5.511521610893899137e-01 1.304963687892904648e-35 -2.113138846585561356e-35 5.511521610893899137e-01 3.232764897814372328e-36 -7.054039988462939767e-35 5.511521610893899137e-01 7.974307030464134955e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.682783801913494586e-36 -2.916353354825908871e-33 5.511521610893899137e-01 7.499798216079838695e-38 4.843162144919647471e-34 5.511521610893899137e-01 5.010140534413867288e-39 4.838256186334363906e-37 5.511521610893899137e-01 4.010310238345746211e-38 -7.375181793003856945e-34 5.511521610893899137e-01 6.572598132721406097e-38 -2.063629275944806903e-31 6.688448645849520335e-32 5.511521610893899137e-01 -1.612340688517690275e-31 -2.762749157516096741e-32 5.511521610893899137e-01 5.070691472790853531e-32 -6.097894875468322716e-33 5.511521610893899137e-01 -6.493970514461556998e-31 -3.257828496583015078e-32 5.511521610893899137e-01 3.263199516953179408e-32 3.350929661161666969e-33 5.511521610893899137e-01 4.611758674846738442e-31 -1.142401283953754532e-32 5.511521610893899137e-01 9.078813092456368596e-31 -2.427143490458209002e-32 5.511521610893899137e-01 -3.707996154977914111e-31 -1.005214785246823979e-32 5.511521610893899137e-01 2.108009668548692463e-32 -5.565508141517109443e-33 5.511521610893899137e-01 3.993801553493286858e-32 -2.281701216058222731e-32 5.511521610893899137e-01 1.062959870656067884e-32 -2.066967237840850745e-32 5.511521610893899137e-01 -6.006480808485334302e-32 6.054374322309786519e-34 5.511521610893899137e-01 1.256006704479162178e-31 1.846752820246126828e-33 5.511521610893899137e-01 -4.518253458164972514e-31 -1.185676347230074322e-32 5.511521610893899137e-01 5.967450787270980854e-31 -4.287664964466390639e-32 5.511521610893899137e-01 6.173729352556617726e-33 -9.764268921716599979e-32 5.511521610893899137e-01 3.544799661415376388e-31 2.010991575644229962e-32 5.511521610893899137e-01 3.644749446659820287e-31 6.844193557718299278e-32 5.511521610893899137e-01 -2.126442401779329327e-31 9.353931824620400246e-32 5.511521610893899137e-01 -2.345104402179759659e-33 2.661355179711990131e-31 5.511521610893899137e-01 1.082847778143033712e-30 4.123285624304127108e-31 5.511521610893899137e-01 1.612490047844318588e-32 1.706051360392535493e-31 5.511521610893899137e-01 8.234413684688681770e-31 1.105857680471920212e-30 5.511521610893899137e-01 0.000000000000000000e+00 4.255858518355741805e-32 5.511521610893899137e-01 -8.000032744833821776e-33 -3.711729140615269797e-33 5.511521610893899137e-01 3.104545484164111282e-35 -4.328699591140422837e-33 5.511521610893899137e-01 -2.416545279417239897e-32 -3.762146336367095563e-33 5.511521610893899137e-01 -3.135737510824985075e-32 -1.111688397434554543e-33 5.511521610893899137e-01 3.864704053203938971e-34 -1.209042220261260509e-32 5.511521610893899137e-01 2.612014865111965016e-32 -3.558594179087206046e-33 5.511521610893899137e-01 3.273138538184421415e-33 -1.203390031682833843e-32 5.511521610893899137e-01 6.208026473930686349e-34 -4.517609382202077460e-33 5.511521610893899137e-01 -1.702873565918794262e-36 -6.020619616488641948e-33 5.511521610893899137e-01 7.216310297474077933e-33 -5.266928996545739637e-33 5.511521610893899137e-01 -1.065165917815147210e-36 -3.007322374385154897e-33 5.511521610893899137e-01 1.849795887944143741e-34 -1.506819244745694127e-33 5.511521610893899137e-01 -6.208055981355432556e-34 -5.267936479465842327e-33 5.511521610893899137e-01 -7.338738634976246674e-34 -3.007862716854756044e-33 5.511521610893899137e-01 3.455715350518089336e-35 -5.266800072573146551e-33 5.511521610893899137e-01 -1.971908283206304609e-33 -4.514860983363640478e-33 5.511521610893899137e-01 3.259607522410052804e-33 -3.304141311875189503e-33 5.511521610893899137e-01 -6.025559036107633817e-33 -3.286236694408907931e-33 5.511521610893899137e-01 -1.946778018444609176e-35 -6.260204736263885542e-33 5.511521610893899137e-01 -4.737407014413756140e-33 3.381759353131704334e-33 5.511521610893899137e-01 -2.804627774709108475e-34 -4.924882087481323256e-33 5.511521610893899137e-01 -1.221626287900307221e-33 -3.324798760332462349e-33 5.511521610893899137e-01 2.100410730294778288e-33 -3.045342603623979208e-33 5.511521610893899137e-01 -4.100020164959082116e-35 -3.078754471060739333e-33 5.511521610893899137e-01 1.246768181232042828e-33 -6.540679123437629233e-33 5.511521610893899137e-01 1.149483803378053866e-32 -2.955387001526149038e-33 5.511521610893899137e-01 4.375523941046185762e-35 -4.697892353980698080e-33 5.511521610893899137e-01 1.108452960098921929e-32 -4.752401433270106900e-33 5.511521610893899137e-01 3.638178048489731707e-33 -4.784726957708674046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -2.938776766596279353e-33 5.511521610893899137e-01 -2.409378201690617302e-36 -4.854273599709752977e-33 5.511521610893899137e-01 -6.697534012546389907e-36 -4.873029285939404931e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.372374093489259343e-33 5.511521610893899137e-01 -2.272528782731722383e-33 -6.767614695838561382e-33 5.511521610893899137e-01 -2.877816604985414113e-33 -4.889259068717669802e-33 5.511521610893899137e-01 -4.889410545885136790e-34 -3.195661850434708181e-33 5.511521610893899137e-01 -2.996592268956474661e-34 -3.385348732386027581e-33 5.511521610893899137e-01 7.050516753101862712e-34 -6.582763354464275839e-33 5.511521610893899137e-01 -1.726450071677988945e-36 -3.291344079200021888e-33 5.511521610893899137e-01 5.333266878240635817e-35 -3.314828343337523493e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 new file mode 100644 index 000000000..d7b0ec677 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 @@ -0,0 +1 @@ +1.786499140402910898e-02 1.219025168772197872e-30 -2.061350679195397059e-31 1.785146619118939751e-02 -9.088030628340098222e-33 1.393727461163637243e-31 1.782418098358570444e-02 8.416680943954785125e-31 5.070691472790853531e-32 1.778266193180831276e-02 3.083834705487193332e-31 1.647756026154257990e-30 1.772618746159203632e-02 1.490534683593706111e-31 3.263199516953179408e-32 1.765377507078429165e-02 1.415282428565477326e-30 1.522120426024128610e-30 1.756416331614273768e-02 -1.491509779375724108e-31 -1.010975222135009452e-31 1.745578863112032600e-02 7.711288369379520972e-32 5.821588855282304127e-31 1.732675651657127058e-02 -5.635030251248151319e-32 2.108009668548692463e-32 1.717480654251533206e-02 -6.153526910182389613e-32 2.489377390136957169e-31 1.699727049186759709e-02 -7.452266308646484897e-32 2.050136264808488947e-31 1.679102286916022910e-02 1.116391988804065522e-32 -6.006480808485334302e-32 1.655242289492476690e-02 2.155072474711587442e-31 1.254637453596010338e-31 1.627724701948258038e-02 4.461835589921824044e-31 1.606774306115706125e-31 1.596061093524065236e-02 2.781727869749155645e-34 3.402485386963482174e-32 1.559688007076428726e-02 5.815928248263278141e-31 6.173729352556617726e-33 1.517956765325232001e-02 -4.284405479207655328e-32 8.253958216199754513e-35 1.470121968994313189e-02 5.482810314984024248e-34 -2.515302655945666252e-34 1.415328673319700761e-02 9.663928469904542086e-35 9.626114629871546684e-33 1.352598318952005427e-02 -1.134415308057596725e-31 8.793799817194899781e-32 1.280813639516813034e-02 -1.646495290354010478e-31 9.332863360537578569e-32 1.198702997070378098e-02 7.332611161745850011e-33 1.618113804892623203e-32 1.104824943796820468e-02 2.929500813919224937e-33 -3.296298748378319555e-33 9.975543208627353151e-03 -1.177916986927023080e-33 3.935774258612676784e-35 8.750719768572296636e-03 1.078812607213867500e-32 6.432884777481389612e-33 7.353613318991375145e-03 4.196749418562749869e-34 5.884341886932585872e-35 5.762166180091505933e-03 -1.690908208614039301e-32 -1.195292996992720207e-32 3.952722249407784015e-03 2.723644687208776301e-33 3.603175351998728114e-32 1.900704636829885722e-03 -3.341285563626358694e-35 3.864704053203938971e-34 -3.998958664629946071e-04 2.000347947764716070e-33 6.869593950703046195e-33 -2.738027981654521208e-03 -1.299310535341134450e-34 -5.687726185110405598e-33 -4.874968260864200389e-03 6.394453540747697885e-34 6.264480079860168169e-34 -6.706028089909856632e-03 3.792234435617083444e-34 -1.069644379309003009e-36 -8.142377943033657361e-03 4.014659126157913485e-34 -8.060955391565888706e-33 -9.268420375211786424e-03 -2.979666767466250584e-33 9.070959407796831379e-39 -1.018552970198861353e-02 9.995100124784569229e-34 1.931211898328097440e-34 -1.078749224543992281e-02 1.501261960996105635e-33 -1.802760076126178113e-34 -1.089270899258410787e-02 5.197957972586126182e-33 1.016813347749601594e-33 -1.054244458732895608e-02 4.372873701430834135e-33 -8.460633277420454411e-34 -9.981439339801162838e-03 4.265742886675583257e-35 5.153735354357563358e-33 -9.266053553068535203e-03 5.184284687530419145e-33 -4.026465047472468186e-33 -8.295845506956858045e-03 2.013771030157760808e-33 9.031751106761569233e-33 -6.989605370277018545e-03 4.907765156984922479e-33 -1.946778018444609176e-35 -5.427426853013662261e-03 2.146243631063305260e-35 3.461243656248069857e-33 -3.918674894688610119e-03 1.606190421071709619e-33 -4.152201498676860125e-34 -2.592638169155561060e-03 8.898962355468307551e-36 5.087612203537692155e-34 -1.436760624707282248e-03 2.311903151836662979e-33 -3.636894581700903678e-34 -4.322979969844952843e-04 -3.453768035410177292e-33 -1.061626469938827926e-32 4.523791085092895934e-04 1.186440986346068982e-34 1.246768181232042828e-33 1.233321845374947892e-03 2.425364612286880779e-32 -7.134035947390421354e-34 1.919998166912073156e-03 3.005264002094712790e-32 2.647510627961730437e-32 2.521447097608605671e-03 -3.025072287832607301e-33 -1.749010815731762617e-32 3.044677145599743607e-03 0.000000000000000000e+00 1.910801707555194848e-32 3.483606480501018517e-03 -1.166391929881695717e-34 -1.667092276747645340e-32 3.840774522548483574e-03 0.000000000000000000e+00 1.806916393655533957e-32 4.128935819625061641e-03 -8.224779587819093516e-33 1.942390328511743824e-32 4.359355053051283506e-03 -3.908947354900799352e-36 -3.233952536463438536e-37 4.541643474033266355e-03 -3.100640009528949161e-35 -2.272528782731722383e-33 4.683885605064238775e-03 -6.003933837716056402e-33 -2.877816604985414113e-33 4.792761780226757751e-03 0.000000000000000000e+00 -6.739733327963650152e-33 4.873659654621166105e-03 3.471184117644577121e-34 -2.996592268956474661e-34 4.930770528039748329e-03 2.174815863601836037e-33 4.088771734767767148e-33 4.967168041485876470e-03 1.733030324772810164e-33 3.463366548236675634e-33 4.984867893779819717e-03 -7.989583522313930872e-35 -3.451388966455412406e-33 1.219025168772197872e-30 5.511521610893899137e-01 8.188535716359637875e-32 -9.088030628340098222e-33 5.511521610893899137e-01 2.423194187666158305e-32 8.416680943954785125e-31 5.511521610893899137e-01 7.410096935743693115e-33 3.083834705487193332e-31 5.511521610893899137e-01 -2.787803481625604565e-32 1.490534683593706111e-31 5.511521610893899137e-01 1.521391938874292871e-32 1.415282428565477326e-30 5.511521610893899137e-01 4.761986729142090379e-33 -1.491509779375724108e-31 5.511521610893899137e-01 -2.486097670950934026e-32 7.711288369379520972e-32 5.511521610893899137e-01 -9.120973661842751120e-33 -5.635030251248151319e-32 5.511521610893899137e-01 -5.455745693634111084e-33 -6.153526910182389613e-32 5.511521610893899137e-01 -2.283138488157920833e-32 -7.452266308646484897e-32 5.511521610893899137e-01 3.634249058361741254e-33 1.116391988804065522e-32 5.511521610893899137e-01 1.522137282030466403e-33 2.155072474711587442e-31 5.511521610893899137e-01 2.576421217373871953e-33 4.461835589921824044e-31 5.511521610893899137e-01 -1.118411058063982529e-32 2.781727869749155645e-34 5.511521610893899137e-01 -1.882240901357352221e-32 5.815928248263278141e-31 5.511521610893899137e-01 -5.069724044132510212e-32 -4.284405479207655328e-32 5.511521610893899137e-01 6.745253903130761803e-32 5.482810314984024248e-34 5.511521610893899137e-01 6.838490331625611715e-32 9.663928469904542086e-35 5.511521610893899137e-01 6.932088389392429618e-32 -1.134415308057596725e-31 5.511521610893899137e-01 2.527717721699126820e-31 -1.646495290354010478e-31 5.511521610893899137e-01 3.990966925283136989e-31 7.332611161745850011e-33 5.511521610893899137e-01 1.714949971642328725e-31 2.929500813919224937e-33 5.511521610893899137e-01 1.108663111022782843e-30 -1.177916986927023080e-33 5.511521610893899137e-01 4.850415190095525195e-32 1.078812607213867500e-32 5.511521610893899137e-01 7.681097194163084624e-34 4.196749418562749869e-34 5.511521610893899137e-01 -1.364218020698895923e-33 -1.690908208614039301e-32 5.511521610893899137e-01 -8.147223787513243048e-34 2.723644687208776301e-33 5.511521610893899137e-01 3.661934818988863426e-34 -3.341285563626358694e-35 5.511521610893899137e-01 -8.167033872537366791e-35 2.000347947764716070e-33 5.511521610893899137e-01 2.121886347837056675e-34 -1.299310535341134450e-34 5.511521610893899137e-01 -3.958774408165175441e-37 6.394453540747697885e-34 5.511521610893899137e-01 -3.772643918754414573e-36 3.792234435617083444e-34 5.511521610893899137e-01 -2.198538092860321267e-36 4.014659126157913485e-34 5.511521610893899137e-01 -6.514312051763950670e-37 -2.979666767466250584e-33 5.511521610893899137e-01 1.344718119704852008e-36 9.995100124784569229e-34 5.511521610893899137e-01 -1.596539800662342077e-36 1.501261960996105635e-33 5.511521610893899137e-01 -1.718834146137470594e-36 5.197957972586126182e-33 5.511521610893899137e-01 1.058737060380784340e-36 4.372873701430834135e-33 5.511521610893899137e-01 -1.065567503230144586e-36 4.265742886675583257e-35 5.511521610893899137e-01 -9.820818159637571184e-37 5.184284687530419145e-33 5.511521610893899137e-01 -1.821320916532643268e-35 2.013771030157760808e-33 5.511521610893899137e-01 -5.034252844245116114e-36 4.907765156984922479e-33 5.511521610893899137e-01 1.286690998515404549e-34 2.146243631063305260e-35 5.511521610893899137e-01 8.636015325953288225e-33 1.606190421071709619e-33 5.511521610893899137e-01 -3.489970250415837310e-35 8.898962355468307551e-36 5.511521610893899137e-01 6.065937263706933481e-35 2.311903151836662979e-33 5.511521610893899137e-01 1.495322351462086941e-34 -3.453768035410177292e-33 5.511521610893899137e-01 1.868525391950803367e-34 1.186440986346068982e-34 5.511521610893899137e-01 2.049783731702362665e-34 2.425364612286880779e-32 5.511521610893899137e-01 1.913762142357593685e-34 3.005264002094712790e-32 5.511521610893899137e-01 1.174864251130577670e-34 -3.025072287832607301e-33 5.511521610893899137e-01 7.994468142967189702e-35 0.000000000000000000e+00 5.511521610893899137e-01 4.468226415995556820e-35 -1.166391929881695717e-34 5.511521610893899137e-01 1.393706649057642718e-35 0.000000000000000000e+00 5.511521610893899137e-01 -1.155815865560166942e-36 -8.224779587819093516e-33 5.511521610893899137e-01 -4.006881125302465257e-36 -3.908947354900799352e-36 5.511521610893899137e-01 -3.196156189547332784e-36 -3.100640009528949161e-35 5.511521610893899137e-01 -4.967446765927542058e-36 -6.003933837716056402e-33 5.511521610893899137e-01 -2.424150876061110738e-36 0.000000000000000000e+00 5.511521610893899137e-01 -9.430321678422058656e-38 3.471184117644577121e-34 5.511521610893899137e-01 -9.876554103350274757e-37 2.174815863601836037e-33 5.511521610893899137e-01 1.482217323769206854e-37 1.733030324772810164e-33 5.511521610893899137e-01 -1.025654498532010812e-37 -7.989583522313930872e-35 5.511521610893899137e-01 1.142733614113401684e-37 -2.061350679195397059e-31 7.586682608738626671e-32 5.511521610893899137e-01 1.393727461163637243e-31 -2.391630673301931328e-32 5.511521610893899137e-01 5.070691472790853531e-32 1.391565859533581074e-33 5.511521610893899137e-01 1.647756026154257990e-30 -2.787803481625604565e-32 5.511521610893899137e-01 3.263199516953179408e-32 1.521391938874292871e-32 5.511521610893899137e-01 1.522120426024128610e-30 -1.256544347068023030e-33 5.511521610893899137e-01 -1.010975222135009452e-31 -2.486097670950934026e-32 5.511521610893899137e-01 5.821588855282304127e-31 -9.120973661842751120e-33 5.511521610893899137e-01 2.108009668548692463e-32 -5.455745693634111084e-33 5.511521610893899137e-01 2.489377390136957169e-31 -2.283138488157920833e-32 5.511521610893899137e-01 2.050136264808488947e-31 -2.043987524647870486e-32 5.511521610893899137e-01 -6.006480808485334302e-32 1.522137282030466403e-33 5.511521610893899137e-01 1.254637453596010338e-31 2.576421217373871953e-33 5.511521610893899137e-01 1.606774306115706125e-31 -1.118411058063982529e-32 5.511521610893899137e-01 3.402485386963482174e-32 -4.289653331841396490e-32 5.511521610893899137e-01 6.173729352556617726e-33 -9.884548905100599844e-32 5.511521610893899137e-01 8.253958216199754513e-35 1.930429042162672444e-32 5.511521610893899137e-01 -2.515302655945666252e-34 6.838490331625611715e-32 5.511521610893899137e-01 9.626114629871546684e-33 9.339500819876474435e-32 5.511521610893899137e-01 8.793799817194899781e-32 2.648088343223329061e-31 5.511521610893899137e-01 9.332863360537578569e-32 4.111337546807339230e-31 5.511521610893899137e-01 1.618113804892623203e-32 1.699903643951803445e-31 5.511521610893899137e-01 -3.296298748378319555e-33 1.105653845484677787e-30 5.511521610893899137e-01 3.935774258612676784e-35 4.248562082474514538e-32 5.511521610893899137e-01 6.432884777481389612e-33 -3.745788587741275739e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.373483558803951944e-33 5.511521610893899137e-01 -1.195292996992720207e-32 -3.823987916856379983e-33 5.511521610893899137e-01 3.603175351998728114e-32 -1.138439287153641839e-33 5.511521610893899137e-01 3.864704053203938971e-34 -1.211873249114559839e-32 5.511521610893899137e-01 6.869593950703046195e-33 -3.549393287847614230e-33 5.511521610893899137e-01 -5.687726185110405598e-33 -1.203745802986104080e-32 5.511521610893899137e-01 6.264480079860168169e-34 -4.517670951076338410e-33 5.511521610893899137e-01 -1.069644379309003009e-36 -6.020729614302972554e-33 5.511521610893899137e-01 -8.060955391565888706e-33 -5.266866122889023921e-33 5.511521610893899137e-01 9.070959407796831379e-39 -3.007920819985351288e-33 5.511521610893899137e-01 1.931211898328097440e-34 -1.506229308853190546e-33 5.511521610893899137e-01 -1.802760076126178113e-34 -5.267933525829985385e-33 5.511521610893899137e-01 1.016813347749601594e-33 -3.008206801044675184e-33 5.511521610893899137e-01 -8.460633277420454411e-34 -5.267280259187078551e-33 5.511521610893899137e-01 5.153735354357563358e-33 -4.514880388973547146e-33 5.511521610893899137e-01 -4.026465047472468186e-33 -3.309597391467730915e-33 5.511521610893899137e-01 9.031751106761569233e-33 -3.296418435146650144e-33 5.511521610893899137e-01 -1.946778018444609176e-35 -6.266020168621704829e-33 5.511521610893899137e-01 3.461243656248069857e-33 3.369800634269440874e-33 5.511521610893899137e-01 -4.152201498676860125e-34 -4.924956201924874492e-33 5.511521610893899137e-01 5.087612203537692155e-34 -3.324764357731118827e-33 5.511521610893899137e-01 -3.636894581700903678e-34 -3.047812399090413050e-33 5.511521610893899137e-01 -1.061626469938827926e-32 -3.104531643107324429e-33 5.511521610893899137e-01 1.246768181232042828e-33 -6.565869087566140549e-33 5.511521610893899137e-01 -7.134035947390421354e-34 -3.005968420000862632e-33 5.511521610893899137e-01 2.647510627961730437e-32 -4.772570074307657881e-33 5.511521610893899137e-01 -1.749010815731762617e-32 -4.810111817991044072e-33 5.511521610893899137e-01 1.910801707555194848e-32 -4.845374235260760454e-33 5.511521610893899137e-01 -1.667092276747645340e-32 -2.995328471614479668e-33 5.511521610893899137e-01 1.806916393655533957e-32 -4.891212315286276050e-33 5.511521610893899137e-01 1.942390328511743824e-32 -4.894063380546019290e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.388619886557735543e-33 5.511521610893899137e-01 -2.272528782731722383e-33 -6.775814907502302766e-33 5.511521610893899137e-01 -2.877816604985414113e-33 -4.892480650296777516e-33 5.511521610893899137e-01 -6.739733327963650152e-33 -3.197438937453405757e-33 5.511521610893899137e-01 -2.996592268956474661e-34 -3.386411385778523483e-33 5.511521610893899137e-01 4.088771734767767148e-33 -6.582620142872433735e-33 5.511521610893899137e-01 3.463366548236675634e-33 -3.291486747752258884e-33 5.511521610893899137e-01 -3.451388966455412406e-33 -3.314779795957439418e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 new file mode 100644 index 000000000..4a5c25ee6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 @@ -0,0 +1 @@ +1.799778436423971409e-02 1.219025168772197872e-30 -2.149629174367300742e-31 1.798581963798388805e-02 -2.547749298567240989e-29 1.393727461163637243e-31 1.796167813123256476e-02 9.248305222816737997e-31 6.562428130299290628e-29 1.792493185355002738e-02 4.085533839483115743e-29 -3.889919889812817590e-29 1.787492902271115708e-02 1.354041690245903251e-31 1.898269583475151629e-32 1.781078210778701265e-02 1.415282428565477326e-30 -1.926387805552289444e-29 1.773135150706650967e-02 -1.470728288658100625e-31 -1.016522188324816620e-30 1.763522455702333513e-02 7.607428998900385867e-32 5.811202918234390726e-31 1.752068945830497979e-02 -5.691745879160194111e-32 -1.893639501625071104e-30 1.738570361799311043e-02 -6.120544238769751067e-32 -2.672007641289552916e-30 1.722785580849505241e-02 6.794270284953473327e-32 -2.074432228495144465e-30 1.704432144738322538e-02 -4.414965795742949096e-31 1.751593262715021738e-30 1.683181020539359016e-02 2.168285515390814547e-31 1.254637453596010338e-31 1.658650506770730990e-02 -1.495196759340117625e-31 7.570401156133287865e-31 1.630399191357161451e-02 2.781727869749155645e-34 3.402485386963482174e-32 1.597917866688803798e-02 5.815928248263278141e-31 8.214561457864649796e-31 1.560620313584362533e-02 -4.226938242677714770e-32 -6.112850916285418976e-35 1.517832885349972537e-02 5.482810314984024248e-34 -2.515302655945666252e-34 1.468782862579815982e-02 -2.422063877957254614e-31 9.480849026106304245e-33 1.412585619303672116e-02 2.982973084057903701e-31 8.793799817194899781e-32 1.348230756387135305e-02 -1.643443539183447700e-31 -8.214705870198037319e-32 1.274567539186835172e-02 1.577995049480980166e-31 1.623711531595984600e-32 1.190290250895358060e-02 3.012268158423843884e-33 1.292610077452696246e-32 1.093924476792008937e-02 -1.177916986927023080e-33 3.935774258612676784e-35 9.838159163957388431e-03 -1.290539357634013215e-33 3.993313283509172683e-34 8.581241374760576607e-03 -4.819831381353186080e-33 5.884341886932585872e-35 7.148247939311277131e-03 -3.164811428019896678e-33 6.443656674984563977e-33 5.517252857428797501e-03 2.703255481406595149e-33 -4.073814292903174464e-33 3.665006504697506176e-03 -1.416005646938911502e-32 3.549377186825527043e-34 1.567599311221681054e-03 2.000347947764716070e-33 -1.802926846517315153e-32 -7.811222221411782615e-04 -5.623684681962583616e-33 -1.454411642046522691e-34 -3.103007922958699559e-03 -1.838460586560540422e-33 -1.228097582379752015e-33 -5.199426999447688720e-03 3.665786754285398957e-34 -1.069644379309003009e-36 -6.973119444680726114e-03 -1.060500932882088620e-34 1.093184245933168355e-33 -8.336978678820262251e-03 -2.979666767466250584e-33 2.229590324476974472e-36 -9.425339071166433449e-03 1.312557608857429119e-34 -1.546265504241876010e-33 -1.030753342517499484e-02 1.501261960996105635e-33 2.278907910954674984e-34 -1.085143921970906783e-02 5.390389136525588787e-34 1.016813347749601594e-33 -1.088421244523845276e-02 -5.648927656619281196e-35 -1.003865248524299504e-34 -1.048488384838473612e-02 1.491106517551685953e-33 -2.785306349843858574e-34 -9.908089277260737071e-03 -4.970829372705128249e-34 -4.746510235930920077e-34 -9.180631676533910351e-03 6.070948481785306704e-34 5.916940148861884058e-34 -8.181516242304015182e-03 -3.535007175409306647e-33 -2.009372712486677764e-35 -6.851724683032456992e-03 3.163343212336492066e-35 -7.876898445206682528e-34 -5.281288580302534626e-03 1.611428068024115904e-33 -4.178389733438892408e-34 -3.803212291732335597e-03 6.171668904368829264e-36 -2.235170712664407360e-34 -2.506361257386052928e-03 -6.125133017672881067e-34 -3.636894581700903678e-34 -1.377082102084136242e-03 1.183726395400383997e-33 -5.688649430207863190e-34 -3.966108345036283489e-04 6.490322450524500754e-33 -3.445423970556099455e-34 4.666799725983937584e-04 -2.059832891718379434e-33 3.146810422034122736e-34 1.227292532381542983e-03 9.654117347840357155e-33 1.291507840463730036e-34 1.894536139817574018e-03 -1.005187012212588500e-32 9.562142754408546077e-34 2.477266634252319171e-03 8.354045048976923314e-36 -8.602391027651434444e-34 2.982891756475050671e-03 -1.077364779223984655e-34 1.952709246269234806e-34 3.407931392727246017e-03 -7.729145568591987267e-33 -3.180073628014644746e-33 3.753475245200006607e-03 -2.725462520813445041e-34 -4.516723506150108411e-34 4.031464857816904543e-03 4.078291795837875167e-33 -5.099387918464743503e-34 4.252736165035643154e-03 -4.208581604253366338e-33 -1.227443330168335911e-33 4.426443954647979982e-03 -1.738516360303765341e-33 -7.429448756720615104e-34 4.560178974122994743e-03 1.493849476002967948e-36 -2.397859825961023666e-33 4.660079425228842720e-03 3.471184117644577121e-34 -1.401187875912048392e-33 4.730930133365732898e-03 2.263513525322121667e-34 -3.641880348981279427e-34 4.776245171839331970e-03 5.066575763068170477e-35 -1.022274601875958317e-33 4.798331390832154264e-03 -8.009661784401173479e-35 1.049354263020949057e-33 1.219025168772197872e-30 5.511521610893899137e-01 4.114335215482925721e-29 -2.547749298567240989e-29 5.511521610893899137e-01 2.882047122032719151e-29 9.248305222816737997e-31 5.511521610893899137e-01 -3.471060282920869642e-28 4.085533839483115743e-29 5.511521610893899137e-01 -2.478328409548690705e-29 1.354041690245903251e-31 5.511521610893899137e-01 -4.760071514253114014e-29 1.415282428565477326e-30 5.511521610893899137e-01 -1.192390400657338190e-30 -1.470728288658100625e-31 5.511521610893899137e-01 -2.222392764189609121e-31 7.607428998900385867e-32 5.511521610893899137e-01 -2.581446728278788609e-31 -5.691745879160194111e-32 5.511521610893899137e-01 -7.536942668129204208e-32 -6.120544238769751067e-32 5.511521610893899137e-01 4.266280235830796144e-32 6.794270284953473327e-32 5.511521610893899137e-01 6.563289423335584247e-33 -4.414965795742949096e-31 5.511521610893899137e-01 -2.283605390315669631e-32 2.168285515390814547e-31 5.511521610893899137e-01 -2.059205168580225327e-31 -1.495196759340117625e-31 5.511521610893899137e-01 -2.098161439290507655e-32 2.781727869749155645e-34 5.511521610893899137e-01 -2.823718845965968353e-32 5.815928248263278141e-31 5.511521610893899137e-01 -3.157587119733249815e-32 -4.226938242677714770e-32 5.511521610893899137e-01 7.379425188619455696e-32 5.482810314984024248e-34 5.511521610893899137e-01 9.517445073193804196e-33 -2.422063877957254614e-31 5.511521610893899137e-01 6.621822711954710688e-32 2.982973084057903701e-31 5.511521610893899137e-01 2.384253162230904344e-31 -1.643443539183447700e-31 5.511521610893899137e-01 3.970739694744006864e-31 1.577995049480980166e-31 5.511521610893899137e-01 1.708044936054189412e-31 3.012268158423843884e-33 5.511521610893899137e-01 1.108558251649963851e-30 -1.177916986927023080e-33 5.511521610893899137e-01 4.844870933633260426e-32 -1.290539357634013215e-33 5.511521610893899137e-01 7.706230958198821154e-34 -4.819831381353186080e-33 5.511521610893899137e-01 -1.356668462051774935e-33 -3.164811428019896678e-33 5.511521610893899137e-01 -7.953852581409622786e-34 2.703255481406595149e-33 5.511521610893899137e-01 3.766355122431778432e-34 -1.416005646938911502e-32 5.511521610893899137e-01 -9.799885310739010467e-35 2.000347947764716070e-33 5.511521610893899137e-01 2.005233745589640025e-34 -5.623684681962583616e-33 5.511521610893899137e-01 -6.110425351671128988e-36 -1.838460586560540422e-33 5.511521610893899137e-01 -3.529957010917058842e-36 3.665786754285398957e-34 5.511521610893899137e-01 -3.314139050591534997e-36 -1.060500932882088620e-34 5.511521610893899137e-01 -6.549974620718971693e-37 -2.979666767466250584e-33 5.511521610893899137e-01 2.094272811063005541e-36 1.312557608857429119e-34 5.511521610893899137e-01 -1.653402918031087435e-36 1.501261960996105635e-33 5.511521610893899137e-01 -1.860207581066935175e-36 5.390389136525588787e-34 5.511521610893899137e-01 1.084488942099937802e-36 -5.648927656619281196e-35 5.511521610893899137e-01 -1.065283704277287659e-36 1.491106517551685953e-33 5.511521610893899137e-01 -9.773823804167548562e-37 -4.970829372705128249e-34 5.511521610893899137e-01 -1.799481661881643528e-35 6.070948481785306704e-34 5.511521610893899137e-01 -5.229508455448575678e-36 -3.535007175409306647e-33 5.511521610893899137e-01 1.288355501329216972e-34 3.163343212336492066e-35 5.511521610893899137e-01 8.635822048817139493e-33 1.611428068024115904e-33 5.511521610893899137e-01 -3.555155743341351473e-35 6.171668904368829264e-36 5.511521610893899137e-01 6.059881837107416445e-35 -6.125133017672881067e-34 5.511521610893899137e-01 1.495326014813041659e-34 1.183726395400383997e-33 5.511521610893899137e-01 1.870264363190951477e-34 6.490322450524500754e-33 5.511521610893899137e-01 2.054970988482785465e-34 -2.059832891718379434e-33 5.511521610893899137e-01 1.913261091978488926e-34 9.654117347840357155e-33 5.511521610893899137e-01 1.180459809288329567e-34 -1.005187012212588500e-32 5.511521610893899137e-01 7.957749167336128566e-35 8.354045048976923314e-36 5.511521610893899137e-01 4.378548838516980763e-35 -1.077364779223984655e-34 5.511521610893899137e-01 1.503455206200842488e-35 -7.729145568591987267e-33 5.511521610893899137e-01 -5.928056248641673425e-37 -2.725462520813445041e-34 5.511521610893899137e-01 -4.842584065038806837e-36 4.078291795837875167e-33 5.511521610893899137e-01 -3.066262945676626989e-36 -4.208581604253366338e-33 5.511521610893899137e-01 -4.835570408178955663e-36 -1.738516360303765341e-33 5.511521610893899137e-01 -2.663482672229399405e-36 1.493849476002967948e-36 5.511521610893899137e-01 1.312984183720976117e-37 3.471184117644577121e-34 5.511521610893899137e-01 -9.158691372125902189e-37 2.263513525322121667e-34 5.511521610893899137e-01 1.164346048741381478e-37 5.066575763068170477e-35 5.511521610893899137e-01 -8.702592989173307279e-38 -8.009661784401173479e-35 5.511521610893899137e-01 1.784896947985151813e-37 -2.149629174367300742e-31 4.113733362375304710e-29 5.511521610893899137e-01 1.393727461163637243e-31 2.877232297171751061e-29 5.511521610893899137e-01 6.562428130299290628e-29 -3.471120468231631743e-28 5.511521610893899137e-01 -3.889919889812817590e-29 -2.478328409548690705e-29 5.511521610893899137e-01 1.898269583475151629e-32 -4.760071514253114014e-29 5.511521610893899137e-01 -1.926387805552289444e-29 -1.198408931733548302e-30 5.511521610893899137e-01 -1.016522188324816620e-30 -2.222392764189609121e-31 5.511521610893899137e-01 5.811202918234390726e-31 -2.581446728278788609e-31 5.511521610893899137e-01 -1.893639501625071104e-30 -7.536942668129204208e-32 5.511521610893899137e-01 -2.672007641289552916e-30 4.266280235830796144e-32 5.511521610893899137e-01 -2.074432228495144465e-30 -1.751083488150486255e-32 5.511521610893899137e-01 1.751593262715021738e-30 -2.283605390315669631e-32 5.511521610893899137e-01 1.254637453596010338e-31 -2.059205168580225327e-31 5.511521610893899137e-01 7.570401156133287865e-31 -2.098161439290507655e-32 5.511521610893899137e-01 3.402485386963482174e-32 -5.231131276450012074e-32 5.511521610893899137e-01 8.214561457864649796e-31 -7.972411980701338900e-32 5.511521610893899137e-01 -6.112850916285418976e-35 2.564600327651366611e-32 5.511521610893899137e-01 -2.515302655945666252e-34 9.517445073193804196e-33 5.511521610893899137e-01 9.480849026106304245e-33 9.029235142438755505e-32 5.511521610893899137e-01 8.793799817194899781e-32 2.504623783755106585e-31 5.511521610893899137e-01 -8.214705870198037319e-32 4.091110316268209105e-31 5.511521610893899137e-01 1.623711531595984600e-32 1.692998608363664132e-31 5.511521610893899137e-01 1.292610077452696246e-32 1.105548986111858795e-30 5.511521610893899137e-01 3.935774258612676784e-35 4.243017826012249769e-32 5.511521610893899137e-01 3.993313283509172683e-34 -3.743275211337701915e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.365934000156830956e-33 5.511521610893899137e-01 6.443656674984563977e-33 -3.804650796246018128e-33 5.511521610893899137e-01 -4.073814292903174464e-33 -1.127997256809350338e-33 5.511521610893899137e-01 3.549377186825527043e-34 -1.213506100552761468e-32 5.511521610893899137e-01 -1.802926846517315153e-32 -3.561058548072355895e-33 5.511521610893899137e-01 -1.454411642046522691e-34 -1.204317257777189548e-32 5.511521610893899137e-01 -1.228097582379752015e-33 -4.517428264168501102e-33 5.511521610893899137e-01 -1.069644379309003009e-36 -6.021845215260703704e-33 5.511521610893899137e-01 1.093184245933168355e-33 -5.266869689145919479e-33 5.511521610893899137e-01 2.229590324476974472e-36 -3.007171265293993135e-33 5.511521610893899137e-01 -1.546265504241876010e-33 -1.506286171970559353e-33 5.511521610893899137e-01 2.278907910954674984e-34 -5.268074899264915187e-33 5.511521610893899137e-01 1.016813347749601594e-33 -3.008181049162955958e-33 5.511521610893899137e-01 -1.003865248524299504e-34 -5.267279975388125881e-33 5.511521610893899137e-01 -2.785306349843858574e-34 -4.514875689538000469e-33 5.511521610893899137e-01 -4.746510235930920077e-34 -3.309378998921221073e-33 5.511521610893899137e-01 5.916940148861884058e-34 -3.296613690757853670e-33 5.511521610893899137e-01 -2.009372712486677764e-35 -6.265853718340324185e-33 5.511521610893899137e-01 -7.876898445206682528e-34 3.369607357133291457e-33 5.511521610893899137e-01 -4.178389733438892408e-34 -4.925608056854129901e-33 5.511521610893899137e-01 -2.235170712664407360e-34 -3.324824911997113784e-33 5.511521610893899137e-01 -3.636894581700903678e-34 -3.047812032755317471e-33 5.511521610893899137e-01 -5.688649430207863190e-34 -3.104357745983309468e-33 5.511521610893899137e-01 -3.445423970556099455e-34 -6.565350361888098526e-33 5.511521610893899137e-01 3.146810422034122736e-34 -3.006018525038772979e-33 5.511521610893899137e-01 1.291507840463730036e-34 -4.772010518491883012e-33 5.511521610893899137e-01 9.562142754408546077e-34 -4.810479007747354619e-33 5.511521610893899137e-01 -8.602391027651434444e-34 -4.846271011035546161e-33 5.511521610893899137e-01 1.952709246269234806e-34 -2.994230986043047606e-33 5.511521610893899137e-01 -3.180073628014644746e-33 -4.890649305045580235e-33 5.511521610893899137e-01 -4.516723506150108411e-34 -4.894899083485755691e-33 5.511521610893899137e-01 -5.099387918464743503e-34 -3.388489993313865014e-33 5.511521610893899137e-01 -1.227443330168335911e-33 -6.775683031144554724e-33 5.511521610893899137e-01 -7.429448756720615104e-34 -4.892719982092945600e-33 5.511521610893899137e-01 -2.397859825961023666e-33 -3.197213335818249773e-33 5.511521610893899137e-01 -1.401187875912048392e-33 -3.386339599505401269e-33 5.511521610893899137e-01 -3.641880348981279427e-34 -6.582651929999936953e-33 5.511521610893899137e-01 -1.022274601875958317e-33 -3.291471208232297431e-33 5.511521610893899137e-01 1.049354263020949057e-33 -3.314715579624052068e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 new file mode 100644 index 000000000..ace5d2731 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 @@ -0,0 +1 @@ +1.801709400689215437e-02 1.870252469389928983e-32 3.772306472703611470e-32 1.800569290347733137e-02 2.425418466977416466e-30 1.393727461163637243e-31 1.798269078284147823e-02 7.698580410971097993e-32 7.035688929068638410e-31 1.794768418838936161e-02 8.706156194655386424e-31 -1.704042599242793723e-30 1.790005879194533911e-02 -1.627837359585986376e-30 1.898269583475151629e-32 1.783897822318526727e-02 -2.381729722385684803e-31 2.230090373758786688e-30 1.776336884076336678e-02 2.367622077266560260e-31 -1.016476588676869837e-30 1.767190015172353731e-02 -1.006517010801585865e-31 5.811589563732545292e-31 1.756296050514583734e-02 -5.694977228746045541e-32 6.913755400644628304e-31 1.743462760058129418e-02 5.260990018161603804e-31 -2.959117991882015539e-32 1.728463326462507596e-02 3.333486456369566368e-31 -4.818221347395336360e-31 1.711032185942713141e-02 1.470273958940915261e-30 1.752158823011152689e-30 1.690860160107952523e-02 2.167716327131818013e-31 1.841224833278552701e-30 1.667588798975544809e-02 -1.494740924604525302e-31 7.570401156133287865e-31 1.640803849950950993e-02 3.430290262260976874e-31 3.373401733722996796e-32 1.610027766217173376e-02 -2.962373658227604648e-32 2.105430754470588841e-31 1.574711173574207604e-02 -4.226938242677714770e-32 -5.446762673239320482e-31 1.534223231613530795e-02 5.482810314984024248e-34 -2.515302655945666252e-34 1.487840859496854760e-02 -2.664774326951202723e-32 9.365823068514941263e-33 1.434736857659678518e-02 -4.687056074656060086e-31 8.802904790080362200e-32 1.373967057257909422e-02 6.311702027893481846e-33 4.586301157546150024e-32 1.304456786816447431e-02 -1.461910636686037064e-31 1.629429939583507205e-32 1.224987183973277882e-02 3.023625359501312721e-33 -5.476281764718770536e-32 1.134182230273371103e-02 -1.177916986927023080e-33 3.031276590526414797e-35 1.030497886729738431e-02 -1.292345973754802025e-33 2.932207129696775430e-33 9.122154018600395903e-03 -4.843016817324846145e-33 5.884341886932585872e-35 7.774417984314650233e-03 -3.146125316699416021e-33 -4.431660113535341005e-33 6.241217590880353619e-03 2.703255481406595149e-33 -4.066241194489102664e-33 4.500666380616709546e-03 3.465744316476486500e-33 3.672980277890503045e-34 2.530080852587576583e-03 -6.011766506432110770e-33 2.997448148125118837e-33 3.068657059938871817e-04 -5.657456831321278243e-33 -1.412196455348154622e-34 -2.055235181163645591e-03 -1.682035059826884539e-34 2.112416578775951922e-33 -4.247755544518323420e-03 -5.807058352221019404e-33 3.091789610177026299e-33 -6.168755053402635337e-03 -1.060500932882088620e-34 1.093184245933168355e-33 -7.722865136024759797e-03 7.806236547608311400e-33 -2.371904263865415729e-36 -8.903892717692190456e-03 5.233580396036429465e-33 1.004896813333467181e-33 -9.884908864795578440e-03 1.505027898584846831e-33 4.564949712870212008e-34 -1.063058615375953204e-02 5.390389136525588787e-34 -1.334832119755790363e-33 -1.093736171125525396e-02 1.088683606055592579e-33 -1.003345707247363814e-34 -1.073704333206193344e-02 -3.015622567870276489e-33 -2.783295135507272625e-34 -1.025087691175463264e-02 -4.939098852159043306e-34 -4.746510235930920077e-34 -9.617669559340992491e-03 6.070948481785306704e-34 2.832121834794291524e-33 -8.812934136663759868e-03 -3.535007175409306647e-33 2.242904326193411519e-33 -7.688833974023862386e-03 3.163343212336492066e-35 -7.843152159624582796e-34 -6.261815907053394636e-03 -3.111295634302739543e-33 -1.220019417269349346e-34 -4.706741915362419940e-03 1.230426359528592904e-33 3.886102740456713059e-34 -3.320281673716350516e-03 -6.125133017672881067e-34 -3.636894581700903678e-34 -2.106877402484847589e-03 1.165916744376332503e-33 -5.862783709920098955e-33 -1.052621100582597051e-03 6.490322450524500754e-33 -5.893875062911622686e-33 -1.348607103235023759e-04 -2.081255929814878366e-33 -2.596174259158380855e-33 6.746727993788862940e-04 -1.479279502398157968e-32 -5.976672257611569619e-33 1.386143335776003193e-03 -1.005187012212588500e-32 9.562142754408546077e-34 2.008458733674122181e-03 8.354045048976923314e-36 -8.602391027651434444e-34 2.550007832326943447e-03 -1.077364779223984655e-34 3.736016790926291752e-33 3.018100641738330567e-03 -7.711688638639462383e-33 4.239121601808301150e-33 3.408665945440942074e-03 -2.725462520813445041e-34 3.429935640686640084e-33 3.724658918106924302e-03 -1.212324125627397849e-32 -5.112386581054691704e-34 3.977564169111118611e-03 -4.214200311327525950e-33 8.781671458729282482e-34 4.177177812447414700e-03 -1.735505821677683526e-33 -7.421922410155410565e-34 4.331647492378620616e-03 1.493849476002967948e-36 -1.525221877680855878e-34 4.447577556637734471e-03 4.950083638508133179e-33 -2.506563288518469099e-34 4.530125591774786589e-03 2.263513525322121667e-34 8.084353685595123472e-34 4.583084496499048761e-03 5.066575763068170477e-35 1.651816689170527790e-34 4.608946429057193470e-03 -8.009661784401173479e-35 6.758914310815100052e-34 1.870252469389928983e-32 5.511521610893899137e-01 4.114331810894601471e-29 2.425418466977416466e-30 5.511521610893899137e-01 2.882626282648707266e-29 7.698580410971097993e-32 5.511521610893899137e-01 -3.471057781682156163e-28 8.706156194655386424e-31 5.511521610893899137e-01 -2.479093284826504802e-29 -1.627837359585986376e-30 5.511521610893899137e-01 -4.764196667008044661e-29 -2.381729722385684803e-31 5.511521610893899137e-01 -1.202691575267287242e-30 2.367622077266560260e-31 5.511521610893899137e-01 -2.208516825998628134e-31 -1.006517010801585865e-31 5.511521610893899137e-01 -2.585512927356208926e-31 -5.694977228746045541e-32 5.511521610893899137e-01 -7.578476584024165265e-32 5.260990018161603804e-31 5.511521610893899137e-01 4.364564411634871470e-32 3.333486456369566368e-31 5.511521610893899137e-01 8.174652137514213234e-33 1.470273958940915261e-30 5.511521610893899137e-01 -3.173678765100465252e-32 2.167716327131818013e-31 5.511521610893899137e-01 -1.984835970850571401e-31 -1.494740924604525302e-31 5.511521610893899137e-01 -1.003349279266970671e-32 3.430290262260976874e-31 5.511521610893899137e-01 -3.496505108114665667e-32 -2.962373658227604648e-32 5.511521610893899137e-01 -3.072549736412839561e-32 -4.226938242677714770e-32 5.511521610893899137e-01 7.568719884743484077e-32 5.482810314984024248e-34 5.511521610893899137e-01 9.702001613305849040e-34 -2.664774326951202723e-32 5.511521610893899137e-01 6.540809380023967697e-32 -4.687056074656060086e-31 5.511521610893899137e-01 2.349297441899640856e-31 6.311702027893481846e-33 5.511521610893899137e-01 3.970254306736757534e-31 -1.461910636686037064e-31 5.511521610893899137e-01 1.702829082551505789e-31 3.023625359501312721e-33 5.511521610893899137e-01 1.108515649859955719e-30 -1.177916986927023080e-33 5.511521610893899137e-01 4.842162287042667999e-32 -1.292345973754802025e-33 5.511521610893899137e-01 7.706954215134349083e-34 -4.843016817324846145e-33 5.511521610893899137e-01 -1.341384945630975066e-33 -3.146125316699416021e-33 5.511521610893899137e-01 -7.743650155758533075e-34 2.703255481406595149e-33 5.511521610893899137e-01 3.842808249157783298e-34 3.465744316476486500e-33 5.511521610893899137e-01 -7.869646262167047071e-35 -6.011766506432110770e-33 5.511521610893899137e-01 2.018122582035714971e-34 -5.657456831321278243e-33 5.511521610893899137e-01 -1.007232929966661810e-36 -1.682035059826884539e-34 5.511521610893899137e-01 -3.707518286877727171e-36 -5.807058352221019404e-33 5.511521610893899137e-01 -5.199395389979625847e-37 -1.060500932882088620e-34 5.511521610893899137e-01 -1.105281172742548632e-36 7.806236547608311400e-33 5.511521610893899137e-01 5.053550691433800391e-36 5.233580396036429465e-33 5.511521610893899137e-01 -9.667163261075147847e-37 1.505027898584846831e-33 5.511521610893899137e-01 -1.889157129456798123e-36 5.390389136525588787e-34 5.511521610893899137e-01 1.174273785369945998e-36 1.088683606055592579e-33 5.511521610893899137e-01 -1.070182585832611062e-36 -3.015622567870276489e-33 5.511521610893899137e-01 -1.045108199912892681e-36 -4.939098852159043306e-34 5.511521610893899137e-01 -1.869374939087081262e-35 6.070948481785306704e-34 5.511521610893899137e-01 -6.155833774162642870e-36 -3.535007175409306647e-33 5.511521610893899137e-01 1.273214299150985563e-34 3.163343212336492066e-35 5.511521610893899137e-01 8.633835002662380735e-33 -3.111295634302739543e-33 5.511521610893899137e-01 -3.561952131634788319e-35 1.230426359528592904e-33 5.511521610893899137e-01 6.061302615627726133e-35 -6.125133017672881067e-34 5.511521610893899137e-01 1.491374983233796989e-34 1.165916744376332503e-33 5.511521610893899137e-01 1.824749277318427801e-34 6.490322450524500754e-33 5.511521610893899137e-01 1.999688415732405552e-34 -2.081255929814878366e-33 5.511521610893899137e-01 1.866991032115306720e-34 -1.479279502398157968e-32 5.511521610893899137e-01 1.067242963141412009e-34 -1.005187012212588500e-32 5.511521610893899137e-01 6.729644674724585598e-35 8.354045048976923314e-36 5.511521610893899137e-01 3.733776261172701441e-35 -1.077364779223984655e-34 5.511521610893899137e-01 8.599606597698550157e-36 -7.711688638639462383e-33 5.511521610893899137e-01 -5.971186761199111254e-36 -2.725462520813445041e-34 5.511521610893899137e-01 -7.678138488379691988e-36 -1.212324125627397849e-32 5.511521610893899137e-01 -4.397232944523604083e-36 -4.214200311327525950e-33 5.511521610893899137e-01 -5.623164516421098716e-36 -1.735505821677683526e-33 5.511521610893899137e-01 -3.240870642076605302e-36 1.493849476002967948e-36 5.511521610893899137e-01 8.956700534824534889e-38 4.950083638508133179e-33 5.511521610893899137e-01 -8.567856454910784429e-37 2.263513525322121667e-34 5.511521610893899137e-01 9.022108244246431799e-38 5.066575763068170477e-35 5.511521610893899137e-01 -1.158565097773380867e-37 -8.009661784401173479e-35 5.511521610893899137e-01 1.805788395031964209e-37 3.772306472703611470e-32 4.113729957786980459e-29 5.511521610893899137e-01 1.393727461163637243e-31 2.877811457787739176e-29 5.511521610893899137e-01 7.035688929068638410e-31 -3.471117966992918264e-28 5.511521610893899137e-01 -1.704042599242793723e-30 -2.479093284826504802e-29 5.511521610893899137e-01 1.898269583475151629e-32 -4.764196667008044661e-29 5.511521610893899137e-01 2.230090373758786688e-30 -1.208710106343497354e-30 5.511521610893899137e-01 -1.016476588676869837e-30 -2.208516825998628134e-31 5.511521610893899137e-01 5.811589563732545292e-31 -2.585512927356208926e-31 5.511521610893899137e-01 6.913755400644628304e-31 -7.578476584024165265e-32 5.511521610893899137e-01 -2.959117991882015539e-32 4.364564411634871470e-32 5.511521610893899137e-01 -4.818221347395336360e-31 -1.589947216732623219e-32 5.511521610893899137e-01 1.752158823011152689e-30 -3.173678765100465252e-32 5.511521610893899137e-01 1.841224833278552701e-30 -1.984835970850571401e-31 5.511521610893899137e-01 7.570401156133287865e-31 -1.003349279266970671e-32 5.511521610893899137e-01 3.373401733722996796e-32 -5.903917538598709389e-32 5.511521610893899137e-01 2.105430754470588841e-31 -7.887374597380928646e-32 5.511521610893899137e-01 -5.446762673239320482e-31 2.753895023775394444e-32 5.511521610893899137e-01 -2.515302655945666252e-34 9.702001613305849040e-34 5.511521610893899137e-01 9.365823068514941263e-33 8.948221810508012514e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.469668063423843097e-31 5.511521610893899137e-01 4.586301157546150024e-32 4.090624928260959775e-31 5.511521610893899137e-01 1.629429939583507205e-32 1.687782754860980509e-31 5.511521610893899137e-01 -5.476281764718770536e-32 1.105506384321850663e-30 5.511521610893899137e-01 3.031276590526414797e-35 4.240309179421657342e-32 5.511521610893899137e-01 2.932207129696775430e-33 -3.743202885644148780e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.350650483736030915e-33 5.511521610893899137e-01 -4.431660113535341005e-33 -3.783630553680909499e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.120351944136749894e-33 5.511521610893899137e-01 3.672980277890503045e-34 -1.211575861504189483e-32 5.511521610893899137e-01 2.997448148125118837e-33 -3.559769664427748315e-33 5.511521610893899137e-01 -1.412196455348154622e-34 -1.203806938535019083e-32 5.511521610893899137e-01 2.112416578775951922e-33 -4.517605825444461715e-33 5.511521610893899137e-01 3.091789610177026299e-33 -6.019051015749110279e-33 5.511521610893899137e-01 1.093184245933168355e-33 -5.267319972856590410e-33 5.511521610893899137e-01 -2.371904263865415729e-36 -3.004211987413622368e-33 5.511521610893899137e-01 1.004896813333467181e-33 -1.505599485378635766e-33 5.511521610893899137e-01 4.564949712870212008e-34 -5.268103848813305204e-33 5.511521610893899137e-01 -1.334832119755790363e-33 -3.008091264319686029e-33 5.511521610893899137e-01 -1.003345707247363814e-34 -5.267284874269681071e-33 5.511521610893899137e-01 -2.783295135507272625e-34 -4.514943415357496482e-33 5.511521610893899137e-01 -4.746510235930920077e-34 -3.310077931693275656e-33 5.511521610893899137e-01 2.832121834794291524e-33 -3.297540016076567957e-33 5.511521610893899137e-01 2.242904326193411519e-33 -6.267367838558147091e-33 5.511521610893899137e-01 -7.843152159624582796e-34 3.367620310978532699e-33 5.511521610893899137e-01 -1.220019417269349346e-34 -4.925676020737064307e-33 5.511521610893899137e-01 3.886102740456713059e-34 -3.324810704211910804e-33 5.511521610893899137e-01 -3.636894581700903678e-34 -3.048207135913241788e-33 5.511521610893899137e-01 -5.862783709920098955e-33 -3.108909254570561836e-33 5.511521610893899137e-01 -5.893875062911622686e-33 -6.570878619163136175e-33 5.511521610893899137e-01 -2.596174259158380855e-33 -3.010645531025091221e-33 5.511521610893899137e-01 -5.976672257611569619e-33 -4.783332203106574704e-33 5.511521610893899137e-01 9.562142754408546077e-34 -4.822760052673469995e-33 5.511521610893899137e-01 -8.602391027651434444e-34 -4.852718736808988746e-33 5.511521610893899137e-01 3.736016790926291752e-33 -3.000665931507357516e-33 5.511521610893899137e-01 4.239121601808301150e-33 -4.896027686181915068e-33 5.511521610893899137e-01 3.429935640686640084e-33 -4.897734637909096858e-33 5.511521610893899137e-01 -5.112386581054691704e-34 -3.389820963312711877e-33 5.511521610893899137e-01 8.781671458729282482e-34 -6.776470625252796823e-33 5.511521610893899137e-01 -7.421922410155410565e-34 -4.893297370062792903e-33 5.511521610893899137e-01 -1.525221877680855878e-34 -3.197255067231273288e-33 5.511521610893899137e-01 -2.506563288518469099e-34 -3.386280516013679905e-33 5.511521610893899137e-01 8.084353685595123472e-34 -6.582678143522368557e-33 5.511521610893899137e-01 1.651816689170527790e-34 -3.291500038812183029e-33 5.511521610893899137e-01 6.758914310815100052e-34 -3.314713490479347053e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 new file mode 100644 index 000000000..291a9271c --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 @@ -0,0 +1 @@ +1.804432112266367641e-02 1.409421330449194964e-30 3.802228882595608456e-32 1.803336190886439469e-02 1.062723533160975026e-30 1.393727461163637243e-31 1.801125163053411693e-02 1.386702104419931651e-30 4.869415230409048861e-32 1.797760311777902784e-02 8.707339244767703448e-31 7.688870505352508142e-31 1.793182687820524951e-02 6.704626009558033337e-31 1.898269583475151629e-32 1.787312042240506507e-02 1.869025083076677888e-30 1.231499536135263713e-31 1.780045371389215106e-02 -1.673474570203391222e-30 -1.016476588676869837e-30 1.771255046393132790e-02 -1.006517010801585865e-31 5.813868303882018801e-31 1.760786491533172446e-02 -5.685911436673960094e-32 6.913755400644628304e-31 1.748455367841220132e-02 5.260276543215873210e-31 -2.959117991882015539e-32 1.734044209792500596e-02 -2.665366460272018580e-31 1.743224163654003952e-31 1.717298454337667923e-02 -2.757076175302157245e-30 -3.615162441103835642e-31 1.697921793148403358e-02 2.167716327131818013e-31 -1.660759734682948260e-32 1.675570771334694564e-02 -4.755780731155188900e-32 2.387494942370911436e-30 1.649848550091981975e-02 -1.265818297496653836e-30 1.821350945817981609e-30 1.620297748555245623e-02 -2.962373658227604648e-32 -4.163234945023159059e-31 1.586392283893037214e-02 -1.796688997509781679e-31 -2.698772326755300077e-31 1.547528142438794538e-02 5.482810314984024248e-34 -2.562796258814976092e-31 1.503013043908538009e-02 -2.664774326951202723e-32 9.365823068514941263e-33 1.452055013832902891e-02 2.740650802503020783e-31 8.802904790080362200e-32 1.393749967633215771e-02 6.311702027893481846e-33 -3.576825382768648683e-32 1.327068549500118322e-02 -2.478366692657851076e-33 1.600581396803133040e-31 1.250842681840221536e-02 3.063386329129121957e-33 8.596287454726111535e-33 1.163752594950993521e-02 2.682283765568151242e-32 -1.609386896218923072e-33 1.064315557146978432e-02 1.108301311421255330e-32 -2.184282412892549210e-32 9.508781547471045065e-03 2.542539209632757569e-33 5.884341886932585872e-35 8.216148241559168008e-03 6.642178836896760616e-33 -4.461987934305584477e-33 6.745364548301843385e-03 2.697211393089774814e-33 -4.066241194489102664e-33 5.075142816101437665e-03 3.475453272704983204e-33 3.672980277890503045e-34 3.183259388343621064e-03 1.032070394264240496e-33 -4.058187474347944177e-33 1.047323364375913734e-03 3.897593698696004178e-33 -1.380013732107948148e-34 -1.307655263461107980e-03 -1.682035059826884539e-34 -7.809054911741957181e-34 -3.562634631395650894e-03 2.160106018361275099e-33 -2.221144025664548715e-33 -5.577236309898176737e-03 -1.060500932882088620e-34 5.996202611749455781e-33 -7.257810888474278480e-03 -1.869539276755243209e-34 -2.371904263865415729e-36 -8.534686747710663879e-03 -3.350772332347236815e-33 -6.741731574779184697e-35 -9.577783128391914591e-03 -2.565874468850511216e-33 -5.612306205718183536e-34 -1.041489662664574038e-02 -4.352800846794577006e-34 2.332430737732712415e-34 -1.089112521209250478e-02 -7.946244428741099679e-34 8.413194537401148923e-34 -1.086395641202846443e-02 -3.015622567870276489e-33 1.236751035189497686e-34 -1.044102027886548677e-02 -4.939098852159043306e-34 8.829179003792957368e-34 -9.861937689031216939e-03 -6.581729857226590560e-33 -6.158519895191060805e-33 -9.140188873589118190e-03 -3.530895042009466820e-33 -1.359581540403495286e-33 -8.144452627583584001e-03 3.163343212336492066e-35 1.260569097006284439e-34 -6.833050544570240699e-03 5.861937167396657446e-34 -5.833758326302929995e-34 -5.286062680982047887e-03 5.013218318636227726e-33 -5.570877157312373569e-34 -3.840752270771029091e-03 -8.393564298052711028e-33 1.718433903646358835e-33 -2.572074255418364559e-03 9.194525065555849818e-33 -9.042311532760118781e-34 -1.466847863185411893e-03 6.479355884011066783e-33 6.064480309580447475e-33 -5.088823375038156911e-04 -1.933193655585858080e-32 1.722399621043867116e-33 3.330489143654904549e-04 -1.479279502398157968e-32 2.989768900984245525e-33 1.073772957375441258e-03 8.597671604073580231e-33 8.244743404072263347e-35 1.722239076703683093e-03 1.579494188928886452e-35 8.829668807531083747e-33 2.286944466718735230e-03 -1.077364779223984655e-34 6.252731372642918868e-33 2.775775842928240953e-03 -7.711688638639462383e-33 -4.896698783054772646e-33 3.192849310600539853e-03 -2.725462520813445041e-34 -1.974081174953009497e-33 3.533128474645330815e-03 -9.547420366510072366e-34 2.280268829797199119e-33 3.806163237620873926e-03 1.532336354108531477e-33 -3.433371983605525850e-33 4.022191732447183248e-03 4.161925169087877536e-33 -7.423646401909025020e-34 4.189746935706888976e-03 1.493849476002967948e-36 4.130788254664797110e-34 4.315756726708988578e-03 3.419528593794266143e-34 -2.506563288518469099e-34 4.405638023762918631e-03 1.784331142119893580e-33 -1.163568616658025166e-34 4.463378049026053666e-03 8.369539444608574512e-34 1.651816689170527790e-34 4.491598266988698802e-03 -8.019546545807585765e-35 -9.036934416631003767e-34 1.409421330449194964e-30 5.511521610893899137e-01 4.111917865361087550e-29 1.062723533160975026e-30 5.511521610893899137e-01 2.884907303026033118e-29 1.386702104419931651e-30 5.511521610893899137e-01 -3.471034258093734797e-28 8.707339244767703448e-31 5.511521610893899137e-01 -2.482072749274465120e-29 6.704626009558033337e-31 5.511521610893899137e-01 -4.762279752724122361e-29 1.869025083076677888e-30 5.511521610893899137e-01 -1.218958895711070047e-30 -1.673474570203391222e-30 5.511521610893899137e-01 -2.349220698816356930e-31 -1.006517010801585865e-31 5.511521610893899137e-01 -2.614782336004479819e-31 -5.685911436673960094e-32 5.511521610893899137e-01 -6.698017490890739294e-32 5.260276543215873210e-31 5.511521610893899137e-01 5.082547480352268813e-32 -2.665366460272018580e-31 5.511521610893899137e-01 8.145685438317608205e-33 -2.757076175302157245e-30 5.511521610893899137e-01 -6.402472599173773716e-32 2.167716327131818013e-31 5.511521610893899137e-01 -1.842068139538466789e-31 -4.755780731155188900e-32 5.511521610893899137e-01 -7.521881906004319670e-33 -1.265818297496653836e-30 5.511521610893899137e-01 -3.576427225447460374e-32 -2.962373658227604648e-32 5.511521610893899137e-01 -3.152594597733007430e-32 -1.796688997509781679e-31 5.511521610893899137e-01 7.604035746541812995e-32 5.482810314984024248e-34 5.511521610893899137e-01 1.083844094875034222e-33 -2.664774326951202723e-32 5.511521610893899137e-01 6.412020190535773863e-32 2.740650802503020783e-31 5.511521610893899137e-01 2.336271532713347629e-31 6.311702027893481846e-33 5.511521610893899137e-01 3.978099258341334575e-31 -2.478366692657851076e-33 5.511521610893899137e-01 1.707057802780934355e-31 3.063386329129121957e-33 5.511521610893899137e-01 1.108640101060972195e-30 2.682283765568151242e-32 5.511521610893899137e-01 4.842147606466829586e-32 1.108301311421255330e-32 5.511521610893899137e-01 7.566335973054127237e-34 2.542539209632757569e-33 5.511521610893899137e-01 -1.341324053149783408e-33 6.642178836896760616e-33 5.511521610893899137e-01 -7.634482126704785268e-34 2.697211393089774814e-33 5.511521610893899137e-01 3.780580917812735910e-34 3.475453272704983204e-33 5.511521610893899137e-01 -6.886033285054593385e-35 1.032070394264240496e-33 5.511521610893899137e-01 1.987486337590316258e-34 3.897593698696004178e-33 5.511521610893899137e-01 -1.699224349079421196e-37 -1.682035059826884539e-34 5.511521610893899137e-01 -3.995394898050044367e-36 2.160106018361275099e-33 5.511521610893899137e-01 3.385440286988921100e-37 -1.060500932882088620e-34 5.511521610893899137e-01 -5.793029193575336347e-36 -1.869539276755243209e-34 5.511521610893899137e-01 5.419627633055729042e-36 -3.350772332347236815e-33 5.511521610893899137e-01 -1.433355851189197240e-36 -2.565874468850511216e-33 5.511521610893899137e-01 -1.998516990124010069e-36 -4.352800846794577006e-34 5.511521610893899137e-01 1.174171074729040136e-36 -7.946244428741099679e-34 5.511521610893899137e-01 -1.074202084097573588e-36 -3.015622567870276489e-33 5.511521610893899137e-01 -1.037241542460244644e-36 -4.939098852159043306e-34 5.511521610893899137e-01 -1.874161178853949314e-35 -6.581729857226590560e-33 5.511521610893899137e-01 -5.785223906159868245e-36 -3.530895042009466820e-33 5.511521610893899137e-01 1.271754028536620153e-34 3.163343212336492066e-35 5.511521610893899137e-01 8.634097139393541480e-33 5.861937167396657446e-34 5.511521610893899137e-01 -3.550708002483374411e-35 5.013218318636227726e-33 5.511521610893899137e-01 6.090157415235210673e-35 -8.393564298052711028e-33 5.511521610893899137e-01 1.491430635161527278e-34 9.194525065555849818e-33 5.511521610893899137e-01 1.824422890713884993e-34 6.479355884011066783e-33 5.511521610893899137e-01 2.004249528347693347e-34 -1.933193655585858080e-32 5.511521610893899137e-01 1.890813613059016630e-34 -1.479279502398157968e-32 5.511521610893899137e-01 1.088634952614288462e-34 8.597671604073580231e-33 5.511521610893899137e-01 6.762503370702183158e-35 1.579494188928886452e-35 5.511521610893899137e-01 3.972703379115322034e-35 -1.077364779223984655e-34 5.511521610893899137e-01 1.026686045672795007e-35 -7.711688638639462383e-33 5.511521610893899137e-01 -5.304625682845452319e-36 -2.725462520813445041e-34 5.511521610893899137e-01 -6.806957189859287814e-36 -9.547420366510072366e-34 5.511521610893899137e-01 -3.902989090438313080e-36 1.532336354108531477e-33 5.511521610893899137e-01 -5.406580765841531974e-36 4.161925169087877536e-33 5.511521610893899137e-01 -3.171986855925060054e-36 1.493849476002967948e-36 5.511521610893899137e-01 9.580544734040440899e-38 3.419528593794266143e-34 5.511521610893899137e-01 -8.947562486808009407e-37 1.784331142119893580e-33 5.511521610893899137e-01 8.947550998143539446e-38 8.369539444608574512e-34 5.511521610893899137e-01 -1.282577352568352558e-37 -8.019546545807585765e-35 5.511521610893899137e-01 1.752723524745863905e-37 3.802228882595608456e-32 4.111316012253466539e-29 5.511521610893899137e-01 1.393727461163637243e-31 2.880092478165065028e-29 5.511521610893899137e-01 4.869415230409048861e-32 -3.471094443404496898e-28 5.511521610893899137e-01 7.688870505352508142e-31 -2.482072749274465120e-29 5.511521610893899137e-01 1.898269583475151629e-32 -4.762279752724122361e-29 5.511521610893899137e-01 1.231499536135263713e-31 -1.224977426787280159e-30 5.511521610893899137e-01 -1.016476588676869837e-30 -2.349220698816356930e-31 5.511521610893899137e-01 5.813868303882018801e-31 -2.614782336004479819e-31 5.511521610893899137e-01 6.913755400644628304e-31 -6.698017490890739294e-32 5.511521610893899137e-01 -2.959117991882015539e-32 5.082547480352268813e-32 5.511521610893899137e-01 1.743224163654003952e-31 -1.592843886652283859e-32 5.511521610893899137e-01 -3.615162441103835642e-31 -6.402472599173773716e-32 5.511521610893899137e-01 -1.660759734682948260e-32 -1.842068139538466789e-31 5.511521610893899137e-01 2.387494942370911436e-30 -7.521881906004319670e-33 5.511521610893899137e-01 1.821350945817981609e-30 -5.983839655931504096e-32 5.511521610893899137e-01 -4.163234945023159059e-31 -7.967419458701096515e-32 5.511521610893899137e-01 -2.698772326755300077e-31 2.789210885573723362e-32 5.511521610893899137e-01 -2.562796258814976092e-31 1.083844094875034222e-33 5.511521610893899137e-01 9.365823068514941263e-33 8.819432621019818679e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.456642154237549870e-31 5.511521610893899137e-01 -3.576825382768648683e-32 4.098469879865536816e-31 5.511521610893899137e-01 1.600581396803133040e-31 1.692011475090409074e-31 5.511521610893899137e-01 8.596287454726111535e-33 1.105630835522867139e-30 5.511521610893899137e-01 -1.609386896218923072e-33 4.240294498845818930e-32 5.511521610893899137e-01 -2.184282412892549210e-32 -3.757264709852171136e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.350589591254839086e-33 5.511521610893899137e-01 -4.461987934305584477e-33 -3.772713750775534718e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.126574677271254676e-33 5.511521610893899137e-01 3.672980277890503045e-34 -1.210592248527077012e-32 5.511521610893899137e-01 -4.058187474347944177e-33 -3.562833288872288186e-33 5.511521610893899137e-01 -1.380013732107948148e-34 -1.203723207485513256e-32 5.511521610893899137e-01 -7.809054911741957181e-34 -4.517893702055634297e-33 5.511521610893899137e-01 -2.221144025664548715e-33 -6.018192532181413170e-33 5.511521610893899137e-01 5.996202611749455781e-33 -5.272007720877423321e-33 5.511521610893899137e-01 -2.371904263865415729e-36 -3.003845910472000465e-33 5.511521610893899137e-01 -6.741731574779184697e-35 -1.506066124903717487e-33 5.511521610893899137e-01 -5.612306205718183536e-34 -5.268213208673972136e-33 5.511521610893899137e-01 2.332430737732712415e-34 -3.008091367030327034e-33 5.511521610893899137e-01 8.413194537401148923e-34 -5.267288893767945697e-33 5.511521610893899137e-01 1.236751035189497686e-34 -4.514935548700044084e-33 5.511521610893899137e-01 8.829179003792957368e-34 -3.310125794090944090e-33 5.511521610893899137e-01 -6.158519895191060805e-33 -3.297169406208565213e-33 5.511521610893899137e-01 -1.359581540403495286e-33 -6.267513865619583546e-33 5.511521610893899137e-01 1.260569097006284439e-34 3.367882447709694129e-33 5.511521610893899137e-01 -5.833758326302929995e-34 -4.925563579445549836e-33 5.511521610893899137e-01 -5.570877157312373569e-34 -3.324522156215835916e-33 5.511521610893899137e-01 1.718433903646358835e-33 -3.048201570720468652e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.108941893231015967e-33 5.511521610893899137e-01 6.064480309580447475e-33 -6.570422507901606968e-33 5.511521610893899137e-01 1.722399621043867116e-33 -3.008263272930720230e-33 5.511521610893899137e-01 2.989768900984245525e-33 -4.781193004159287358e-33 5.511521610893899137e-01 8.244743404072263347e-35 -4.822431465713694137e-33 5.511521610893899137e-01 8.829668807531083747e-33 -4.850329465629562497e-33 5.511521610893899137e-01 6.252731372642918868e-33 -2.998998677648328276e-33 5.511521610893899137e-01 -4.896698783054772646e-33 -4.895361125103561357e-33 5.511521610893899137e-01 -1.974081174953009497e-33 -4.896863456610576203e-33 5.511521610893899137e-01 2.280268829797199119e-33 -3.389326719458626852e-33 5.511521610893899137e-01 -3.433371983605525850e-33 -6.776254041502216780e-33 5.511521610893899137e-01 -7.423646401909025020e-34 -4.893228486276641382e-33 5.511521610893899137e-01 4.130788254664797110e-34 -3.197248828789281084e-33 5.511521610893899137e-01 -2.506563288518469099e-34 -3.386318486616869476e-33 5.511521610893899137e-01 -1.163568616658025166e-34 -6.582678889094829215e-33 5.511521610893899137e-01 1.651816689170527790e-34 -3.291512440037662392e-33 5.511521610893899137e-01 -9.036934416631003767e-34 -3.314718796966375808e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 new file mode 100644 index 000000000..245d735ad --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 @@ -0,0 +1 @@ +1.805761600264701311e-02 1.409421330449194964e-30 3.791443320103482540e-32 1.804691184049187630e-02 1.062827799345986936e-30 1.393988126626167016e-31 1.802531658659698929e-02 -2.012542319488162019e-31 -1.539237796364254074e-30 1.799245301295517366e-02 -2.154544498282114946e-30 7.687985358095770542e-31 1.794774679027047112e-02 6.705407144447153410e-31 1.906080932366352633e-32 1.789041612119665614e-02 5.503853486405646783e-31 1.231499536135263713e-31 1.781945760947587290e-02 -1.673474570203391222e-30 4.969750700253189050e-31 1.773362809608793750e-02 -1.006399579877223115e-31 -2.450391713601550534e-31 1.763142211758921343e-02 -5.683994427484644451e-32 6.139480083342183026e-32 1.751104456315425578e-02 -3.679893743179468845e-31 1.939285398483593982e-31 1.737037802532987937e-02 1.330694110468978144e-31 -6.248896977827989497e-31 1.720694425521140242e-02 -8.797647488600853050e-32 -3.613594590129044464e-31 1.701785904989592743e-02 2.168952821877497262e-31 -1.685489629596535144e-32 1.679977982418905114e-02 1.072656372310652428e-30 1.469694771816673888e-31 1.654884505949806225e-02 7.168187815833642267e-31 1.821655066242736027e-30 1.626060479445498932e-02 -2.965344071836276016e-32 -4.163234945023159059e-31 1.592994135096987424e-02 -1.796225338613371251e-31 -2.699699644548120933e-31 1.555097960701775327e-02 5.482810314984024248e-34 4.274949384107784734e-31 1.511698639147877540e-02 2.752312077069242928e-31 9.478717216224903081e-33 1.462025905830787592e-02 7.203214565276606173e-33 8.802904790080362200e-32 1.405200410851620806e-02 6.380642315495872987e-33 -2.470616529648640127e-32 1.340220801717666513e-02 4.152160829799634761e-31 -4.882959606214692195e-32 1.265950439265974871e-02 3.063386329129121957e-33 5.488327734988232200e-32 1.181104451385940439e-02 -1.425956100956308518e-32 3.948972551949973258e-32 1.084238249425841308e-02 -1.174971233247231040e-32 1.467896205484483944e-32 9.737392212724934118e-03 -1.527679930058262571e-33 -1.622728334194530676e-32 8.478241168063224004e-03 -6.321951170828711093e-34 1.009095269639372584e-32 7.045456964980040607e-03 -3.823407570479320152e-33 -4.066241194489102664e-33 5.418135454767793006e-03 1.374188111140489639e-32 -2.563824720130054099e-33 3.574355444654529756e-03 -1.620590543036386185e-33 -8.364684178173658519e-35 1.491882338539318037e-03 2.879648838369351615e-34 -1.340981708040922803e-33 -8.354337967466054409e-04 -1.682035059826884539e-34 -7.805232285484782430e-34 -3.123589675081596927e-03 2.160106018361275099e-33 -2.024927040724557008e-34 -5.190393761742326945e-03 7.378179953081242236e-33 2.257412927744100416e-33 -6.943584490877732600e-03 -1.869539276755243209e-34 -2.613690742523013622e-36 -8.294556692145172577e-03 3.646519531589362870e-33 -6.741731574779184697e-35 -9.373856081621964251e-03 5.648551718150260103e-34 1.004911441479089579e-33 -1.025559093209626842e-02 -4.338473194193477704e-34 -5.184214008118828885e-34 -1.083065636595820225e-02 2.119832002711290432e-33 2.298379463647810836e-33 -1.091493526085888371e-02 -3.015622567870276489e-33 6.582914481665234623e-34 -1.055033899671229368e-02 3.025736258488239067e-33 -5.253802576869495765e-34 -1.000577501772464267e-02 4.638719740046352135e-33 7.867353815190463358e-33 -9.321498505030591242e-03 -3.530895042009466820e-33 2.602794223550400509e-33 -8.408339129547817703e-03 -3.251437603056696360e-34 1.262180556773353332e-34 -7.173166148704137463e-03 4.584986485963824885e-33 8.707306289057649163e-34 -5.666490983690903628e-03 -3.939659913135530780e-33 9.345294637592855281e-34 -4.184478824136440671e-03 -6.989032654287877954e-34 1.716932213358961582e-33 -2.881033083285400136e-03 1.222267445625011048e-33 -9.042311532760118781e-34 -1.743507277141761623e-03 1.508854035999832956e-33 -5.622755668895527717e-34 -7.576172253194132268e-04 6.710874656876233107e-33 1.722399621043867116e-33 1.047464364624914367e-04 2.299358678432296483e-32 -6.080545366322808843e-34 8.639989970993660088e-04 -4.548476114407360038e-33 3.838010613405255521e-33 1.529091178297889908e-03 8.836395442841935703e-33 -2.932755047303569183e-33 2.108568454861107881e-03 -8.284073467953947913e-33 -1.827627959745173091e-32 2.610395794717391450e-03 2.932761959762336215e-33 3.619148956511313883e-33 3.041523665627441156e-03 1.940440036357583108e-33 2.389051134859181145e-34 3.398003030600520516e-03 2.486608055228097660e-33 -1.377964295380245540e-32 3.684529859286169752e-03 1.532336354108531477e-33 1.308953829062360029e-33 3.911609371573238243e-03 -4.383683774031964527e-33 1.088904753600586791e-33 4.088009183123506897e-03 1.462803637524868075e-36 -2.128052782520143612e-34 4.220855284296411852e-03 2.898236950839277052e-33 -2.503974908514965981e-34 4.315724034851960676e-03 -8.124208054879120773e-34 1.271011556946934550e-34 4.376722471212647451e-03 -2.703415192906141797e-34 -1.629185103944478011e-34 4.406551935599332254e-03 -8.019546545807585765e-35 1.735230922648109921e-33 1.409421330449194964e-30 5.511521610893899137e-01 4.109678511081683674e-29 1.062827799345986936e-30 5.511521610893899137e-01 2.884150692069667555e-29 -2.012542319488162019e-31 5.511521610893899137e-01 -3.471069558968689050e-28 -2.154544498282114946e-30 5.511521610893899137e-01 -2.482649640250264392e-29 6.705407144447153410e-31 5.511521610893899137e-01 -4.763139161610846482e-29 5.503853486405646783e-31 5.511521610893899137e-01 -1.222861747139933484e-30 -1.673474570203391222e-30 5.511521610893899137e-01 -2.358638285914408749e-31 -1.006399579877223115e-31 5.511521610893899137e-01 -2.616591702060852752e-31 -5.683994427484644451e-32 5.511521610893899137e-01 -6.699012561171022208e-32 -3.679893743179468845e-31 5.511521610893899137e-01 5.107511310605744606e-32 1.330694110468978144e-31 5.511521610893899137e-01 7.548698108543963107e-33 -8.797647488600853050e-32 5.511521610893899137e-01 -6.238107590593755315e-32 2.168952821877497262e-31 5.511521610893899137e-01 -2.245044367091578993e-31 1.072656372310652428e-30 5.511521610893899137e-01 -1.729180389140164311e-33 7.168187815833642267e-31 5.511521610893899137e-01 -5.008965900054580210e-32 -2.965344071836276016e-32 5.511521610893899137e-01 -3.699969942877761107e-32 -1.796225338613371251e-31 5.511521610893899137e-01 7.827456163148242792e-32 5.482810314984024248e-34 5.511521610893899137e-01 2.300951961293530376e-33 2.752312077069242928e-31 5.511521610893899137e-01 6.590855024682098826e-32 7.203214565276606173e-33 5.511521610893899137e-01 2.333855258248745653e-31 6.380642315495872987e-33 5.511521610893899137e-01 3.978040409136271573e-31 4.152160829799634761e-31 5.511521610893899137e-01 1.704835696629792891e-31 3.063386329129121957e-33 5.511521610893899137e-01 1.108560532643517835e-30 -1.425956100956308518e-32 5.511521610893899137e-01 4.838644581117076359e-32 -1.174971233247231040e-32 5.511521610893899137e-01 7.533326027263965140e-34 -1.527679930058262571e-33 5.511521610893899137e-01 -1.341904373696786305e-33 -6.321951170828711093e-34 5.511521610893899137e-01 -7.613354049345748477e-34 -3.823407570479320152e-33 5.511521610893899137e-01 3.792230165415608834e-34 1.374188111140489639e-32 5.511521610893899137e-01 -6.867495010946281092e-35 -1.620590543036386185e-33 5.511521610893899137e-01 1.987198874525490931e-34 2.879648838369351615e-34 5.511521610893899137e-01 -1.982874188626154574e-37 -1.682035059826884539e-34 5.511521610893899137e-01 -3.815527954194791792e-36 2.160106018361275099e-33 5.511521610893899137e-01 8.465965153656699045e-37 7.378179953081242236e-33 5.511521610893899137e-01 -6.500364458767885375e-36 -1.869539276755243209e-34 5.511521610893899137e-01 5.343485907019659284e-36 3.646519531589362870e-33 5.511521610893899137e-01 -1.472667836074892705e-36 5.648551718150260103e-34 5.511521610893899137e-01 -1.880258932770736361e-36 -4.338473194193477704e-34 5.511521610893899137e-01 1.099637698887633153e-36 2.119832002711290432e-33 5.511521610893899137e-01 -1.059421299099188549e-36 -3.015622567870276489e-33 5.511521610893899137e-01 -1.033516908815799093e-36 3.025736258488239067e-33 5.511521610893899137e-01 -1.872768450327034567e-35 4.638719740046352135e-33 5.511521610893899137e-01 -5.932542027717243014e-36 -3.530895042009466820e-33 5.511521610893899137e-01 1.271707758396048074e-34 -3.251437603056696360e-34 5.511521610893899137e-01 8.634091697154241273e-33 4.584986485963824885e-33 5.511521610893899137e-01 -3.552362954111236193e-35 -3.939659913135530780e-33 5.511521610893899137e-01 6.096828260615472791e-35 -6.989032654287877954e-34 5.511521610893899137e-01 1.493258605624862016e-34 1.222267445625011048e-33 5.511521610893899137e-01 1.823697137081214433e-34 1.508854035999832956e-33 5.511521610893899137e-01 2.004950397571597836e-34 6.710874656876233107e-33 5.511521610893899137e-01 1.890765892900594591e-34 2.299358678432296483e-32 5.511521610893899137e-01 1.085552567163162661e-34 -4.548476114407360038e-33 5.511521610893899137e-01 6.771502876237034066e-35 8.836395442841935703e-33 5.511521610893899137e-01 3.958857412899519727e-35 -8.284073467953947913e-33 5.511521610893899137e-01 9.910181914135898215e-36 2.932761959762336215e-33 5.511521610893899137e-01 -5.478985241836660105e-36 1.940440036357583108e-33 5.511521610893899137e-01 -6.901809519328158182e-36 2.486608055228097660e-33 5.511521610893899137e-01 -3.958003497215862471e-36 1.532336354108531477e-33 5.511521610893899137e-01 -5.502918800263140589e-36 -4.383683774031964527e-33 5.511521610893899137e-01 -3.179453685899519367e-36 1.462803637524868075e-36 5.511521610893899137e-01 9.397075247079383502e-38 2.898236950839277052e-33 5.511521610893899137e-01 -9.561413535056866417e-37 -8.124208054879120773e-34 5.511521610893899137e-01 8.905228143544522530e-38 -2.703415192906141797e-34 5.511521610893899137e-01 -1.284584864072890547e-37 -8.019546545807585765e-35 5.511521610893899137e-01 1.669911490670958511e-37 3.791443320103482540e-32 4.109076657974062663e-29 5.511521610893899137e-01 1.393988126626167016e-31 2.879335867208699465e-29 5.511521610893899137e-01 -1.539237796364254074e-30 -3.471129744279451151e-28 5.511521610893899137e-01 7.687985358095770542e-31 -2.482649640250264392e-29 5.511521610893899137e-01 1.906080932366352633e-32 -4.763139161610846482e-29 5.511521610893899137e-01 1.231499536135263713e-31 -1.228880278216143596e-30 5.511521610893899137e-01 4.969750700253189050e-31 -2.358638285914408749e-31 5.511521610893899137e-01 -2.450391713601550534e-31 -2.616591702060852752e-31 5.511521610893899137e-01 6.139480083342183026e-32 -6.699012561171022208e-32 5.511521610893899137e-01 1.939285398483593982e-31 5.107511310605744606e-32 5.511521610893899137e-01 -6.248896977827989497e-31 -1.652542619629648506e-32 5.511521610893899137e-01 -3.613594590129044464e-31 -6.238107590593755315e-32 5.511521610893899137e-01 -1.685489629596535144e-32 -2.245044367091578993e-31 5.511521610893899137e-01 1.469694771816673888e-31 -1.729180389140164311e-33 5.511521610893899137e-01 1.821655066242736027e-30 -7.416378330538623932e-32 5.511521610893899137e-01 -4.163234945023159059e-31 -8.514794803845850192e-32 5.511521610893899137e-01 -2.699699644548120933e-31 3.012631302180153706e-32 5.511521610893899137e-01 4.274949384107784734e-31 2.300951961293530376e-33 5.511521610893899137e-01 9.478717216224903081e-33 8.998267455166143642e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.454225879772947893e-31 5.511521610893899137e-01 -2.470616529648640127e-32 4.098411030660473814e-31 5.511521610893899137e-01 -4.882959606214692195e-32 1.689789368939267611e-31 5.511521610893899137e-01 5.488327734988232200e-32 1.105551267105412779e-30 5.511521610893899137e-01 3.948972551949973258e-32 4.236791473496065703e-32 5.511521610893899137e-01 1.467896205484483944e-32 -3.760565704431187602e-33 5.511521610893899137e-01 -1.622728334194530676e-32 -4.351169911801842326e-33 5.511521610893899137e-01 1.009095269639372584e-32 -3.770600943039630783e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.125409752510967341e-33 5.511521610893899137e-01 -2.563824720130054099e-33 -1.210573710252968691e-32 5.511521610893899137e-01 -8.364684178173658519e-35 -3.562862035178770419e-33 5.511521610893899137e-01 -1.340981708040922803e-33 -1.203726043983908681e-32 5.511521610893899137e-01 -7.805232285484782430e-34 -4.517713835111779152e-33 5.511521610893899137e-01 -2.024927040724557008e-34 -6.017684479694746072e-33 5.511521610893899137e-01 2.257412927744100416e-33 -5.272715056142616008e-33 5.511521610893899137e-01 -2.613690742523013622e-36 -3.003922052198036592e-33 5.511521610893899137e-01 -6.741731574779184697e-35 -1.506105436888603236e-33 5.511521610893899137e-01 1.004911441479089579e-33 -5.268094950616619123e-33 5.511521610893899137e-01 -5.184214008118828885e-34 -3.008165900406168430e-33 5.511521610893899137e-01 2.298379463647810836e-33 -5.267274112982947432e-33 5.511521610893899137e-01 6.582914481665234623e-34 -4.514931824066399512e-33 5.511521610893899137e-01 -5.253802576869495765e-34 -3.310111866805675240e-33 5.511521610893899137e-01 7.867353815190463358e-33 -3.297316724330122850e-33 5.511521610893899137e-01 2.602794223550400509e-33 -6.267518492633640369e-33 5.511521610893899137e-01 1.262180556773353332e-34 3.367877005470394605e-33 5.511521610893899137e-01 8.707306289057649163e-34 -4.925580128961828294e-33 5.511521610893899137e-01 9.345294637592855281e-34 -3.324455447762033530e-33 5.511521610893899137e-01 1.716932213358961582e-33 -3.048018773674135264e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.109014468594283237e-33 5.511521610893899137e-01 -5.622755668895527717e-34 -6.570352420979215920e-33 5.511521610893899137e-01 1.722399621043867116e-33 -3.008268044946562605e-33 5.511521610893899137e-01 -6.080545366322808843e-34 -4.781501242704400259e-33 5.511521610893899137e-01 3.838010613405255521e-33 -4.822341470658345308e-33 5.511521610893899137e-01 -2.932755047303569183e-33 -4.850467925291720360e-33 5.511521610893899137e-01 -1.827627959745173091e-32 -2.999355356190920271e-33 5.511521610893899137e-01 3.619148956511313883e-33 -4.895535484662552603e-33 5.511521610893899137e-01 2.389051134859181145e-34 -4.896958308940044797e-33 5.511521610893899137e-01 -1.377964295380245540e-32 -3.389381733865404280e-33 5.511521610893899137e-01 1.308953829062360029e-33 -6.776350379536638100e-33 5.511521610893899137e-01 1.088904753600586791e-33 -4.893235953106615606e-33 5.511521610893899137e-01 -2.128052782520143612e-34 -3.197250663484150737e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386379871721694157e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582679312323374569e-33 5.511521610893899137e-01 -1.629185103944478011e-34 -3.291512640788812789e-33 5.511521610893899137e-01 1.735230922648109921e-33 -3.314727078169783218e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 new file mode 100644 index 000000000..2b5dc8767 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 @@ -0,0 +1 @@ +1.806711336598328804e-02 1.409421330449194964e-30 3.791443320103482540e-32 1.805657788473700315e-02 1.062827799345986936e-30 -1.292581316342299398e-30 1.803532315507581918e-02 1.180769493513372141e-30 1.224883545742278985e-30 1.800297833654828858e-02 4.702500847272684229e-31 7.687985358095770542e-31 1.795897884004885731e-02 6.705698914802670139e-31 1.903163228811187253e-32 1.790255615419862958e-02 5.503853486405646783e-31 -4.442596643541410612e-31 1.783272397975311369e-02 4.011006079294889920e-31 -5.403333301397521871e-31 1.774826040735070012e-02 -1.006399579877223115e-31 2.247527024521629837e-31 1.764768579987054456e-02 -5.683994427484644451e-32 9.063282885881363816e-31 1.752923596687258612e-02 9.739837602568446055e-33 -5.615519624455993469e-31 1.739083013318851526e-02 -5.393187370346192394e-31 4.748096114124831692e-32 1.723003312461110145e-02 -1.280628529538821202e-30 2.349940842800636697e-31 1.704401110992252028e-02 -3.106560090443000140e-31 -1.685489629596535144e-32 1.682948016254097803e-02 1.072656372310652428e-30 1.469694771816673888e-31 1.658264684441760131e-02 -9.263641715558220427e-31 1.785243406463995023e-31 1.629913998435786673e-02 -2.965344071836276016e-32 -4.162423886925431250e-31 1.597393284255928247e-02 -2.017755089059754883e-32 -2.699070359958201799e-31 1.560125496213432550e-02 5.238698115317381787e-34 1.550899281276668078e-30 1.517449324991218020e-02 -2.196649816182515576e-31 5.043749065414007522e-31 1.468608228250591410e-02 7.173760446969209747e-33 8.802904790080362200e-32 1.412738459674193862e-02 6.380642315495872987e-33 -2.470616529648640127e-32 1.348856294507621081e-02 -9.781909590741513190e-33 -3.888458781806910150e-31 1.275844836638341008e-02 -1.573038638744831542e-32 5.488327734988232200e-32 1.192441070305258824e-02 2.393222809928629309e-33 -2.712690164858815077e-32 1.097224220731497953e-02 -1.174971233247231040e-32 -9.977164535934985846e-35 9.886070519491550745e-03 -1.524253962930136058e-33 -3.074995537067733714e-33 8.648324997547005705e-03 -6.321951170828711093e-34 -4.575739739925714751e-33 7.239790543698054748e-03 -3.827776008141302375e-33 -4.066241194489102664e-33 5.639795965338170042e-03 -1.455504942207753933e-32 2.150567978989621741e-33 3.826599396527695200e-03 2.636026561498492949e-33 -8.594012710484557682e-33 1.778050499221967354e-03 2.885542115883947223e-34 -3.774308344045064080e-34 -5.232206783301683161e-04 -1.682035059826884539e-34 9.936966919309771973e-35 -2.831879899226090978e-03 2.160106018361275099e-33 1.411430311854760236e-33 -4.931257503353858249e-03 -8.602645705920587643e-35 -3.714517189026420107e-33 -6.729993609239199107e-03 -2.972566291740817352e-33 -2.788226054807816039e-33 -8.135174008484019267e-03 3.648695857140544478e-33 5.173174611498185701e-33 -9.237347591479757453e-03 5.651005434159133659e-34 1.004420698277314868e-33 -1.014698800645182086e-02 -5.206406984452160238e-33 -5.184214008118828885e-34 -1.077926951605447450e-02 2.119832002711290432e-33 2.298379463647810836e-33 -1.093428609128605650e-02 -3.015421174779958754e-33 2.913088487362088749e-33 -1.061618448698502595e-02 -4.754132794684438376e-33 -5.257717173353933981e-34 -1.009354934550890821e-02 -4.203984796617222785e-33 -9.753507214731115624e-34 -9.430222685311991440e-03 5.335039079714446464e-33 -6.263139898173513117e-33 -8.566057161918480545e-03 -3.259384816415664526e-34 4.605267504791728498e-33 -7.379627388203574036e-03 -4.531250053637266733e-33 8.707306289057649163e-34 -5.911702033722796706e-03 -1.608063158613080095e-33 -1.398793121077393480e-33 -4.406180628828078143e-03 -6.979888567629792538e-34 -6.843049430542406552e-34 -3.080199348376857355e-03 1.220313526918869399e-33 -9.042311532760118781e-34 -1.921731481273175265e-03 1.508854035999832956e-33 -5.664766445869374180e-34 -9.168351317392290766e-04 -3.990061490866478591e-33 -8.978536526698844924e-33 -4.109022705331527819e-05 7.236292230237556541e-34 -5.982309999929781922e-34 7.301963518011125604e-04 -4.548476114407360038e-33 3.832685179751328113e-33 1.406084070286037343e-03 8.836395442841935703e-33 -2.932755047303569183e-33 1.995149761950515150e-03 1.683777575254716931e-32 -1.827627959745173091e-32 2.505409581427200764e-03 2.932761959762336215e-33 3.619148956511313883e-33 2.944200587550648007e-03 -1.159682692093020224e-32 2.389051134859181145e-34 3.311049968435234719e-03 -4.516448044940250150e-33 7.230496779092677483e-33 3.606278702120196272e-03 -5.691170918874049770e-33 1.307920275296015364e-33 3.840479891835154279e-03 6.754265949370798883e-33 1.088904753600586791e-33 4.022574995710576605e-03 1.462803637524868075e-36 -2.125190800330826990e-34 4.159820032485237427e-03 -9.767636771861241842e-34 -2.503974908514965981e-34 4.257896095069992407e-03 -8.124208054879120773e-34 1.271011556946934550e-34 4.320988971261963650e-03 5.365807209145916773e-34 -1.627622228731936620e-34 4.351852527843493544e-03 -1.078387385112303824e-33 -2.609950498376899706e-34 1.409421330449194964e-30 5.511521610893899137e-01 4.109038320034489288e-29 1.062827799345986936e-30 5.511521610893899137e-01 2.884519767204063391e-29 1.180769493513372141e-30 5.511521610893899137e-01 -3.471029240878280159e-28 4.702500847272684229e-31 5.511521610893899137e-01 -2.482913206110615654e-29 6.705698914802670139e-31 5.511521610893899137e-01 -4.762745872744839086e-29 5.503853486405646783e-31 5.511521610893899137e-01 -1.220446525323430312e-30 4.011006079294889920e-31 5.511521610893899137e-01 -2.327114933879150980e-31 -1.006399579877223115e-31 5.511521610893899137e-01 -2.609694446083101317e-31 -5.683994427484644451e-32 5.511521610893899137e-01 -6.813645921479329469e-32 9.739837602568446055e-33 5.511521610893899137e-01 5.052296712245193520e-32 -5.393187370346192394e-31 5.511521610893899137e-01 6.742443697242529811e-33 -1.280628529538821202e-30 5.511521610893899137e-01 -5.979600512855226819e-32 -3.106560090443000140e-31 5.511521610893899137e-01 -2.254652443717403436e-31 1.072656372310652428e-30 5.511521610893899137e-01 -1.835088247219043480e-32 -9.263641715558220427e-31 5.511521610893899137e-01 -4.379169768228529425e-32 -2.965344071836276016e-32 5.511521610893899137e-01 -3.212800472530549036e-32 -2.017755089059754883e-32 5.511521610893899137e-01 7.894942837571399296e-32 5.238698115317381787e-34 5.511521610893899137e-01 4.354859286719888466e-34 -2.196649816182515576e-31 5.511521610893899137e-01 6.462118883197823475e-32 7.173760446969209747e-33 5.511521610893899137e-01 2.316516037742253615e-31 6.380642315495872987e-33 5.511521610893899137e-01 3.968667318365815120e-31 -9.781909590741513190e-33 5.511521610893899137e-01 1.704022483468703161e-31 -1.573038638744831542e-32 5.511521610893899137e-01 1.108583391856955513e-30 2.393222809928629309e-33 5.511521610893899137e-01 4.839510252324944016e-32 -1.174971233247231040e-32 5.511521610893899137e-01 7.641576859304135297e-34 -1.524253962930136058e-33 5.511521610893899137e-01 -1.339305856778594244e-33 -6.321951170828711093e-34 5.511521610893899137e-01 -7.607516662531926255e-34 -3.827776008141302375e-33 5.511521610893899137e-01 3.785970087242830488e-34 -1.455504942207753933e-32 5.511521610893899137e-01 -6.982170696299638299e-35 2.636026561498492949e-33 5.511521610893899137e-01 1.980329397432504876e-34 2.885542115883947223e-34 5.511521610893899137e-01 -2.654513132401053575e-37 -1.682035059826884539e-34 5.511521610893899137e-01 -3.875412129620557616e-36 2.160106018361275099e-33 5.511521610893899137e-01 5.191507755215942904e-37 -8.602645705920587643e-35 5.511521610893899137e-01 -6.767573582980993981e-36 -2.972566291740817352e-33 5.511521610893899137e-01 4.988214959649010859e-36 3.648695857140544478e-33 5.511521610893899137e-01 -2.447716552176715167e-36 5.651005434159133659e-34 5.511521610893899137e-01 -1.859314732544452388e-36 -5.206406984452160238e-33 5.511521610893899137e-01 6.643397477786722474e-37 2.119832002711290432e-33 5.511521610893899137e-01 -1.150330674446841035e-36 -3.015421174779958754e-33 5.511521610893899137e-01 -9.980648125227584068e-37 -4.754132794684438376e-33 5.511521610893899137e-01 -1.871769035231830432e-35 -4.203984796617222785e-33 5.511521610893899137e-01 -4.972637365541917370e-36 5.335039079714446464e-33 5.511521610893899137e-01 1.274208728763331596e-34 -3.259384816415664526e-34 5.511521610893899137e-01 8.634510955108184479e-33 -4.531250053637266733e-33 5.511521610893899137e-01 -3.515134532180869001e-35 -1.608063158613080095e-33 5.511521610893899137e-01 6.112047175480541048e-35 -6.979888567629792538e-34 5.511521610893899137e-01 1.495090750963376133e-34 1.220313526918869399e-33 5.511521610893899137e-01 1.843272595358051398e-34 1.508854035999832956e-33 5.511521610893899137e-01 2.035404475865304381e-34 -3.990061490866478591e-33 5.511521610893899137e-01 1.925120824253144312e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.150196590899929294e-34 -4.548476114407360038e-33 5.511521610893899137e-01 7.216299027763283840e-35 8.836395442841935703e-33 5.511521610893899137e-01 4.386276564750608690e-35 1.683777575254716931e-32 5.511521610893899137e-01 1.416806077627147752e-35 2.932761959762336215e-33 5.511521610893899137e-01 -3.286573472097530610e-36 -1.159682692093020224e-32 5.511521610893899137e-01 -4.782331738568268762e-36 -4.516448044940250150e-33 5.511521610893899137e-01 -3.069916833668002172e-36 -5.691170918874049770e-33 5.511521610893899137e-01 -5.130540096264236742e-36 6.754265949370798883e-33 5.511521610893899137e-01 -2.808957395281953115e-36 1.462803637524868075e-36 5.511521610893899137e-01 1.463931694700338780e-37 -9.767636771861241842e-34 5.511521610893899137e-01 -9.108146734402299417e-37 -8.124208054879120773e-34 5.511521610893899137e-01 9.821770445021751647e-38 5.365807209145916773e-34 5.511521610893899137e-01 -1.280861203138393574e-37 -1.078387385112303824e-33 5.511521610893899137e-01 1.756711259019237455e-37 3.791443320103482540e-32 4.108436466926868277e-29 5.511521610893899137e-01 -1.292581316342299398e-30 2.879704942343095302e-29 5.511521610893899137e-01 1.224883545742278985e-30 -3.471089426189042260e-28 5.511521610893899137e-01 7.687985358095770542e-31 -2.482913206110615654e-29 5.511521610893899137e-01 1.903163228811187253e-32 -4.762745872744839086e-29 5.511521610893899137e-01 -4.442596643541410612e-31 -1.226465056399640424e-30 5.511521610893899137e-01 -5.403333301397521871e-31 -2.327114933879150980e-31 5.511521610893899137e-01 2.247527024521629837e-31 -2.609694446083101317e-31 5.511521610893899137e-01 9.063282885881363816e-31 -6.813645921479329469e-32 5.511521610893899137e-01 -5.615519624455993469e-31 5.052296712245193520e-32 5.511521610893899137e-01 4.748096114124831692e-32 -1.733168060759791835e-32 5.511521610893899137e-01 2.349940842800636697e-31 -5.979600512855226819e-32 5.511521610893899137e-01 -1.685489629596535144e-32 -2.254652443717403436e-31 5.511521610893899137e-01 1.469694771816673888e-31 -1.835088247219043480e-32 5.511521610893899137e-01 1.785243406463995023e-31 -6.786582198712573694e-32 5.511521610893899137e-01 -4.162423886925431250e-31 -8.027625333498638668e-32 5.511521610893899137e-01 -2.699070359958201799e-31 3.080117976603310211e-32 5.511521610893899137e-01 1.550899281276668078e-30 4.354859286719888466e-34 5.511521610893899137e-01 5.043749065414007522e-31 8.869531313681868291e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.436886659266455856e-31 5.511521610893899137e-01 -2.470616529648640127e-32 4.089037939890017361e-31 5.511521610893899137e-01 -3.888458781806910150e-31 1.688976155778177881e-31 5.511521610893899137e-01 5.488327734988232200e-32 1.105574126318850457e-30 5.511521610893899137e-01 -2.712690164858815077e-32 4.237657144703933359e-32 5.511521610893899137e-01 -9.977164535934985846e-35 -3.749740621227170672e-33 5.511521610893899137e-01 -3.074995537067733714e-33 -4.348571394883650093e-33 5.511521610893899137e-01 -4.575739739925714751e-33 -3.770017204358248218e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.126035760328245175e-33 5.511521610893899137e-01 2.150567978989621741e-33 -1.210688385938322066e-32 5.511521610893899137e-01 -8.594012710484557682e-33 -3.563548982888069281e-33 5.511521610893899137e-01 -3.774308344045064080e-34 -1.203732760373346415e-32 5.511521610893899137e-01 9.936966919309771973e-35 -4.517773719287204940e-33 5.511521610893899137e-01 1.411430311854760236e-33 -6.018011925434590048e-33 5.511521610893899137e-01 -3.714517189026420107e-33 -5.272982265266828970e-33 5.511521610893899137e-01 -2.788226054807816039e-33 -3.004277323145407374e-33 5.511521610893899137e-01 5.173174611498185701e-33 -1.507080485604705087e-33 5.511521610893899137e-01 1.004420698277314868e-33 -5.268074006416393044e-33 5.511521610893899137e-01 -5.184214008118828885e-34 -3.008601198357277368e-33 5.511521610893899137e-01 2.298379463647810836e-33 -5.267365022358294863e-33 5.511521610893899137e-01 2.913088487362088749e-33 -4.514896371970106534e-33 5.511521610893899137e-01 -5.257717173353933981e-34 -3.310101872654723295e-33 5.511521610893899137e-01 -9.753507214731115624e-34 -3.296356819667947391e-33 5.511521610893899137e-01 -6.263139898173513117e-33 -6.267268395596912081e-33 5.511521610893899137e-01 4.605267504791728498e-33 3.368296263424337811e-33 5.511521610893899137e-01 8.707306289057649163e-34 -4.925207844742524467e-33 5.511521610893899137e-01 -1.398793121077393480e-33 -3.324303258613382826e-33 5.511521610893899137e-01 -6.843049430542406552e-34 -3.047835559140283959e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.107056922766599540e-33 5.511521610893899137e-01 -5.664766445869374180e-34 -6.567307013149844966e-33 5.511521610893899137e-01 -8.978536526698844924e-33 -3.004832551811307783e-33 5.511521610893899137e-01 -5.982309999929781922e-34 -4.775036840330723745e-33 5.511521610893899137e-01 3.832685179751328113e-33 -4.817893509143082799e-33 5.511521610893899137e-01 -2.932755047303569183e-33 -4.846193733773209144e-33 5.511521610893899137e-01 -1.827627959745173091e-32 -2.995097477328784548e-33 5.511521610893899137e-01 3.619148956511313883e-33 -4.893343072892813665e-33 5.511521610893899137e-01 2.389051134859181145e-34 -4.894838831159284939e-33 5.511521610893899137e-01 7.230496779092677483e-33 -3.388493647201856377e-33 5.511521610893899137e-01 1.307920275296015364e-33 -6.775978000832638893e-33 5.511521610893899137e-01 1.088904753600586791e-33 -4.892865456815997765e-33 5.511521610893899137e-01 -2.125190800330826990e-34 -3.197198241067151656e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386334545041629000e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582670146900360426e-33 5.511521610893899137e-01 -1.627622228731936620e-34 -3.291512268422719519e-33 5.511521610893899137e-01 -2.609950498376899706e-34 -3.314718398192948455e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 new file mode 100644 index 000000000..3ca418b6e --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 @@ -0,0 +1 @@ +1.807287672320099028e-02 3.164087156628939504e-31 9.942975825973756746e-31 1.806244665201316504e-02 -1.085177402730688066e-30 1.694466978071154796e-30 1.804140473746466966e-02 -2.969524457806788919e-30 1.872996459437099683e-31 1.800938416947807721e-02 4.702500847272684229e-31 7.687608739825321013e-31 1.796582650400196587e-02 -3.029328851137965171e-30 1.903163228811187253e-32 1.790997161198396373e-02 5.503853486405646783e-31 4.120665466624815181e-31 1.784084398192265636e-02 4.011244058800179774e-31 1.028320477955721576e-30 1.775723511144627897e-02 -1.524641943227125187e-30 2.247330918814019639e-31 1.765768165947211726e-02 -5.682401887581259434e-32 -5.607940717539653123e-32 1.754043894553080490e-02 9.739837602568446055e-33 1.325538945151555855e-32 1.740344930861694242e-02 -2.673332581443883287e-32 -8.066475638589354568e-32 1.724430475397105075e-02 2.363182077915059793e-30 2.349298806889960130e-31 1.706020323396765029e-02 -3.107064287059630793e-31 -4.204768928243035181e-31 1.684789783376705596e-02 1.072577494976792241e-30 1.468905998478072015e-31 1.660363807154877080e-02 -9.264872277873667333e-31 -4.520619358755593171e-31 1.632310248805226779e-02 -2.965344071836276016e-32 -4.162423886925431250e-31 1.600132171929377622e-02 -2.025209179592617023e-32 2.208702846878285599e-31 1.563259134351488791e-02 -8.650930104970672751e-31 -1.802185303913225370e-31 1.521037402686594570e-02 -2.196649816182515576e-31 1.226021397410734054e-31 1.472719092416708946e-02 7.138628672296636600e-33 8.802904790080362200e-32 1.417450302697508338e-02 -3.655812497529102183e-31 -2.471986719052780083e-32 1.354258432862065833e-02 8.886840178566166225e-32 7.155258673008218071e-32 1.282039048543549657e-02 4.249438718672782935e-32 -1.789690272568214350e-32 1.199542934549937753e-02 2.389923208440380923e-33 1.643402474908239138e-32 1.105364361052948129e-02 5.449939623461131350e-33 -9.716741310014274257e-35 9.979321377856910022e-03 3.580908177937360760e-33 -3.070865982252067423e-33 8.755057805725286954e-03 -6.330180308084747197e-34 1.365673676454876113e-32 7.361801069419062794e-03 1.250035460668059189e-32 1.226056933539344084e-32 5.779028399042017601e-03 1.203637185508669357e-34 3.067647984389174742e-33 3.985113222356582129e-03 2.636026561498492949e-33 4.654431603932868533e-33 1.957961460083287690e-03 -2.714472459481445071e-33 1.124440004305540693e-33 -3.232430373775946938e-04 -1.035349427030647488e-33 1.005598138711710790e-34 -2.644175407615291691e-03 -2.874880064197850637e-33 1.529347374910233844e-34 -4.763428138426785766e-03 1.078265221712011597e-33 5.599816241143319680e-33 -6.590248810475938905e-03 -1.166680527405230685e-32 -1.158196583934431043e-33 -8.031607666879369070e-03 -4.445355006707590199e-34 -3.010634469532647036e-33 -9.148589770501652438e-03 5.651005434159133659e-34 -9.398904360574760081e-34 -1.007565331569645721e-02 2.251107472276590388e-33 -5.178706242641185794e-34 -1.074152350426420613e-02 -1.489711957138894375e-33 -1.311035468714979987e-33 -1.094118737353279476e-02 5.117256287909316903e-34 -6.140429152333295727e-34 -1.065639968735614118e-02 2.203117986637698052e-33 -5.257717173353933981e-34 -1.014773521899640062e-02 2.718127069683124700e-33 -7.896988047986915536e-33 -9.497801010947116637e-03 -1.608789120202838326e-33 4.152363634485582691e-33 -8.662336448804963326e-03 -3.259384816415664526e-34 -2.413982160259627036e-33 -7.507254141933886182e-03 -1.181267332960900537e-33 -9.158256581189675172e-34 -6.067263763080232505e-03 2.227444846913826618e-34 4.320145222270692769e-34 -4.549263176778189748e-03 -6.974255266373161154e-34 -6.843049430542406552e-34 -3.208920581501915285e-03 1.217902941105186126e-33 -9.042311532760118781e-34 -2.037080915246171960e-03 9.602999019172642638e-33 -5.664766445869374180e-34 -1.019935965791402173e-03 -3.990061490866478591e-33 7.853838189085814910e-33 -1.353488757122176173e-04 7.236292230237556541e-34 -5.982309999929781922e-34 6.436213374585932241e-04 -4.546823513834103787e-33 3.829379978604814926e-33 1.326408407110067286e-03 8.836395442841935703e-33 -2.936344435061161726e-33 1.921607069993320691e-03 -1.289885248227656694e-32 2.137320683870446837e-32 2.437264443250392303e-03 2.932761959762336215e-33 3.617043637372483973e-33 2.880756137315133164e-03 -8.951878579547795097e-34 2.366366155393414663e-34 3.253921765575504364e-03 1.023267826489446956e-33 -3.850151013787885202e-33 3.554785550054229571e-03 2.853858458901780832e-35 1.307272369824395214e-33 3.793603431702712199e-03 -1.242946472815877787e-33 1.089590271795947122e-33 3.979394086684456301e-03 1.642691454571552590e-36 5.814442342299030255e-33 4.119495836177664363e-03 -9.765765009792075833e-34 -2.503974908514965981e-34 4.219656142252208725e-03 2.308659076579265217e-33 1.271011556946934550e-34 4.284110738441826612e-03 1.424476173859684447e-34 1.328560682228456524e-34 4.315646821968673920e-03 2.091326642826814645e-33 -6.290035997558984419e-35 3.164087156628939504e-31 5.511521610893899137e-01 4.109018244191380040e-29 -1.085177402730688066e-30 5.511521610893899137e-01 2.884519259740471962e-29 -2.969524457806788919e-30 5.511521610893899137e-01 -3.471004292635915296e-28 4.702500847272684229e-31 5.511521610893899137e-01 -2.481915189565772335e-29 -3.029328851137965171e-30 5.511521610893899137e-01 -4.762648758124759363e-29 5.503853486405646783e-31 5.511521610893899137e-01 -1.222092255011954608e-30 4.011244058800179774e-31 5.511521610893899137e-01 -2.342972818317967151e-31 -1.524641943227125187e-30 5.511521610893899137e-01 -2.626521983575185370e-31 -5.682401887581259434e-32 5.511521610893899137e-01 -6.855912233401724089e-32 9.739837602568446055e-33 5.511521610893899137e-01 5.046074733967154048e-32 -2.673332581443883287e-32 5.511521610893899137e-01 6.759169400138994932e-33 2.363182077915059793e-30 5.511521610893899137e-01 -4.925693231242576936e-32 -3.107064287059630793e-31 5.511521610893899137e-01 -2.275350319505702927e-31 1.072577494976792241e-30 5.511521610893899137e-01 -2.842563117938824155e-32 -9.264872277873667333e-31 5.511521610893899137e-01 -4.639266084832117991e-32 -2.965344071836276016e-32 5.511521610893899137e-01 -3.134016789180174896e-32 -2.025209179592617023e-32 5.511521610893899137e-01 8.087905493957705687e-32 -8.650930104970672751e-31 5.511521610893899137e-01 -3.041282362580032157e-34 -2.196649816182515576e-31 5.511521610893899137e-01 6.379273141718118446e-32 7.138628672296636600e-33 5.511521610893899137e-01 2.308108875491821155e-31 -3.655812497529102183e-31 5.511521610893899137e-01 3.968214502418553227e-31 8.886840178566166225e-32 5.511521610893899137e-01 1.704228900262278559e-31 4.249438718672782935e-32 5.511521610893899137e-01 1.108584415097579557e-30 2.389923208440380923e-33 5.511521610893899137e-01 4.839556798109347675e-32 5.449939623461131350e-33 5.511521610893899137e-01 7.631139078059495742e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.339598673657634186e-33 -6.330180308084747197e-34 5.511521610893899137e-01 -7.614489537121553831e-34 1.250035460668059189e-32 5.511521610893899137e-01 3.799369442434800067e-34 1.203637185508669357e-34 5.511521610893899137e-01 -6.988073990787023096e-35 2.636026561498492949e-33 5.511521610893899137e-01 1.986600580704522294e-34 -2.714472459481445071e-33 5.511521610893899137e-01 -3.664465101049645506e-37 -1.035349427030647488e-33 5.511521610893899137e-01 -3.876298429759674771e-36 -2.874880064197850637e-33 5.511521610893899137e-01 6.414819634859823859e-37 1.078265221712011597e-33 5.511521610893899137e-01 -6.882227971923951538e-36 -1.166680527405230685e-32 5.511521610893899137e-01 4.942521982876558586e-36 -4.445355006707590199e-34 5.511521610893899137e-01 -2.102322576033843612e-36 5.651005434159133659e-34 5.511521610893899137e-01 -1.892710780859099885e-36 2.251107472276590388e-33 5.511521610893899137e-01 7.565288363685921993e-37 -1.489711957138894375e-33 5.511521610893899137e-01 -1.121573214330675443e-36 5.117256287909316903e-34 5.511521610893899137e-01 -1.003170074323236142e-36 2.203117986637698052e-33 5.511521610893899137e-01 -1.878090125021735637e-35 2.718127069683124700e-33 5.511521610893899137e-01 -5.325069368220264756e-36 -1.608789120202838326e-33 5.511521610893899137e-01 1.272756291696468634e-34 -3.259384816415664526e-34 5.511521610893899137e-01 8.634118525923798869e-33 -1.181267332960900537e-33 5.511521610893899137e-01 -3.515729058050027646e-35 2.227444846913826618e-34 5.511521610893899137e-01 6.119266067379315353e-35 -6.974255266373161154e-34 5.511521610893899137e-01 1.493218671503615264e-34 1.217902941105186126e-33 5.511521610893899137e-01 1.825837817773036302e-34 9.602999019172642638e-33 5.511521610893899137e-01 2.020457013198977008e-34 -3.990061490866478591e-33 5.511521610893899137e-01 1.900093425692108319e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.119048685104252743e-34 -4.546823513834103787e-33 5.511521610893899137e-01 6.935980761220657147e-35 8.836395442841935703e-33 5.511521610893899137e-01 4.084926185444964587e-35 -1.289885248227656694e-32 5.511521610893899137e-01 1.255302636380236061e-35 2.932761959762336215e-33 5.511521610893899137e-01 -4.509529047892060847e-36 -8.951878579547795097e-34 5.511521610893899137e-01 -5.880793396288818814e-36 1.023267826489446956e-33 5.511521610893899137e-01 -3.532495649918603502e-36 2.853858458901780832e-35 5.511521610893899137e-01 -5.365131284508042127e-36 -1.242946472815877787e-33 5.511521610893899137e-01 -2.806322324567701582e-36 1.642691454571552590e-36 5.511521610893899137e-01 1.072004369155120361e-37 -9.765765009792075833e-34 5.511521610893899137e-01 -9.663381986857736476e-37 2.308659076579265217e-33 5.511521610893899137e-01 1.260146771585506233e-37 1.424476173859684447e-34 5.511521610893899137e-01 -1.282820976068467938e-37 2.091326642826814645e-33 5.511521610893899137e-01 1.734424440223135084e-37 9.942975825973756746e-31 4.108416391083759029e-29 5.511521610893899137e-01 1.694466978071154796e-30 2.879704434879503872e-29 5.511521610893899137e-01 1.872996459437099683e-31 -3.471064477946677397e-28 5.511521610893899137e-01 7.687608739825321013e-31 -2.481915189565772335e-29 5.511521610893899137e-01 1.903163228811187253e-32 -4.762648758124759363e-29 5.511521610893899137e-01 4.120665466624815181e-31 -1.228110786088164720e-30 5.511521610893899137e-01 1.028320477955721576e-30 -2.342972818317967151e-31 5.511521610893899137e-01 2.247330918814019639e-31 -2.626521983575185370e-31 5.511521610893899137e-01 -5.607940717539653123e-32 -6.855912233401724089e-32 5.511521610893899137e-01 1.325538945151555855e-32 5.046074733967154048e-32 5.511521610893899137e-01 -8.066475638589354568e-32 -1.731495490470145186e-32 5.511521610893899137e-01 2.349298806889960130e-31 -4.925693231242576936e-32 5.511521610893899137e-01 -4.204768928243035181e-31 -2.275350319505702927e-31 5.511521610893899137e-01 1.468905998478072015e-31 -2.842563117938824155e-32 5.511521610893899137e-01 -4.520619358755593171e-31 -7.046678515316162260e-32 5.511521610893899137e-01 -4.162423886925431250e-31 -7.948841650148264529e-32 5.511521610893899137e-01 2.208702846878285599e-31 3.273080632989616601e-32 5.511521610893899137e-01 -1.802185303913225370e-31 -3.041282362580032157e-34 5.511521610893899137e-01 1.226021397410734054e-31 8.786685572202163262e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.428479497016023395e-31 5.511521610893899137e-01 -2.471986719052780083e-32 4.088585123942755468e-31 5.511521610893899137e-01 7.155258673008218071e-32 1.689182572571753279e-31 5.511521610893899137e-01 -1.789690272568214350e-32 1.105575149559474501e-30 5.511521610893899137e-01 1.643402474908239138e-32 4.237703690488337019e-32 5.511521610893899137e-01 -9.716741310014274257e-35 -3.750784399351634456e-33 5.511521610893899137e-01 -3.070865982252067423e-33 -4.348864211762690035e-33 5.511521610893899137e-01 1.365673676454876113e-32 -3.770714491817210719e-33 5.511521610893899137e-01 1.226056933539344084e-32 -1.124695824809048175e-33 5.511521610893899137e-01 3.067647984389174742e-33 -1.210694289232809478e-32 5.511521610893899137e-01 4.654431603932868533e-33 -3.562921864560867240e-33 5.511521610893899137e-01 1.124440004305540693e-33 -1.203742859893032863e-32 5.511521610893899137e-01 1.005598138711710790e-34 -4.517774605587343724e-33 5.511521610893899137e-01 1.529347374910233844e-34 -6.017889594246625378e-33 5.511521610893899137e-01 5.599816241143319680e-33 -5.273096919655771717e-33 5.511521610893899137e-01 -1.158196583934431043e-33 -3.004323016122179853e-33 5.511521610893899137e-01 -3.010634469532647036e-33 -1.506735091628562241e-33 5.511521610893899137e-01 -9.398904360574760081e-34 -5.268107402464707528e-33 5.511521610893899137e-01 -5.178706242641185794e-34 -3.008509009268687593e-33 5.511521610893899137e-01 -1.311035468714979987e-33 -5.267336264898178871e-33 5.511521610893899137e-01 -6.140429152333295727e-34 -4.514901477231906738e-33 5.511521610893899137e-01 -5.257717173353933981e-34 -3.310165083552622606e-33 5.511521610893899137e-01 -7.896988047986915536e-33 -3.296709251670625592e-33 5.511521610893899137e-01 4.152363634485582691e-33 -6.267413639303598356e-33 5.511521610893899137e-01 -2.413982160259627036e-33 3.367903834239951517e-33 5.511521610893899137e-01 -9.158256581189675172e-34 -4.925213790001215978e-33 5.511521610893899137e-01 4.320145222270692769e-34 -3.324231069694394901e-33 5.511521610893899137e-01 -6.843049430542406552e-34 -3.048022767086260110e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.108800400525101071e-33 5.511521610893899137e-01 -5.664766445869374180e-34 -6.568801759416477704e-33 5.511521610893899137e-01 7.853838189085814910e-33 -3.007335291667411233e-33 5.511521610893899137e-01 -5.982309999929781922e-34 -4.778151630910291400e-33 5.511521610893899137e-01 3.829379978604814926e-33 -4.820696691808509002e-33 5.511521610893899137e-01 -2.936344435061161726e-33 -4.849207237566265671e-33 5.511521610893899137e-01 2.137320683870446837e-32 -2.996712511741253756e-33 5.511521610893899137e-01 3.617043637372483973e-33 -4.894566028468608426e-33 5.511521610893899137e-01 2.366366155393414663e-34 -4.895937292817005625e-33 5.511521610893899137e-01 -3.850151013787885202e-33 -3.388956226018107084e-33 5.511521610893899137e-01 1.307272369824395214e-33 -6.776212592020882888e-33 5.511521610893899137e-01 1.089590271795947122e-33 -4.892862821745283761e-33 5.511521610893899137e-01 5.814442342299030255e-33 -3.197237433799706242e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386390068566874718e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582642349927652142e-33 5.511521610893899137e-01 1.328560682228456524e-34 -3.291512464400012793e-33 5.511521610893899137e-01 -6.290035997558984419e-35 -3.314720626874827970e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener new file mode 100644 index 000000000..628200486 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04275027929649642 +1 0.04278020085843042 +2 0.042841306080199114 +3 0.04293616991274339 +4 0.04306878310572499 +5 0.043244710139460636 +6 0.04347130612588618 +7 0.04375799752770975 +8 0.0441166318622986 +9 0.044561900975706614 +10 0.04511184046984128 +11 0.04578840368360244 +12 0.04661810119826244 +13 0.04763268470416382 +14 0.048869835332139476 +15 0.050373788872664964 +16 0.05219579100648223 +17 0.05439422210924104 +18 0.05703416152266364 +19 0.06018607576352497 +20 0.0639232188721544 +21 0.06831723895029577 +22 0.07343138940685787 +23 0.07930835809046836 +24 0.08595531643455993 +25 0.09332781491095406 +26 0.10129875441183091 +27 0.10963150524586682 +28 0.1179797107559022 +29 0.12588668450888285 +30 0.1328434305277984 +31 0.13854559498311456 +32 0.14278838898884882 +33 0.1453885360112828 +34 0.1461854077451984 +35 0.14512910883487187 +36 0.1424782687516996 +37 0.1386015608427453 +38 0.13378570900164893 +39 0.12806948908144877 +40 0.12148133678532885 +41 0.11416218889878457 +42 0.10645677618433959 +43 0.09868394933803322 +44 0.09109590790904701 +45 0.08387528274125837 +46 0.07712198267203546 +47 0.070891806102701 +48 0.06521352205057637 +49 0.06009428336266686 +50 0.05552463757222115 +51 0.05147705342355682 +52 0.0479089553970462 +53 0.04477923434803962 +54 0.04205021062749422 +55 0.039687820590206646 +56 0.037661691498033195 +57 0.035945151713104466 +58 0.03451522317228356 +59 0.03335251502993871 +60 0.0324411007228787 +61 0.03176840003345971 +62 0.03132507558492764 +63 0.031104950321266492 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz new file mode 100644 index 000000000..344b33b94 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9113467178159012 1.52981473979834e-17 -7.285963317525396e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9118207030005194 2.4356512675384276e-17 -4.0371305039281874e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9127743388359983 3.454511287684024e-17 -2.4342198996719724e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9142190279772142 -3.7805832133561053e-17 -6.187356610896914e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9161720534593132 8.08847126094152e-17 -1.8444388620018818e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9186567927099443 7.624575724484052e-17 -4.2919769635106175e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9217030010428517 6.272071258496405e-17 -3.9391032327044283e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.925347162129954 1.4141367885175324e-17 3.146741008977123e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9296329011007516 1.1088047906842848e-18 5.835085188499181e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9346114531277034 -2.0504488237343844e-17 1.7701525078822793e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.940342176301173 3.559466455352199e-17 2.7495111659289614e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.946893091891418 -3.045864829789633e-17 2.119102352303812e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9543414272689816 8.067035165472685e-18 4.121068695006254e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9627741262623368 -1.870788975333611e-17 5.3084548060882654e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9722882779667155 3.660444927292243e-17 3.251847136040509e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9829913973364102 1.3581447031430828e-17 3.125576604787391e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9950014687017616 -4.118705058000745e-17 3.446492762707248e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0084466362117483 -8.865062328403779e-17 1.7844272464522037e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.023464393037961 -7.602811454023911e-18 -9.871186330915401e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.040200084553638 -3.138237495724817e-17 -6.265535927027836e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.058804501263267 8.677553375451521e-17 -2.931272198935586e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.0794302982439206 6.094602264010128e-17 -2.2996176940207053e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.1022268171987384 3.197486758250074e-17 -1.3578778968453203e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.12732287599752 1.1318785368923217e-17 -7.646027667241512e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.1548113892755625 5.856403062013724e-18 -2.9676360444466984e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.184740467910381 1.441457238308895e-18 2.0153685010153982e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.2171055515686695 7.804693693893463e-18 1.6432711070823478e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.2518435689574163 1.153667377461574e-18 3.3992772049736565e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.288831104402282 9.909985187319486e-18 2.4231000161257828e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.327894237667093 1.991549964551224e-18 2.7065499685146866e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.368811106170914 5.066131804225531e-18 1.5278164473742527e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4113136582980177 2.515670410582171e-18 1.3655658877007711e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.4550878098511 -1.343254400198156e-18 4.472104759015239e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.4997817856351814 4.997962653857424e-18 -1.7534271430040907e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.5450212267834305 -5.125458072305984e-18 -2.21598359122604e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.5904292073919266 3.982635935733684e-18 -5.515340484734182e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.635639130456872 -4.045198320447347e-18 5.424655960822307e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.6803020888246514 -2.174743890960021e-18 -8.825199777786374e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7240933384758597 8.631783923228953e-19 -6.31502755059402e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.766719372056884 -6.178874722888603e-18 2.9446121414646406e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.807927284146484 7.483317567898438e-18 -1.6695814083938387e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.847512053619732 -7.662581215227974e-18 8.093731858821852e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.8853201853486885 7.242012928022721e-18 9.588665338036008e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.9212436403689885 -2.811830352432161e-18 1.1515156930841316e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9552123071239187 1.1669855271938639e-18 -1.6094522284859282e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9871872780225495 3.3800547434177307e-18 -8.558646627551363e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.0171547361444437 -8.44164941413383e-18 1.4818503032186843e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.0451205324165964 1.1886871268958032e-17 -1.0706329863426312e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0711057380030007 -1.4680856377692787e-17 1.4999959841514587e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.095143219172094 1.5904706042676323e-17 -1.3944790716929502e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.1172743484169367 -1.6426454527125003e-17 1.4766377831313285e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.13754618894071 1.5724518477437784e-17 -7.225885441206907e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.1560091217074677 -1.395724218161694e-17 8.968709669575571e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1727148674098062 1.2261064884780166e-17 -1.302289598660321e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.187714854623662 -9.88644752264553e-18 1.0227256347251076e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.201058886885623 7.329293159836358e-18 1.1842007005921356e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.212794064539282 -4.966689961692812e-18 2.675882485238888e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.2229638372071734 3.675682829397587e-18 -1.461982837251266e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.231607017584284 -2.510742621139139e-18 5.638588561064134e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.2387573434972587 1.4051126587625507e-18 -6.375374530429193e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2444432086929433 -8.575319617855292e-19 -1.0301959660137817e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2486874830520263 3.741308854417688e-19 7.590407877874241e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2515073967721797 -7.699661337650653e-20 3.7502729432308877e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.25291446930372 -2.1132103023772633e-19 -7.945729957343846e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener new file mode 100644 index 000000000..f2faacc95 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04139064492444978 +1 0.04139364161946814 +2 0.04139998021778682 +3 0.041410381392008914 +4 0.04142600406782261 +5 0.04144854541319732 +6 0.041480385309005906 +7 0.0415247855094199 +8 0.04158615700073799 +9 0.04167041273763614 +10 0.04178542686323676 +11 0.04194162540489177 +12 0.042152736679326286 +13 0.04243673116281114 +14 0.04281697859365053 +15 0.043323641749235024 +16 0.0439953074233546 +17 0.04488081951294205 +18 0.04604121850887172 +19 0.047551595586775304 +20 0.04950252605066836 +21 0.052000545274302 +22 0.055166864099561605 +23 0.05913286995808192 +24 0.06403041987551535 +25 0.06997518063752493 +26 0.07704141806248538 +27 0.08523000464733294 +28 0.09443335334864929 +29 0.10437372905599929 +30 0.11455911316135221 +31 0.12429544251244935 +32 0.13274800822157265 +33 0.13938270350379953 +34 0.14390050573425775 +35 0.14604213071632915 +36 0.14562799323555595 +37 0.14289197665023395 +38 0.1384066592716264 +39 0.13261661604699776 +40 0.12557217304176357 +41 0.11733397399292311 +42 0.10829039744168133 +43 0.09898268175666296 +44 0.08984253266411547 +45 0.08117207549876683 +46 0.07312961503322109 +47 0.06580301945931642 +48 0.05923313727922417 +49 0.053422687918401525 +50 0.048326116660702086 +51 0.04387450309753007 +52 0.04000268514533666 +53 0.03665078010935086 +54 0.03376462174129549 +55 0.03129590603530467 +56 0.029202139995884453 +57 0.027446539034470693 +58 0.025997903409307174 +59 0.02482995333621405 +60 0.02392107195187513 +61 0.02325417023185736 +62 0.0228165590528654 +63 0.022599842604787725 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz new file mode 100644 index 000000000..865e77043 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8754554710550593 -1.0117280927497715e-16 6.54891966628024e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8757029994054615 -1.0785147578832718e-16 9.248986920727721e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8762033488347074 -9.187177964338296e-17 1.901372736118508e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8769672088227105 -4.882863848419154e-17 2.998682467214636e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8780108746037532 3.9879104169806975e-17 6.444485400642168e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8793565629604898 9.768716065079919e-17 6.828716923373327e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8810328372586376 5.62802815842055e-17 9.662669808964605e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8830751444542202 4.416405072647162e-17 6.055447299932795e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8855264665537634 3.526188401201809e-17 1.2496816720913084e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8884380879910998 6.57361598499468e-17 3.18127926442687e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.891870478289674 1.1413238519924338e-17 7.393123203481303e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8958942858016457 -5.896847597045772e-18 2.404971119692142e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9005914327192939 -4.0853904377836766e-18 7.977821093806274e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9060562932485339 1.0851257954117667e-17 -1.422217718075068e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9123969249453066 -1.6394207633757912e-17 3.429222511870093e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9197363066466604 1.6061491555818797e-19 -8.390663036487738e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9282135138669405 -2.783326274702666e-17 5.0862059588829254e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9379847324419386 -3.586215282786781e-17 5.1877344978725064e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9492239719226123 -9.873439940931157e-17 2.6900560224089524e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9621232900962573 -8.445977421416774e-17 8.033071485273681e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9768922777531195 -4.326833584675276e-17 7.680947061608919e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9937564780159092 -2.450974237262555e-17 3.284131485991176e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0129543179088945 -1.3982457403739633e-17 2.0611718955244116e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.034730287338102 -9.547658830400087e-18 9.822623988157096e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0593221063872647 -5.569784772181392e-18 4.3621576134997676e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0869423393415976 -2.2632856235234153e-18 -1.4843798897101864e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.117753387565026 -2.6343251244706676e-18 -1.3753483408430078e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.1518435689574162 5.1455531568557315e-18 -2.8427656773134777e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1892121226488337 1.4077638251012128e-18 3.4901157262163745e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.2297619722543107 7.308424313180803e-18 -7.247922711243705e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.273302758942622 3.2040269411787295e-18 1.5383609857300669e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.319561571414803 4.006904323032681e-18 2.0045323494221884e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.3681862979434865 5.9632748616899954e-18 2.454162043199172e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.418745563724671 4.2597699495209943e-19 9.608068169755085e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.4707387040705324 5.7718222464802e-18 -2.312841075898914e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.523623837875957 -4.0727874131366255e-18 7.3343808690901e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.5768553826843323 -1.1779505737004018e-18 -1.5069670270277176e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.6299039969752194 -5.410160398397614e-18 -1.9933757234623016e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.6822692463057045 -5.402515342958978e-18 -1.822103240630447e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7334888014956893 1.5620104241094017e-18 -9.810787146283103e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.783155732028479 -6.298245235489619e-18 3.570728196081138e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.830934764101847 6.673248351744974e-18 -1.9847501131499126e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.876572091132655 -2.675131134566011e-18 2.397478499917473e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.919889675439072 5.4610226313770996e-18 -1.7115679724314351e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9607727784947424 -3.0056578977413296e-20 -1.2550977514231167e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.999158175502586 -9.122899582573474e-19 1.2480625321834901e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.0350236115355105 5.3863199368340706e-18 -3.376231569737864e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.068379040386745 -8.968964254970196e-18 3.936066519133359e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0992592252108997 8.890564085631831e-18 -5.067911839411626e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.1277173788244417 -1.1499082030324815e-17 6.45094179727298e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.153819714044437 1.1282535442927314e-17 -6.224287350971898e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.177640871681009 -1.1920373870642032e-17 6.088276775015901e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.1992599404884623 1.0095211447248937e-17 -6.269575609418405e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.218756929414201 -8.00254552602578e-18 5.277186166929336e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.236210031962295 7.179197382270634e-18 -3.598464294868181e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.251693587833473 -4.217060674370166e-18 4.016630260218693e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.265276605087503 4.771534282466994e-18 -3.642832574620289e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.2770217160672384 -2.6573735416704896e-18 1.5225079431333288e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.286984463577432 -1.6511119480392004e-19 -1.151572053197526e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.2952128637981164 -1.3960117053933124e-18 1.5674485715388363e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.301747137962336 1.025830638329932e-18 -3.0033910893406807e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.3066195571860764 7.936027332520631e-19 5.272900083565806e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.3098543608583566 1.7114222808427938e-19 -3.150938632238916e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.311467719190404 -6.562217458251147e-19 -1.4414422374156033e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener new file mode 100644 index 000000000..3f33482b1 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0414320986123798 +1 0.041435349290263455 +2 0.04144208130851779 +3 0.041452770943414256 +4 0.04146817083925893 +5 0.04148935830058169 +6 0.04151780380235514 +7 0.04155546343155764 +8 0.041604900113974864 +9 0.041669439734878105 +10 0.04175336961685284 +11 0.04186218822460827 +12 0.042002916324086675 +13 0.04218448095011686 +14 0.042418184132971895 +15 0.0427182679278418 +16 0.04310258517220661 +17 0.043593380531021984 +18 0.04421817732675026 +19 0.04501075042427065 +20 0.046012141501810606 +21 0.04727163726920011 +22 0.04884758008936617 +23 0.05080781062453124 +24 0.053229451328237 +25 0.05619762863182935 +26 0.059802607443922205 +27 0.06413469173519454 +28 0.06927616410956103 +29 0.07528955408518653 +30 0.0822017282356714 +31 0.08998380476862505 +32 0.09852074696509402 +33 0.1075580277822716 +34 0.11669225616613076 +35 0.12536887548274395 +36 0.13294561957672707 +37 0.13903020895880616 +38 0.14337679937002537 +39 0.14576896116002383 +40 0.14603401559909782 +41 0.14423362904947454 +42 0.14078125541196979 +43 0.13613481607804123 +44 0.13049219233787873 +45 0.12389388619614902 +46 0.11645462428483375 +47 0.108538041836738 +48 0.10054310626611064 +49 0.09277747238442538 +50 0.0854601588639929 +51 0.07871121766078981 +52 0.07258820582110381 +53 0.06711518705827169 +54 0.062291116600872824 +55 0.05809712636072085 +56 0.05450231294315485 +57 0.0514647597546257 +58 0.04894153722492347 +59 0.04689553994141874 +60 0.04529580546150961 +61 0.044117590309882895 +62 0.04334237604740632 +63 0.042957843824442454 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz new file mode 100644 index 000000000..370d1a7e7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8783910259994623 -9.851488804632187e-19 1.3301653027420989e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8785884877949415 -1.3402566400439807e-18 1.673603835717979e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8789866970796802 -8.078868289395344e-19 1.1983679293246106e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8795922742024418 -1.2575578386977063e-18 1.2325706247290434e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8804152724198606 -1.6024958523873823e-18 -2.5324712291786793e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8814693260738478 -6.542499824014205e-19 -2.655620564833909e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8827718495703336 4.484427668140076e-19 -2.442648988119337e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8843442881850287 -1.3795490220637562e-19 -3.755208021960591e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8862124217313263 3.595741379800149e-21 -1.464723975739869e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8884067219416205 -2.8113853609811726e-19 -8.663991270071356e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.890962763960794 2.8580415186412374e-19 5.146086523556533e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8939216915400294 -5.548542431787984e-19 1.7876785759864272e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.897330734230395 1.983610005787487e-19 1.7546338353654138e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.901243772955289 -3.7561193032082804e-19 6.495149006003024e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9057219475994507 -1.5559638822904065e-18 1.8891729326278332e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9108342964414653 -8.264773006513298e-19 2.184597201060651e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9166584120798988 -1.66153169304808e-20 1.9450435749120716e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9232810915862848 -3.5633341894780336e-19 5.866799029020349e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.930798949519093 -1.2170793044142193e-18 5.994199016440623e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9393189506259083 -7.790082073594774e-19 -2.0800345874759729e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9489588039599155 -1.825347961463535e-18 -7.791970269175018e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9598471410939584 -1.3461329097134964e-18 -4.624785494037522e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.9721233775106988 -5.138865418919494e-19 -2.312974835984229e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9859371275340094 -3.3866165419647196e-19 -1.879558083817356e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.001447009098177 -5.990390137237601e-20 -6.103559653020911e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0188186354777424 -7.275305021777005e-20 -7.743374556754355e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.0382215480437273 -7.275118425393616e-20 -5.2366823587254586e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.059824799900073 -9.168704561260868e-21 1.495919591134385e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.083790860003999 -1.0215597267619105e-19 -2.6231564500496814e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1102674796304464 5.511378450911044e-20 4.7124690613815086e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1393771611006067 -8.30316737176043e-21 5.262917351342211e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.1712039118955 1.115364989605363e-19 2.782544596065962e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2057770810002104 1.579854630218318e-19 6.777610655308823e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.2430543790963036 3.838516830074238e-21 5.422901457180961e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.282913395343749 1.108231762634283e-19 1.0787293061895563e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.3251499036050984 -1.1185863813271345e-19 -4.855545455497648e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3694826723541773 4.1658537682434424e-20 -4.431785405487333e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4155642765610335 -1.09175928821316e-19 -6.479880280404295e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.462989568854928 -7.14026162048998e-20 -4.3578162339263e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.5113053414786815 5.855705902481826e-20 1.128785728864534e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.560028588319711 -1.0322448221211242e-19 -6.463082197429434e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6086727267151524 1.7725952600460433e-19 8.082531667083235e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6567698079163007 -1.149124792263937e-19 -5.485023054623841e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.703882221109272 1.3744526403119772e-19 6.777163788827528e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.7496121390535166 -9.034986400327364e-20 -2.19306936881376e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.793613977886753 -2.76983174201291e-20 -4.339049483382573e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.835606740411229 7.082907415655858e-20 3.0138009875708696e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.8753803423529423 -1.6940527731858444e-19 -8.841203590084194e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9127885671292395 2.48020764270714e-19 1.2684795337521353e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9477375035631006 -2.5630339419960277e-19 -1.2211352481384955e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.980174933253151 3.2707453511593737e-19 1.6612675616768303e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0100809680184417 -3.1273475294927187e-19 -1.5084561698632757e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0374603302279812 2.9793319400328865e-19 1.4047456034506751e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0623359002599226 -2.8241385116855197e-19 -1.5136009942368388e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0847432090941282 2.2292052023083817e-19 1.0196047541853823e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1047258072686836 -1.9713971334166315e-19 -1.0739594560230513e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.122331423497043 1.177168376978391e-19 6.543448527564912e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1376088096052817 -1.0768795202030094e-19 -5.1995135879384954e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.150605076887851 1.0382610766816056e-19 4.641259342300025e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.161363576277215 -2.0980419395223303e-20 -9.634800448710992e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1699223275537047 2.611904629461775e-20 3.8009207215517174e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1763128797573956 -2.728179729354991e-20 -5.8770462728048404e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1805595070850963 3.2114719888882228e-21 -1.0202382770207982e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1826786669044314 -2.560099661307703e-21 -1.2930540084198142e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener new file mode 100644 index 000000000..2da25988f --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041431523605681135 +1 0.041434753480376105 +2 0.04144144243563891 +3 0.04145206374107273 +4 0.04146736529244385 +5 0.041488417603703844 +6 0.041516681893528695 +7 0.04155410195916442 +8 0.04160322466553608 +9 0.041667355127127215 +10 0.041750754010369553 +11 0.04185888578819251 +12 0.041998728136566695 +13 0.04217915379629884 +14 0.042411396835426524 +15 0.042709614871993894 +16 0.04309155675102233 +17 0.04357934038986184 +18 0.044200336574154515 +19 0.04498813945207321 +20 0.04598358080747046 +21 0.0472357097911629 +22 0.048802609159670614 +23 0.05075184981202897 +24 0.0531602952489517 +25 0.056112857193514505 +26 0.05969967971640681 +27 0.06401110908639907 +28 0.06912972425438511 +29 0.07511871632294978 +30 0.0820061025290169 +31 0.08976475969599965 +32 0.0982826882348466 +33 0.1073095245222959 +34 0.11644610021451877 +35 0.1251422399768002 +36 0.13275452681938668 +37 0.1388827711810835 +38 0.14328005287921095 +39 0.1457296491882826 +40 0.14605678720801793 +41 0.14431166473213178 +42 0.14090226991169702 +43 0.13628848280661082 +44 0.13067830918347245 +45 0.12411211862513782 +46 0.11669991012051818 +47 0.10879810764542852 +48 0.10080771631551246 +49 0.09303872933718235 +50 0.08571271699430998 +51 0.07895252276612656 +52 0.07281685346023217 +53 0.06733062476527923 +54 0.062493451860995454 +55 0.05828695927961056 +56 0.05468069792464334 +57 0.05163329767362211 +58 0.049101810282993014 +59 0.04704905704832793 +60 0.04544400767767934 +61 0.04426186044095481 +62 0.04348405109802231 +63 0.04309822933372733 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz new file mode 100644 index 000000000..beac65819 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8783557255360728 3.167224099333261e-19 -9.321016871223934e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8785525580001896 -2.914690788139957e-19 -1.5470207957232792e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8789494977301089 1.006912992183837e-19 -3.5103958857828874e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8795531431379864 -2.519525425282082e-19 -1.3959929047950352e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8803735141950442 1.4489618619572955e-19 -3.3084568857982466e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8814242001540722 2.612241851419053e-19 -7.294441216867245e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8827225579252445 4.723331694796115e-19 -4.2226622959070253e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8842899621354297 2.377523118271864e-19 -1.4166715838776653e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.886152107913881 3.617668206609701e-21 1.034243868520375e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8883393672678854 9.485696240287965e-20 -2.795147295664801e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.890887199466296 -1.1294418234714679e-21 1.843368150973366e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8938366150476658 4.497095689943134e-19 1.1380476332318427e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.897234691794111 -7.675549194009782e-19 2.168578996536718e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9011351391093252 -1.0154088592991967e-18 7.171499685183263e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.905598904521361 -1.5283142897715705e-18 9.146924070027737e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.910694812251114 -1.5026797061098611e-18 8.777202548382583e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9165002186510165 3.476217929649274e-19 8.345743035220681e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9231016624535056 -7.373452999462007e-19 -2.2614003508442343e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9305954787355424 -3.8366003359017046e-19 1.2956971210348385e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.939088333780911 -1.03177156590877e-18 -2.6598209693645523e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9486976230218995 -1.0984385458222306e-18 -6.295372781671454e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9595516553206715 -5.273965170102473e-19 -1.494978563909243e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.9717895233877394 -2.4524235188707244e-19 -4.260462941498117e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9855605315809908 -6.109764467771963e-20 1.4278497232837836e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.001023018428773 1.3482596558474488e-20 3.0888545584440624e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.018342372208258 3.905215292143839e-20 3.6899429611767715e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.037687994977772 5.723915048975112e-20 -1.0318291107887755e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0592289262890526 -1.7302377253309623e-20 2.9301157906369024e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.083127797434045 2.5725012807896028e-20 -5.680998739969661e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1095327589462394 -5.250645109376495e-20 -8.010490387316411e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1385670213257733 -5.176863406034446e-21 -2.1001910597861954e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.1703156907383168 -1.4788119181418952e-20 4.8845853276100886e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2048096938161352 -1.410619835290788e-20 7.903798468244585e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.242008727616783 2.4544492787511778e-20 3.552885409465278e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.2817925237798975 -5.356624007937554e-20 3.358596933408221e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.323959005843907 2.6007506488053363e-20 -5.718945442069232e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3682289107296226 -4.2395978353347025e-20 -4.2178832919211465e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4142565108881238 1.5884312447477484e-20 -7.005523258345597e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.461638189995924 2.1500190829291523e-20 -5.3917428080386654e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.509921979572976 -2.8382824612187316e-20 1.816694699830254e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.5586254954837924 5.702515351548381e-20 2.9195274908427252e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.607262037437914 -4.200468953232298e-20 9.294552580494238e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6553630915491726 8.460063694884053e-20 1.199275841301308e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.702490201285616 -3.870550237737808e-20 4.8999629654570516e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.7482444137021638 5.7597992939959424e-21 -3.3255937789275525e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.7922785882487338 -2.8295510973839034e-20 -5.432072538392806e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.8343098244488303 -6.135608424111156e-20 -1.1136089082961671e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.874126031351556 7.531502460842483e-20 -7.68399178538083e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9115792820095225 -7.966397236771155e-20 8.007453802539009e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.94657424945964 1.1852627940933556e-19 -4.610395606893448e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.979057566243054 -1.2262642321168788e-19 1.291926771454475e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.009008424465314 1.19615522025406e-19 -8.347955237812826e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.036430807386101 -1.0508399572539226e-19 7.86407380595151e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.06134700958731 1.0702918398051738e-19 -9.806141162607922e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0837921050158252 -7.520188542120663e-20 4.218929959367957e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1038092933708112 6.425188308257616e-20 -7.236053804859407e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1214460385872416 -5.356790023747801e-20 4.7966651592619505e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1367508976062575 2.737186320984367e-20 -1.7814768530248604e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1497708499089487 -2.5163936237082562e-20 3.958134771270676e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.160549161462604 1.6780237656099325e-20 3.7637775130012435e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1691237999029753 -7.106408289942292e-21 2.0996446407208497e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1755262841641856 3.381340201084727e-21 -9.922934918980257e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1797808723528984 -2.7210551267011493e-21 -9.40045616944471e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1819040140989525 3.662625570675696e-21 -1.4858145192915057e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener new file mode 100644 index 000000000..ad4d71b29 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041431159968245763 +1 0.0414343766705071 +2 0.041441038357545174 +3 0.04145161639296752 +4 0.04146685566220852 +5 0.04148782237410154 +6 0.041515971878580755 +7 0.04155324018025903 +8 0.04160216395934773 +9 0.041666035157624556 +10 0.041749097534570685 +11 0.041856794000993965 +12 0.041996074896036975 +13 0.0421757785109457 +14 0.04240709578511528 +15 0.04270413074377016 +16 0.04308456621417947 +17 0.043570439631689925 +18 0.04418902489774111 +19 0.044973801339273416 +20 0.045965467324147594 +21 0.04721292091934338 +22 0.04877407965050171 +23 0.05071634252842101 +24 0.0531164077453049 +25 0.056059049433738156 +26 0.05963433320190204 +27 0.0639326298686573 +28 0.06903670360728371 +29 0.07501016202250434 +30 0.08188174891400904 +31 0.08962545358340034 +32 0.09813118445377166 +33 0.10715123022230368 +34 0.11628910559140161 +35 0.1249974229295405 +36 0.13263221526469673 +37 0.13878816780384723 +38 0.14321763872385676 +39 0.1457037199935348 +40 0.14607037256371103 +41 0.144360598186313 +42 0.14097874693428394 +43 0.13638579915652513 +44 0.13079625951414806 +45 0.12425050723715576 +46 0.11685567710490194 +47 0.10896346274333556 +48 0.1009761158622855 +49 0.09320511837625593 +50 0.0858736465464215 +51 0.07910634090531145 +52 0.07296265326499976 +53 0.06746804380934066 +54 0.06262254989024513 +55 0.05840811151609661 +56 0.05479456174331278 +57 0.051740885430423565 +58 0.049204130031355486 +59 0.04714707031454202 +60 0.04553863288563279 +61 0.04435397899054626 +62 0.043574515271603956 +63 0.04318787140600699 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz new file mode 100644 index 000000000..2a2271a28 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8783333422653203 3.0949281007768247e-19 -1.1000076338027177e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8785297747426166 -1.42833431820084e-19 -5.250080142786166e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8789259075692553 6.642204773721767e-20 -1.0865807581321575e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8795283252010604 1.6271991821093396e-19 3.342303702065465e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.88034702643248 4.168295514510483e-19 5.540217709260785e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8813955718294244 8.917118398962562e-19 8.821054777696175e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.882691281721143 5.653468921288331e-19 5.989277418850332e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8842554857841827 3.5785730898880224e-19 3.001701555560058e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8861138252662064 1.7844336290746563e-19 2.985640514280362e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.888296608721087 1.200071271939896e-19 6.126338575788869e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.890839221685344 1.2057247932965619e-19 -1.1757101721021457e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.893782589930785 -2.9177333775389784e-20 -4.560134156117137e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.897173694660969 1.0478345055603712e-19 -2.699061379360931e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.901066136127572 -1.1660629455478366e-20 -1.7374376383675212e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.905520739440012 2.3851824741424325e-19 6.373690707344213e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9106061925816686 3.4015705870174317e-19 4.844048565658888e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9163997015353937 2.3821548045123213e-19 5.329409436079684e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9229876405889992 -2.0919769592492554e-20 3.131089926545402e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9304661669001044 3.590013077262543e-21 -5.573783355852306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9389417567274243 2.3989104206553085e-19 -1.0175099104619003e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9485316057998638 4.325305148366821e-19 5.432922105314611e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9593638174506798 2.2150301168744425e-19 3.1109184491357803e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.971577278771488 1.2881779313862214e-19 1.0513865830929054e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9853210965882924 9.119765945782808e-20 -3.478077156380651e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0007534312692954 4.930483443329068e-20 1.7429733859548817e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.018039527464748 2.584094596805484e-21 -1.8992644779579915e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.037348698026179 -2.2101925513111336e-21 -9.900541704532163e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0588499732049517 -3.6239781408397987e-20 -2.0472670151039673e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.082706086782238 4.4456444007387515e-21 -7.147769657771003e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1090654423999817 -2.0865152808835925e-20 -2.8737803696694503e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1380517000970323 8.087539002600304e-21 9.532465815109054e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.169750663933322 7.422472280911661e-21 5.30383241538462e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.204194262559518 9.571046787953284e-23 -5.5247586574942045e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.241343456102475 3.608788285539383e-20 4.739828509977617e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.281079339255744 -6.072359737695206e-21 -7.490252788923752e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.323201203745981 3.077282625009981e-20 -2.145292842919299e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3674310399967773 -7.425693806885901e-21 -9.983613626924786e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4134242024188106 9.978110420136703e-21 -4.629439075945029e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.4607780501430954 5.376165897239119e-21 1.4876873606198793e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.5090414044151057 -3.8742415548454794e-20 6.723126756384934e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.557732279404554 1.2140947272953879e-20 1.7127995807041196e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6063639035839103 -4.448000129437174e-20 -1.2770119184577303e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6544674049098544 2.963206307905874e-20 5.291313169986185e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.701603790003181 -1.4316447681710713e-20 -9.542808052828657e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.747373390281946 1.8502133993105775e-20 -3.708657223867362e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.791428076061492 1.585269652375784e-20 2.2546296639158953e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.833483736652398 -1.8300393184683892e-20 -1.9352476226650636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.87332700512417 4.1563893383718353e-20 2.6123435141668744e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.910808865120798 -5.858347020637631e-20 -1.862051488475525e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9458330877781975 5.404928592663921e-20 3.594425272028334e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.9783455735565445 -6.510486110470244e-20 -3.853490941218289e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.008324928478876 5.945756852718273e-20 3.164232068934169e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.035774664858374 -5.123000300461315e-20 -3.719003168207221e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0607167039670182 5.229410337127496e-20 3.2029642179955153e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0831858284548233 -3.8048094731352424e-20 -2.6498765875939152e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1032250143709224 2.72857965639939e-20 2.1723485641180438e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.120881556829117 -2.1848337229898458e-20 -1.764306532859029e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1362038885663495 1.4559858188829543e-20 1.7603789328098527e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.149238904919009 -1.0103545981417903e-20 -8.967479564094792e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1600298175889807 5.681232309598346e-21 4.178612640398914e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1686145608857506 -1.9673941768269033e-21 -8.422023452429667e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1750246344837882 5.782485733295224e-21 2.275710584955142e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1792842861823307 1.1006241727322953e-21 6.632280138536292e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1814099606453445 -4.243055911518313e-21 1.5003185818924737e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener new file mode 100644 index 000000000..4faed9f89 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04157195801479472 +1 0.04157932549027338 +2 0.04159452585964221 +3 0.04161851756828408 +4 0.04165280867767965 +5 0.041699545206190645 +6 0.04176163543936573 +7 0.04184291592837965 +8 0.041948366431396725 +9 0.042084382565968956 +10 0.04225911631124153 +11 0.04248289551544847 +12 0.0427687338816991 +13 0.04313294198748004 +14 0.04359584694068441 +15 0.044182622131034986 +16 0.04492421758331545 +17 0.04585836347015007 +18 0.047030591554960456 +19 0.048495178201915276 +20 0.050315854091923094 +21 0.05256604586812437 +22 0.05532831055248588 +23 0.058692494633858 +24 0.06275200060907327 +25 0.06759738932380878 +26 0.07330642377286588 +27 0.0799294711471809 +28 0.0874690364596107 +29 0.09585078356451426 +30 0.10486712758550402 +31 0.1141477563402789 +32 0.12315620989328348 +33 0.1312126432464777 +34 0.13780807080564067 +35 0.14265272501748136 +36 0.1454979447188084 +37 0.14613323032868536 +38 0.1445490200844069 +39 0.14114859626998372 +40 0.13642648534344332 +41 0.1306191090839431 +42 0.1237590010399058 +43 0.1159574399218824 +44 0.10760911880118629 +45 0.09914524419813159 +46 0.09089952384544306 +47 0.08310547056543953 +48 0.07588433787121183 +49 0.06929878616783347 +50 0.0633754049498601 +51 0.058113080621306934 +52 0.053489160222783196 +53 0.04945579711162347 +54 0.045958362691300006 +55 0.0429472149153323 +56 0.04037808000377092 +57 0.03821211347456315 +58 0.036415835494770565 +59 0.034960994016314764 +60 0.03382439609718616 +61 0.0329877351573271 +62 0.03243743376656774 +63 0.032164515601952805 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz new file mode 100644 index 000000000..a53581294 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.884989317295536 -5.0108954078447624e-17 -4.742247366741344e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8852700136672462 -5.883953842516014e-17 -1.3715544777791804e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8858358478859487 2.5633983856080006e-17 2.9903671811213294e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8866957645298275 2.668180929495165e-17 8.65248077350837e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.887863334741747 5.171362194483314e-17 9.760975576643867e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8893569418884497 6.003408106611861e-17 5.78003631756551e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.891200029834506 1.0917461984979519e-17 2.1499151166995855e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8934214141368355 1.6431404584195373e-17 2.2396622601378082e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8960556561148083 8.205781727190208e-18 -1.1138783000909959e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8991434990707494 -5.792684861855456e-18 -3.687153742641566e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.902732364807378 1.485356059365815e-17 -7.045968937403926e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.9068769068693248 2.213875216434845e-17 2.2462933636920996e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9116396144397412 -1.0340336745334172e-17 4.9377316933258047e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9170914573152236 2.8721248469766036e-17 6.368244599243866e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9233125575737495 3.6582065253840844e-17 6.433977382982912e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9303928670682555 5.17189435389041e-17 7.203661983316977e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9384328212725248 8.862710164759301e-17 1.3383926529173477e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9475439287078322 5.494824397455874e-17 1.1611293635329614e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9578492404998924 4.207915517996141e-17 8.765126833124805e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9694836257111257 6.198078601709982e-17 3.6995307173223434e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9825937539592913 5.928586450316247e-17 2.391166752772385e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9973376562717196 3.01240569422641e-17 1.740789214068586e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.0138836967982185 1.6854911860689905e-17 9.545995825412685e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0324087404252817 1.005148797685407e-17 5.515107833617539e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.053095233905976 6.505914042148056e-18 3.6634482083271354e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0761268211639776 4.5721264836472885e-18 4.580346723926299e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.101681990669658 5.402002215023801e-18 4.494616263110479e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.129924400440045 1.2939087423805524e-18 8.699910047048996e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1609870919354206 3.019425293391911e-18 5.851739846362596e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.194948233479877 -1.120829868726922e-18 7.88005518260951e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.2318076266997973 1.0625122004335556e-18 2.7681091167719145e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2714745120644273 -4.400234267428504e-19 1.1671374015309262e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.3137661403688585 -1.694712186181077e-18 -3.2487082201372366e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.3584186367031412 -1.9233838196118363e-19 -3.329672726553708e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.405091335138688 -4.014623638089361e-18 -1.8413889643869384e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.4533636102737986 6.949928666476694e-19 -3.886055873384936e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.502748042238719 -1.7433393363065483e-18 -1.4017628939559986e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.5527300953815506 1.877777505113591e-18 -1.8701334277356672e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.6027991264632204 2.3403513366244345e-18 -1.0509255191162959e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.652458924124138 1.2846930698250825e-19 1.4947410374256058e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.701232070356048 3.305720553805393e-18 -2.293322862115787e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.74868034351546 -3.540355367613809e-18 3.643646950762984e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.7944358238859706 2.255867989178734e-18 -2.01619340638025e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8382211797675962 -3.448513098646837e-18 3.310536797969935e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.879837677310483 8.451210918739354e-19 -6.872803895786421e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.91915217467959 9.560492453772601e-20 -2.0825670753846824e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.956084067503216 -1.5516351806771173e-18 1.4947550108437544e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9905944219558633 3.866509755268147e-18 -4.454570456124455e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.022677383407258 -4.325638010915628e-18 4.0257036634383485e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.052352615070973 6.2025524192515265e-18 -5.878393128601746e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.079658822026951 -6.595622548425217e-18 6.9660731420796e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.1046487323251144 6.053316716543601e-18 -5.9248535788955695e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.12738439168631 -6.236906148126373e-18 6.335657676722336e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1479326128831646 5.668119246240927e-18 -5.484662708444005e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1663614192681724 -4.546045063920738e-18 4.626945140291536e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1827373641010657 3.736473259020216e-18 -4.0227822285373624e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.197123545382946 -2.9404762934001575e-18 2.9188929665039917e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.2095781632805447 1.8876159438894476e-18 -2.1438549405222784e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.220153494631111 -1.5459296778614354e-18 1.8596640478959765e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.2288951822406537 9.690785854359564e-19 -8.480037638425914e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2358417504462063 -5.565240479889735e-19 6.291180013270469e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2410242854861724 2.6687195721090655e-19 -6.006520162150756e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2444662333943772 -2.1320580227752767e-19 1.691968391565676e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.246183278899612 -2.7346252962316175e-20 1.2280832254384746e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener new file mode 100644 index 000000000..b9b465ec0 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0414586067293743 +1 0.04146298037959526 +2 0.04147204730433017 +3 0.0414864677858511 +4 0.04150728601655086 +5 0.04153599797703809 +6 0.041574647642724526 +7 0.04162595661486482 +8 0.04169349377491985 +9 0.04178189315946592 +10 0.04189712989185801 +11 0.042046865568348565 +12 0.04224087576573757 +13 0.04249157295748899 +14 0.042814637532817806 +15 0.04322976695736643 +16 0.04376154715373442 +17 0.04444043916542588 +18 0.04530385572151752 +19 0.04639727334786675 +20 0.04777528237112576 +21 0.049502415231536145 +22 0.051653508760727065 +23 0.05431324565904421 +24 0.05757438496723718 +25 0.061534038910397236 +26 0.06628720590430467 +27 0.07191667017045388 +28 0.0784784047772787 +29 0.08598179449643652 +30 0.09436169300496523 +31 0.10342550420888139 +32 0.1128136247204845 +33 0.12199717818538072 +34 0.13029031208530534 +35 0.1371328491390891 +36 0.14222269699322038 +37 0.145308263954973 +38 0.14617177455363273 +39 0.1447697075085206 +40 0.14148719572478802 +41 0.1368315004796831 +42 0.1310747919132957 +43 0.1242525885432 +44 0.11646812508050722 +45 0.1081076271237402 +46 0.09961614403421955 +47 0.09133891407928739 +48 0.08351908058034527 +49 0.07628433304493165 +50 0.06969966710560682 +51 0.06379259587961304 +52 0.05856198666449303 +53 0.05398514846508404 +54 0.050015439788023884 +55 0.04659799128392859 +56 0.04368306530574811 +57 0.04122664271453125 +58 0.039190525999689856 +59 0.03754231185829019 +60 0.03625529087634873 +61 0.035308315471243246 +62 0.0346856654401191 +63 0.03437693165912537 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz new file mode 100644 index 000000000..6d5851f07 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8799105122941488 -1.4818039547426395e-17 8.764177354853186e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8801438142297389 -2.1611756731588002e-17 8.768115972514028e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8806143821668642 -1.73166004851659e-17 -1.1148193301621493e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8813302031330725 1.4374257505516665e-17 -9.363638813796147e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8823034052283742 2.0632215233429184e-17 -6.8376706336636196e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8835504355494204 2.6494136059998168e-17 -3.464505766557596e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8850922987190912 1.509210046786807e-17 -2.7622113106934002e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8869548568700507 4.615140851063601e-18 -9.669561639694123e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8891691917871605 2.7700940671753266e-18 -2.1032729473972124e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8917720294923865 -5.304300170309955e-18 -2.167382154382066e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.8948062267528696 2.37553908536632e-19 -1.960926676215573e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8983213176818905 7.123531887961463e-18 -4.595575935295597e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.9023741166176247 -2.498107909340288e-17 -3.9303946201610456e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9070293705939625 1.3255167196590463e-18 -3.010360634286847e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.912360450699874 1.2305850236951042e-18 -3.066258351279711e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9184500661203119 -1.2035671906394122e-17 -3.565276057664299e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9253909772567166 -1.6850762086372362e-17 -3.0918062888306485e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9332866745320818 1.7019547078288147e-17 9.307318213571045e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9422519766965138 9.014130387809894e-18 3.4368479632978663e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9524134859585833 9.210366991730079e-19 1.448927624198405e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9639098162906274 1.1020386192761802e-17 1.2825507356529638e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9768914849375068 1.8012507408866832e-18 -5.762941028792815e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.9915203246853552 2.3436906144304097e-18 -1.205386359754901e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.0079682351278803 4.2548394131358493e-19 7.918028149299706e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0264150435044437 -5.588696464160026e-20 1.3721120958224374e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0470451890202512 -8.93256721441966e-19 -7.40651727486165e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.070042881382301 -7.684726851792031e-19 -1.77530053819022e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.095585316864181 -3.7214240819596913e-19 -1.0472359525435372e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.1238334766072695 -3.309214348747377e-19 8.186434157007143e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1549196184069537 -2.149982312841141e-19 1.2826161666784079e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1889222410911957 -2.8910103527373565e-19 6.955200010624968e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.225843045231043 -5.047421097371697e-19 2.025313010214588e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.26559523403105 -1.5831161307032564e-19 -2.2389360599032424e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.307998098550897 -2.261812384344355e-19 2.2565270863236893e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3527878956705406 5.065899291860715e-19 3.149182113277332e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.3996269882386483 1.0383173420431231e-19 4.554963500846137e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4481021550151265 5.741472342134584e-20 -3.565171847655363e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.497731272924313 9.577173256440004e-20 -7.457967190892717e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5479957721031035 -9.757996259475069e-20 -3.100616674328214e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.598376943092892 1.6198443988384673e-19 -9.863903182490844e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.648370815226264 -1.823381437664442e-19 6.430123848049863e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.697494772645707 5.262114574221734e-19 3.5447561568294535e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.7453032732283527 -3.129105374352937e-19 3.6815357787302563e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7914152626632656 -2.40559870104534e-19 -3.9040395157938506e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.8355354801897885 7.694711161765388e-20 -5.920933898056655e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8774500127611233 2.1524878276153628e-19 7.152451335832207e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9170129276559305 4.1753944841999717e-19 3.099060585188274e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9541332819067936 -7.475722945733658e-19 5.620834793056669e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.988763675139281 3.3409953797282103e-19 -5.393487286056188e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0208910536726523 -4.930396167767249e-19 8.572447661604486e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.050528869489975 6.516460959330137e-19 -6.51242302947236e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0777104936304487 -4.598748608951661e-19 2.9290663724454975e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.1024836401282645 5.631556635382123e-19 2.5255422033388196e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.124905506164225 -4.509559522972745e-19 7.187309576835938e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.145038292980541 1.3310096361445248e-19 -5.950517357367694e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1629454843040827 -1.0985602684744378e-19 -4.51591260772626e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.178689033406833 4.3019655729368527e-19 -1.955404597954926e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1923272747216185 -2.460772687576164e-19 3.2054176024782314e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.203913401700197 -1.094030958348145e-19 4.2725967407467936e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.213494380522006 8.116697895669598e-20 4.3049559829646744e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.2211101860382603 1.304608057140352e-19 -3.624827048561639e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.2267932763420575 -3.768999954537053e-20 -9.037285109619152e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.2305682424987436 7.450864072794135e-21 -2.497588208932462e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.232451585406962 1.6750060038730048e-20 8.385129816166974e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener new file mode 100644 index 000000000..fc5c7da78 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041459080819323514 +1 0.041463266696433784 +2 0.04147193209502261 +3 0.041485683192457545 +4 0.04150547752883694 +5 0.04153268491730249 +6 0.041569173727612464 +7 0.041617427080000075 +8 0.04168069483465271 +9 0.041763188706713146 +10 0.041870329336341675 +11 0.04200905560470784 +12 0.04218820773650762 +13 0.0424189964757561 +14 0.04271557040093348 +15 0.04309569155328883 +16 0.043581524955702444 +17 0.04420053883626715 +18 0.044986497443778986 +19 0.045980504637466404 +20 0.04723202071098073 +21 0.04879972345750561 +22 0.05075201357885669 +23 0.05316687145502611 +24 0.05613065713604213 +25 0.059735314239021634 +26 0.06407330792707908 +27 0.06922953116338072 +28 0.0752694107318753 +29 0.08222262584793823 +30 0.0900622783790213 +31 0.09867211816276647 +32 0.10779090004496208 +33 0.11700211790076079 +34 0.12573067925013412 +35 0.1333183777373251 +36 0.13937196072972097 +37 0.14363604060969207 +38 0.14588288856285453 +39 0.1459364183364081 +40 0.14389765477961405 +41 0.14020886193159668 +42 0.13532787355879522 +43 0.12940848983223147 +44 0.12249050504400215 +45 0.11472482654541673 +46 0.1065275360850208 +47 0.09829908580578099 +48 0.09034506161117566 +49 0.08287391131061793 +50 0.07599089898368076 +51 0.06974915339593592 +52 0.06416838206795744 +53 0.0592431215229901 +54 0.054949760747959625 +55 0.05124670150327936 +56 0.04808356464695303 +57 0.045414725213881804 +58 0.043200303861606566 +59 0.04140627936351526 +60 0.04000448663295717 +61 0.0389725520598811 +62 0.03829380399516897 +63 0.037957185175737894 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz new file mode 100644 index 000000000..7d537aaa6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.879936010982227 7.065757362297639e-19 -4.185955767784441e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8801589386050144 -1.7839760375315284e-17 -4.2297060552550195e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.880608507723525 8.950786087621875e-18 -7.831584021347905e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8812922009247397 -2.2727782303556557e-18 -2.4458798754215535e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8822213794974036 -3.35609544394301e-17 -4.658203839781102e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8834114491398541 -2.4493112297663907e-17 -3.7533830657906356e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8848820821520327 -2.457917587374665e-18 -3.059480649067188e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8866574969403591 -3.74321740884732e-18 -2.4351222531532415e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8887667955452834 8.322483134643879e-18 -1.0519442361574095e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8912443595280617 -1.03374848938201e-17 -4.494180773268634e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.894130303829676 -2.762338817768821e-19 -8.313797466446848e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8974709870251014 1.1362965882607877e-17 -2.95543911428465e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.901319574587844 6.548243631061822e-18 -1.2982718033004681e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9057366491584975 9.109298954366831e-18 -2.3301966156362085e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9107908581380517 -3.4083406720379194e-18 -1.7627230277966106e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9165595838929044 3.847517374050949e-18 -1.481971297289927e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9231296150962724 4.0082297611608184e-19 -7.497972130578195e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9305977887838615 -1.438262172710932e-17 -1.9100807504074708e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9390715610385563 -2.094187358979795e-18 -1.848474145498587e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9486694492225969 -1.698047899660851e-17 -4.2380471687500544e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9595212696792217 -4.214195735110433e-18 -2.510399448234755e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.971768071133231 -6.448136005462612e-18 -3.472465658461082e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.9855616350309646 -6.074151969575942e-19 -2.6815487984281575e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.001063379371996 -1.977169747459427e-18 -1.0624324230774459e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0184424623047796 2.196954502456048e-19 -3.958767479299041e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.037872836815875 -1.4139233952391604e-18 2.530508643805923e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.059528960621076 -1.541127416404053e-18 2.206367360604349e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0835798204395943 -1.3850189537065089e-18 -9.749619666275856e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.110180894789757 -2.3188207387249985e-18 -4.913525895212078e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1394636657467223 -1.064274984800763e-18 -3.851035982549103e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.171522054580109 -1.7893674161786327e-18 1.0619970777484762e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.2063924359207 -1.7198056957621688e-19 4.681802318675927e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.244035676661467 6.748538187233446e-19 1.892100503429274e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.284329044979419 -3.8268916941973404e-20 2.3474573847887815e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3270639255075363 1.6441736266156921e-18 -1.531835616134155e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.37195431517773 -1.6404917084902775e-19 2.416663584079753e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.4186474306266654 1.4963493613718155e-18 -1.7892138404523974e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4667276556583704 -5.698799654018461e-19 1.552650840260815e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.5157247694511127 -9.424463594428599e-20 -5.078339958634567e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.565139500355549 4.280600920723459e-19 -5.988256677955406e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.6144764027154346 -1.2372424164223354e-18 2.7256904704554126e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.663260221263783 1.1633434656570315e-18 -5.1467383957617427e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.711043733707909 -1.7849496684066456e-18 2.568050601086811e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7574192067063534 1.3675518739658064e-18 -4.879299750176103e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.802036841026258 -8.946487796950821e-19 -3.9574834727837375e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.844624286563518 5.633965830487279e-19 -8.329239409850754e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.884984951011993 4.158009442681183e-19 1.0781823355337375e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.922985568337913 -1.4243912073953643e-18 2.9824406149399207e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.958544267253878 1.9750262361069174e-18 -1.9931819154190334e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9916195226316766 -2.379225047834592e-18 1.1541346162304602e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0222013519378534 3.1753306925044314e-18 -3.943940291157273e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.050303921839971 -3.331727280502606e-18 4.460971981042191e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0759591607151067 3.0700268937754346e-18 -1.9100151840347504e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0992113689883127 -3.0338295184036957e-18 1.5849189587568082e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1201129834500847 2.6358980230685945e-18 -2.7217165727866418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1387206414099773 -2.2356823142169837e-18 1.6285195707846627e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.155091682119706 1.962536576335668e-18 -5.1584548171598114e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1692814839363757 -1.3625471930520277e-18 1.0339936888897448e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1813414769057555 8.044901973759628e-19 -9.101893940806207e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.191317683545453 -8.883320840462678e-19 -6.155636391345769e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1992496664228263 5.81833156212664e-19 -6.63319856591771e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.205169784884851 -1.1477474004530748e-19 6.110244386811439e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.209102684523402 1.6029912979484747e-19 -4.398972900491817e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.2110649616649267 -1.6261945703752335e-19 -3.93313171567345e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener new file mode 100644 index 000000000..ae991dec4 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041445327042583135 +1 0.0414490665634075 +2 0.04145681112300285 +3 0.0414691089658215 +4 0.04148682645109605 +5 0.041511203596971386 +6 0.04154393282698502 +7 0.04158726512726232 +8 0.04164414909248003 +9 0.04171840971547714 +10 0.04181497523065795 +11 0.04194016178215449 +12 0.042102027012853004 +13 0.04231080461612225 +14 0.042579432065452505 +15 0.04292418253274048 +16 0.043365408526629554 +17 0.04392839774329313 +18 0.04464432924807358 +19 0.045551298039680686 +20 0.04669534531080781 +21 0.048131386795849884 +22 0.04992386877741169 +23 0.0521468974767896 +24 0.0548834816345962 +25 0.05822340371487408 +26 0.0622591046855921 +27 0.06707885759287759 +28 0.07275646482092221 +29 0.07933682096362389 +30 0.08681704903421228 +31 0.09512213116502652 +32 0.10405415568233825 +33 0.11326187082959766 +34 0.12223954935490432 +35 0.1303388660460896 +36 0.13704039604370064 +37 0.14206557396698827 +38 0.14518279871707157 +39 0.14618868358926546 +40 0.14502005744481944 +41 0.14201245338891041 +42 0.13764394234232671 +43 0.13222453245224994 +44 0.12579864370985502 +45 0.11844274864070704 +46 0.11045966382432254 +47 0.10228037238279487 +48 0.09424883187500871 +49 0.08661714918640119 +50 0.079533644201776 +51 0.07306989699766377 +52 0.06725949636324598 +53 0.06210760370183106 +54 0.05759867149555112 +55 0.053701950951108135 +56 0.05037142279618738 +57 0.04756009567434832 +58 0.04522666387322327 +59 0.043335754297950356 +60 0.04185799620450135 +61 0.04077000602659984 +62 0.04005433101347692 +63 0.03969938290923216 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz new file mode 100644 index 000000000..94bcedee6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8791738669209226 1.701546495325969e-19 -6.095187601120418e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8793858847500051 6.779906370997021e-18 -1.1303739639494601e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8798134622309113 7.934864771648852e-18 -4.253374111315632e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.880463735596428 5.269618450359536e-18 6.132925725812283e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8813475409831628 -9.532768133161335e-18 5.584606804129179e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8824795734364483 -1.156367439526095e-17 -1.2996133510111979e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.88387860024689 -6.709933013602591e-18 -2.033116546323147e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8855677295414592 -2.15095962621934e-18 -1.608198026865791e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8875747349889345 2.6029057209308463e-18 -1.2960581700498522e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.889932437186588 1.5187163577237834e-18 -7.410482738698371e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.8926791416847986 -5.339413785787683e-18 3.490112885397532e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8958591325732497 1.7940851611418407e-17 2.371092200444163e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.899523218956968 2.929772676161413e-19 3.697692966180753e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9037293293142268 7.422123620791183e-20 3.132238956835482e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.908543145431589 5.933833575283083e-18 1.734174600577743e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9140387630684275 1.852075420518976e-18 7.54247042907666e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.920299360373361 -5.581105133524472e-18 1.0491184536359983e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.927417846932732 5.723603522324887e-18 7.126024422488742e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9354974556773346 3.423210528513448e-18 7.993441526130269e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9446522261231145 9.073058689909978e-18 5.536698041976434e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.955007309932994 -6.076500391144077e-19 -1.4448666034074638e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9666990078748852 2.5934008097566354e-18 1.4868707466913588e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.979874420294782 4.492781609608977e-19 1.0767130417496557e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9946905607481384 3.7057544084843425e-19 1.0146569395474371e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.011312744385329 5.367458261400043e-21 -3.5913081914744495e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.029912019711389 2.3417341025938267e-19 -8.334466317655181e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.050661366357251 3.5614568167931924e-19 -1.1706838604087939e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0737303363830977 -2.308323489194424e-19 -9.85119660552973e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.0992777792624 3.11023697892734e-19 -1.0932607899062592e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1274422721685298 -6.375642989763246e-20 -5.785255621145808e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1583298941329843 1.2542387610216678e-19 -3.20112994703731e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.1919988476784034 -5.968528118427075e-20 3.594675500491886e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.228439426895967 -3.2239377164550785e-19 9.053662187334257e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.2675623155769165 3.4827992774571505e-19 6.418688255804601e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.3091942847450535 -9.750376802910433e-20 7.303051436242485e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.3530802223831495 7.846049486376997e-19 -2.5284151159504445e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3988946281692924 -5.548994004891861e-20 -1.9614394599730856e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.446249960953354 -2.5186104652729252e-20 -1.5770962460579075e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.4947031938512993 2.2413228033662523e-19 -1.7871817876548288e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.543770898352245 -4.436095960325143e-19 8.081261953487728e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.5929571750008256 3.483257044575158e-19 -3.229267690244833e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6417803411954486 -8.216434129956713e-19 4.4119626025400685e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6897854690631116 4.738979686539391e-19 -2.229418137936172e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7365525778792663 -2.6424244663308556e-19 1.4545091713552163e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.7817100862428474 1.427389828164629e-19 -6.71814686836178e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.824950214816541 3.6097123476891045e-19 -1.133606053656544e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.866041039181137 -4.781106571631652e-19 3.027009444526241e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.904819222801416 9.769850121951713e-19 -5.588514870714049e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.941177988748218 -1.1604044608505294e-18 6.112581570969967e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9750559222024013 1.0888525935236551e-18 -4.930797474649088e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.006426930397174 -1.3625421027346555e-18 7.29018416799337e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0352922049876696 1.2282256101670867e-18 -7.477157855253858e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.061673399850161 -1.067337682617537e-18 4.874121613603069e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.085606782979188 1.0227434669254665e-18 -5.197502602906365e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1071383127889627 -6.864152512679844e-19 4.269094811613597e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1263196578995314 5.901087217658505e-19 -2.846873999230078e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.143204718028132 -4.768332157268248e-19 1.9970172371679599e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.157846591433172 2.328689939257137e-19 -1.311792382103001e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1702952697849898 -2.454675357301998e-19 1.7817110018561744e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.180595927717503 1.642494831250929e-19 -8.149948469376971e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.188787675401489 6.083923678236937e-20 -6.504484279954105e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.194902667214529 6.145501169718553e-20 -1.698293134280198e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1989654821995472 -8.333668336106109e-20 5.855595978162093e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.200992712276598 -3.487767525085576e-21 -3.229866238427112e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener new file mode 100644 index 000000000..8e54d47e3 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04144054208436112 +1 0.04144409586587292 +2 0.04145145516537695 +3 0.041463139752019186 +4 0.041479970942061115 +5 0.041503124208672235 +6 0.04153420378298187 +7 0.041575343251204606 +8 0.041629337369100405 +9 0.041699811641437316 +10 0.04179143762776264 +11 0.04191020337411097 +12 0.04206374970876496 +13 0.042261784161005865 +14 0.04251658461059021 +15 0.04284360390273965 +16 0.04326218374958333 +17 0.043796380104186704 +18 0.04447589119702167 +19 0.04533706137193542 +20 0.04642390594938778 +21 0.047789061226911025 +22 0.04949450577064875 +23 0.051611821106958666 +24 0.054221660231121814 +25 0.05741197342604569 +26 0.06127441277227098 +27 0.06589822239909815 +28 0.07136086373388549 +29 0.0777146936853932 +30 0.08496931100329116 +31 0.093069534900205 +32 0.10185300150988472 +33 0.11100739353852199 +34 0.12006912117295708 +35 0.12842328987454232 +36 0.13548342550570078 +37 0.1409414415783029 +38 0.14456251414739757 +39 0.14613594206416028 +40 0.14553726481164225 +41 0.14299755447632337 +42 0.13898061076570395 +43 0.13388074575243838 +44 0.12777934152209108 +45 0.1207312816332953 +46 0.11294983310286946 +47 0.1048612848929129 +48 0.09683196333433751 +49 0.0891368402052708 +50 0.08195478659549262 +51 0.07537288884538088 +52 0.06943408362004713 +53 0.06415095473351323 +54 0.059513639343837854 +55 0.055496680702518085 +56 0.052060826230550805 +57 0.04915936171404459 +58 0.04675029165805342 +59 0.044797559285974085 +60 0.04327116666277864 +61 0.04214719496511254 +62 0.041407772321972534 +63 0.04104102329826275 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz new file mode 100644 index 000000000..d1a86153c --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8788968686814775 5.935145963695602e-18 5.704790165259476e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8791032222507325 2.9274815436505934e-18 5.793965900895888e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8795193681735805 2.5190875798009857e-18 8.900212472558596e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8801522351135014 -3.510246453286521e-18 -4.8728782663666265e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8810123441253772 -4.757831036282159e-18 -8.61393887921492e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8821139631990096 -4.1577456549347416e-18 -4.3964652857853916e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8834753146737977 -3.016693039638362e-18 -3.6230642114608365e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8851188364843414 -1.0544489568002812e-18 -2.850056884915772e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8870714981616468 -9.466658271804622e-19 1.0284960315504387e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8893651722642852 -5.457454638720269e-18 -7.770016627960046e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.8920370613657955 -4.739719757395633e-20 3.530547525812142e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.895130179779739 -9.37344272143462e-19 9.207528050881052e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.898693887730515 9.032711818302275e-18 2.1066459598316248e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9027844735079193 1.5126181290146976e-18 1.1792738966272956e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.907465776069129 8.451625998763317e-18 2.1415381140017713e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9128098363027637 4.624861281979817e-18 1.1787682937451602e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9188975594232192 -3.958487541906101e-18 6.829826471555455e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9258193633149077 -1.489946378709708e-19 7.497662653481627e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9336757776198055 -3.261961950262656e-18 3.779757798115109e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9425779453969048 3.5943618242475434e-18 -3.7026408766279606e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9526479626603697 8.290609905004844e-18 -3.925592244535189e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9640189703546316 6.5481518474515024e-18 -1.9096723868723105e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.9768348877302018 3.6194909549906556e-18 -3.2600820180075725e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9912496451399382 1.445318514600938e-18 1.0693496942470345e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.007425737853255 6.837807135547284e-19 5.669186629001252e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0255318810712284 2.317023194913422e-19 3.8936035876136174e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.045739501561417 -9.254144366723115e-20 1.6361794024769926e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.068217756634081 5.939509468160047e-20 3.0727549107325935e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.093126732730186 -3.6292929066298753e-19 -1.3204598285230481e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1206084537744645 2.936200371590237e-19 3.4395487860547965e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1507753390710076 -1.4824900058487393e-19 -8.429750419115118e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.183695813820083 -1.4693817486493102e-19 5.520918018319251e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.219376336561411 -1.7058509399533282e-19 2.2738013061659693e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.2577465538333716 -6.796851472466944e-19 -1.0092007447912085e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.2986538519327055 7.147743274542969e-20 2.1276117009906205e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.3418637789088748 -4.96768393906934e-19 -3.7693456358085478e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.387068140326381 2.58861687936319e-19 -3.771388005819843e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.433895845497993 2.6222466695798722e-20 -1.5629586959442755e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.4819202223406913 1.0311514378442223e-19 -2.961007642812898e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.5306705751521883 5.820310130697113e-19 9.118438454382897e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.5796556416858563 -2.514463393136698e-19 -2.4867095475600336e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.628391711514693 4.827239387630167e-19 6.497041585612647e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.676419000405795 -6.774532423083731e-19 -1.5369928012155972e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.7233115805329935 3.087804276153838e-19 3.2148461881181123e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.768687459928029 -2.808217824434559e-19 -1.4599353692968685e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.8122231845020473 -2.1642722139935498e-19 -2.530866950845011e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.8536657152416125 3.625168827844602e-19 3.0464896507684116e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.8928330655126198 -4.568937621636928e-19 -5.518216854887877e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.929602750433735 9.025175823034918e-19 6.827752259482073e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9639004676757765 -8.699812588041144e-19 -8.977199557686857e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.9956898234445206 8.985971605544934e-19 1.0482825971955224e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0249636270814184 -1.07477927865434e-18 -7.964424496160624e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0517368036825014 8.300023499126894e-19 9.218184439056004e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.076040305097591 -7.157098004287063e-19 -8.5339361711595815e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0979159466633113 6.262574208719875e-19 6.051351959909549e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.117412095375455 -4.225078019687824e-19 -6.009853494448832e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.134580173456733 3.7681638211452194e-19 4.2455341842587125e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1494715881155266 -2.455898786989531e-19 -3.1642063846161596e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1621352219848124 1.5370450667441352e-19 2.5231059206953404e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1726155577606354 -9.252921911876231e-20 -9.240331520884381e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1809513011719464 -9.934521898350259e-21 1.848869642804555e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1871743901273693 -9.301413057086079e-20 -1.466720353893475e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1913093011615783 1.4976094974661644e-20 -3.211747369080815e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.193372585416903 4.57564569586905e-20 -8.561986249752828e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener new file mode 100644 index 000000000..3f8ba8648 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04143664422359852 +1 0.041440060138863546 +2 0.041447134249361355 +3 0.04145836681308158 +4 0.04147454835323606 +5 0.04149681034919958 +6 0.041526697132302434 +7 0.04156626286344886 +8 0.041618198653083985 +9 0.04168599617971524 +10 0.04177415555216281 +11 0.04188844658703223 +12 0.04203623402269071 +13 0.042226878262796926 +14 0.04247222370610243 +15 0.04278718605997436 +16 0.04319044748227577 +17 0.04370526283493567 +18 0.0443603702056194 +19 0.04519098206673684 +20 0.046239807303146065 +21 0.04755801559816582 +22 0.049206000739820586 +23 0.05125372496893626 +24 0.05378033065898682 +25 0.056872590062549085 +26 0.06062163720121381 +27 0.06511730877998273 +28 0.07043935237753572 +29 0.07664480506276257 +30 0.0837511003850631 +31 0.09171500347875826 +32 0.1003958679581365 +33 0.10950652120736357 +34 0.11860985372907501 +35 0.12711661644633437 +36 0.13440694442202114 +37 0.14014245023155936 +38 0.144084121187044 +39 0.1460181275569136 +40 0.1457938767500849 +41 0.14356816545299292 +42 0.13978819313128785 +43 0.1348852190278622 +44 0.12898369836731932 +45 0.12213003076816675 +46 0.11448737980731134 +47 0.10646450874323858 +48 0.09844237551962157 +49 0.09071024508420758 +50 0.08346555146590494 +51 0.07680809067379347 +52 0.07078696456998052 +53 0.06541964315707728 +54 0.06069999153105468 +55 0.056605356374527266 +56 0.05310056742000245 +57 0.05014017370164885 +58 0.04768170413972135 +59 0.045688632616641335 +60 0.04413053167984842 +61 0.04298311647066296 +62 0.04222822874751713 +63 0.041853796953166204 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz new file mode 100644 index 000000000..ed353fe9e --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.878666181269265 -5.295902948453637e-18 -2.2763669763097563e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8788685976452955 -7.074040512991991e-18 2.7205839553710903e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8792768022019717 -6.269370321728867e-19 -3.803996482068257e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.879897588717999 -3.892428033712656e-19 3.19856404599831e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8807412736114943 1.3060528883337608e-18 -2.0725065284868638e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8818218477238382 1.254314980204004e-18 -8.385927755970823e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.883157180079009 2.0692760813997338e-18 -2.636909425380721e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.884769274608177 3.2334758832707515e-19 -2.0887361650984814e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.886684580814134 6.443878487414969e-19 1.068240950634624e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8889343591291927 -1.0453272785659841e-18 -1.1734116518224594e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.8915551012144196 -1.0337190428865879e-18 -1.1659706678602371e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.8945890045622686 2.5540781101460144e-19 -2.6767002802559535e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.8980844993726955 -3.972563373242129e-18 -8.711744242226363e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9020968236123423 8.722814034504926e-18 3.172783994760613e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9066886392382447 2.146963557526456e-18 -5.834059133678907e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9119306785105374 8.352675556375602e-19 -7.585362609531923e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.917902403821648 -3.6339796171428855e-19 -2.4926091532387773e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9246926571409713 1.6411719033056341e-18 -3.904087728225159e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.93240026555296 2.6788036733043113e-18 -1.8589456383769035e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9411345569072345 2.4319619125959372e-18 -4.713597403378293e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.951015723696946 1.9546721999125473e-19 -3.942506826806461e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.962174953275782 1.2910563486175442e-19 -2.804674475397091e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.974754217794278 4.95631203342041e-19 -1.0558951097225412e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9889055872593737 9.425863692544096e-20 -7.140957369348489e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0047898937157678 5.4774655195103995e-19 -2.7931101405081773e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0225745340952788 1.9856036252859662e-19 -2.8052097276690033e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.042430155237719 1.4418746786167191e-19 -2.0932107010875307e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0645259200679633 1.6488396417264893e-19 -1.9428249651211215e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.089023014631418 -3.105194946964913e-19 -3.0571688906496266e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.116066031056947 1.7180208112985426e-19 2.194568710889839e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1457718660183827 -5.663581096082585e-20 -6.686184839026045e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.178215828746498 1.618475694230528e-19 1.8166095979731e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2134146430093233 3.5066708975922184e-19 1.4847758806234251e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.2513103032641157 -2.6473790242586913e-20 1.5038598095973467e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.291763454225462 3.3616110398438134e-19 2.562263499052595e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.3345528789645984 -4.650170937975025e-19 -1.0134763257849567e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3793819304501036 1.5337422280057186e-20 1.0296799433048626e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4258898052884756 -4.445220700319764e-19 -2.200003147156826e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.4736592595665066 -2.1296684235905591e-19 -2.433258662404368e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.522227193970893 3.499315352040772e-19 6.874286984112056e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.571105746533172 -1.6914165095849844e-19 -1.355172064033723e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6198095381228983 7.054627456941059e-19 3.1102907713383783e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6678750861050737 -3.9992804557186476e-19 -1.6041188820687685e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.714871422832011 3.469597586476596e-19 2.830047780617147e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.760409524101228 -3.2815607800274294e-19 -7.555230552037239e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.804156146669714 -1.5096924594108338e-19 -7.875607566655785e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.845845564899815 1.922654067293942e-19 1.1362167723804078e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.8852835601153406 -5.363893870300963e-19 -3.834060602367143e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9223373377336324 8.626659384511526e-19 3.472185571459152e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9569240892055437 -8.721386489033879e-19 -4.649106823395035e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.9890005904525982 1.0672991153029092e-18 6.901788608443445e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0185541530398625 -1.0225910308312507e-18 -4.587361663297308e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0455952904121864 9.070858931208286e-19 5.710484779722701e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.070151470176567 -9.24078979154795e-19 -5.206070299114703e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0922617999701725 7.372970549893983e-19 3.0159321146517975e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1119725739497195 -5.659453094545259e-19 -4.716866605429622e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1293336033981363 4.375843850926666e-19 2.401303307859121e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1443951647810437 -3.4844152072140765e-19 -1.1797139584447788e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.157205390469654 2.1661664533273546e-19 2.2622623664806454e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1678082867449375 -1.0380023611613293e-19 -5.542766535944786e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1762422731044215 1.168326506194776e-19 7.173920892492914e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.182539127279872 -3.95627195515269e-20 -1.6559273739345036e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1867232440796434 1.2657788408820301e-20 1.780519663735972e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.188811137832341 -5.2324703105615905e-20 -6.496331901895322e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener new file mode 100644 index 000000000..3642ca07b --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0414344481013313 +1 0.04143778367518003 +2 0.04144469142280824 +3 0.04145565987586224 +4 0.041471461032988474 +5 0.0414931998740958 +6 0.04152238459525 +7 0.0415610213607754 +8 0.04161173853160419 +9 0.041677946604529406 +10 0.04176404146921561 +11 0.041875660006592 +12 0.04201999840611084 +13 0.04220620467867648 +14 0.04244585737152615 +15 0.042753541957449334 +16 0.04314753403271842 +17 0.04365059324125735 +18 0.04429086224177583 +19 0.04510284901837189 +20 0.04612844578315571 +21 0.04741790044411718 +22 0.04903060356778962 +23 0.05103548159245915 +24 0.05351069368497902 +25 0.05654221631407445 +26 0.06022077410686769 +27 0.06463645697678157 +28 0.06987028872854513 +29 0.07598204323811703 +30 0.08299383357361578 +31 0.09086954477839329 +32 0.09948138729871513 +33 0.10855809484578015 +34 0.11767912729212285 +35 0.12627221561018004 +36 0.133703510023137 +37 0.1396104583975605 +38 0.14375099351938908 +39 0.14590993209975922 +40 0.14592453594698993 +41 0.1439043685117157 +42 0.14028206112170988 +43 0.13550454160630426 +44 0.12973038300824416 +45 0.12300219736281041 +46 0.11545684373325323 +47 0.10748390682837579 +48 0.09947339789693144 +49 0.09172354566745906 +50 0.08444268021089006 +51 0.07774005507031738 +52 0.07166879798086584 +53 0.06624957514229825 +54 0.061478716665723465 +55 0.057335400595689694 +56 0.05378672100349848 +57 0.0507887477874041 +58 0.048298740308704145 +59 0.046279890500890195 +60 0.04470151067861862 +61 0.04353909298849611 +62 0.0427743040960467 +63 0.04239495225578481 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz new file mode 100644 index 000000000..bf41fc2d0 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8785340972958648 -1.2670569672736025e-18 6.425794799095023e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8787341044083754 -4.337545924023283e-19 1.6804719236274879e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8791374483448158 -2.377832955841299e-18 6.6481916477523565e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8797508381046804 -3.469293035945451e-18 1.447686596711303e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8805844614571932 -2.262631876194173e-18 3.4019660322292756e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8816521349554456 -2.9754471048622068e-18 5.161294357873187e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8829715053495577 -1.2513202332486155e-18 -1.6990575717744405e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8845643034058837 -1.3741722495969553e-18 -9.221031783553793e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8864566511362162 -1.4060559251597187e-18 -7.176133770239653e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.8886794232379154 1.3947649363921136e-20 6.888511842824963e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.89126866306627 6.877685992938176e-19 7.128781444974133e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.894266052611152 4.8409253000533344e-18 -5.223279801249339e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.897719434608663 -3.4276477209160546e-18 2.7373209049324054e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.90168338292633 -5.603806978988592e-18 -3.50445236792668e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.9062198145237463 -4.668936472887255e-18 1.743311974277051e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.911398632353882 -2.804022461051219e-18 2.2480557251438288e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9172983832301314 -1.348499691650589e-18 3.189005133543193e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.924006907557009 3.3352230010164243e-18 6.39590216263746e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9316219484570565 5.343876476667432e-18 3.2294972875354107e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9402516756866148 4.751341737359195e-18 4.139252512654213e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9500150642234215 1.990523507222396e-18 2.993642402107367e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9610420478749542 4.2191629023308243e-19 1.3231164362871559e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.973473344078394 2.6929497384442736e-19 6.187796906445316e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9874598167058128 -5.925436038136735e-20 3.2564012588794363e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.003161208939032 -1.3597097024969224e-19 4.409952501067069e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0207440384542332 -1.4173590062523954e-19 -1.084299719544451e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.0403784035992305 -1.6481626199315845e-19 -1.6256464448296567e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0622334048811357 -8.433373824411512e-20 -2.6221497546583496e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.086470846330306 -1.2370480437912777e-19 -1.2533596338286803e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1132368551550527 6.92776145088423e-20 -1.9066999777616782e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1426510594543666 -1.4814550558710061e-21 -2.5417201658540117e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.1747930127177915 8.706167019965151e-20 -1.1881402441880038e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.2096856439982133 1.1714112424363978e-19 8.163739109961441e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.2472786291195423 5.674076419730481e-20 2.164549170770715e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.287440897392976 1.647169115765989e-19 7.495230249431295e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.32995954143029 -4.489984577088448e-20 2.0588786195948482e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.374545408659291 4.881538457807048e-20 -4.2361067641546e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4208442435206194 -7.90687336315312e-20 5.921049070052113e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.4684447287998714 -4.5934366128061294e-21 -1.2467904747339818e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.516888647666397 3.1208187326510955e-20 -9.507997464446168e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.565690517943155 -1.4186756676965046e-19 2.7676452725120506e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6143643136516985 6.643623751917365e-20 -1.9639759331910475e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6624443857699136 -1.390141688201603e-19 9.960221488988363e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.709496554171786 1.512456374549945e-19 -1.0938122836013374e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.755127526733694 -2.5670840141905562e-20 9.07614893505934e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.798998029015574 4.2911037595489473e-20 6.415070617866911e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.840834787313864 5.76925661484952e-20 -4.0563820150736766e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.8804358454984107 -1.162858414518964e-19 1.6640554457606538e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9176618714286695 1.6032434852473695e-19 -1.846205301375823e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.952424650162928 -2.426706635597313e-19 2.2905864275628376e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.984676583819176 2.224739065741512e-19 -2.908177341431064e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0144014794189005 -2.630906050896412e-19 2.9604994113598316e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.041607030966647 2.7236931044564986e-19 -2.9973610249582957e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.06631847309043 -2.0107028716041818e-19 2.4224819180449774e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0885731726924135 1.8093348815540446e-19 -2.0910074414054282e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.108416088915517 -1.6294403054485878e-19 2.1182917183052314e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1258960139712415 1.307359156683172e-19 -1.531973541197499e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1410624836862175 -1.0126712266726253e-19 9.586326303283239e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.153963135911982 3.9417375862766083e-20 -8.277948695606817e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1646416602889196 -3.7649750373833883e-20 6.601546725613741e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.173136283860058 4.6609347386997157e-20 -3.0282315941351194e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.179478674823999 1.175465515193212e-20 1.2368941317716678e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1836931706739104 1.1100315434655062e-20 -2.158059616815489e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1857962589672835 -3.232829637545908e-20 7.16797356694354e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener new file mode 100644 index 000000000..74cfb6854 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04143299769934156 +1 0.04143628099242074 +2 0.04144308053013499 +3 0.04145387731392976 +4 0.04146943145123786 +5 0.04149083092002364 +6 0.04151956074573737 +7 0.041557596336294585 +8 0.04160752586979329 +9 0.04167270789257375 +10 0.04175747164676185 +11 0.04186736905709821 +12 0.04200948866315067 +13 0.04219284289955177 +14 0.04242884069763604 +15 0.04273185692669434 +16 0.04311990799000635 +17 0.04361543789051498 +18 0.04424620981105288 +19 0.04504628272284443 +20 0.04605702816760372 +21 0.04732810600701867 +22 0.04891826607797455 +23 0.05089577195028999 +24 0.05333815118656699 +25 0.05633086461175904 +26 0.059964362356287625 +27 0.06432887504836521 +28 0.06950620996739645 +29 0.07555784417102926 +30 0.08250881995612358 +31 0.09032747315371806 +32 0.09889390621499143 +33 0.10794707435974155 +34 0.11707693920515837 +35 0.1257220594295827 +36 0.13324269076770417 +37 0.1392585526558932 +38 0.14352535744759665 +39 0.14582713872911565 +40 0.1459947775336761 +41 0.14410829257333344 +42 0.14058913198263934 +43 0.13589155730004834 +44 0.1301978223671541 +45 0.12354897073798175 +46 0.11606774345062948 +47 0.10812852165300742 +48 0.10012691473060215 +49 0.09236691378634396 +50 0.0850634595100194 +51 0.07833230638313023 +52 0.07222925237588612 +53 0.06677703147284206 +54 0.061973569617895685 +55 0.05779923098847468 +56 0.05422236589579418 +57 0.05120022998815947 +58 0.048689947560732326 +59 0.046654527985621135 +60 0.0450631150370987 +61 0.043891056411423136 +62 0.04311990533693745 +63 0.042737392193991 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz new file mode 100644 index 000000000..6501c64ce --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8784459952495691 2.894202302058075e-19 8.162905450825316e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8786444424378275 5.347128259809661e-19 1.6876496936962949e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8790446396026663 9.873637064641165e-19 -3.8518418269937636e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8796532415215153 1.2509083847765793e-18 -1.6962286421816882e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.8804803536921602 -3.4418253851156475e-20 -3.496485187146204e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.88153968122524 3.8263745134124396e-19 1.3518799287760575e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.8828487287708964 9.48228766045267e-19 1.1684960557174846e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8844290524980885 3.6247164888609844e-19 1.0529101514863037e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8863065651497035 4.613331572248561e-19 -2.075552412959067e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.888511895005338 -2.2241301360681767e-19 2.9380042230354935e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.891080799120573 4.711903895950514e-19 9.288641039226765e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.894054630386051 -1.389956649141753e-19 1.4051044223713203e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.897480856640477 1.879203955720753e-18 1.6447580435121759e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.9014136281235303 2.4314199639482696e-18 1.4493620237384326e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.905914386776276 3.1850808938569172e-18 1.6460386710873221e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9110525070370765 2.7675955912522337e-18 1.5411044466572425e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9169059525407672 3.790391829160873e-18 1.0776780235045617e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.923561926130345 2.5035942111221374e-18 7.762345575142862e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.931117481387896 1.7164394223945824e-18 1.6096498674494737e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.939680051955247 1.8552452558776846e-18 1.8318477894124125e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9493678396549075 1.6229741741067104e-18 1.898362168029549e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.960309983188094 7.842315893590362e-19 7.579302121036494e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.9726464053589228 3.5343301396104686e-19 4.845198960989993e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9865272078098624 1.7571416269682663e-19 3.013797565784802e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0021114479199054 -4.5370069195624867e-20 2.000636332617781e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.0195650930892532 -1.2429673538363789e-19 1.4183780460364358e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.039057904381386 -1.1184042460780548e-19 5.247195546246644e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0607589572194933 -1.6989416091629736e-19 1.6828840243049422e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.084830466774558 2.2377315264914018e-20 -1.1752605987122382e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.111419558552922 -3.205571856441104e-20 -6.173178495028939e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.140647624024987 9.124231548749985e-20 -1.1174008899654617e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.1725969465691066 8.739334059739365e-20 5.256274759805444e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.207294394324863 -1.4580928438236474e-20 1.099287550517872e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.2446945613161926 3.598097899268279e-20 -3.28435780472313e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.2846716751463814 -1.5048798981079808e-19 6.699737068618943e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.3270181370640244 6.864272876592856e-20 -4.823682202877192e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3714496284538806 -5.2380656673143745e-20 -3.9870155006478456e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.417616064749429 1.7499219681411703e-20 -8.025310754105896e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.465109895102292 6.811684154471355e-20 -1.289963659255413e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.5134759627474867 -2.568226189593235e-20 5.63602523180321e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.5622302871590676 1.807186076900261e-19 -3.06635040934288e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6108864785880854 -1.468575184648461e-19 1.7243482026118764e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6589774727126785 6.981119624874818e-20 -2.410429331630257e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.706066983242395 -1.448074247037089e-19 5.2552924569815663e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.7517589434227765 -1.7977069302379405e-20 2.2057117639125374e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.7957102125419784 -1.2852725898398536e-20 -8.354107393220575e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.8376427805089905 -4.8898168711142545e-20 8.450405565951978e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.8773497170747895 1.9620291331677434e-19 -2.464135865405214e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.914687484318064 -1.3169950201921972e-19 2.079599188149943e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.94956438808568 2.008440353805706e-19 -2.187136012667402e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.9819300090759095 -1.8417343803023756e-19 3.2219930594051214e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.011765898556824 1.4224607896132489e-19 -2.5882563248221003e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.03907793619327 -1.7732915280824656e-19 2.3822993646970667e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.063889919530172 8.904874498519592e-20 -2.0419007133438084e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0862380950502506 -6.247414158592887e-20 1.929161174385223e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1061665624881596 5.743466869026258e-20 -1.857318953347886e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.123723464987119 -3.217546325657478e-20 8.139989371751067e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.138957859895444 6.175946367904081e-21 -9.195281327578959e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.151917064412695 4.089035713947293e-20 7.698558929235852e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.162644562054567 1.2368362290054365e-20 -6.358989720537693e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.171178453844319 -1.8693948562544736e-20 5.05390480163755e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1775503356211026 -4.812978242452787e-20 -3.2768094871757204e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1817845065102768 1.2354718316957766e-21 -1.961811956705475e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1838974358136816 2.5548210421753337e-20 3.333217090712742e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 new file mode 100644 index 000000000..6d1ef51ef --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 @@ -0,0 +1 @@ +1.808106747070066175e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.807078580715130306e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.805004350307681110e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.801847939345325306e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.797554364154923395e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.792048785868505245e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.785235163869434982e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.776994525102073771e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.767182816516461863e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.755628300419606602e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.742128444632521159e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.726446251218766159e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.708305959465872964e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.687388051157759014e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.663323479909889491e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.635687042703695693e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.603989812840880130e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.567670562473844065e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.526086124315449710e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.478500682799109567e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.424074054506016887e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.361849129507392182e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.290738817657252624e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.209513101114317521e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.116787167333753786e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.011012123102545887e-02 0.000000000000000000e+00 0.000000000000000000e+00 8.904705120817103456e-03 0.000000000000000000e+00 0.000000000000000000e+00 7.532798172563831551e-03 0.000000000000000000e+00 0.000000000000000000e+00 5.974083548811051983e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.207094541101505381e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.209814951728908405e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.936941851754964528e-05 0.000000000000000000e+00 0.000000000000000000e+00 -2.376112240447952884e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.522524792054723880e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.387991281830767906e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.879719163931013168e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.021013665270310664e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.972270141313742051e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.068179250183457114e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094379480659390599e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.071069278947441548e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.022161199875585430e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.590483874896173211e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.791868462450572186e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.680965917186222472e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.280487282043275415e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.751820235034294460e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.391192401969948117e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.200452284327990282e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.165985124838061354e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.683708331995340868e-04 0.000000000000000000e+00 0.000000000000000000e+00 5.214653808973020166e-04 0.000000000000000000e+00 0.000000000000000000e+00 1.214011141617175535e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.817885645353806839e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.341179196580205762e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.791321399079477183e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.172640149024354497e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.481488964810755191e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.726849142404297516e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.917876876403285705e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.062026997202422898e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.165140973873835209e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.231525313351568521e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.264014455361304218e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.805559322863033612e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -7.523163845262640051e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.394689268473244043e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -8.275480229788904056e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -9.027796614315168061e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.761581922631320025e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener new file mode 100644 index 000000000..ad4d71b29 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.041431159968245763 +1 0.0414343766705071 +2 0.041441038357545174 +3 0.04145161639296752 +4 0.04146685566220852 +5 0.04148782237410154 +6 0.041515971878580755 +7 0.04155324018025903 +8 0.04160216395934773 +9 0.041666035157624556 +10 0.041749097534570685 +11 0.041856794000993965 +12 0.041996074896036975 +13 0.0421757785109457 +14 0.04240709578511528 +15 0.04270413074377016 +16 0.04308456621417947 +17 0.043570439631689925 +18 0.04418902489774111 +19 0.044973801339273416 +20 0.045965467324147594 +21 0.04721292091934338 +22 0.04877407965050171 +23 0.05071634252842101 +24 0.0531164077453049 +25 0.056059049433738156 +26 0.05963433320190204 +27 0.0639326298686573 +28 0.06903670360728371 +29 0.07501016202250434 +30 0.08188174891400904 +31 0.08962545358340034 +32 0.09813118445377166 +33 0.10715123022230368 +34 0.11628910559140161 +35 0.1249974229295405 +36 0.13263221526469673 +37 0.13878816780384723 +38 0.14321763872385676 +39 0.1457037199935348 +40 0.14607037256371103 +41 0.144360598186313 +42 0.14097874693428394 +43 0.13638579915652513 +44 0.13079625951414806 +45 0.12425050723715576 +46 0.11685567710490194 +47 0.10896346274333556 +48 0.1009761158622855 +49 0.09320511837625593 +50 0.0858736465464215 +51 0.07910634090531145 +52 0.07296265326499976 +53 0.06746804380934066 +54 0.06262254989024513 +55 0.05840811151609661 +56 0.05479456174331278 +57 0.051740885430423565 +58 0.049204130031355486 +59 0.04714707031454202 +60 0.04553863288563279 +61 0.04435397899054626 +62 0.043574515271603956 +63 0.04318787140600699 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz new file mode 100644 index 000000000..2a2271a28 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.8783333422653203 3.0949281007768247e-19 -1.1000076338027177e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.8785297747426166 -1.42833431820084e-19 -5.250080142786166e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.8789259075692553 6.642204773721767e-20 -1.0865807581321575e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.8795283252010604 1.6271991821093396e-19 3.342303702065465e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.88034702643248 4.168295514510483e-19 5.540217709260785e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.8813955718294244 8.917118398962562e-19 8.821054777696175e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.882691281721143 5.653468921288331e-19 5.989277418850332e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.8842554857841827 3.5785730898880224e-19 3.001701555560058e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.8861138252662064 1.7844336290746563e-19 2.985640514280362e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.888296608721087 1.200071271939896e-19 6.126338575788869e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 1.890839221685344 1.2057247932965619e-19 -1.1757101721021457e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 1.893782589930785 -2.9177333775389784e-20 -4.560134156117137e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 1.897173694660969 1.0478345055603712e-19 -2.699061379360931e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 1.901066136127572 -1.1660629455478366e-20 -1.7374376383675212e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 1.905520739440012 2.3851824741424325e-19 6.373690707344213e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 1.9106061925816686 3.4015705870174317e-19 4.844048565658888e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 1.9163997015353937 2.3821548045123213e-19 5.329409436079684e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 1.9229876405889992 -2.0919769592492554e-20 3.131089926545402e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 1.9304661669001044 3.590013077262543e-21 -5.573783355852306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 1.9389417567274243 2.3989104206553085e-19 -1.0175099104619003e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 1.9485316057998638 4.325305148366821e-19 5.432922105314611e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 1.9593638174506798 2.2150301168744425e-19 3.1109184491357803e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 1.971577278771488 1.2881779313862214e-19 1.0513865830929054e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 1.9853210965882924 9.119765945782808e-20 -3.478077156380651e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.0007534312692954 4.930483443329068e-20 1.7429733859548817e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.018039527464748 2.584094596805484e-21 -1.8992644779579915e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.037348698026179 -2.2101925513111336e-21 -9.900541704532163e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.0588499732049517 -3.6239781408397987e-20 -2.0472670151039673e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.082706086782238 4.4456444007387515e-21 -7.147769657771003e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.1090654423999817 -2.0865152808835925e-20 -2.8737803696694503e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.1380517000970323 8.087539002600304e-21 9.532465815109054e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.169750663933322 7.422472280911661e-21 5.30383241538462e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.204194262559518 9.571046787953284e-23 -5.5247586574942045e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.241343456102475 3.608788285539383e-20 4.739828509977617e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.281079339255744 -6.072359737695206e-21 -7.490252788923752e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.323201203745981 3.077282625009981e-20 -2.145292842919299e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.3674310399967773 -7.425693806885901e-21 -9.983613626924786e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.4134242024188106 9.978110420136703e-21 -4.629439075945029e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.4607780501430954 5.376165897239119e-21 1.4876873606198793e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.5090414044151057 -3.8742415548454794e-20 6.723126756384934e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.557732279404554 1.2140947272953879e-20 1.7127995807041196e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.6063639035839103 -4.448000129437174e-20 -1.2770119184577303e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.6544674049098544 2.963206307905874e-20 5.291313169986185e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.701603790003181 -1.4316447681710713e-20 -9.542808052828657e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.747373390281946 1.8502133993105775e-20 -3.708657223867362e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.791428076061492 1.585269652375784e-20 2.2546296639158953e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.833483736652398 -1.8300393184683892e-20 -1.9352476226650636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.87332700512417 4.1563893383718353e-20 2.6123435141668744e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.910808865120798 -5.858347020637631e-20 -1.862051488475525e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9458330877781975 5.404928592663921e-20 3.594425272028334e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 2.9783455735565445 -6.510486110470244e-20 -3.853490941218289e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.008324928478876 5.945756852718273e-20 3.164232068934169e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.035774664858374 -5.123000300461315e-20 -3.719003168207221e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0607167039670182 5.229410337127496e-20 3.2029642179955153e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0831858284548233 -3.8048094731352424e-20 -2.6498765875939152e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1032250143709224 2.72857965639939e-20 2.1723485641180438e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.120881556829117 -2.1848337229898458e-20 -1.764306532859029e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1362038885663495 1.4559858188829543e-20 1.7603789328098527e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.149238904919009 -1.0103545981417903e-20 -8.967479564094792e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1600298175889807 5.681232309598346e-21 4.178612640398914e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1686145608857506 -1.9673941768269033e-21 -8.422023452429667e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1750246344837882 5.782485733295224e-21 2.275710584955142e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1792842861823307 1.1006241727322953e-21 6.632280138536292e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1814099606453445 -4.243055911518313e-21 1.5003185818924737e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz new file mode 100644 index 000000000..4c66b97d3 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0002134372911426838 -1.7057763111594283e-19 6.06271584585194e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00021698799244651535 7.872295462345334e-20 2.893593016589088e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00022414232036500895 -3.660865515435014e-20 5.988713330426863e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002350064854528676 -8.968343457424502e-20 -1.8421179084104493e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002497406732533568 -2.2973650808816637e-19 -3.0535029633647913e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00026856000085121503 -4.914689076278177e-19 -4.861743403815135e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00029173563868637955 -3.1159216136197656e-19 -3.3010031927632434e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0003195959486150547 -1.9723382921081193e-19 -1.6543942992923095e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00035252742910291037 -9.834944509850796e-20 -1.645542221681659e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0003909751813445287 -6.614218749909666e-20 -3.3765447456113306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.00043544251075924715 -6.64537825504458e-20 6.479952021688762e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.00048648915056515355 1.608115056513253e-20 2.5133277950015017e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005447274306665914 -5.775162522036312e-20 1.4875935121476868e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006108155074341768 6.426781124049498e-21 9.575925091443053e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0006854465087359711 -1.3145984752161396e-19 -3.512873407468126e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007693321236612947 -1.8747829801327623e-19 -2.6698078353848553e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008631787681542657 -1.3129297685564392e-19 -2.9373155280255044e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0009676539784995367 1.1529976220394379e-20 -1.7257069795807174e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0010833401216692815 -1.978643465872421e-21 3.07200274202207e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001210671872156191 -1.3221646626040307e-19 5.608027860809481e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0013498532141710518 -2.3839012798934374e-19 -2.9943667593744656e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015007490405354032 -1.2208186357934328e-19 -1.7145894262140387e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0016627458376335892 -7.099820507511757e-20 -5.794739874120442e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0018345756442293716 -5.026378709647618e-20 1.9169497411748356e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020140977336178196 -2.717446605006273e-20 -9.606435483903244e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002198033727515264 -1.4242293214887583e-21 1.046783721506859e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023816547436167766 1.2181524010788035e-21 5.4567049564085345e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0025584245949650843 1.9973633840645646e-20 1.1283556397015762e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027196121609157258 -2.4502265189021085e-21 3.939508693849657e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028539002275411937 1.1499874062050273e-20 1.5838902612395834e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029470387783142532 -4.457464599177887e-21 -5.253839134508088e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002981618916053307 -4.090911638250555e-21 -2.9232186977951922e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00293907123493911 -5.275103121068116e-23 3.044982673575248e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0028097263164663737 -1.9889914624891055e-20 -2.6123667264672667e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0025914818113492066 3.3467941923429138e-21 4.128269011721156e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0022892337847080055 -1.6960509690570815e-20 1.1823827865445726e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0019145714576364913 4.092687189253263e-21 5.5024902259610776e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0014768912502634323 -5.499457121646904e-21 2.551525351338771e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.000986477095241831 -2.9630854526384194e-21 -8.19942103831017e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.0004626016485823241 2.135296605535404e-20 -3.7054658410594565e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 6.645801536188381e-05 -6.691509327160866e-21 -9.440131904180764e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0005760515617787356 2.4515248838651843e-20 7.038278785948858e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0010531551399952182 -1.6331775603560346e-20 -2.916318688638637e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0014875008364888058 7.890541078898045e-21 5.259539281177747e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0018658171068570337 -1.0197491135065711e-20 2.0440344436742742e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002174544747575507 -8.737247948163392e-21 -1.2426440117234909e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0024063844232184834 1.008630125252407e-20 1.066615909474954e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002568281521687816 -2.2908029661725366e-20 -1.439798773340924e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026728035103071863 3.2288406208360194e-20 1.0262737019330008e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002731536079283084 -2.978938074380554e-20 -1.9810752565527344e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027547226464451494 3.5882684895281315e-20 2.123859859990847e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002750841348061253 -3.277016738687726e-20 -1.7439733429814187e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027269549713935903 2.823552686860848e-20 2.049736633255698e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002689093692548725 -2.882200808531014e-20 -1.765320650640216e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026423315206418134 2.0970289636518718e-20 1.4604852078725645e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025908797516205257 -1.5038625743290687e-20 -1.197294605753093e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025381967175690926 1.204175828046831e-20 9.724013584093825e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002487189894409341 -8.024697305928453e-21 -9.702366531543843e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002440191927531488 5.5685912023244984e-21 4.942445741275785e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023989351240101043 -3.131223465085994e-21 -2.3030513871113032e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023646773172610446 1.084333552272829e-21 4.641816426552135e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002338306776228957 -3.187029508374228e-21 -1.2542628069120262e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002320422666736375 -6.0661139134862655e-22 -3.655395531304516e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002311393182161269 2.3385694352564296e-21 -8.269038287326057e-22 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..a658a399d --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.000781429855081113 -8.43160699906258e-18 4.015674428072143e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0007891575002701956 -1.3424144597639162e-17 2.2250732018399183e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0008046679848871945 -1.903961361714741e-17 1.3416255582710055e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0008280705271667897 2.0836766082194876e-17 3.4101749675265574e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0008595258910245344 -4.457978415377342e-17 1.0165664647895922e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0008992423149247493 -4.202301387939086e-17 2.3655323787847544e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0009474693978479268 -3.456865628626943e-17 2.1710452594592475e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0010044892986785586 -7.794045470674477e-18 -1.7343331074863486e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0010706043731418592 -6.111201566119122e-19 -3.216019811782014e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0011461200909839223 1.1301093004044035e-17 -9.756233801771216e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0012313217349751542 -1.961807629192555e-17 -1.5153990210411553e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0013264429738327637 1.678734983324723e-17 -1.1679478410418557e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0014316239186382698 -4.446163865034375e-18 -2.271335917250529e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0015468557203771021 1.0310893866973251e-17 -2.9257663384209064e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0016719081634916572 -2.0174621322258143e-17 -1.79226257656107e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.00180623610059575 -7.485443882094181e-18 -1.7226683003790084e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.001948860041155035 2.2700331936069118e-17 -1.8995419343450417e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0020982158981989723 4.885998260491882e-17 -9.834909331889217e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002251969048900105 4.1903059632404455e-18 5.440525678800069e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0024067888401012225 1.729646377780488e-17 3.4532636665646057e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002558081996778296 -4.782652295848636e-17 1.615577007184596e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0026996877962159617 -3.3590532087894703e-17 1.2674392617389112e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002823544689447477 -1.762301736864236e-17 7.48397337341814e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0029193217789043025 -6.2383730169889985e-18 4.2141246725494264e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0029742070607698913 -3.227769203839384e-18 1.6356190192235667e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002973027417493166 -7.944622720118912e-19 -1.110774704726121e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0029032409583940595 -4.301573796030116e-18 -9.056924219241903e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002759396582056336 -6.358462682662754e-19 -1.873518977663132e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0025407427949425314 -5.461909752354977e-18 -1.3354968104234607e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002251933981569124 -1.0976470668799053e-18 -1.4917208642432899e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0019020997614424644 -2.7922094922625915e-18 -8.420593367182336e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0014978976451738466 -1.3865171833809964e-18 -7.526345901162312e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.001047080880568305 7.403375655620459e-19 -2.4648102025493944e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0005638983854983842 -2.754637917717582e-18 9.664051591794993e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -7.035256401898056e-05 2.8249072931245018e-18 1.221344145242859e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.00041174351160693423 -2.1950384028118846e-18 3.0397918273050477e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.000870057541071249 2.229519796349726e-18 -2.9898108559736554e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0012958504974688407 1.198614795318564e-18 4.864027929572564e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0016797399795649775 -4.75742636334429e-19 3.4805410818489315e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.002008952579598087 3.4055001566206588e-18 -1.622929345338293e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0022732209561222507 -4.124446649665421e-18 9.201934013509314e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0024695917308510495 4.2232481962958625e-18 -4.46087780526771e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0026066025521308068 -3.991451075917023e-18 -5.2848136230214714e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0026941095805829885 1.5497463753597264e-18 -6.346603627716657e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0027412287928526282 -6.43186595272939e-19 8.87053073900154e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002756047334462461 -1.8629244764351258e-18 4.717116584775352e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002745236991818988 4.652633317758843e-18 -8.167249970299456e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002714535675026289 -6.551474788477598e-18 5.900816841563284e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002668934404535075 8.091385719208333e-18 -8.267260282904828e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0026127144001070767 -8.765913106912533e-18 7.6857015395749575e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002549504584876266 9.053475911661538e-18 -8.138521053190775e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0024824991975716786 -8.666602340929877e-18 3.9825623767055463e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002414547771062899 7.692564191246168e-18 -4.943123716569884e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.00234788501865464 -6.75771240850382e-18 7.177597266658701e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002284211054660715 5.448936917602929e-18 -5.636774437802611e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0022247973322563445 -4.039555764301492e-18 -6.526747752949251e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0021705770825989007 2.7374019058479726e-18 -1.4748184145606605e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0021222215542208342 -2.0258605349016433e-18 8.057750002266332e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0020802040829722454 1.3838012215800757e-18 -3.107720270924411e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002044850475076598 -7.744308784510383e-19 3.5138014502003045e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0020163787078646724 4.726305939413185e-19 5.677947330140674e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.001994929662642328 -2.0620304604151786e-19 -4.183469705440318e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0019805901725577827 4.24368498590258e-20 -2.0669710373367705e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0019734094146990925 1.164700424991592e-19 4.379306237422766e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..1414ebfeb --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00016118581925062618 5.576161247538833e-17 -3.60945122687116e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0001656970133946807 5.944257395741653e-17 -5.097599129246586e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00017480610168316501 5.0635329893578736e-17 -1.047945692548162e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00018868731626167534 2.6912009623614717e-17 -1.6527303222262102e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00020760400728772672 -2.1979454445498014e-17 -3.551892055672954e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00023191081598682948 -5.3840489703374385e-17 -3.763662089784899e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00026205616017347874 -3.101899882185425e-17 -5.325601347104044e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0002985846173486225 -2.4341112000356276e-17 -3.3374728657208713e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.000342138604261337 -1.9434663577307178e-17 -6.887647542469269e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.00039345850248996816 -3.6230626563015764e-17 -1.7533689416177343e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.00045338004629070437 -6.2904310752849686e-18 -4.0747358307988333e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0005228273466748668 3.2500602967265532e-18 -1.325505029975894e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0006027993449328371 2.251671768678402e-18 -4.396993336635848e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006943467364901696 -5.980694271950384e-18 7.838583688566945e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0007985354477195169 9.035702966693846e-18 -1.8900233982735877e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.00091639155355609 -8.852325781308518e-20 4.62453206553308e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0010488210760414478 1.534036291319255e-17 -2.803273405984057e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0011964964184620517 1.976550303239732e-17 -2.8592310796604126e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0013596993436878525 5.4417677608305053e-17 -1.4826301902022226e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0015381085854997566 4.655018708326048e-17 -4.4274447092941446e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0017305187581792853 2.38474368086793e-17 -4.233370572218955e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0019344768609799916 1.3508597476416764e-17 -1.8100561658057462e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002145824337668358 7.706461615411439e-18 -1.1360193445949936e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0023581225024961864 5.262212797719205e-18 -5.413760438641265e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0025619738906388287 3.06979891399055e-18 -2.4042125956929327e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0027443255736624783 1.2474147625674776e-18 8.181191840913995e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0028878804403961937 1.4519139853640846e-18 7.580262103063306e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029708403906774815 -2.835982742401369e-18 1.5667964465220665e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002967441311753757 -7.758920745079994e-19 -1.9235848249562203e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028585075343672195 -4.02805385436784e-18 3.9947082657108387e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.00263988653420942 -1.7659063728192843e-18 -8.478709818207305e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0023177157093757965 -2.2084139769178812e-18 -1.1048023363576311e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0019077516335051993 -3.2866718271904736e-18 -1.3526167137727763e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0014235711438092267 -2.3477814134221376e-19 -5.295507535654695e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0008795880789932278 -3.1811523045713797e-18 1.274727357237996e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.00030309880961089527 2.244725584407917e-18 -4.0423598662516864e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0002696488148107171 6.49230004351463e-19 8.305681336367797e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0008133186889337842 2.9818215954170803e-18 1.0986533378493736e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0013138945212059013 2.9776080065904273e-18 1.0042561388014515e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0017565355312659562 -8.609054208920512e-19 5.407236537661941e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002121392091817916 3.471291472611057e-18 -1.968014561932938e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.002394157095213907 -3.677975250550452e-18 1.0938993140849854e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0025791132029956733 1.4744043060135684e-18 -1.321375456394864e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0026915307498752376 -3.009854425041555e-18 9.433343868569707e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002745813722938356 1.6565748458355264e-20 6.917498380752847e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027545341273276618 5.028105820336864e-19 -6.878723617876268e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027278597953494395 -2.968681873504964e-18 1.860817325999247e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002674470806099238 4.9432640318603135e-18 -2.169371568211943e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002601775584671402 -4.9000536090997e-18 2.7931905625022225e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0025160262308341315 6.3377439115576915e-18 -3.555450512628876e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0024229303189933576 -6.218393791937026e-18 3.4305294247295157e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002327355998172432 6.5699398197978515e-18 -3.3555669018603555e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0022329504811495877 -5.5639976058055994e-18 3.455490146244283e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0021423717611575993 4.4106202608853375e-18 -2.9085325603741377e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0020575044162266156 -3.956830152125751e-18 1.9833013727196057e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0019796409485710697 2.324242104124197e-18 -2.213774448216571e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0019096306681199672 -2.629841431493795e-18 2.0077550459887983e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0018480048739474087 1.4646171703134563e-18 -8.391335431336962e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0017950805495360288 9.100139183623179e-20 6.346914257699624e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0017510056423632489 7.694148683336089e-19 -8.639026676001068e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0017158167299872367 -5.653887732272503e-19 1.655325489486733e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0016894898158072028 -4.373958614783212e-19 -2.9061702762657185e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0016719774385454045 -9.432540886230386e-20 1.736646636618525e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0016632344909509786 3.616780333653643e-19 7.944540042371351e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz new file mode 100644 index 000000000..39aebf2a6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00021448018820844085 5.429669344620961e-19 -7.331234812124304e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002180488938694068 7.386853435746445e-19 -9.224103708634566e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0002252394775816804 4.452685716856786e-19 -6.604830740274765e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00023615864275656177 6.9310572049314325e-19 -6.793339635147116e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00025096731054967755 8.832190521800897e-19 1.3957769908585326e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0002698815708122417 3.605912916932382e-19 1.4636510133416353e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.000293173794347618 -2.4716020005444566e-19 1.3462712685847843e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0003211737554759144 7.603414248391937e-20 2.0696910166437928e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00035426955305368775 -1.9818006321953968e-21 8.072857846284719e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0003929080400696078 1.549501117359848e-19 4.775177512159436e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.000437594371413545 -1.57521575948232e-19 -2.836276708611169e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0004888901501956188 3.058091152176126e-19 -9.852829104881225e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005474094876858834 -1.0932709414483108e-19 -9.670702302822126e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006138120820263688 2.070193271272817e-19 -3.57981541125617e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0006887921568942849 8.575728563013946e-19 -1.0412217444894107e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007730617731063618 4.555147503453059e-19 -1.2040454684744102e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008673266241453014 9.157567833419622e-21 -1.0720149697258209e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.000972251943121949 1.9639393392145277e-19 -3.2334989635216997e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001088415581410094 6.707958888450684e-19 -3.3037157419111447e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001216244675836969 4.293520569925475e-19 1.1464155580280603e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0013559316279085707 1.0060444737007397e-18 4.294561253000086e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015073244312433938 7.419240623021422e-19 2.548960519613642e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0016697858071058537 2.832296781185012e-19 1.274801079398085e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0018420153214102535 1.8665410258849317e-19 1.0359224997889684e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020218289483927444 3.301616469907071e-20 3.363990093100482e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002205891858486691 4.009800085336887e-20 4.2677776210797595e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023894031888950333 4.0096972423369306e-20 2.88620879895022e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002565737106188528 5.053351333329074e-21 -8.244793154696728e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002726053767644317 5.630348510867136e-20 1.4457583463204542e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028589082335136553 -3.0376081438011154e-20 -2.5972875072473073e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029499064031579176 4.5763086408326705e-21 -2.9006682718271074e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002981485628037983 -6.147358244244408e-20 -1.533605467449359e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.002935231460463323 -8.707402936519048e-20 -3.735494759695934e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002801911873843739 -2.115606846273411e-21 -2.9888438575000884e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0025796965370810643 -6.108043309637889e-20 -5.945439883368321e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0022738228580517473 6.165113014336106e-20 2.6761443710652948e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0018960148821540227 -2.2960193071497517e-20 2.4425881037187615e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0014555084697767569 6.017254910880972e-20 3.5714000201453496e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0009628284704643068 3.9353706228766814e-20 2.4018198349589066e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.0004378252898714587 -3.2273849628567547e-20 -6.221326938705501e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 9.103051642959901e-05 5.689239644853904e-20 3.562141720411595e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0005996204408875667 -9.769697083111858e-20 -4.4547047953863544e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0010751973812516316 6.33342612617665e-20 3.0230823101810566e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0015074791797740177 -7.575325430229642e-20 -3.7352484682690495e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0018829421848463247 4.9796522799536745e-20 1.2087149220406482e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0021881882888749055 1.5265987504644047e-20 2.3914764998401058e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0024163929085959253 -3.9037597289347914e-20 -1.6610629273930224e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002575175447023442 9.336808469408523e-20 4.872848465306177e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026770998174196464 -1.3669718022284615e-19 -6.991252363251511e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002733705046709045 1.4126216960765687e-19 6.730313309939602e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002755168561673398 -1.8026783686645643e-19 -9.156112067658865e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027498859352584806 1.7236443493574766e-19 8.313888779287683e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.00272487348855362 -1.64206523735177e-19 -7.742285751226588e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002686119093173064 1.5565300439312475e-19 8.342244590006829e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026386577140640626 -1.2286312647639756e-19 -5.619573637262896e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025866657094750323 1.0865397904480048e-19 5.919150751094903e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025335748941174236 -6.487988949377299e-20 -3.606435796944588e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024822795171641934 5.93524474792794e-20 2.8657231506059494e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024350834353240743 -5.722398361880638e-20 -2.5580401166849795e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023936943436300775 1.1563403490239076e-20 5.310241088972087e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023593511347499816 -1.4395568810872393e-20 -2.0948856698126724e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002332927968355708 1.50364215367427e-20 3.2391467540787326e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0023150140409815573 -1.770009726953785e-21 5.623065312061286e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002305971192104205 1.4110044609339557e-21 7.126695111458789e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz new file mode 100644 index 000000000..ac82d241a --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00021384199171302655 -1.7456224070019234e-19 5.137298592125735e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00021739969048406612 1.6064381267906748e-19 8.526438548131129e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00022456810948682542 -5.549622716711057e-20 1.9347622787285416e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002354536510749442 1.3886418830638838e-19 7.694045063432386e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.000250216787076366 -7.985984615538697e-20 1.8234631624787766e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0002690730131862875 -1.43974274169776e-19 4.020347040615901e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00029229396709052816 -2.6032744711288894e-19 2.327329449939842e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00032020856053576314 -1.3103770046755232e-19 7.808016050081042e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00035320391516925105 -1.9938856501773144e-21 -5.700257432284555e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.000391725814516038 -5.2280619822722136e-20 1.5405514725688192e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0004362782846603279 6.224943018310407e-22 -1.0159763400923235e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.00048742178787759003 -2.4785840081379395e-19 -6.272374124783955e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005457693492826101 4.2303955258264165e-19 -1.1952170004342727e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006119797280248245 5.596447871920646e-19 -3.952587549740635e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0006867464822715822 8.423337236313972e-19 -5.041346968516345e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007707814510329725 8.282051674476194e-19 -4.8375741528603615e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008647907761860704 -1.9159250243438822e-19 -4.599774309758603e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0009694411071531416 4.0638945553445294e-19 1.2463756904561046e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0010853130660645474 2.1145505663685037e-19 -7.141262683756521e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0012128384103086956 5.686631283012024e-19 1.4659660753761492e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.001352216637584809 6.054067783538093e-19 3.469708313481546e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015033060911113145 2.906757301012151e-19 8.239606662808918e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0016654840428666946 1.351658522332046e-19 2.3481633574479464e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0018374699369969351 3.3674098901596836e-20 -7.869624606987447e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020171062488659863 -7.430962230299585e-21 -1.7024288651772584e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0022010926948477644 -2.1523678477844102e-20 -2.0337200373491605e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023846724553701496 -3.154748149134714e-20 5.686948442861772e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002561274542129829 9.536242615145502e-21 -1.6149396502516754e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027221256179582086 -1.417839640312413e-20 3.13109473268038e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028558588596408214 2.8939043991462913e-20 4.414999088355224e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029481682681272723 2.8532394539004647e-21 1.1575248413017777e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002981585178362607 8.150503845286515e-21 -2.692149759337826e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.002937596950218824 7.77466170696077e-21 -4.3561956065880133e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002806705964374628 -1.352775024268006e-20 -1.95818047152975e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0025869154627362473 2.9523148981180924e-20 -1.851097958076139e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.002283254037057757 -1.433409340543694e-20 3.1520091395487736e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.001907366454839772 2.336663509094621e-20 2.3246954915651704e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0014685849598256777 -8.754673132846314e-21 3.86110928339916e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0009772853264928773 -1.1849876639398306e-20 2.971670700688686e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.0004529647123015533 1.5643255122828165e-20 -1.001275209851085e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 7.602158278614791e-05 -3.1429536596513126e-20 -1.609103885937852e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0005852272621065483 2.3150975411628687e-20 -5.122712741098365e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.001061739336216024 -4.662782388389235e-20 -6.609834716755122e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0014952860227254831 2.133262128134245e-20 -2.7006251776696298e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.001872496753553123 -3.174525828327006e-21 1.8329081981613513e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0021798735536899183 1.559513202235993e-20 2.9938985187295234e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002410297770434798 3.38165384254713e-20 6.137679564158287e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0025709806607893473 -4.151003857543393e-20 4.235048678305764e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026744896872678866 4.390697053142967e-20 -4.413325468092828e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027323924432685423 -6.532601504234017e-20 2.5410295022163535e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027549068966852526 6.75858181597839e-20 -7.120482320563722e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027504789083481035 -6.592635346413803e-20 4.6009935699980306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027261530885393623 5.791727133995816e-20 -4.3343012731166383e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026879431535051074 -5.898936605049607e-20 5.404675893718979e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002640907916095478 4.144768166789472e-20 -2.3252723645904217e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002589245070897267 -3.541256421502466e-20 3.988166692307365e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025364024878714274 2.952406398090685e-20 -2.6436923685494068e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024852825746275323 -1.5086061561148503e-20 9.818648174753773e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024382068664029616 1.3869157838583664e-20 -2.181534533068891e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002396898073788279 -9.248464247752702e-21 -2.0744141101502846e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023626066438473775 3.91671228658525e-21 -1.157223681253052e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0023362153425667163 -1.8636329592062797e-21 5.469047024945339e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0023183194470744687 1.499715413524702e-21 5.18108173301554e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0023092846720935774 -2.0186639985391698e-21 8.189098832855064e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz new file mode 100644 index 000000000..4c66b97d3 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0002134372911426838 -1.7057763111594283e-19 6.06271584585194e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00021698799244651535 7.872295462345334e-20 2.893593016589088e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00022414232036500895 -3.660865515435014e-20 5.988713330426863e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002350064854528676 -8.968343457424502e-20 -1.8421179084104493e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002497406732533568 -2.2973650808816637e-19 -3.0535029633647913e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00026856000085121503 -4.914689076278177e-19 -4.861743403815135e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00029173563868637955 -3.1159216136197656e-19 -3.3010031927632434e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0003195959486150547 -1.9723382921081193e-19 -1.6543942992923095e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00035252742910291037 -9.834944509850796e-20 -1.645542221681659e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0003909751813445287 -6.614218749909666e-20 -3.3765447456113306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.00043544251075924715 -6.64537825504458e-20 6.479952021688762e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.00048648915056515355 1.608115056513253e-20 2.5133277950015017e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005447274306665914 -5.775162522036312e-20 1.4875935121476868e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006108155074341768 6.426781124049498e-21 9.575925091443053e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0006854465087359711 -1.3145984752161396e-19 -3.512873407468126e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007693321236612947 -1.8747829801327623e-19 -2.6698078353848553e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008631787681542657 -1.3129297685564392e-19 -2.9373155280255044e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0009676539784995367 1.1529976220394379e-20 -1.7257069795807174e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0010833401216692815 -1.978643465872421e-21 3.07200274202207e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001210671872156191 -1.3221646626040307e-19 5.608027860809481e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0013498532141710518 -2.3839012798934374e-19 -2.9943667593744656e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015007490405354032 -1.2208186357934328e-19 -1.7145894262140387e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0016627458376335892 -7.099820507511757e-20 -5.794739874120442e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0018345756442293716 -5.026378709647618e-20 1.9169497411748356e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020140977336178196 -2.717446605006273e-20 -9.606435483903244e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002198033727515264 -1.4242293214887583e-21 1.046783721506859e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023816547436167766 1.2181524010788035e-21 5.4567049564085345e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0025584245949650843 1.9973633840645646e-20 1.1283556397015762e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027196121609157258 -2.4502265189021085e-21 3.939508693849657e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028539002275411937 1.1499874062050273e-20 1.5838902612395834e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029470387783142532 -4.457464599177887e-21 -5.253839134508088e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002981618916053307 -4.090911638250555e-21 -2.9232186977951922e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00293907123493911 -5.275103121068116e-23 3.044982673575248e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0028097263164663737 -1.9889914624891055e-20 -2.6123667264672667e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0025914818113492066 3.3467941923429138e-21 4.128269011721156e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0022892337847080055 -1.6960509690570815e-20 1.1823827865445726e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0019145714576364913 4.092687189253263e-21 5.5024902259610776e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0014768912502634323 -5.499457121646904e-21 2.551525351338771e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.000986477095241831 -2.9630854526384194e-21 -8.19942103831017e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.0004626016485823241 2.135296605535404e-20 -3.7054658410594565e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 6.645801536188381e-05 -6.691509327160866e-21 -9.440131904180764e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0005760515617787356 2.4515248838651843e-20 7.038278785948858e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0010531551399952182 -1.6331775603560346e-20 -2.916318688638637e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0014875008364888058 7.890541078898045e-21 5.259539281177747e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0018658171068570337 -1.0197491135065711e-20 2.0440344436742742e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002174544747575507 -8.737247948163392e-21 -1.2426440117234909e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0024063844232184834 1.008630125252407e-20 1.066615909474954e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002568281521687816 -2.2908029661725366e-20 -1.439798773340924e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026728035103071863 3.2288406208360194e-20 1.0262737019330008e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002731536079283084 -2.978938074380554e-20 -1.9810752565527344e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027547226464451494 3.5882684895281315e-20 2.123859859990847e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002750841348061253 -3.277016738687726e-20 -1.7439733429814187e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027269549713935903 2.823552686860848e-20 2.049736633255698e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002689093692548725 -2.882200808531014e-20 -1.765320650640216e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026423315206418134 2.0970289636518718e-20 1.4604852078725645e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025908797516205257 -1.5038625743290687e-20 -1.197294605753093e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025381967175690926 1.204175828046831e-20 9.724013584093825e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002487189894409341 -8.024697305928453e-21 -9.702366531543843e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002440191927531488 5.5685912023244984e-21 4.942445741275785e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023989351240101043 -3.131223465085994e-21 -2.3030513871113032e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023646773172610446 1.084333552272829e-21 4.641816426552135e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002338306776228957 -3.187029508374228e-21 -1.2542628069120262e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002320422666736375 -6.0661139134862655e-22 -3.655395531304516e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002311393182161269 2.3385694352564296e-21 -8.269038287326057e-22 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..734930982 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0003326218989528543 2.7617658330265403e-17 2.61369988459996e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0003375969137801967 3.242953876052921e-17 7.55935214479825e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0003476130153929089 -1.412822559960903e-17 -1.6481473343258077e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.000362802413323527 -1.4705736854687574e-17 -4.768833477103534e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0003833635212338227 -2.8502074492654484e-17 -5.379782783408022e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0004095608901147525 -3.3087913518606905e-17 -3.18567950760139e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0004417247941166601 -6.0171827666327225e-18 -1.1849303627277245e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00048025015947046867 -9.056204146313389e-18 -1.2343946947853004e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0005255944092309327 -4.5226343323687095e-18 6.139164322857284e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0005782736493008512 3.192650780121429e-18 2.0321827535257312e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0006388564358022485 -8.18657202106689e-18 3.883401006818886e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0007079541306231229 -1.2201821099203057e-17 -1.2380494418396556e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0007862065598774593 5.699098943582957e-18 -2.72144149365609e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0008742613271557329 -1.5829778163296885e-17 -3.5098717732190924e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0009727446878852369 -2.0162284321767462e-17 -3.5461005390312893e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0010822213522271443 -2.850500750072714e-17 -3.9703138698626326e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0012031399455602698 -4.8847018604159915e-17 -7.37658003041558e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0013357601205304557 -3.0284843414645096e-17 -6.3995895801553954e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0014800565028223734 -2.3192017314251527e-17 -4.8309185962993365e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0016355938136946291 -3.41608441593436e-17 -2.0390043498687905e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0018013667447074103 -3.2675532342970746e-17 -1.317896723315599e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0019755976413780704 -1.6602939084508697e-17 -9.594397373350017e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002155485083020173 -9.28962109699043e-18 -5.261296228926496e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002336897510061175 -5.53989932060714e-18 -3.0396636011393303e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002514008828992838 -3.585748584191709e-18 -2.0191173970585544e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0026788786303317694 -2.519937392236236e-18 -2.524467995430687e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0028209903167235677 -2.977325195020039e-18 -2.4772174666808586e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0029267768926896113 -7.131405996154962e-19 -4.794974223714351e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029792056308620527 -1.664162775700917e-18 -3.2251990624556394e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002958310746728321 6.177478043623802e-19 -4.343109443398878e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002850423075087114 -5.856058954527972e-19 -1.525649321840083e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002650888941286115 2.4251986257928084e-19 -6.43270301142025e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.002362228253415845 9.34044283838225e-19 1.7905325562775033e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0019949156299296296 1.0600771487834288e-19 1.8351563189604776e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0015593487588417996 2.2126684940935e-18 1.0148855071280148e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.001065370608717932 -3.830468203945732e-19 2.1418080927302242e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0005314613452943762 9.608452427174969e-19 7.725846483387659e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 1.277587437384818e-05 -1.0349411299883987e-18 1.0307280802220213e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.000539540549201639 -1.2898896968889995e-18 5.792198710049355e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.001033863365763062 -7.080613617706567e-20 -8.238297530461193e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0014842313050933136 -1.8219550271874575e-18 1.2639698515308211e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0018758317430887699 1.9512745118847722e-18 -2.0082038911597845e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002193273723302718 -1.2433265173682359e-18 1.1112293531006533e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0024284999612931217 1.9006554468642727e-18 -1.8246095105670787e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002589665453761893 -4.657903161685444e-19 3.7879607199062643e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0026901028987589173 -5.269286076975573e-20 1.147811344211878e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027420043391204914 8.551870830525193e-19 -8.238374545257297e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002756001587826272 -2.131035207489247e-18 2.4551461336179427e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027407225843634566 2.3840847378065585e-18 -2.2187752740095196e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002703464992151357 -3.418550170140703e-18 3.2398890765618725e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.00265044647232578 3.635191621294467e-18 -3.8393662665639286e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0025868833354692785 -3.336298590081536e-18 3.2654958541464997e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0025171283521914535 3.437484302051553e-18 -3.491911420448099e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002445044729542906 -3.1239961718780507e-18 3.0228837046053e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0023737878980673297 2.5055625613896685e-18 -2.5501508133137304e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002305719753224704 -2.059365311561708e-18 2.2171651188503592e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002242576191518404 1.6206498637396157e-18 -1.6087541664772952e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002185609554138115 -1.0403636067814576e-18 1.1815902835310191e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0021357050657231412 8.520424828455545e-19 -1.0249578588981103e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.00209347425586339 -5.341097566284763e-19 4.673791070537809e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0020593285312783213 3.067294317473381e-19 -3.4673974601163954e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002033535817146026 -1.4708705595094634e-19 3.310506567996382e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002016262792533886 1.1750883868205654e-19 -9.325320355063615e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0020076047715262817 1.507194641787769e-20 -6.768607236980436e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..f8221751a --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0002418890912603295 8.166994519672103e-18 -4.830395289298026e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002460867378322417 1.1911366427552897e-17 -4.832566066933504e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0002545446654163565 9.544081780120762e-18 6.144350830430947e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.000267388448930672 -7.922403088220893e-18 5.160789767884239e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002848071684065379 -1.1371490013965926e-17 3.7685969465611626e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00030705413325844477 -1.4602300345664324e-17 1.9094698403448724e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0003344476073144295 -8.318043788243679e-18 1.522398733274224e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00036737130265043804 -2.54364485379563e-18 5.329399794504481e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0004062743185657267 -1.5267433315445791e-18 1.1592234303188244e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0004516700853584303 2.923476501933151e-18 1.1945573582942535e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0005041337233338858 -1.30928350065196e-19 1.0807689753340476e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0005642970369177745 -3.926149994639142e-18 2.5328616081885627e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0006328401215937834 1.3768375728673976e-17 2.166245488835872e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.000710478256062311 -7.305614046002024e-19 1.6591667692456223e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.000797942371150134 -6.782395952137947e-19 1.6899749167662025e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0008959509181330565 6.6334865813719775e-18 1.965009604061939e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.001005170391999146 9.287333939907284e-18 1.7040557177587784e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0011261610947173907 -9.380360152961124e-18 -5.1297485473563216e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0012593039559598432 -4.968157443582963e-18 -1.894226182307287e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.001404703390358982 -5.076313671918416e-19 -7.985795913390662e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0015620603226483448 -6.073909666180341e-18 -7.068806096619178e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.001730508772808718 -9.927632385035601e-19 3.176257402249872e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0019084089696431571 -1.2917301470682405e-18 6.643512971265865e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0020930901934262604 -2.3450639376381348e-19 -4.3640383260531556e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0022805379594168784 3.0802221338944303e-20 -7.562425468694285e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0024650235528616564 4.923203724303628e-19 4.082118002185898e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0026386805112197384 4.2354538117468417e-19 9.784607282066967e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002791044033015019 2.0510709251021828e-19 5.771863584148763e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0029085875819328416 1.8238806398201348e-19 -4.511970877250485e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029743180244362214 1.18496739802636e-19 -7.069166721129936e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002967844460887509 1.5933866036429935e-19 -3.8333735166648986e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002873340893795541 2.781897045744591e-19 -1.1162556424622276e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0026852637044336063 8.725378766925729e-20 1.2339944479566358e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0024054587076563477 1.246602783610137e-19 -1.243689780184046e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0020441190229020345 -2.792081342570243e-19 -1.7356785273968534e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0016127065685414888 -5.722708469636585e-20 -2.5104779771746415e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0011209534299640661 -3.164424889202437e-20 1.9649521684903064e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0005863102935876441 -5.278479737414418e-20 4.110474734594288e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -3.822077733964758e-05 5.3781407263118673e-20 1.708911580765792e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0004940473527234025 -8.927807410483649e-20 5.43651155580634e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.000994416084178316 1.004960619859036e-19 -3.5439766549251056e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0014512041549679066 -2.900225819482283e-19 -1.9537000163714736e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.001849856583370825 1.7246131893510458e-19 -2.0290864005750908e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002174464269921146 1.3258509227949683e-19 2.1517198161081562e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0024160595461254824 -4.240956685765644e-20 3.2633355135813506e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0025819842820327954 -1.1863483179088134e-19 -3.9420890108306145e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026858684638254794 -2.301277693367533e-19 -1.7080539388734665e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002740239510015288 4.1202608572466453e-19 -3.0979352433196167e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002756064437475968 -1.84139682372687e-19 2.9726321735180168e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027422672231135117 2.7173985028917655e-19 -4.724723054519e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.00270637592779901 -3.591561540389444e-19 3.5893360266220027e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002654806679240631 2.534610234130534e-19 -1.6143612611475957e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002592943101368493 -3.1038446098881507e-19 -1.3919580432926498e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0025252621077361927 2.4854534766476666e-19 -3.9613012056915957e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002455685218253947 -7.335888373918574e-20 3.2796405011131304e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.00238743915465618 6.054738660566267e-20 2.4889549930391505e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002322938774452006 -2.371037622456302e-19 1.0777254699669872e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0022639569395830365 1.3562601847073488e-19 -1.7666728387998482e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0022117718032271545 6.029775269922765e-20 -2.354850927126079e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0021672866297253756 -4.473535586108003e-20 -2.372685793405679e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0021311251623827806 -7.190375500675353e-20 1.9978312613900226e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002103705657618092 2.077292470088909e-20 4.98091921854756e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002085296448751538 -4.1065598357037816e-21 1.3765511388645053e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002076055449545017 -9.231831788723096e-21 -4.621482419195507e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..aebb27b92 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00024234801114993143 -3.894307439963611e-19 2.307098567638991e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00024635876211808567 9.832422484171884e-18 2.3312116331266824e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0002544391505558975 -4.933245095641642e-18 4.3163944581190325e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00026670726193601995 1.2526466333374389e-18 1.348051979103637e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002833409642874032 1.8497192567514456e-17 2.5673791130902487e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0003045786766017165 1.3499431774662575e-17 2.0686851881068285e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00033072018347130386 1.3546865900611662e-18 1.68623937154455e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00036212729351606514 2.063082364313627e-18 1.3421228923422735e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00039922405897261054 -4.586954565288974e-18 5.7978133910368376e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0004424961717505628 5.6975271394578705e-18 2.4769774455133933e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0004924890206754478 1.5224690090743966e-19 4.582167440491675e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0005498037278668969 -6.2627232025843386e-18 1.6288966548060973e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0006150902702949029 -3.609078628599557e-18 7.155453100704723e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006890365254218376 -5.020609804708599e-18 1.284292900471079e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0007723517467145819 1.8785143271225627e-18 9.715286061721346e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0008657425648547343 -2.120567515537155e-18 8.1679168317379e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0009698791147595451 -2.209144495006594e-19 4.132523543556189e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.001085348302581414 7.927013047027515e-18 1.0527451334423211e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001212590555816958 1.154215888627796e-18 1.0187905200094096e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0013518156658449904 9.358827695313778e-18 2.3358088558553627e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.001502892587474987 2.322663086659805e-18 1.3836120810921973e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0016652074035612017 3.5539040944090254e-18 1.9138569519695167e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0018374832676058353 3.3477819848171547e-19 1.4779414153203359e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0020175562862254585 1.0897213791528265e-18 5.855619259905713e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.00220210243662701 -1.210856221843716e-19 2.181883251466063e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002386313384621587 7.792869349009108e-19 -1.3946953076890155e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0025635243988042303 8.49395706065202e-19 -1.21604413895418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002724806673561617 7.63356189485108e-19 5.3735239488675546e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002858550780765744 1.2780230613271784e-18 2.708100415714816e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029500892836917675 5.865774578663182e-19 2.12250680421494e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.00298143613324072 9.862137184097912e-19 -5.853219844716895e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.002933696288591909 9.478746258731611e-20 -2.5803854657315538e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0027973610491171556 -3.7194714060879874e-19 -1.042835281463367e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0025705058453528128 2.1091996275119012e-20 -1.2938062106915845e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.002258579213685612 -9.061898475154185e-19 8.442745102660366e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0018735308951461777 9.041605503836419e-20 -1.3319493569915866e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0014245589861274456 -8.247161842648046e-19 9.861290748163858e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0009227441619401436 3.1409057449277425e-19 -8.557468660270053e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0003894652260247667 5.1943134771776017e-20 2.798938042948045e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.00014555662620502373 -2.359262448217966e-19 3.3004406092130924e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0006585872190207138 6.81908831602629e-19 -1.5022701932522565e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.001136909348119088 -6.411792651860934e-19 2.836635989385824e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.001569561604330459 9.837788671781127e-19 -1.4153866385759026e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0019415326541954191 -7.537291707380992e-19 2.6892366019124796e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0022391435656554538 4.930876083449301e-19 2.1811755685003007e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002457141076673022 -3.1051724429768434e-19 4.590678300970158e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0026055947840126488 -2.291695890163824e-19 -5.942425242778251e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0026973465511387395 7.850562921926804e-19 -1.6437785902449064e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002744079092896333 -1.0885399782385712e-18 1.09854652012749e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027559276604176273 1.3113150268320426e-18 -6.361037879234918e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002741142078551636 -1.7500903733472862e-18 2.1737112146788486e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002706729419966196 1.8362886908094872e-18 -2.4586743479106204e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002658651309209621 -1.6920519571068777e-18 1.0527089963943014e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026019049377079594 1.6721016954449799e-18 -8.735315092703605e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025406289630762334 -1.4527808918255066e-18 1.5000799709641654e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024783665027780645 1.232201138990019e-18 -8.975620808143325e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024180706669036196 -1.0816562752643758e-18 2.8430935203596036e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023619646075072834 7.509708300369073e-19 -5.698878561843732e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023116851632782793 -4.433965108589918e-19 5.016528515481764e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0022684163369933517 4.896061478871421e-19 3.392692299970714e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022329969200674767 -3.206786014400704e-19 3.655901724540588e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002206004884941566 6.325834601444416e-20 -3.3676743985754394e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0021878212163921 -8.83492118071788e-20 2.4245034206797268e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002178675557590342 8.96280651814142e-20 2.1677540449426416e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..2c1664e72 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00022861638995061412 -9.378110280929854e-20 3.3593758186027728e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00023243939180693924 -3.7367600483587315e-18 6.230080530699251e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00024014209330393277 -4.373317866846334e-18 2.3442563333732737e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002518382278624516 -2.9043615970321798e-18 -3.380175267582155e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00026769920350782695 5.2540057577559385e-18 -3.0779681089303083e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00028795496622194587 6.3733441330821165e-18 7.162847069904456e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00031289496426522293 3.6981940812121115e-18 1.1205565782525992e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0003428690328541022 1.1855060464068156e-18 8.863618179667735e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00037828794650171434 -1.4345971132029724e-18 7.143252613205361e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.00041962329428608627 -8.370438026412703e-19 4.084303576149228e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.00046740621519373546 2.9428294469873624e-18 -1.923583259232776e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0005222243794051642 -9.888139137417317e-18 -1.3068325904169973e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005847164085985652 -1.614750541967008e-19 -2.0379914693555584e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006555626845391649 -4.0907194734716683e-20 -1.7263402701082524e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0007354711900911078 -3.270445198562052e-18 -9.557940788147526e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0008251566496440725 -1.020775370519574e-18 -4.157048876938419e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.000925310777397244 3.076038155609101e-18 -5.782239029602394e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0010365608959495873 -3.1545764505482054e-18 -3.927523760430442e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0011594135558912343 -1.8867098806541395e-18 -4.4056025716683686e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0012941790853822975 -5.0006359046347534e-18 -3.0515630911347053e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0014408722675839385 3.349076322439581e-19 7.963413509539103e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015990836638596889 -1.4293584608683432e-18 -8.194920252995373e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0017678156159625586 -2.476206293438656e-19 -5.934327198334533e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.001945276909826115 -2.0424345507026795e-19 -5.592303649959164e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002128630844137283 -2.958286220327733e-21 1.9793572708691714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002313693584880558 -1.2906518113413107e-19 4.5935591225023825e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0024945840144819462 -1.9629046212021078e-19 6.452249396167764e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0026633339004071156 1.2722374795629077e-19 5.429508298454172e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002809479495267787 -1.7142138324359386e-19 6.025530469911282e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0029196741859781636 3.513949412142433e-20 3.188556138049053e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029773879116115286 -6.912764036591711e-20 1.7643096882375778e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0029632784975306605 3.2895671709938725e-20 -1.9812131705111873e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0028636101055322526 1.7768802396418092e-19 -4.989945480322569e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002673935692083534 -1.9195523484110742e-19 -3.5376739035457927e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.002396584039323478 5.373941246359942e-20 -4.025092581632018e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.002041583792532888 -4.3243671304309796e-19 1.393541455287168e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.001619813638242889 3.0583400376682175e-20 1.0810515972101722e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0011404340597322062 1.3881376008775268e-20 8.692200042607799e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0006193858021004246 -1.2353099067742396e-19 9.85009104525558e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -8.387897945003379e-05 2.4449638753331153e-19 -4.4540049899942265e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0004379962644822379 -1.9198046477474397e-19 1.7798178662145821e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0009303229594475738 4.528505427174263e-19 -2.4316627230355277e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0013822139181560917 -2.611898895594905e-19 1.2287486246954047e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0017810926095463654 1.4563779551337288e-19 -8.016558731167652e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002111861169213919 -7.867089885099482e-20 3.7027211650135125e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0023645402985356776 -1.9895007613399052e-19 6.247894262968191e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0025426956607321597 2.635117219353469e-19 -1.6683427969886317e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0026590722882421625 -5.384674008233126e-19 3.0801220482742405e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027257989817026816 6.395594263355376e-19 -3.368962542675276e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027536938814982205 -6.001234600283495e-19 2.717619684046951e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002751784651691069 7.509680244974869e-19 -4.0180007589292017e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027275378112395702 -6.769391993489244e-19 4.1210517107296714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002687343670386002 5.882654703867969e-19 -2.686382660749836e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026365967385867935 -5.636872720360258e-19 2.8646147918595725e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025797878249249097 3.783192491410663e-19 -2.3529208313163357e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002520637312960096 -3.2523969727894597e-19 1.569060757024852e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002462345553716518 2.6280765732704274e-19 -1.100660365997884e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024074476262056646 -1.283462492528691e-19 7.229972062966677e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023578271345748416 1.3528996279498665e-19 -9.819938691097725e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023148592037393867 -9.052645758221024e-20 4.491861711664283e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0022795274365317213 -3.353167683163198e-20 3.584960567668669e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022525162174536558 -3.3871062506677544e-20 9.360179311218046e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002234280871200433 4.593119313247102e-20 -3.227324377830378e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002225098015441253 1.922290608828308e-21 1.780147757338762e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..91e57f2b6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00022361814476765522 -3.2711685242718005e-18 -3.144207428144258e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002273420366594921 -1.6134877793323278e-18 -3.1933568275570026e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00023484509123430445 -1.3884005635807542e-18 -4.905371338405412e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002462381958094024 1.9346799186852328e-18 2.685697387233486e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00026168851148389635 2.6222888577450834e-18 4.74759102877122e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00028142037042053886 2.2915505029773037e-18 2.423121343415101e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0003057162980879161 1.6626568881400038e-18 1.9968596699122665e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0003349179919269955 5.811618212989277e-19 1.5708150113490225e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0003694270204264124 5.217569164799866e-19 -5.668578104608857e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.000409704920302203 3.007887918177992e-18 4.2824614562006734e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.00045627225859984734 2.6123067872466822e-20 -1.9458688986801605e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0005097060843493566 5.166193212766302e-19 -5.07474898353427e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005706350129672349 -4.9783986391549716e-18 -1.1610824734114321e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006397309568174205 -8.336827507094403e-19 -6.4995935664243976e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0007176962272854219 -4.658131933937677e-18 -1.1803133595873725e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.000805244376928629 -2.5490022903018226e-18 -6.496806925212978e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0009030727152886576 2.1817289633669746e-18 -3.764273619663312e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0010118239121114812 8.211871665331662e-20 -4.132352974585609e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0011320334970685516 1.7978373782786236e-18 -2.083221678825616e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0012640593880964 -1.9810402871712353e-18 2.0407185208914137e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0014079888657353796 -4.569387565892521e-18 2.163598649131318e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015635177288136 -3.609028041864377e-18 1.0525200629974077e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0017297958453163559 -1.9948902618865995e-18 1.796801249553533e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0019052331651456115 -7.965904227848139e-19 -5.893743949445315e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002087260828909099 -3.768672179869336e-19 -3.124584462193114e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002272043803403633 -1.277032341170775e-19 -2.145968031738647e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002454145243694464 5.100441666752648e-20 -9.017838136051412e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0026261495403984104 -3.2735734791873024e-20 -1.6935555095483044e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027782620556483163 2.000292628715449e-19 7.277742881222032e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.00289792036941702 -1.6182931801934286e-19 -1.8957147466064888e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0029694758495876564 8.17077570516955e-20 4.646075160939488e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0029741360034581887 8.09852926233374e-20 -3.042865896994007e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0028958985850256074 9.40183432051644e-20 -1.2532105037812516e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.0027286805148889408 3.746099377653758e-19 5.562231714646964e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.002473084507358168 -3.93949415267651e-20 -1.1726377869600534e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0021373126240092255 2.7379497386271195e-19 2.0774829930687415e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0017330851739728599 -1.4267217872934948e-19 2.0786086497142112e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0012691008951134358 -1.4452569188484022e-20 8.614280629631421e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0007586067454050657 -5.683213433782749e-20 1.631965761338529e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.00022620031967893203 -3.207876506744183e-19 -5.0256470598937305e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.00029911468540063795 1.3858519331074513e-19 1.3705553411393315e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0007982851277944509 -2.66054342058819e-19 -3.5808585105980472e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0012600418700553112 3.7337981853527396e-19 8.471169039688114e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0016732519339176866 -1.701849999823247e-19 -1.771869424151285e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002022876905381713 1.5477553227468522e-19 8.046465338388056e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002297264418550507 1.1928433079282638e-19 1.3948927893879424e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002495165107209903 -1.9980196337804428e-19 -1.6790793547574708e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0026282430016582553 2.5181798440478103e-19 3.0413771449313497e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027088198681152207 -4.974245159077408e-19 -3.7631304131965097e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002748017067722794 4.794920508971555e-19 4.947802936749827e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002755360633505076 -4.952637669883986e-19 -5.777632188767106e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002738628358883448 5.923669221244351e-19 4.389609772892203e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027044568645953693 -4.574575888636508e-19 -5.080622274906302e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002658474742244099 3.9446500321913744e-19 4.703497363333518e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026053870460311327 -3.451631309118635e-19 -3.3352157102166633e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002549077817824225 2.3286608813222246e-19 3.3123437412960956e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002492817177722575 -2.0768316333630412e-19 -2.3399353406330693e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024393242559482393 1.3535739238660911e-19 1.7439591870140416e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002390648411373088 -8.471457102278156e-20 -1.3906152808486717e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002348294934311981 5.099767908121954e-20 5.092828686917836e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.00231334732132588 5.4754332136656124e-21 -1.0190084992042989e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022865642088470226 5.126493907598062e-20 8.083860927621836e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002268453301584673 -8.254107109964718e-21 1.7701615033420535e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002259324564038492 -2.5218770136575924e-20 4.718957224768912e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..9af24fb7f --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0002194524800612796 2.918848354959894e-18 1.2546245784256423e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002231077870895615 3.898872716369432e-18 -1.4994557264278967e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0002304727628029204 3.4553770014905485e-19 2.0965808818683565e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00024165648250340662 2.145320122665655e-19 -1.7628954863347913e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00025682340653841805 -7.198338719021919e-19 1.1422664520474042e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.00027619430301428197 -6.913184120262321e-19 4.621922205442818e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00030004731216197206 -1.1404859841540479e-18 1.453338328395566e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00032871899161852474 -1.7821372208950986e-19 1.1512114513395927e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00036260511734779414 -3.551557554136189e-19 -5.887633085064573e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0004021609322952062 5.761343886273329e-19 6.467283677494194e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0004479004285773042 5.697364844461988e-19 6.42627253358009e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0005003941125500401 -1.407685669998081e-19 1.4752691440516443e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005602645277872137 2.1894868882269562e-18 4.801496665961109e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006281785899755989 -4.80759780589825e-18 -1.7486867553821396e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0007048355102810914 -1.183303604510871e-18 3.2154542994504237e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007909487395172728 -4.6035951837749355e-19 4.180688994890173e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008872199449205367 2.0028757193430952e-19 1.3738069215587463e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0009943025273774946 -9.045354412260874e-19 2.151746388493863e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.001112751598511882 -1.4764284336758671e-18 1.024561905939126e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0012429566744556395 -1.3403810638143367e-18 2.597909395377283e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0013850526371152708 -1.0773218072031526e-19 2.1729211577040543e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.001538803828335631 -7.115684966287363e-20 1.545802398267358e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.001703455595122856 -2.731682088253008e-19 5.819588716072971e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.001877547393175203 -5.195085144279695e-20 3.9357540863636244e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020586819985752144 -3.0189169583707746e-19 1.5394286901017714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002243246955989694 -1.0943697291432874e-19 1.54609740371375e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002426087807453508 -7.946923451396743e-20 1.1536776015198297e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.00260013886475009 -9.087615318274101e-20 1.0707921781449247e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027560275551210085 1.7114349056235656e-19 1.6849652408967945e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.002881684136044738 -9.468908829437387e-20 -1.2095412876660914e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002962011256509088 3.1214949606109326e-20 3.685105223472319e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0029787141681943286 -8.920263765458061e-20 -1.001228305778602e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00291452046945091 -1.932709243437222e-19 -8.183374353390028e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002762087189692616 1.459108670442898e-20 -8.288555840350561e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.002520928566014164 -1.8527591893518689e-19 -1.4121970647832997e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.002197953298067628 2.5629517619000103e-19 5.585796671693134e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0018051345991662263 -8.453253435194077e-21 -5.675103259828754e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0013512075684881594 2.449992995500529e-19 1.2125364889589438e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0008480783944642337 1.173771354065771e-19 1.3410957702736459e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.0003183592786555245 -1.9286552186105507e-19 -3.788778127242024e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.00020891039315346958 9.322278645600371e-20 7.469060117401556e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0007124138316730492 -3.8881731685736115e-19 -1.7142434802395326e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0011803997856740293 2.2042120659718926e-19 8.841135884964981e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0016022842256609644 -1.9122762078971074e-19 -1.5597869502733722e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0019634978963277575 1.808639315658302e-19 4.1640816462839086e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0022515526214084967 8.320702615846372e-20 4.340658130254288e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0024624418537030892 -1.0596749442163614e-19 -6.262283295634732e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002606492626846252 2.9563216984705076e-19 2.1131507867423388e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002696152568201153 -4.754601962755594e-19 -1.91370258141311e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002742731643223398 4.806811011126829e-19 2.5623652728496025e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027560613068236474 -5.882442139279923e-19 -3.803935706925738e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002744166138027287 5.636032565532708e-19 2.5283342944249297e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027138477983584073 -4.999423502872441e-19 -3.1473460272122354e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026708917537944547 5.093081263784426e-19 2.8693368961403553e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002620146606781617 -4.063628652222496e-19 -1.6622375026892317e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025656222509702867 3.119219803642655e-19 2.599711223152911e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025106450386819454 -2.41175579502795e-19 -1.3234835075576556e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024580284893025188 1.9204429715887727e-19 6.502018976641585e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002409931986528058 -1.1938873220307107e-19 -1.246850792237005e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002367947102369918 5.72097244569956e-20 3.0549077546999205e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023332234473285927 -6.439256787472673e-20 -3.953922003381795e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002306568724125822 2.1805078379397512e-20 9.1266795075108e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022885252006694425 -6.97636743613354e-21 -9.813372605302348e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022794248197213797 2.883887319502092e-20 3.5804673668835534e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz new file mode 100644 index 000000000..a0a0efa6c --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00021706610394002683 6.983411857362144e-19 -3.5415906902381836e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002206792994821459 2.3906478098499074e-19 -9.261957323573343e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00022795947095620916 1.310547772321504e-18 -3.6641651939951433e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0002390145343909575 1.9121083542137058e-18 -7.978955963575787e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.00025400722037746226 1.2470544483141597e-18 -1.8750009306158625e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0002731560106480483 1.6399241020519739e-18 -2.8446585393602823e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00029673622596165 6.896678507698539e-19 9.364392524987741e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00032508110934421653 7.573780050744305e-19 5.082191594979625e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00035858268600743676 7.749507617643204e-19 3.9551416357341367e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.00039769210090058146 -7.687277089042188e-21 -3.796618188862834e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.00044291903139917043 -3.7906514983021026e-19 -3.929043299331437e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0004948296397346446 -2.6680864407966987e-18 2.878821950433132e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005540423598932023 1.8891554488360056e-18 -1.5086803323486599e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006212205981519654 3.0885503267973678e-18 1.9314864960176196e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0006970611556086289 2.573294427020884e-18 -9.608301620758076e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007822768447318071 1.545443039151569e-18 -1.2390207711623967e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008775713605561285 7.43228519281598e-19 -1.7576270710774893e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0009836039732779227 -1.8382153647252427e-18 -3.5251152990539384e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0011009410309938017 -2.94528906871001e-18 -1.7799444092574644e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.00122999060820394 -2.618712266619737e-18 -2.281357967644057e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0013709159358824144 -1.0970813327048553e-18 -1.6499524794503076e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0015235225625257487 -2.3254007516078165e-19 -7.292384832325581e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0016871136339548913 -1.484225068048669e-19 -3.4104176373695773e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0018603074313121642 3.265816877816014e-20 -1.7947725912056112e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020408116747255007 7.494069409853902e-20 -2.4305548512646754e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002225150546996695 7.811804793355178e-20 5.976141336955435e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002408343592469608 9.083883898020436e-20 8.95978551235149e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002583541534979211 4.6480722085990986e-20 1.4452035039799628e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.002741633846633535 6.81801702706965e-20 6.907918708068836e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028708580132458784 -3.818250695166611e-20 1.0508818132924406e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002956462304839964 8.165071556001079e-22 1.400874562294921e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0029805050563186677 -4.798422767858966e-20 6.548460632614937e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0029250805467947063 -6.456258377932278e-20 -4.4994624530252206e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002781968413069122 -3.127279480920803e-20 -1.1929959532545267e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0025500193458723687 -9.078408178341243e-20 -4.131012349836625e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.0022353208981889285 2.4746647029203284e-20 -1.1347554006104405e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0018498112320817284 -2.690470470461322e-20 2.3347393976691903e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.0014024048232324092 4.3578903415619743e-20 -3.2633989908755444e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.0009042872269975533 2.5316825159752253e-21 6.871712645753005e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.0003767324712604629 -1.7200459888689024e-20 5.240353350161946e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.00015142132740265628 7.819061601358617e-20 -1.5253936730738503e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0006574521897756214 -3.6616475883340566e-20 1.0824495799057973e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.001129187072176272 7.661795956727663e-20 -5.489597598584919e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0015562427934796722 -8.33593599386626e-20 6.028570039329978e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.001924518723889883 1.4148539021191514e-20 -5.00233909992712e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0022210593667823368 -2.365051110534208e-20 -3.535680034578396e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002440363462568505 -3.179738251153571e-20 2.235683713811991e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0025915606994420673 6.409119282031086e-20 -9.171477551035524e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026871675774132737 -8.836311116465733e-20 1.0175400416679732e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002738606399436009 1.3374846065394218e-19 -1.2624616597132832e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027558836324093 -1.2261697439434246e-19 1.6028482265609275e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002747198405155534 1.45002955557471e-19 -1.6316856484748379e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002719455626432948 -1.5011693406654686e-19 1.6520020064708736e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002678539157018419 1.108203232993287e-19 -1.33515614433046e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026293881289056282 -9.97218830102927e-20 1.1524632701845978e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002576093256297602 8.980695457141448e-20 -1.1675010583616853e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002522027069045359 -7.205538245259325e-20 8.443505279627671e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024700470661557497 5.581359350536609e-20 -5.2835244589626196e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024223837999610086 -2.1724971891236282e-20 4.562409312970794e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023806850947726524 2.075074128301461e-20 -3.6384567443546e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.00234614380360798 -2.5688842539309594e-20 1.6690163873867394e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0023195998126868318 -6.47860358984792e-21 -6.817168737647394e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002301618114437729 -6.117962840584048e-21 1.1894192215675975e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022925451279314224 1.7817810411672563e-20 -3.950644122052555e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz new file mode 100644 index 000000000..6694e8d70 --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00021547384651826305 -1.5951458534091953e-19 -4.499002979990733e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0002190597849224076 -2.947081296016243e-19 -9.3015177584256e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00022628507087591452 -5.441876405989279e-19 2.122950947122117e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00023725688003110689 -6.894408595944497e-19 9.34880081840159e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0002521368383331612 1.896969499098811e-20 1.9270953671126704e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0002711419675324041 -2.1089145822046288e-19 -7.450915442782946e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00029454578817711765 -5.226183336129744e-19 -6.440191263331198e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0003226794271754594 -1.9977703261720773e-19 -5.803137054246331e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.00035593251543604665 -2.5426476658667075e-19 1.1439451978566877e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.00039475358216540336 1.2258341310380144e-19 -1.6192873768157662e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0004396495507433153 -2.5969760150986417e-19 -5.119454582353429e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0004911838104532393 7.66077610995044e-20 -7.744263389462121e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0005499721712688019 -1.0357273213232232e-18 -9.065119501508926e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0006166757967942274 -1.3400823676459752e-18 -7.988190115843288e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0006919899438326246 -1.7554642178937657e-18 -9.072177708064851e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0007766270057118787 -1.5253662911401367e-18 -8.493830462396077e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0008712919508430892 -2.089082648017581e-18 -5.939645716130816e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0009766477604794288 -1.3798613599508526e-18 -4.2782335388626513e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0010932678981876332 -9.460192970317982e-19 -8.871620030420274e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0012215721963753005 -1.022522432127824e-18 -1.0096268679214729e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0013617418492768785 -8.945057234511813e-19 -1.0462864114398255e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.001513608514769939 -4.322309352697997e-19 -4.1773487435586606e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0016765119566637433 -1.947953694449675e-19 -2.670441878257701e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.001849120387193805 -9.684524050436866e-20 -1.6610610414682363e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002029207990543852 2.5005811685943805e-20 -1.1026550382762415e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0022133854723126256 6.850641432304806e-20 -7.817421253147278e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023967825454849624 6.164109171974697e-20 -2.892003164972459e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0025726869446069302 9.363753394548587e-20 -9.275251668584783e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0027321540465956575 -1.2333305667635956e-20 6.477474188234604e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0028636158805277825 1.766757856204842e-20 3.402360668325748e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.002952539655481474 -5.0288399363735457e-20 6.158579153076719e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0029812149194108507 -4.8167028535074625e-20 -2.897007193146384e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0029314034303744474 8.036310219423775e-21 -6.058747091265871e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -0.002794277434355201 -1.9830994329929058e-20 1.8101809018639573e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H -0.0025682692094889325 8.294178080221945e-20 -3.692574564100025e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H -0.00225894510404842 -3.7832588302414357e-20 2.6585828705241933e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H -0.0018781332552006693 2.886971212468455e-20 2.197452209478956e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H -0.001434930833372014 -9.644732744788045e-21 4.423167365539387e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H -0.000940108421542915 -3.7542744423952413e-20 7.109662585253982e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H -0.00041407129640509037 1.415483414560681e-20 -3.1063074864626687e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.00011454772515692837 -9.960345117742353e-20 1.6900256547666636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0006221600404147328 8.094083867412492e-20 -9.503782383401408e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.001096259021836397 -3.847659168073307e-20 1.3285133352812701e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0015265346962142477 7.981092506723827e-20 -2.89646579482216e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0018992299128765496 9.90810059606014e-21 -1.2156828054206853e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002201111317032433 7.083807654791922e-21 4.6043843437463696e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002425842183551068 2.6950331358459802e-20 -4.6574592897562413e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002581657558426352 -1.0813765968657442e-19 1.3581138074359578e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026811085101957053 7.258646515228943e-20 -1.146175586748582e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002735689115271835 -1.1069562414191538e-19 1.2054447399780698e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027555118866057393 1.0150758838562827e-19 -1.7758084377061478e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027488947212349637 -7.839923382602622e-20 1.4265230668789825e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002722810239002734 9.773534579441574e-20 -1.313009443214669e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026832058827096672 -4.907940824088871e-20 1.125397990889407e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026350793306151006 3.443275814728922e-20 -1.0632613503521611e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002582573593359264 -3.165524177009134e-20 1.0236653549699711e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002529096373471574 1.773357610791345e-20 -4.486372733485266e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024775285523954914 -3.403886187442503e-21 5.0679991755200574e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024301457838222145 -2.2536808705137473e-20 -4.24307739112236e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023886323356769623 -6.816849605299979e-21 3.5047709268195654e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023542090762057617 1.0303210149540425e-20 -2.7854705533625803e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0023277367410486785 2.6526833596040676e-20 1.8060206303351137e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002309795043077232 -6.809329700041944e-22 1.0812568995892273e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002300739778039746 -1.4080951385915824e-20 -1.837109802926417e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst1D.dat b/drivers/py/pes/friction/onheH/060K/inst1D.dat new file mode 100644 index 000000000..5902cd8fd --- /dev/null +++ b/drivers/py/pes/friction/onheH/060K/inst1D.dat @@ -0,0 +1,64 @@ +1.8783333422653203 0.041431159968245763 +1.8785297747426166 0.0414343766705071 +1.8789259075692553 0.041441038357545174 +1.8795283252010604 0.04145161639296752 +1.88034702643248 0.04146685566220852 +1.8813955718294244 0.04148782237410154 +1.882691281721143 0.041515971878580755 +1.8842554857841827 0.04155324018025903 +1.8861138252662064 0.04160216395934773 +1.888296608721087 0.041666035157624556 +1.890839221685344 0.041749097534570685 +1.893782589930785 0.041856794000993965 +1.897173694660969 0.041996074896036975 +1.901066136127572 0.0421757785109457 +1.905520739440012 0.04240709578511528 +1.9106061925816686 0.04270413074377016 +1.9163997015353937 0.04308456621417947 +1.9229876405889992 0.043570439631689925 +1.9304661669001044 0.04418902489774111 +1.9389417567274243 0.044973801339273416 +1.9485316057998638 0.045965467324147594 +1.9593638174506798 0.04721292091934338 +1.971577278771488 0.04877407965050171 +1.9853210965882924 0.05071634252842101 +2.0007534312692954 0.0531164077453049 +2.018039527464748 0.056059049433738156 +2.037348698026179 0.05963433320190204 +2.0588499732049517 0.0639326298686573 +2.082706086782238 0.06903670360728371 +2.1090654423999817 0.07501016202250434 +2.1380517000970323 0.08188174891400904 +2.169750663933322 0.08962545358340034 +2.204194262559518 0.09813118445377166 +2.241343456102475 0.10715123022230368 +2.281079339255744 0.11628910559140161 +2.323201203745981 0.1249974229295405 +2.3674310399967773 0.13263221526469673 +2.4134242024188106 0.13878816780384723 +2.4607780501430954 0.14321763872385676 +2.5090414044151057 0.1457037199935348 +2.557732279404554 0.14607037256371103 +2.6063639035839103 0.144360598186313 +2.6544674049098544 0.14097874693428394 +2.701603790003181 0.13638579915652513 +2.747373390281946 0.13079625951414806 +2.791428076061492 0.12425050723715576 +2.833483736652398 0.11685567710490194 +2.87332700512417 0.10896346274333556 +2.910808865120798 0.1009761158622855 +2.9458330877781975 0.09320511837625593 +2.9783455735565445 0.0858736465464215 +3.008324928478876 0.07910634090531145 +3.035774664858374 0.07296265326499976 +3.0607167039670182 0.06746804380934066 +3.0831858284548233 0.06262254989024513 +3.1032250143709224 0.05840811151609661 +3.120881556829117 0.05479456174331278 +3.1362038885663495 0.051740885430423565 +3.149238904919009 0.049204130031355486 +3.1600298175889807 0.04714707031454202 +3.1686145608857506 0.04553863288563279 +3.1750246344837882 0.04435397899054626 +3.1792842861823307 0.043574515271603956 +3.1814099606453445 0.04318787140600699 diff --git a/drivers/py/pes/friction/onheH/080K/RESTART b/drivers/py/pes/friction/onheH/080K/RESTART new file mode 100644 index 000000000..245aa5ac7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/RESTART @@ -0,0 +1,309 @@ + + + [ step, potential{electronvolt} ] + + 9 + 30 + + + + + + + + + 2.53345216e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 1.72235221e-03, 1.72564486e-03, 1.73232409e-03, 1.74257898e-03, 1.75669626e-03, + 1.77506375e-03, 1.79817438e-03, 1.82663050e-03, 1.86114762e-03, 1.90255678e-03, + 1.95180434e-03, 2.00994772e-03, 2.07814516e-03, 2.15763721e-03, 2.24971723e-03, + 2.35568786e-03, 2.47680008e-03, 2.61417169e-03, 2.76868215e-03, 2.94084215e-03, + 3.13063787e-03, 3.33735276e-03, 3.55924133e-03, 3.79301177e-03, 4.03384766e-03, + 4.27534006e-03, 4.50944956e-03, 4.72663307e-03, 4.91885423e-03, 5.08171010e-03, + 5.21152470e-03, 5.30503079e-03, 5.35913346e-03, 5.37145175e-03, 5.34187041e-03, + 5.27555224e-03, 5.17916092e-03, 5.05953489e-03, 4.92050141e-03, 4.76260264e-03, + 4.58670740e-03, 4.39431766e-03, 4.18989655e-03, 3.97974921e-03, 3.76927721e-03, + 3.56289325e-03, 3.36407393e-03, 3.17538524e-03, 2.99830210e-03, 2.83366253e-03, + 2.68193764e-03, 2.54330027e-03, 2.41768821e-03, 2.30486163e-03, 2.20445393e-03, + 2.11601603e-03, 2.03905164e-03, 1.97301970e-03, 1.91739906e-03, 1.87173957e-03, + 1.83566484e-03, 1.80887313e-03, 1.79113792e-03, 1.78230810e-03 ] + + + [ -1.46119364e-03, 2.24939908e-20, -1.53818802e-19, -1.47160522e-03, -3.19290121e-19, + -1.33296168e-19, -1.49240296e-03, 6.26085011e-20, -1.73921107e-19, -1.52353182e-03, + -2.35010365e-19, -2.78168273e-19, -1.56489872e-03, 1.69081922e-19, 2.56295273e-19, + -1.61635955e-03, 4.10905170e-20, 3.84167235e-19, -1.67770132e-03, 2.09909161e-19, + 5.96731936e-19, -1.74861908e-03, 1.67268409e-19, 6.81154786e-19, -1.82868699e-03, + 2.52653425e-19, 5.11026697e-19, -1.91732303e-03, 8.31480652e-20, 3.40808208e-19, + -2.01374676e-03, 3.39291017e-19, 2.55411188e-19, -2.11692956e-03, 5.77639498e-19, + -2.35170091e-19, -2.22553704e-03, 7.24223704e-19, -3.99338501e-19, -2.33786324e-03, + 2.89816092e-19, -5.18413026e-19, -2.45175720e-03, 3.10880212e-19, -9.08921653e-20, + -2.56454250e-03, -2.74647698e-19, 1.88771344e-20, -2.67293174e-03, -2.57628376e-19, + 1.56808051e-19, -2.77293901e-03, -5.02102387e-19, 3.40645543e-19, -2.85979516e-03, + -3.50295848e-19, 2.79837259e-19, -2.92787285e-03, -1.82219837e-19, 4.94526008e-20, + -2.97063112e-03, -1.68944567e-19, -5.63844996e-20, -2.98059366e-03, -1.74352096e-20, + -1.76983680e-20, -2.95054936e-03, -4.37544593e-20, -2.62584083e-20, -2.87653675e-03, + 3.50530467e-20, 7.43358094e-21, -2.75647028e-03, -2.22494527e-20, -2.34102534e-20, + -2.59006520e-03, 4.53247734e-20, 1.31476173e-20, -2.37917153e-03, -3.94147882e-20, + -1.24887493e-20, -2.12795610e-03, 1.23820294e-20, 3.32129629e-20, -1.84072789e-03, + -7.52763048e-20, 6.02017608e-21, -1.52040337e-03, -8.49976229e-21, 4.19050075e-20, + -1.17093233e-03, -6.75903551e-20, 8.07117489e-21, -7.98459585e-04, 7.22669326e-21, + 3.00884721e-20, -4.13096283e-04, -4.73647459e-20, -1.01143055e-20, -2.63215801e-05, + 7.58789048e-21, 6.48513860e-22, 3.51447939e-04, -3.79951542e-20, -2.47213209e-20, + 7.14481562e-04, 1.63960510e-20, 3.88107751e-21, 1.05839467e-03, -9.48372184e-21, + -4.52205912e-21, 1.37933108e-03, 2.81056352e-20, 7.57482876e-21, 1.67236800e-03, + 1.05590930e-20, -5.50743343e-21, 1.93160759e-03, 1.93366596e-20, 6.79359489e-21, + 2.15252345e-03, 1.47127517e-21, 7.66540291e-21, 2.33233287e-03, -5.54214058e-22, + 8.81946734e-21, 2.47283258e-03, -6.67944187e-21, -6.19663174e-21, 2.57904871e-03, + -7.06738199e-21, -1.75653954e-20, 2.65588959e-03, 6.38406425e-21, -1.30041614e-20, + 2.70793752e-03, 4.39210831e-21, -8.57813338e-22, 2.73939133e-03, 2.05529704e-21, + 9.20875254e-21, 2.75401485e-03, 8.35284089e-22, 1.11117163e-20, 2.75501256e-03, + -6.74803833e-21, 4.29093582e-21, 2.74518995e-03, -1.84794302e-21, -1.69735699e-21, + 2.72704547e-03, -4.76543171e-21, -5.48556113e-21, 2.70278454e-03, 5.50901133e-21, + 4.05429556e-21, 2.67433801e-03, -4.90393550e-21, 1.24661741e-21, 2.64338320e-03, + 9.68782409e-21, 1.43698701e-21, 2.61136606e-03, -5.03491651e-21, -9.60137985e-21, + 2.57952335e-03, 4.36270792e-21, -4.47107769e-21, 2.54890572e-03, -5.90028026e-21, + -3.14743979e-21, 2.52041794e-03, 2.61174983e-21, 7.34430602e-21, 2.49481058e-03, + -4.86087916e-21, 3.25906618e-21, 2.47267563e-03, 2.81973215e-21, 3.32643419e-21, + 2.45447022e-03, -2.57217687e-21, -7.85741671e-22, 2.44053675e-03, 2.59810588e-21, + 2.80128902e-22, 2.43111851e-03, 1.33066557e-21, -2.29443557e-21, 2.42637137e-03, + -9.38114746e-23, -2.51975753e-21 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] + + + [ 1.37851002e-02, 0.00000000e+00, 0.00000000e+00, 1.37414965e-02, 0.00000000e+00, + 0.00000000e+00, 1.36538616e-02, 0.00000000e+00, 0.00000000e+00, 1.35213375e-02, + 0.00000000e+00, 0.00000000e+00, 1.33426284e-02, 0.00000000e+00, 0.00000000e+00, + 1.31159914e-02, 0.00000000e+00, 0.00000000e+00, 1.28392233e-02, 0.00000000e+00, + 0.00000000e+00, 1.25096457e-02, 0.00000000e+00, 0.00000000e+00, 1.21240878e-02, + 0.00000000e+00, 0.00000000e+00, 1.16788681e-02, 0.00000000e+00, 0.00000000e+00, + 1.11697762e-02, 0.00000000e+00, 0.00000000e+00, 1.05920564e-02, 0.00000000e+00, + 0.00000000e+00, 9.94039479e-03, 0.00000000e+00, 0.00000000e+00, 9.20891247e-03, + 0.00000000e+00, 0.00000000e+00, 8.39116920e-03, 0.00000000e+00, 0.00000000e+00, + 7.48018104e-03, 0.00000000e+00, 0.00000000e+00, 6.46845836e-03, 0.00000000e+00, + 0.00000000e+00, 5.34807095e-03, 0.00000000e+00, 0.00000000e+00, 4.11074889e-03, + 0.00000000e+00, 0.00000000e+00, 2.74802931e-03, 0.00000000e+00, 0.00000000e+00, + 1.25146059e-03, 0.00000000e+00, 0.00000000e+00, -3.85657281e-04, 0.00000000e+00, + 0.00000000e+00, -2.04525306e-03, 0.00000000e+00, 0.00000000e+00, -3.62426524e-03, + 0.00000000e+00, 0.00000000e+00, -5.08727294e-03, 0.00000000e+00, 0.00000000e+00, + -6.39714725e-03, 0.00000000e+00, 0.00000000e+00, -7.51622135e-03, 0.00000000e+00, + 0.00000000e+00, -8.41975585e-03, 0.00000000e+00, 0.00000000e+00, -9.20560546e-03, + 0.00000000e+00, 0.00000000e+00, -9.89176595e-03, 0.00000000e+00, 0.00000000e+00, + -1.04641162e-02, 0.00000000e+00, 0.00000000e+00, -1.08343833e-02, 0.00000000e+00, + 0.00000000e+00, -1.09427101e-02, 0.00000000e+00, 0.00000000e+00, -1.07818608e-02, + 0.00000000e+00, 0.00000000e+00, -1.04585206e-02, 0.00000000e+00, 0.00000000e+00, + -1.00573991e-02, 0.00000000e+00, 0.00000000e+00, -9.58247094e-03, 0.00000000e+00, + 0.00000000e+00, -9.02764460e-03, 0.00000000e+00, 0.00000000e+00, -8.31126177e-03, + 0.00000000e+00, 0.00000000e+00, -7.42995057e-03, 0.00000000e+00, 0.00000000e+00, + -6.40266827e-03, 0.00000000e+00, 0.00000000e+00, -5.28087887e-03, 0.00000000e+00, + 0.00000000e+00, -4.23529950e-03, 0.00000000e+00, 0.00000000e+00, -3.28532244e-03, + 0.00000000e+00, 0.00000000e+00, -2.42597415e-03, 0.00000000e+00, 0.00000000e+00, + -1.65178765e-03, 0.00000000e+00, 0.00000000e+00, -9.57028042e-04, 0.00000000e+00, + 0.00000000e+00, -3.31980647e-04, 0.00000000e+00, 0.00000000e+00, 2.35459946e-04, + 0.00000000e+00, 0.00000000e+00, 7.49031970e-04, 0.00000000e+00, 0.00000000e+00, + 1.21216873e-03, 0.00000000e+00, 0.00000000e+00, 1.62815677e-03, 0.00000000e+00, + 0.00000000e+00, 2.00009876e-03, 0.00000000e+00, 0.00000000e+00, 2.33088703e-03, + 0.00000000e+00, 0.00000000e+00, 2.62318547e-03, 0.00000000e+00, 0.00000000e+00, + 2.87941805e-03, 0.00000000e+00, 0.00000000e+00, 3.10081772e-03, 0.00000000e+00, + 0.00000000e+00, 3.28614225e-03, 0.00000000e+00, 0.00000000e+00, 3.43845273e-03, + 0.00000000e+00, 0.00000000e+00, 3.56080308e-03, 0.00000000e+00, 0.00000000e+00, + 3.65570915e-03, 0.00000000e+00, 0.00000000e+00, 3.72516352e-03, 0.00000000e+00, + 0.00000000e+00, 3.77064849e-03, 0.00000000e+00, 0.00000000e+00, 3.79314631e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -4.81482486e-32, 5.51152161e-01, + 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, + -4.81482486e-32, 5.51152161e-01, 0.00000000e+00, -4.81482486e-32, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.40741243e-32, + 5.51152161e-01, 0.00000000e+00, 1.20370622e-32, 5.51152161e-01, 0.00000000e+00, + 1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -1.50463277e-33, 5.51152161e-01, + 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -6.01853108e-33, + 5.51152161e-01, 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, 0.00000000e+00, + -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, + 0.00000000e+00, -1.50463277e-33, 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, + 5.51152161e-01, 0.00000000e+00, -3.76158192e-33, 5.51152161e-01, 0.00000000e+00, + -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, + 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, + 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, + -1.50463277e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, 5.51152161e-01, + 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, + 5.51152161e-01, 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, 0.00000000e+00, + -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, + 0.00000000e+00, -6.39468927e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, + 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, + -3.38542373e-33, 5.51152161e-01, 0.00000000e+00, -3.19734463e-33, 5.51152161e-01, + 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -6.77084746e-33, + 5.51152161e-01, 0.00000000e+00, -3.19734463e-33, 5.51152161e-01, 0.00000000e+00, + -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, + 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, + 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, + -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, 5.51152161e-01, + 0.00000000e+00, -6.77084746e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, + 5.51152161e-01, 0.00000000e+00, -3.19734463e-33, 5.51152161e-01, 0.00000000e+00, + -3.38542373e-33, 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, 5.51152161e-01, + 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, + 5.51152161e-01 ] + + True + + + + + [ 1.95647695e+00, -4.08126692e-20, 2.79085910e-19, 1.95723343e+00, 5.79313924e-19, + 2.41850032e-19, 1.95875176e+00, -1.13595674e-19, 3.15559149e-19, 1.96104273e+00, + 4.26398338e-19, 5.04703224e-19, 1.96412245e+00, -3.06779023e-19, -4.65017270e-19, + 1.96801233e+00, -7.45538527e-20, -6.97025725e-19, 1.97273902e+00, -3.80855191e-19, + -1.08269908e-18, 1.97833428e+00, -3.03488620e-19, -1.23587429e-18, 1.98483482e+00, + -4.58409570e-19, -9.27197121e-19, 1.99228210e+00, -1.50862268e-19, -6.18355932e-19, + 2.00072201e+00, -6.15603168e-19, -4.63413202e-19, 2.01020447e+00, -1.04805812e-18, + 4.26688141e-19, 2.02078291e+00, -1.31401772e-18, 7.24552182e-19, 2.03251357e+00, + -5.25836806e-19, 9.40598736e-19, 2.04545460e+00, -5.64055146e-19, 1.64913016e-19, + 2.05966499e+00, 4.98315561e-19, -3.42503137e-20, 2.07520313e+00, 4.67436026e-19, + -2.84509546e-19, 2.09212515e+00, 9.11005022e-19, -6.18060795e-19, 2.11048285e+00, + 6.35570125e-19, -5.07731401e-19, 2.13032123e+00, 3.30616207e-19, -8.97258585e-20, + 2.15167555e+00, 3.06529810e-19, 1.02302964e-19, 2.17456799e+00, 3.16341128e-20, + 3.21115824e-20, 2.19900374e+00, 7.93872589e-20, 4.76427567e-20, 2.22496730e+00, + -6.35995814e-20, -1.34873479e-20, 2.25242040e+00, 4.03689838e-20, 4.24751185e-20, + 2.28130094e+00, -8.22364070e-20, -2.38547868e-20, 2.31152283e+00, 7.15134422e-20, + 2.26593492e-20, 2.34297695e+00, -2.24657187e-20, -6.02609683e-20, 2.37553331e+00, + 1.36579896e-19, -1.09228930e-20, 2.40904329e+00, 1.54218071e-20, -7.60316487e-20, + 2.44334113e+00, 1.22634655e-19, -1.46441862e-20, 2.47824598e+00, -1.31119748e-20, + -5.45919516e-20, 2.51356506e+00, 8.59376943e-20, 1.83512035e-20, 2.54909895e+00, + -1.37673242e-20, -1.17665121e-21, 2.58464747e+00, 6.89376852e-20, 4.48538946e-20, + 2.62001510e+00, -2.97486832e-20, -7.04175323e-21, 2.65501396e+00, 1.72070846e-20, + 8.20473808e-21, 2.68946603e+00, -5.09943300e-20, -1.37436253e-20, 2.72320521e+00, + -1.91582175e-20, 9.99258248e-21, 2.75607982e+00, -3.50840674e-20, -1.23261694e-20, + 2.78795566e+00, -2.66945368e-21, -1.39079613e-20, 2.81871837e+00, 1.00555545e-21, + -1.60018738e-20, 2.84827489e+00, 1.21190523e-20, 1.12430508e-20, 2.87655246e+00, + 1.28229235e-20, 3.18703195e-20, 2.90349609e+00, -1.15831248e-20, 2.35945031e-20, + 2.92906600e+00, -7.96895779e-21, 1.55640021e-21, 2.95323521e+00, -3.72909186e-21, + -1.67081855e-20, 2.97598744e+00, -1.51552357e-21, -2.01608868e-20, 2.99731508e+00, + 1.22435124e-20, -7.78539235e-21, 3.01721760e+00, 3.35287268e-21, 3.07965224e-21, + 3.03570007e+00, 8.64630867e-21, 9.95289780e-21, 3.05277184e+00, -9.99544539e-21, + -7.35603677e-21, 3.06844546e+00, 8.89760732e-21, -2.26183891e-21, 3.08273563e+00, + -1.75774038e-20, -2.60724190e-21, 3.09565836e+00, 9.13525678e-21, 1.74205610e-20, + 3.10723019e+00, -7.91561429e-21, 8.11223834e-21, 3.11746761e+00, 1.07053563e-20, + 5.71065491e-21, 3.12638643e+00, -4.73870923e-21, -1.33253692e-20, 3.13400139e+00, + 8.81948671e-21, -5.91318769e-21, 3.14032574e+00, -5.11606840e-21, -6.03541893e-21, + 3.14537093e+00, 4.66690880e-21, 1.42563474e-21, 3.14914636e+00, -4.71395389e-21, + -5.08260552e-22, 3.15165925e+00, -2.41433430e-21, 4.16298027e-21, 3.15291447e+00, + 1.70209755e-22, 4.57180015e-21 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/onheH/080K/clean.sh b/drivers/py/pes/friction/onheH/080K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/onheH/080K/control.in b/drivers/py/pes/friction/onheH/080K/control.in new file mode 100644 index 000000000..687e6ee90 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/control.in @@ -0,0 +1,181 @@ +# Physical settings +xc pbe +spin none +relativistic atomic_zora scalar +charge 0.0 +#vdw_correction_hirshfeld + +# k-grid settings (to be adjusted) +k_grid 12 12 12 + +# accuracy requirements +sc_iter_limit 200 +sc_init_iter 200 + +#Mixing settings + mixer pulay + n_max_pulay 10 + charge_mix_param 0.05 + + +# occupation gaussian broadening +occupation_type gaussian 0.1 + +final_forces_cleaned .true. +compute_forces .true. + + +# IPI + output_level MD_light +# use_pimd_wrapper localhost 41000 + use_pimd_wrapper drag092 41111 + +#=============================================================================== + +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for Pd atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species Pd +# global species definitions + nucleus 46 + mass 106.42 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 62 5.0 + radial_multiplier 2 + angular_grids specified + division 0.5211 50 + division 0.9161 110 + division 1.2296 194 + division 1.5678 302 +# division 1.9785 434 +# division 2.0474 590 +# division 2.1195 770 +# division 2.1568 974 +# division 2.7392 1202 +# outer_grid 974 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 5 s 1. + valence 4 p 6. + valence 4 d 9. +# ion occupancy + ion_occ 5 s 0. + ion_occ 4 p 6. + ion_occ 4 d 8. +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A +# +################################################################################ +# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV + ionic 5 p auto + hydro 4 f 8 +# hydro 5 g 10 + hydro 3 s 2.6 + hydro 3 d 2.5 +# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV +# hydro 5 f 17.2 +# hydro 6 h 14 +# hydro 4 d 4 +# hydro 5 f 7.6 +# hydro 3 p 3.3 +# hydro 4 s 9.4 +# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV +# hydro 4 f 20 +# hydro 5 g 12.8 +# hydro 5 d 9.8 +# hydro 6 h 15.2 +# hydro 5 s 10 +# hydro 6 p 9.8 +# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV +# hydro 5 f 9.2 +# hydro 2 s 5.6 +# hydro 5 f 43.2 +# hydro 5 d 13.2 +# hydro 5 g 14 +# hydro 4 p 4.7 +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for H atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species H +# global species definitions + nucleus 1 + mass 1.00794 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 24 5.0 + radial_multiplier 2 + angular_grids specified + division 0.2421 50 + division 0.3822 110 + division 0.4799 194 + division 0.5341 302 +# division 0.5626 434 +# division 0.5922 590 +# division 0.6542 770 +# division 0.6868 1202 +# outer_grid 770 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 1 s 1. +# ion occupancy + ion_occ 1 s 0.5 +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A +# +################################################################################ +# "First tier" - improvements: -1014.90 meV to -62.69 meV + hydro 2 s 2.1 + hydro 2 p 3.5 +# "Second tier" - improvements: -12.89 meV to -1.83 meV +# hydro 1 s 0.85 +# hydro 2 p 3.7 +# hydro 2 s 1.2 +# hydro 3 d 7 +# "Third tier" - improvements: -0.25 meV to -0.12 meV +# hydro 4 f 11.2 +# hydro 3 p 4.8 +# hydro 4 d 9 +# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/080K/geometry.in b/drivers/py/pes/friction/onheH/080K/geometry.in new file mode 100644 index 000000000..cd6ad1f1f --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/geometry.in @@ -0,0 +1,11 @@ +#=======================================# +# iterations/iteration0105/aims-chain-node-0.56500/geometry.in +#=======================================# +lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 +lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 +lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 +atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd +atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd +atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd +atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd +atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/080K/get1D.sh b/drivers/py/pes/friction/onheH/080K/get1D.sh new file mode 100755 index 000000000..152292560 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/get1D.sh @@ -0,0 +1,5 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 diff --git a/drivers/py/pes/friction/onheH/080K/hessian.dat b/drivers/py/pes/friction/onheH/080K/hessian.dat new file mode 100644 index 000000000..536cf2c98 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/hessian.dat @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 diff --git a/drivers/py/pes/friction/onheH/080K/init.xyz b/drivers/py/pes/friction/onheH/080K/init.xyz new file mode 100644 index 000000000..cf8e637e3 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/init.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1448613 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1460477 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1477077 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1498430 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1524556 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1555471 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1591193 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1631742 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1677134 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1727363 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1782411 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1842257 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1906879 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1976222 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2050185 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2128665 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2211559 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2298731 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2389979 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2485087 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2686011 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2791254 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2899215 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3009534 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3121847 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3235746 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3350802 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3466586 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3582672 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3698644 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3814100 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3928638 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4041854 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4153390 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4262942 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4370210 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4474895 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4576725 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4675494 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4771003 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4951464 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5036114 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5116899 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5193718 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5266471 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5335107 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5399597 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5459909 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5516014 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5567903 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5615583 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5659063 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5698349 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5733452 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5764386 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5791165 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5813803 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5832315 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5846716 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5857018 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0000000 0.0000000 diff --git a/drivers/py/pes/friction/onheH/080K/input.xml b/drivers/py/pes/friction/onheH/080K/input.xml new file mode 100644 index 000000000..d47b32ac2 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/input.xml @@ -0,0 +1,37 @@ + + + [ step, potential{electronvolt}] + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + + + 80 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + true + 0.1 + + + +
diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 new file mode 100644 index 000000000..f7e8f1301 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 @@ -0,0 +1 @@ +3.720388398520301215e-03 0.000000000000000000e+00 -3.513905651654643162e-34 3.628497141532409549e-03 0.000000000000000000e+00 -1.097723571798680044e-35 3.471748552227420671e-03 -3.519601097638216313e-34 -3.519601097638216313e-34 3.249222392664132507e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.959728025341050884e-03 -6.657880537766638369e-32 0.000000000000000000e+00 2.601883413800640168e-03 0.000000000000000000e+00 3.596523669747883986e-34 2.174579628642227085e-03 9.113501074465804053e-35 7.290800859572643243e-34 1.677119110686054859e-03 8.531191684765963609e-33 3.709213775985201625e-34 1.109548526236916587e-03 -4.738419593504333497e-35 1.895367837401733399e-34 4.731838728439276276e-04 9.733607136199079481e-35 0.000000000000000000e+00 -2.285868201143117714e-04 0.000000000000000000e+00 3.559277566511445698e-32 -9.896360316961694617e-04 1.045352753337825443e-34 -4.181411013351301770e-34 -1.800147854025753533e-03 -2.189773281193647412e-34 4.379546562387294823e-34 -2.645196782636759485e-03 0.000000000000000000e+00 4.625518685498290597e-34 -3.504199937986752882e-03 1.232943443907731305e-34 -1.232943443907731305e-34 -4.360530276483679316e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.199960111110484527e-03 -1.449814991114558867e-34 4.291452373699094178e-32 -6.007494845101184720e-03 -3.208134005606111901e-34 1.604067002803055951e-34 -6.767257757396674504e-03 -3.606719440075965691e-34 -1.803359720037982846e-34 -7.463101494303889250e-03 -2.040602554990365392e-31 -1.020301277495182696e-31 -8.088272755342108822e-03 0.000000000000000000e+00 -2.417500258340856453e-34 -8.651093239563707737e-03 1.451912754051572494e-34 1.451912754051572494e-34 -9.171714450910542493e-03 0.000000000000000000e+00 8.998845484584648052e-35 -9.653378848991200911e-03 0.000000000000000000e+00 -3.826729872359883178e-32 -1.008926111218761724e-02 -1.969748780522787136e-35 -1.969748780522787136e-35 -1.046862453772033283e-02 -3.588135771442574632e-36 0.000000000000000000e+00 -1.075208387036870154e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.091014043248580111e-02 6.955007809062499502e-37 6.955007809062499502e-37 -1.093655829433645525e-02 -1.876459997565012593e-36 1.172787498478132871e-37 -1.082770332390313971e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.061780710133074929e-02 1.306233917284244291e-31 -5.280272929437481793e-36 -1.036704283126274606e-02 -2.102903362163559967e-36 2.102903362163559967e-36 -1.007778135951150830e-02 0.000000000000000000e+00 -7.480946858195232559e-37 -9.752005558120672296e-03 6.138936750297449125e-36 0.000000000000000000e+00 -9.392071648532880276e-03 -1.505759228245271097e-35 0.000000000000000000e+00 -8.981681739335552889e-03 0.000000000000000000e+00 2.569620310081615780e-36 -8.491157508742217669e-03 -3.771020965051682968e-36 -3.771020965051682968e-36 -7.922355579451168320e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.283773455459888885e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.584733888446865288e-03 0.000000000000000000e+00 7.795334798217239055e-36 -5.851746685917010374e-03 0.000000000000000000e+00 -1.328502525980003046e-35 -5.128575549245638354e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.444328221387646057e-03 2.561676267283421041e-36 0.000000000000000000e+00 -3.810490951361692261e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.225596648193097132e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.687318318504710625e-03 0.000000000000000000e+00 -7.742020258660349347e-36 -2.193351025710558316e-03 -9.006363132329547732e-37 7.205090505863638186e-36 -1.741393204441632394e-03 -3.381399755828298125e-36 3.381399755828298125e-36 -1.328434488297760814e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.514480039316190567e-04 1.217766394414828974e-35 1.095989754973346151e-33 -6.079201835421683010e-04 5.831357630064511284e-36 -5.831357630064511284e-36 -2.957298309948781616e-04 0.000000000000000000e+00 0.000000000000000000e+00 -1.300140438349945728e-05 0.000000000000000000e+00 2.121685937160069116e-38 2.419260244223479881e-04 1.055445309325769750e-35 0.000000000000000000e+00 4.704780900424327967e-04 1.029491115625907456e-35 -4.021449670413700999e-38 6.738306562621098044e-04 0.000000000000000000e+00 0.000000000000000000e+00 8.529669652356337492e-04 9.897457043082654278e-36 -2.474364260770663569e-36 1.008766725249479745e-03 0.000000000000000000e+00 3.046843455169255892e-37 1.142006124013858958e-03 -4.815795818440879545e-36 1.203948954610219886e-36 1.253359553552030282e-03 0.000000000000000000e+00 2.384954796105029227e-36 1.343405367478624126e-03 1.184061246318775849e-36 1.480076557898469812e-37 1.412623403756171512e-03 -2.357012814476019401e-36 0.000000000000000000e+00 1.461384522050945475e-03 -2.351352180683899304e-36 0.000000000000000000e+00 1.489980234621267633e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 2.284581611628351038e-33 0.000000000000000000e+00 5.511521610893899137e-01 -1.533271994972200045e-34 -3.519601097638216313e-34 5.511521610893899137e-01 -2.681055618252375158e-33 0.000000000000000000e+00 5.511521610893899137e-01 -2.334515315613904659e-34 -6.657880537766638369e-32 5.511521610893899137e-01 -2.524572737686037579e-33 0.000000000000000000e+00 5.511521610893899137e-01 -1.293237893762834565e-33 9.113501074465804053e-35 5.511521610893899137e-01 -6.977117514041343461e-34 8.531191684765963609e-33 5.511521610893899137e-01 -3.019312854241421090e-34 -4.738419593504333497e-35 5.511521610893899137e-01 1.637144051700637228e-34 9.733607136199079481e-35 5.511521610893899137e-01 2.377342091299156848e-34 0.000000000000000000e+00 5.511521610893899137e-01 4.238990875016434757e-34 1.045352753337825443e-34 5.511521610893899137e-01 4.972190997625102208e-34 -2.189773281193647412e-34 5.511521610893899137e-01 1.666342080923118078e-33 0.000000000000000000e+00 5.511521610893899137e-01 2.994295440080899154e-34 1.232943443907731305e-34 5.511521610893899137e-01 3.853827869165482578e-34 0.000000000000000000e+00 5.511521610893899137e-01 -8.605668569862531845e-34 -1.449814991114558867e-34 5.511521610893899137e-01 4.693718325351158097e-34 -3.208134005606111901e-34 5.511521610893899137e-01 8.014240604749163135e-34 -3.606719440075965691e-34 5.511521610893899137e-01 -2.080742260399432118e-33 -2.040602554990365392e-31 5.511521610893899137e-01 -3.303589686086969831e-33 0.000000000000000000e+00 5.511521610893899137e-01 -1.611319943094616615e-33 1.451912754051572494e-34 5.511521610893899137e-01 -1.121425758458653676e-33 0.000000000000000000e+00 5.511521610893899137e-01 -3.519283806609853180e-34 0.000000000000000000e+00 5.511521610893899137e-01 -1.050071631896146472e-34 -1.969748780522787136e-35 5.511521610893899137e-01 -4.432946259850522337e-35 -3.588135771442574632e-36 5.511521610893899137e-01 -1.163815802272215079e-35 0.000000000000000000e+00 5.511521610893899137e-01 -7.489761885728126613e-36 6.955007809062499502e-37 5.511521610893899137e-01 -1.090268449465668511e-36 -1.876459997565012593e-36 5.511521610893899137e-01 -6.790675498879699020e-37 0.000000000000000000e+00 5.511521610893899137e-01 -2.671766473508398401e-35 1.306233917284244291e-31 5.511521610893899137e-01 1.811275820073521366e-35 -2.102903362163559967e-36 5.511521610893899137e-01 2.613147140783643399e-36 0.000000000000000000e+00 5.511521610893899137e-01 -1.572637468450369771e-36 6.138936750297449125e-36 5.511521610893899137e-01 -5.052015181260325457e-36 -1.505759228245271097e-35 5.511521610893899137e-01 -4.136186617747369634e-36 0.000000000000000000e+00 5.511521610893899137e-01 -1.657646950322285497e-36 -3.771020965051682968e-36 5.511521610893899137e-01 -9.459506930102962977e-37 0.000000000000000000e+00 5.511521610893899137e-01 2.681011899131245594e-37 0.000000000000000000e+00 5.511521610893899137e-01 6.049371375343659353e-38 0.000000000000000000e+00 5.511521610893899137e-01 4.658868807797164616e-36 0.000000000000000000e+00 5.511521610893899137e-01 2.279295074798339914e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.280762921376554794e-35 2.561676267283421041e-36 5.511521610893899137e-01 8.309357011954357807e-37 0.000000000000000000e+00 5.511521610893899137e-01 2.336814336934363091e-36 0.000000000000000000e+00 5.511521610893899137e-01 3.047138595688059386e-37 0.000000000000000000e+00 5.511521610893899137e-01 -4.021487232928875715e-37 -9.006363132329547732e-37 5.511521610893899137e-01 1.515061908020372453e-37 -3.381399755828298125e-36 5.511521610893899137e-01 6.564841159741037121e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.337833138823370560e-37 1.217766394414828974e-35 5.511521610893899137e-01 -1.404997745109831350e-36 5.831357630064511284e-36 5.511521610893899137e-01 6.620286138483144266e-37 0.000000000000000000e+00 5.511521610893899137e-01 -1.086345715346688597e-37 0.000000000000000000e+00 5.511521610893899137e-01 -4.145305894034167181e-39 1.055445309325769750e-35 5.511521610893899137e-01 1.834722100254906101e-36 1.029491115625907456e-35 5.511521610893899137e-01 1.071668996725874423e-38 0.000000000000000000e+00 5.511521610893899137e-01 6.865741817485312000e-37 9.897457043082654278e-36 5.511521610893899137e-01 2.726783511179729697e-37 0.000000000000000000e+00 5.511521610893899137e-01 3.669909137330053024e-38 -4.815795818440879545e-36 5.511521610893899137e-01 -1.902692891817905052e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.891180700246646344e-37 1.184061246318775849e-36 5.511521610893899137e-01 -4.260455179752835906e-39 -2.357012814476019401e-36 5.511521610893899137e-01 1.750927410743645403e-38 -2.351352180683899304e-36 5.511521610893899137e-01 7.933108980870365549e-38 0.000000000000000000e+00 5.511521610893899137e-01 -1.262733634977123532e-38 -3.513905651654643162e-34 -4.349671206845358535e-33 5.511521610893899137e-01 -1.097723571798680044e-35 -6.787580017970930240e-33 5.511521610893899137e-01 -3.519601097638216313e-34 -9.315308436726084388e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.867704350035100638e-33 5.511521610893899137e-01 0.000000000000000000e+00 -9.158825556159747152e-33 5.511521610893899137e-01 3.596523669747883986e-34 -7.927490712236544822e-33 5.511521610893899137e-01 7.290800859572643243e-34 -7.331964569877843748e-33 5.511521610893899137e-01 3.709213775985201625e-34 -6.936184103897851767e-33 5.511521610893899137e-01 1.895367837401733399e-34 -6.470538413303646513e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.396518609343793247e-33 5.511521610893899137e-01 3.559277566511445698e-32 -6.210353730972065841e-33 5.511521610893899137e-01 -4.181411013351301770e-34 -6.137033718711199523e-33 5.511521610893899137e-01 4.379546562387294823e-34 -4.967910737550591495e-33 5.511521610893899137e-01 4.625518685498290597e-34 -6.334823274465619016e-33 5.511521610893899137e-01 -1.232943443907731305e-34 -6.248870031557161144e-33 5.511521610893899137e-01 0.000000000000000000e+00 -7.494819675459962757e-33 5.511521610893899137e-01 4.291452373699094178e-32 -6.164880985938593849e-33 5.511521610893899137e-01 1.604067002803055951e-34 -5.832828757998793088e-33 5.511521610893899137e-01 -1.803359720037982846e-34 -8.714995078873141691e-33 5.511521610893899137e-01 -1.020301277495182696e-31 -9.937842504560679404e-33 5.511521610893899137e-01 -2.417500258340856453e-34 -8.245572761568326530e-33 5.511521610893899137e-01 1.451912754051572494e-34 -7.755678576932363249e-33 5.511521610893899137e-01 8.998845484584648052e-35 -6.986181199134695361e-33 5.511521610893899137e-01 -3.826729872359883178e-32 -6.739259981663324819e-33 5.511521610893899137e-01 -1.969748780522787136e-35 -6.678582281072214518e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.645890976496431582e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.641742580359437530e-33 5.511521610893899137e-01 6.955007809062499502e-37 -6.635343086923175037e-33 5.511521610893899137e-01 1.172787498478132871e-37 -6.634931886023597849e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.660970483208793990e-33 5.511521610893899137e-01 -5.280272929437481793e-36 -6.616140060272973849e-33 5.511521610893899137e-01 2.102903362163559967e-36 -6.631639671332925835e-33 5.511521610893899137e-01 -7.480946858195232559e-37 -6.635825455942159846e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.639304833654969526e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.638389005091456977e-33 5.511521610893899137e-01 2.569620310081615780e-36 -6.635910465424031449e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.635198769166719287e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633984717283796719e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634192324759956735e-33 5.511521610893899137e-01 7.795334798217239055e-36 -6.629593949665912017e-33 5.511521610893899137e-01 -1.328502525980003046e-35 -6.631973523398911258e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.621445189259943651e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633421882772514022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.631916004136775141e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633948104614140239e-33 5.511521610893899137e-01 -7.742020258660349347e-36 -6.634654967197003085e-33 5.511521610893899137e-01 7.205090505863638186e-36 -6.634101312282908183e-33 5.511521610893899137e-01 3.381399755828298125e-36 -6.633596334357735389e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634119035159827639e-33 5.511521610893899137e-01 1.095989754973346151e-33 -6.635657816218819237e-33 5.511521610893899137e-01 -5.831357630064511284e-36 -6.633590789859860725e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634361453045243790e-33 5.511521610893899137e-01 2.121685937160069116e-38 -6.634256963779604039e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.632418096373454488e-33 5.511521610893899137e-01 -4.021449670413700999e-38 -6.634242101783742257e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633566244291961454e-33 5.511521610893899137e-01 -2.474364260770663569e-36 -6.633980140122591332e-33 5.511521610893899137e-01 3.046843455169255892e-37 -6.634216119382336707e-33 5.511521610893899137e-01 1.203948954610219886e-36 -6.634443087762890697e-33 5.511521610893899137e-01 2.384954796105029227e-36 -6.634063700403684845e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.634257078928888653e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634235309199602474e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634173487383901324e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634265445810059126e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 new file mode 100644 index 000000000..a9bbb13f5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 @@ -0,0 +1 @@ +9.827793029467396871e-03 -1.313072854774100455e-31 -3.284324436952458275e-32 9.750204098219517751e-03 -1.334967946554760315e-33 -1.097723571798680044e-35 9.610134022608032844e-03 -3.519601097638216313e-34 -3.361032150056577907e-32 9.406280498061712902e-03 -2.223349691391654800e-32 0.000000000000000000e+00 9.136838307760174541e-03 6.237782611722223566e-32 0.000000000000000000e+00 8.799456282326626258e-03 3.201402136139794068e-32 3.596523669747883986e-34 8.391283698408726066e-03 4.209302585735506597e-34 -5.901009053583062380e-34 7.908933069386116579e-03 8.201137449676728405e-33 1.031029847776990184e-33 7.348482289054148603e-03 1.650157890555946013e-32 -3.290838941924883654e-32 6.705523437178024376e-03 8.250043336339598356e-33 -1.663817809179103254e-32 5.975305921006326092e-03 -8.139441989634019748e-33 -2.952276025195770101e-32 5.152706218838658085e-03 1.045352753337825443e-34 -7.580603191080839879e-34 4.232218142429054059e-03 -2.189773281193647412e-34 4.379546562387294823e-34 3.208009985506830603e-03 3.346046045488447714e-32 8.166308151623631949e-34 2.075775594242275368e-03 1.232943443907731305e-34 6.065129588385682335e-34 8.433428111268804692e-04 -6.899071533928664013e-32 3.449535766964332007e-32 -4.691052986403277877e-04 -3.551557327994071153e-32 -9.856784338632608523e-32 -1.828331592089020054e-03 -7.358391594353104887e-32 1.604067002803055951e-34 -3.182952945957112732e-03 -1.890590739130997557e-31 -4.060517638328558960e-34 -4.477407138834214179e-03 1.104285757212834090e-31 2.129493256723933938e-31 -5.680096744224743394e-03 1.657072673191274145e-31 -8.255385666801503823e-32 -6.762244321929002273e-03 1.451912754051572494e-34 -8.745368250111906597e-32 -7.698678224436266045e-03 0.000000000000000000e+00 8.998845484584648052e-35 -8.495041237012211990e-03 -5.089376209619579482e-32 3.799662015622823384e-32 -9.189813109712195727e-03 -5.057074406811382823e-35 -1.969748780522787136e-35 -9.806963835353970163e-03 -3.588135771442574632e-36 -7.800541400908408347e-33 -1.033518958454863503e-02 2.514803731408052415e-35 -8.911835723177285468e-33 -1.072721116669373906e-02 -2.092288613741648783e-32 -1.046217921707650360e-32 -1.091977900575028491e-02 1.276834031488163357e-32 3.192671472469647800e-33 -1.089832599009789293e-02 -1.651397423339197651e-32 6.191727790050192879e-33 -1.067730935182415776e-02 4.149019558991640952e-33 -6.651086801518780795e-36 -1.036705635975119881e-02 4.120215327670808708e-32 2.102903362163559967e-36 -9.994547422934924388e-03 3.320367168419178455e-31 -1.037689549599575235e-32 -9.562901166257322533e-03 -8.265645646404846644e-32 -4.133129770039938243e-32 -9.067363863078780478e-03 -8.359949198748722588e-33 2.086222901616567436e-33 -8.442118091881327391e-03 -1.053974638421897927e-32 6.588811387326720514e-33 -7.681744665209582629e-03 1.551126130366083905e-32 -3.771020965051682968e-36 -6.799966844091973571e-03 -2.426171402493807335e-35 -1.239773586674335625e-32 -5.820402522067262378e-03 1.294900492558985001e-33 1.035920394047188001e-32 -4.845014295757305717e-03 -8.951383859584458994e-33 8.971930453441914298e-33 -3.944395071345497064e-03 -3.974804566422024178e-33 -5.343456633476997506e-35 -3.120120795041275100e-03 7.184302837709172696e-33 3.280503578862635717e-35 -2.368402889714455242e-03 -6.594431780811218674e-33 -3.312297970081256184e-33 -1.685141025544654308e-03 0.000000000000000000e+00 3.067878973098073851e-33 -1.064976569288402040e-03 -5.224038455800806536e-36 0.000000000000000000e+00 -5.004944678057860613e-04 6.766274219515330324e-34 6.735517977063315254e-34 1.443162376945760633e-05 1.284128139968962451e-33 1.143215884889717618e-35 4.844891902074204004e-04 4.369285821298746159e-36 -6.147357750200534932e-34 9.129340172727414080e-04 0.000000000000000000e+00 -3.590184075811312277e-36 1.302338225724948388e-03 6.341201238429676836e-33 -1.206693974592854967e-33 1.655101305999523648e-03 5.831357630064511284e-36 -5.831357630064511284e-36 1.973464747902746105e-03 1.156639227075116307e-33 -6.007540215290330127e-36 2.259278915194569415e-03 1.064840554854361517e-33 1.327675124443156022e-34 2.513576909143040369e-03 -2.074946730704518240e-33 -3.133768974595599924e-33 2.737647690487645530e-03 -5.014722320215609345e-34 5.290693244731488679e-36 2.933084541066641876e-03 1.642066764582142795e-33 5.175939368265225558e-36 3.101630647833304114e-03 9.897457043082654278e-36 1.494245046463509335e-33 3.245048836207884563e-03 -5.561523571099444735e-34 -1.967238765696775577e-33 3.365024562146119030e-03 -2.697337926555218090e-33 1.203948954610219886e-36 3.463101276857102895e-03 4.867560527952439794e-34 2.384954796105029227e-36 3.540636234542143736e-03 5.905021681553023089e-37 1.480076557898469812e-37 3.598765699386124832e-03 -3.536408013145037568e-36 -3.620743259913885313e-34 3.638376485709382459e-03 -4.702454580752408467e-36 -5.995311120174697882e-35 3.660104868431910546e-03 -3.009265538105055593e-34 -1.175494350822287341e-36 -1.313072854774100455e-31 5.511521610893899137e-01 4.740129544181353730e-33 -1.334967946554760315e-33 5.511521610893899137e-01 -6.101623870577366213e-33 -3.519601097638216313e-34 5.511521610893899137e-01 -3.655718644991668957e-33 -2.223349691391654800e-32 5.511521610893899137e-01 -1.807764881136610865e-34 6.237782611722223566e-32 5.511521610893899137e-01 -6.627279241460255689e-33 3.201402136139794068e-32 5.511521610893899137e-01 -5.012842472936626480e-33 4.209302585735506597e-34 5.511521610893899137e-01 -4.968536906870112276e-33 8.201137449676728405e-33 5.511521610893899137e-01 -1.719923352233032322e-33 1.650157890555946013e-32 5.511521610893899137e-01 8.056737417437420275e-34 8.250043336339598356e-33 5.511521610893899137e-01 3.872781655026149313e-34 -8.139441989634019748e-33 5.511521610893899137e-01 5.597982227556824211e-34 1.045352753337825443e-34 5.511521610893899137e-01 7.374384702389412775e-34 -2.189773281193647412e-34 5.511521610893899137e-01 2.656257851845567947e-33 3.346046045488447714e-32 5.511521610893899137e-01 -3.725985926887611149e-34 1.232943443907731305e-34 5.511521610893899137e-01 -1.536173513476463148e-33 -6.899071533928664013e-32 5.511521610893899137e-01 -1.834698473672432104e-33 -3.551557327994071153e-32 5.511521610893899137e-01 -1.288656420355414443e-33 -7.358391594353104887e-32 5.511521610893899137e-01 4.410136388223073198e-33 -1.890590739130997557e-31 5.511521610893899137e-01 -2.733511032959989919e-33 1.104285757212834090e-31 5.511521610893899137e-01 2.645342797528125074e-33 1.657072673191274145e-31 5.511521610893899137e-01 5.162242846726272109e-33 1.451912754051572494e-34 5.511521610893899137e-01 1.125798312144947706e-33 0.000000000000000000e+00 5.511521610893899137e-01 2.003523169800430207e-34 -5.089376209619579482e-32 5.511521610893899137e-01 2.437240037609632547e-35 -5.057074406811382823e-35 5.511521610893899137e-01 5.557199172430913484e-36 -3.588135771442574632e-36 5.511521610893899137e-01 8.711006937094480917e-36 2.514803731408052415e-35 5.511521610893899137e-01 -1.376965024937131914e-36 -2.092288613741648783e-32 5.511521610893899137e-01 5.635303257322522463e-37 1.276834031488163357e-32 5.511521610893899137e-01 -7.538694690190427531e-37 -1.651397423339197651e-32 5.511521610893899137e-01 -2.655068620293160516e-35 4.149019558991640952e-33 5.511521610893899137e-01 1.801137478264412865e-35 4.120215327670808708e-32 5.511521610893899137e-01 2.613947356900190221e-36 3.320367168419178455e-31 5.511521610893899137e-01 -4.406601281731207271e-35 -8.265645646404846644e-32 5.511521610893899137e-01 2.556548808093504941e-35 -8.359949198748722588e-33 5.511521610893899137e-01 -2.906489641777393917e-36 -1.053974638421897927e-32 5.511521610893899137e-01 -1.136177508209943075e-36 1.551126130366083905e-32 5.511521610893899137e-01 -4.554783074442939826e-36 -2.426171402493807335e-35 5.511521610893899137e-01 -1.574581655330030468e-35 1.294900492558985001e-33 5.511521610893899137e-01 -4.606570047530403123e-37 -8.951383859584458994e-33 5.511521610893899137e-01 8.029673726870002088e-36 -3.974804566422024178e-33 5.511521610893899137e-01 -7.115429633753438028e-36 7.184302837709172696e-33 5.511521610893899137e-01 3.533694496133001204e-35 -6.594431780811218674e-33 5.511521610893899137e-01 7.058500471975295707e-36 0.000000000000000000e+00 5.511521610893899137e-01 -2.456613369037341704e-37 -5.224038455800806536e-36 5.511521610893899137e-01 8.812145403188231737e-37 6.766274219515330324e-34 5.511521610893899137e-01 -3.051245130375756472e-37 1.284128139968962451e-33 5.511521610893899137e-01 5.391444708964997325e-37 4.369285821298746159e-36 5.511521610893899137e-01 5.701362940991431369e-37 0.000000000000000000e+00 5.511521610893899137e-01 6.738966364474223023e-37 6.341201238429676836e-33 5.511521610893899137e-01 -1.699595811087869029e-36 5.831357630064511284e-36 5.511521610893899137e-01 3.448324794889830205e-38 1.156639227075116307e-33 5.511521610893899137e-01 -1.400192913861544130e-37 1.064840554854361517e-33 5.511521610893899137e-01 3.622678341956968819e-38 -2.074946730704518240e-33 5.511521610893899137e-01 7.339631684888037912e-37 -5.014722320215609345e-34 5.511521610893899137e-01 -2.778033876711282708e-37 1.642066764582142795e-33 5.511521610893899137e-01 6.702258500782770616e-37 9.897457043082654278e-36 5.511521610893899137e-01 -1.640376304901322737e-38 -5.561523571099444735e-34 5.511521610893899137e-01 6.955944190147575259e-38 -2.697337926555218090e-33 5.511521610893899137e-01 -2.109098202465021155e-37 4.867560527952439794e-34 5.511521610893899137e-01 2.795735386577763507e-37 5.905021681553023089e-37 5.511521610893899137e-01 -1.277117505736407808e-38 -3.536408013145037568e-36 5.511521610893899137e-01 4.244610241015805687e-39 -4.702454580752408467e-36 5.511521610893899137e-01 8.795604253984678790e-38 -3.009265538105055593e-34 5.511521610893899137e-01 -4.043053316555132800e-39 -3.284324436952458275e-32 -1.894123274292355843e-33 5.511521610893899137e-01 -1.097723571798680044e-35 -1.273587668905107715e-32 5.511521610893899137e-01 -3.361032150056577907e-32 -1.028997146346537853e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.815029306587371900e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.326153205993396526e-32 5.511521610893899137e-01 3.596523669747883986e-34 -1.164709529141033605e-32 5.511521610893899137e-01 -5.901009053583062380e-34 -1.160278972534382117e-32 5.511521610893899137e-01 1.031029847776990184e-33 -8.354176170706741895e-33 5.511521610893899137e-01 -3.290838941924883654e-32 -5.828579076729968230e-33 5.511521610893899137e-01 -1.663817809179103254e-32 -6.246974652971093359e-33 5.511521610893899137e-01 -2.952276025195770101e-32 -6.074454595718026724e-33 5.511521610893899137e-01 -7.580603191080839879e-34 -5.896814348234768295e-33 5.511521610893899137e-01 4.379546562387294823e-34 -3.977994966628141968e-33 5.511521610893899137e-01 8.166308151623631949e-34 -7.006851411162470303e-33 5.511521610893899137e-01 6.065129588385682335e-34 -8.170426331950172208e-33 5.511521610893899137e-01 3.449535766964332007e-32 -8.468951292146141676e-33 5.511521610893899137e-01 -9.856784338632608523e-32 -7.922909238829123674e-33 5.511521610893899137e-01 1.604067002803055951e-34 -2.224116430250636375e-33 5.511521610893899137e-01 -4.060517638328558960e-34 -9.367763851433700176e-33 5.511521610893899137e-01 2.129493256723933938e-31 -3.988910020945584499e-33 5.511521610893899137e-01 -8.255385666801503823e-32 -1.472009971747437464e-33 5.511521610893899137e-01 -8.745368250111906597e-32 -5.508454506328761867e-33 5.511521610893899137e-01 8.998845484584648052e-35 -6.433900501493667194e-33 5.511521610893899137e-01 3.799662015622823384e-32 -6.609880418097613996e-33 5.511521610893899137e-01 -1.969748780522787136e-35 -6.628695619301278467e-33 5.511521610893899137e-01 -7.800541400908408347e-33 -6.625541811536615391e-33 5.511521610893899137e-01 -8.911835723177285468e-33 -6.635629783498646017e-33 5.511521610893899137e-01 -1.046217921707650360e-32 -6.633689288147976844e-33 5.511521610893899137e-01 3.192671472469647800e-33 -6.635006687942729225e-33 5.511521610893899137e-01 6.191727790050192879e-33 -6.660803504676641483e-33 5.511521610893899137e-01 -6.651086801518780795e-36 -6.616241443691064712e-33 5.511521610893899137e-01 2.102903362163559967e-36 -6.631638871116809666e-33 5.511521610893899137e-01 -1.037689549599575235e-32 -6.678318831291021544e-33 5.511521610893899137e-01 -4.133129770039938243e-32 -6.608687330392774700e-33 5.511521610893899137e-01 2.086222901616567436e-33 -6.637159308115487671e-33 5.511521610893899137e-01 6.588811387326720514e-33 -6.635388995981918574e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.638807601548151527e-33 5.511521610893899137e-01 -1.239773586674335625e-32 -6.649998635027009584e-33 5.511521610893899137e-01 1.035920394047188001e-32 -6.634713475478463627e-33 5.511521610893899137e-01 8.971930453441914298e-33 -6.626223144746839189e-33 5.511521610893899137e-01 -5.343456633476997506e-35 -6.641368248107463369e-33 5.511521610893899137e-01 3.280503578862635717e-35 -6.598915873512379433e-33 5.511521610893899137e-01 -3.312297970081256184e-33 -6.627194318001733487e-33 5.511521610893899137e-01 3.067878973098073851e-33 -6.634498479810613508e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633371603933390585e-33 5.511521610893899137e-01 6.735517977063315254e-34 -6.634557942986748372e-33 5.511521610893899137e-01 1.143215884889717618e-35 -6.633713674002813852e-33 5.511521610893899137e-01 -6.147357750200534932e-34 -6.633682682179610205e-33 5.511521610893899137e-01 -3.590184075811312277e-36 -6.633578921837261943e-33 5.511521610893899137e-01 -1.206693974592854967e-33 -6.635952414284797671e-33 5.511521610893899137e-01 -5.831357630064511284e-36 -6.634218335225760539e-33 5.511521610893899137e-01 -6.007540215290330127e-36 -6.634392837765095195e-33 5.511521610893899137e-01 1.327675124443156022e-34 -6.634216591690290642e-33 5.511521610893899137e-01 -3.133768974595599924e-33 -6.633518855305220060e-33 5.511521610893899137e-01 5.290693244731488679e-36 -6.634530621861381094e-33 5.511521610893899137e-01 5.175939368265225558e-36 -6.633582592623631910e-33 5.511521610893899137e-01 1.494245046463509335e-33 -6.634269222236758230e-33 5.511521610893899137e-01 -1.967238765696775577e-33 -6.634183259031808665e-33 5.511521610893899137e-01 1.203948954610219886e-36 -6.634463728293955097e-33 5.511521610893899137e-01 2.384954796105029227e-36 -6.633973244935052299e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.634265589648766268e-33 5.511521610893899137e-01 -3.620743259913885313e-34 -6.634248573863469293e-33 5.511521610893899137e-01 -5.995311120174697882e-35 -6.634164862431170501e-33 5.511521610893899137e-01 -1.175494350822287341e-36 -6.634256861527026154e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 new file mode 100644 index 000000000..a229d3dc6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 @@ -0,0 +1 @@ +1.300499993350550006e-02 2.677279359636132140e-32 -3.087951667916717484e-32 1.294644402802191084e-02 -1.795056848215541513e-33 -1.097723571798680044e-35 1.283348758003878022e-02 -2.919759881160563500e-31 -4.702083634295266632e-31 1.266490241113778573e-02 -2.297749134614679399e-32 0.000000000000000000e+00 1.243890345731798498e-02 -4.495927186623138031e-31 2.585709822118868810e-33 1.215312439012616180e-02 9.768285357234000299e-31 3.596523669747883986e-34 1.180461765389846304e-02 4.209302585735506597e-34 -4.308537171031031474e-33 1.138982739691811463e-02 6.650677531837888319e-33 -7.470759643106884753e-33 1.090457353852358063e-02 2.419205547460373255e-31 -3.322949907144324724e-32 1.034405066813579369e-02 8.250043336339598356e-33 -1.663817809179103254e-32 9.702858478626374614e-03 -9.013349788719214587e-33 -1.029310153751141003e-31 8.974985631511245635e-03 -1.340462022764363421e-31 -3.465636496928655558e-32 8.153809526433578730e-03 2.457696916451168065e-31 5.872196252758873491e-34 7.232130807359616470e-03 3.147408753928573026e-32 8.166308151623631949e-34 6.202311958613668762e-03 -3.201964822810057856e-33 2.034473221580892580e-31 5.056416769117172937e-03 -6.618507395564509647e-32 3.449535766964332007e-32 3.786249515449842742e-03 -3.671044008520720134e-32 7.588271018258170159e-32 2.383522635342297767e-03 1.954818640571535403e-32 1.606420963542112964e-31 8.404978132148413321e-04 2.644665653213261353e-31 7.488278953200068596e-32 -8.116363860802451591e-04 1.104285757212834090e-31 3.618691424341870407e-32 -2.461875694578038402e-03 -3.722880471768886118e-31 9.769947932084961270e-34 -4.023251402757254888e-03 1.451912754051572494e-34 8.102130367078274725e-33 -5.455850367077730127e-03 1.223936145039006260e-31 1.531528108033107102e-32 -6.721295353746163832e-03 6.709898553041416394e-32 1.115261322062722242e-33 -7.783896214661429475e-03 -5.057074406811382823e-35 -1.969748780522787136e-35 -8.662003252624219871e-03 -6.630886050859738846e-35 6.248900940214269800e-33 -9.422635330936905002e-03 -2.774683649188397237e-32 4.974156541421739841e-33 -1.007754802845255669e-02 2.040747904937559891e-32 3.309592139775192262e-33 -1.058862366988968552e-02 -7.907133397377493655e-33 -2.526139414705666249e-34 -1.087360180215004614e-02 8.201728049331568593e-34 -7.420024444510445840e-34 -1.089066060949882460e-02 -2.874605469841992836e-33 -8.846042154057230684e-34 -1.066761795895846202e-02 -1.729055715192252240e-33 -1.786528525288388026e-33 -1.031395616518388653e-02 -1.494455606875295124e-33 4.285218883801469575e-33 -9.881133777898822024e-03 4.195796383251809339e-34 -7.345235710961355610e-33 -9.371894395189799692e-03 -8.359949198748722588e-33 -1.826740140296141767e-33 -8.746563136134541741e-03 5.751206958567186904e-33 -5.365100203023742960e-34 -7.949339571288287221e-03 3.614155498076019876e-33 -3.771020965051682968e-36 -6.986597788038257685e-03 -2.108718267383256201e-35 5.509795484842829906e-33 -5.885030248949318921e-03 1.294900492558985001e-33 9.124624072209571714e-34 -4.765083613266077496e-03 -2.896954574741941310e-32 8.971930453441914298e-33 -3.735673687650683909e-03 1.349715775509915567e-33 -5.343456633476997506e-35 -2.800476626354302719e-03 1.503785572341477963e-33 2.873063668472473868e-33 -1.954427718858644820e-03 5.577169285711319671e-33 4.905937806933842568e-34 -1.192014148171513174e-03 1.635168905919498698e-33 1.613567441605265766e-32 -5.050693164003807476e-04 -5.224038455800806536e-36 1.969263124263210691e-36 1.199733105226078421e-04 6.766274219515330324e-34 6.827601207292123160e-34 6.892955496274345275e-04 5.416384496311521110e-33 -2.056049082962311016e-33 1.206444647621798295e-03 -5.574863827906597679e-34 8.371756882679575963e-33 1.674899808472968569e-03 -9.813292311197593915e-33 1.959261272837758941e-32 2.098003848757089545e-03 2.768091664111754389e-32 -1.202165172512488288e-33 2.478912312563796676e-03 4.118308397239630259e-37 -5.831357630064511284e-36 2.820577918545143919e-03 2.685516054567531970e-32 -6.007540215290330127e-36 3.123983653899738491e-03 1.033585907547938591e-33 3.933348210917104740e-34 3.385864640658509898e-03 -2.074946730704518240e-33 -3.133768974595599924e-33 3.609242985434022929e-03 3.325522133223167797e-32 -1.721376913143734076e-35 3.798502250237810983e-03 1.695758804273943118e-33 5.175939368265225558e-36 3.957511670004687510e-03 2.002529389005303715e-32 2.154141195000205390e-32 4.089645859470344980e-03 -5.561523571099444735e-34 -4.529244353682226239e-32 4.197804652640391675e-03 -4.917764417702588864e-32 1.163197055440817204e-32 4.284434077814413058e-03 4.867560527952439794e-34 -1.907537384487932796e-34 4.351546142474803196e-03 -6.457330474434954398e-33 1.480076557898469812e-37 4.400735306612379820e-03 3.516566589829370984e-36 -3.705184287801258006e-33 4.433191365246738624e-03 -4.702454580752408467e-36 -9.070667127788109195e-34 4.449713999228352077e-03 -3.009265538105055593e-34 8.436911341969221425e-34 2.677279359636132140e-32 5.511521610893899137e-01 -7.365805051968623702e-33 -1.795056848215541513e-33 5.511521610893899137e-01 2.175109345038894931e-32 -2.919759881160563500e-31 5.511521610893899137e-01 2.453166706555872560e-32 -2.297749134614679399e-32 5.511521610893899137e-01 -3.612595562895692594e-32 -4.495927186623138031e-31 5.511521610893899137e-01 -1.343804300737656851e-31 9.768285357234000299e-31 5.511521610893899137e-01 -2.064940258710220441e-31 4.209302585735506597e-34 5.511521610893899137e-01 -1.615802161525644894e-31 6.650677531837888319e-33 5.511521610893899137e-01 -1.750018263095921767e-33 2.419205547460373255e-31 5.511521610893899137e-01 2.668216440975985984e-33 8.250043336339598356e-33 5.511521610893899137e-01 -1.260356687825045381e-34 -9.013349788719214587e-33 5.511521610893899137e-01 5.990804722602347133e-33 -1.340462022764363421e-31 5.511521610893899137e-01 -2.481610797581635377e-33 2.457696916451168065e-31 5.511521610893899137e-01 -2.019729683382158985e-33 3.147408753928573026e-32 5.511521610893899137e-01 -4.140627713284038700e-33 -3.201964822810057856e-33 5.511521610893899137e-01 -2.483134921002883152e-32 -6.618507395564509647e-32 5.511521610893899137e-01 -5.086501793016976630e-32 -3.671044008520720134e-32 5.511521610893899137e-01 -2.480660726176012984e-32 1.954818640571535403e-32 5.511521610893899137e-01 4.138054526473353298e-33 2.644665653213261353e-31 5.511521610893899137e-01 -1.296236066594374196e-32 1.104285757212834090e-31 5.511521610893899137e-01 4.756583233480971275e-33 -3.722880471768886118e-31 5.511521610893899137e-01 8.629972842718394302e-34 1.451912754051572494e-34 5.511521610893899137e-01 -1.138831359727056795e-33 1.223936145039006260e-31 5.511521610893899137e-01 -2.175690293323457535e-34 6.709898553041416394e-32 5.511521610893899137e-01 -8.818753803586929292e-35 -5.057074406811382823e-35 5.511521610893899137e-01 -3.269409452189366199e-35 -6.630886050859738846e-35 5.511521610893899137e-01 -5.572560526864203333e-35 -2.774683649188397237e-32 5.511521610893899137e-01 -2.605365239789392194e-35 2.040747904937559891e-32 5.511521610893899137e-01 -7.474300650804326902e-36 -7.907133397377493655e-33 5.511521610893899137e-01 -4.026436312402781817e-37 8.201728049331568593e-34 5.511521610893899137e-01 -2.649925669022457098e-35 -2.874605469841992836e-33 5.511521610893899137e-01 1.818489586830184980e-35 -1.729055715192252240e-33 5.511521610893899137e-01 1.932777436927567416e-36 -1.494455606875295124e-33 5.511521610893899137e-01 -4.326791465681436628e-35 4.195796383251809339e-34 5.511521610893899137e-01 2.710301783988453129e-35 -8.359949198748722588e-33 5.511521610893899137e-01 -6.017867277171347747e-36 5.751206958567186904e-33 5.511521610893899137e-01 -1.737842857672541956e-36 3.614155498076019876e-33 5.511521610893899137e-01 -4.551930513783058723e-36 -2.108718267383256201e-35 5.511521610893899137e-01 -1.380806751921065513e-35 1.294900492558985001e-33 5.511521610893899137e-01 -2.062085481483129848e-37 -2.896954574741941310e-32 5.511521610893899137e-01 1.048674051382297611e-35 1.349715775509915567e-33 5.511521610893899137e-01 -7.834953174496037320e-36 1.503785572341477963e-33 5.511521610893899137e-01 3.592110003330151294e-35 5.577169285711319671e-33 5.511521610893899137e-01 6.519553689324360236e-36 1.635168905919498698e-33 5.511521610893899137e-01 6.187473100117064002e-37 -5.224038455800806536e-36 5.511521610893899137e-01 1.130819175754849439e-36 6.766274219515330324e-34 5.511521610893899137e-01 -9.868162610712666859e-37 5.416384496311521110e-33 5.511521610893899137e-01 -1.685993349848737115e-37 -5.574863827906597679e-34 5.511521610893899137e-01 4.531930584758000118e-37 -9.813292311197593915e-33 5.511521610893899137e-01 2.629391622917063538e-35 2.768091664111754389e-32 5.511521610893899137e-01 8.101310657899353335e-36 4.118308397239630259e-37 5.511521610893899137e-01 1.243809643931513686e-35 2.685516054567531970e-32 5.511521610893899137e-01 8.833864664219796195e-35 1.033585907547938591e-33 5.511521610893899137e-01 -1.329276758881976038e-38 -2.074946730704518240e-33 5.511521610893899137e-01 1.175670432004550569e-34 3.325522133223167797e-32 5.511521610893899137e-01 5.034213723467814691e-35 1.695758804273943118e-33 5.511521610893899137e-01 5.940143821568172711e-35 2.002529389005303715e-32 5.511521610893899137e-01 3.526757412550569678e-35 -5.561523571099444735e-34 5.511521610893899137e-01 3.484494696848043159e-35 -4.917764417702588864e-32 5.511521610893899137e-01 4.687247205117440797e-35 4.867560527952439794e-34 5.511521610893899137e-01 1.739766122033099802e-37 -6.457330474434954398e-33 5.511521610893899137e-01 1.077484886448584865e-35 3.516566589829370984e-36 5.511521610893899137e-01 2.060528750578635321e-36 -4.702454580752408467e-36 5.511521610893899137e-01 -3.543121703534686902e-37 -3.009265538105055593e-34 5.511521610893899137e-01 7.413944312209265929e-37 -3.087951667916717484e-32 -1.400005787044233328e-32 5.511521610893899137e-01 -1.097723571798680044e-35 1.511684063191523974e-32 5.511521610893899137e-01 -4.702083634295266632e-31 1.789741424708501329e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.276020844743063277e-32 5.511521610893899137e-01 2.585709822118868810e-33 -1.410146828922394029e-31 5.511521610893899137e-01 3.596523669747883986e-34 -2.131282786894957618e-31 5.511521610893899137e-01 -4.308537171031031474e-33 -1.682144689710381853e-31 5.511521610893899137e-01 -7.470759643106884753e-33 -8.384271081569630997e-33 5.511521610893899137e-01 -3.322949907144324724e-32 -3.966036377497724273e-33 5.511521610893899137e-01 -1.663817809179103254e-32 -6.760288487256212914e-33 5.511521610893899137e-01 -1.029310153751141003e-31 -6.434480958713617557e-34 5.511521610893899137e-01 -3.465636496928655558e-32 -9.115863616055344950e-33 5.511521610893899137e-01 5.872196252758873491e-34 -8.653982501855868900e-33 5.511521610893899137e-01 8.166308151623631949e-34 -1.077488053175774759e-32 5.511521610893899137e-01 2.034473221580892580e-31 -3.146560202850253836e-32 5.511521610893899137e-01 3.449535766964332007e-32 -5.749927074864347313e-32 5.511521610893899137e-01 7.588271018258170159e-32 -3.144086008023383668e-32 5.511521610893899137e-01 1.606420963542112964e-31 -2.496198292000356275e-33 5.511521610893899137e-01 7.488278953200068596e-32 -1.959661348441745154e-32 5.511521610893899137e-01 3.618691424341870407e-32 -1.877669584992737955e-33 5.511521610893899137e-01 9.769947932084961270e-34 -5.771255534201870143e-33 5.511521610893899137e-01 8.102130367078274725e-33 -7.773084178200766368e-33 5.511521610893899137e-01 1.531528108033107102e-32 -6.851821847806056310e-33 5.511521610893899137e-01 1.115261322062722242e-33 -6.722440356509580063e-33 5.511521610893899137e-01 -1.969748780522787136e-35 -6.666946912995602626e-33 5.511521610893899137e-01 6.248900940214269800e-33 -6.689978423742351660e-33 5.511521610893899137e-01 4.974156541421739841e-33 -6.660306470871603377e-33 5.511521610893899137e-01 3.309592139775192262e-33 -6.641727119124513929e-33 5.511521610893899137e-01 -2.526139414705666249e-34 -6.634655462104950859e-33 5.511521610893899137e-01 -7.420024444510445840e-34 -6.660752075163934764e-33 5.511521610893899137e-01 -8.846042154057230684e-34 -6.616067922605407124e-33 5.511521610893899137e-01 -1.786528525288388026e-33 -6.632320041036781914e-33 5.511521610893899137e-01 4.285218883801469575e-33 -6.677520733130523961e-33 5.511521610893899137e-01 -7.345235710961355610e-33 -6.607149800633824983e-33 5.511521610893899137e-01 -1.826740140296141767e-33 -6.640270685750882298e-33 5.511521610893899137e-01 -5.365100203023742960e-34 -6.635990661331380585e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.638804748987490963e-33 5.511521610893899137e-01 5.509795484842829906e-33 -6.648060885992920207e-33 5.511521610893899137e-01 9.124624072209571714e-34 -6.634459027021858989e-33 5.511521610893899137e-01 8.971930453441914298e-33 -6.623766077959885635e-33 5.511521610893899137e-01 -5.343456633476997506e-35 -6.642087771648206353e-33 5.511521610893899137e-01 2.873063668472473868e-33 -6.598331718440407590e-33 5.511521610893899137e-01 4.905937806933842568e-34 -6.627733264784384037e-33 5.511521610893899137e-01 1.613567441605265766e-32 -6.633634071163698004e-33 5.511521610893899137e-01 1.969263124263210691e-36 -6.633121999297953967e-33 5.511521610893899137e-01 6.827601207292123160e-34 -6.635239634734781923e-33 5.511521610893899137e-01 -2.056049082962311016e-33 -6.634421417808694929e-33 5.511521610893899137e-01 8.371756882679575963e-33 -6.633799625415233350e-33 5.511521610893899137e-01 1.959261272837758941e-32 -6.607958902244539269e-33 5.511521610893899137e-01 -1.202165172512488288e-33 -6.626151507815810356e-33 5.511521610893899137e-01 -5.831357630064511284e-36 -6.621814722034394947e-33 5.511521610893899137e-01 -6.007540215290330127e-36 -6.545914171831510510e-33 5.511521610893899137e-01 3.933348210917104740e-34 -6.634266111241298585e-33 5.511521610893899137e-01 -3.133768974595599924e-33 -6.516685775273253190e-33 5.511521610893899137e-01 -1.721376913143734076e-35 -6.583910681239032196e-33 5.511521610893899137e-01 5.175939368265225558e-36 -6.574851380258028744e-33 5.511521610893899137e-01 2.154141195000205390e-32 -6.598985244348203577e-33 5.511521610893899137e-01 -4.529244353682226239e-32 -6.599407871505229574e-33 5.511521610893899137e-01 1.163197055440817204e-32 -6.587380346422534058e-33 5.511521610893899137e-01 -1.907537384487932796e-34 -6.634078841861506551e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.623477969609223100e-33 5.511521610893899137e-01 -3.705184287801258006e-33 -6.632192289723132357e-33 5.511521610893899137e-01 -9.070667127788109195e-34 -6.634607130644063137e-33 5.511521610893899137e-01 8.436911341969221425e-34 -6.633511424042488234e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 new file mode 100644 index 000000000..f3d8aacd8 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 @@ -0,0 +1 @@ +1.335517212929382587e-02 -6.693878877587190951e-31 -3.087951667916717484e-32 1.330744334312728566e-02 -1.213684258199182118e-33 -2.056035141828573141e-30 1.321149323456228923e-02 -2.908832234922288907e-31 8.602325660804059089e-31 1.306634490577402406e-02 -2.098265043872291450e-32 9.974204537119394011e-34 1.287052877579535244e-02 -4.460480003079173007e-31 2.585709822118868810e-33 1.262207064290500787e-02 9.768285357234000299e-31 1.116281277743738823e-30 1.231847643336966662e-02 -2.189480928175688640e-33 1.022888264814794615e-30 1.195671419516994120e-02 -4.614427952413710396e-31 -8.015054378889686537e-33 1.153319406656717894e-02 -2.308295574419196490e-30 -3.322949907144324724e-32 1.104374729980958647e-02 8.250043336339598356e-33 -1.663817809179103254e-32 1.048360588549852521e-02 1.364662146398175274e-30 -1.029310153751141003e-31 9.847384977699566097e-03 1.093440458118657728e-30 -3.465636496928655558e-32 9.129070877879286172e-03 2.457696916451168065e-31 1.371231758106487328e-31 8.322018242813868441e-03 3.030045097757395693e-32 2.443462173703552736e-31 7.418961350791642220e-03 -2.274089918700068490e-33 -4.458331419928759206e-31 6.412046708685887123e-03 -6.691853979703237233e-32 -6.158866755208911626e-32 5.292901377773730730e-03 -3.671044008520720134e-32 -4.375963896546078666e-31 4.052750384497899594e-03 3.341293584360434652e-31 8.131854037054789675e-33 2.682599786428978283e-03 -8.084581200777077534e-33 7.488278953200068596e-32 1.173507829047855389e-03 -1.330091461042922317e-31 -8.553194666936911631e-32 -4.772777403827129471e-04 -4.312376629269142029e-32 7.384699519880633653e-34 -2.145690171865280264e-03 4.990122847809326256e-32 -4.145878512108949148e-32 -3.732202035930033256e-03 -2.441492490279639564e-32 -1.631934737255446559e-33 -5.199234474029683188e-03 1.536435921600750742e-32 3.701144807132212868e-33 -6.507616137674143708e-03 1.901018688329583423e-32 3.806238379284469876e-35 -7.617791493188826209e-03 -6.007015725491252284e-35 -1.149397111326550325e-32 -8.516242898279445875e-03 -2.807664107056711941e-33 4.974156541421739841e-33 -9.300172437905922240e-03 4.728734298667183786e-33 7.229278327452296042e-33 -9.980195345422368525e-03 -4.187968409212115054e-33 -2.526139414705666249e-34 -1.053442523316933804e-02 8.201728049331568593e-34 -7.866643019918072708e-33 -1.086563676104390641e-02 -2.874605469841992836e-33 -8.846042154057230684e-34 -1.092540260003757764e-02 -1.725556898675415706e-33 1.536472461577130125e-33 -1.071922285387321740e-02 -1.446351582126238043e-32 -2.200977341096902360e-33 -1.037340825884860637e-02 6.788482342927266514e-33 -9.795447575970917515e-34 -9.947561538293363606e-03 -2.067960857596216102e-33 -1.833000825212711464e-33 -9.445983948244454989e-03 -3.602261324782308961e-33 -5.488415539653268128e-34 -8.839683008156611760e-03 -2.609067848005286795e-33 -3.771020965051682968e-36 -8.057966258612131449e-03 -3.114936696831152682e-33 -7.025067205227635856e-34 -7.108271329195539091e-03 1.294900492558985001e-33 9.186809407640757886e-34 -6.012257102638814132e-03 5.787674294264362624e-33 -5.248658299956383594e-33 -4.880972386200791747e-03 1.336763904575895575e-33 -5.343456633476997506e-35 -3.842163781311953505e-03 1.503785572341477963e-33 -3.816486951666632537e-34 -2.899569485978191995e-03 5.549710211502845341e-33 -6.099584029340474043e-33 -2.047902957581568609e-03 8.329951469600288070e-33 1.702489949495875322e-33 -1.281440075611148428e-03 -1.258099185939569056e-35 -4.238144151087907391e-34 -5.926086820032599664e-04 -1.057347131215684707e-33 4.656554367195578838e-34 3.214943058440144705e-05 1.103671635066414801e-34 1.039251585824396595e-33 6.000005873694487079e-04 -7.765458341713399787e-33 -6.044187035165903733e-33 1.114605034138820309e-03 4.887847880882840826e-33 -2.454818997405439943e-33 1.579498506452312739e-03 -2.271225877154838061e-33 -1.618045741211125268e-32 1.998061839655331136e-03 1.525946530332796774e-32 1.900398525897112685e-33 2.373487090107689618e-03 3.575658482313705526e-33 3.876295643168201569e-33 2.708753866618097538e-03 1.681192735973695812e-32 3.834641038867126558e-34 3.005677903174185615e-03 1.396143913708608939e-32 -1.115196190849090322e-32 3.263101423712487428e-03 6.997649623631846345e-34 -2.051601876692518513e-33 3.481863470881151751e-03 1.693063388322277934e-33 8.253148751463969105e-33 3.665850751461711445e-03 3.318442495156327830e-33 2.753110071300010349e-33 3.818850432747788060e-03 -4.776960015542009270e-33 2.193760082574472263e-33 3.944120696478450178e-03 -2.303899171572938198e-33 -2.616492699908066494e-33 4.044410688330879293e-03 4.852942590358737918e-34 -1.922155322081634885e-34 4.121979380377128674e-03 2.187371392533901365e-33 1.480076557898469812e-37 4.178612422650197777e-03 -5.397317873062446844e-34 -4.470025210314790508e-34 4.215636310568740032e-03 5.401325912133581821e-34 -3.086406895955253009e-33 4.233929391276620470e-03 -3.024365710429179756e-34 -2.476738205291551856e-34 -6.693878877587190951e-31 5.511521610893899137e-01 7.023763879665523519e-32 -1.213684258199182118e-33 5.511521610893899137e-01 -5.057396149036795677e-33 -2.908832234922288907e-31 5.511521610893899137e-01 -5.372272997721580511e-32 -2.098265043872291450e-32 5.511521610893899137e-01 -1.560313012198098189e-31 -4.460480003079173007e-31 5.511521610893899137e-01 -6.463023859117665993e-31 9.768285357234000299e-31 5.511521610893899137e-01 -5.358928332297334934e-31 -2.189480928175688640e-33 5.511521610893899137e-01 -3.612694783890924779e-31 -4.614427952413710396e-31 5.511521610893899137e-01 2.254261209392109348e-32 -2.308295574419196490e-30 5.511521610893899137e-01 4.000438915242548913e-32 8.250043336339598356e-33 5.511521610893899137e-01 4.709536657119106721e-32 1.364662146398175274e-30 5.511521610893899137e-01 8.507832497273994774e-32 1.093440458118657728e-30 5.511521610893899137e-01 -1.670196199016318176e-32 2.457696916451168065e-31 5.511521610893899137e-01 1.267514672358606805e-32 3.030045097757395693e-32 5.511521610893899137e-01 -2.807787351858833786e-32 -2.274089918700068490e-33 5.511521610893899137e-01 -3.117418833596663163e-32 -6.691853979703237233e-32 5.511521610893899137e-01 -4.416842538065583511e-32 -3.671044008520720134e-32 5.511521610893899137e-01 -2.924868368941431518e-32 3.341293584360434652e-31 5.511521610893899137e-01 4.444681120124257546e-33 -8.084581200777077534e-33 5.511521610893899137e-01 -2.546219467519335627e-32 -1.330091461042922317e-31 5.511521610893899137e-01 -6.819961976934326677e-34 -4.312376629269142029e-32 5.511521610893899137e-01 -1.241525506237106313e-33 4.990122847809326256e-32 5.511521610893899137e-01 -1.569887313977570801e-33 -2.441492490279639564e-32 5.511521610893899137e-01 -2.402920803610468942e-34 1.536435921600750742e-32 5.511521610893899137e-01 -9.165584842420585955e-35 1.901018688329583423e-32 5.511521610893899137e-01 -1.115131223519625417e-34 -6.007015725491252284e-35 5.511521610893899137e-01 -4.472257011736764337e-35 -2.807664107056711941e-33 5.511521610893899137e-01 -1.673033450966859962e-35 4.728734298667183786e-33 5.511521610893899137e-01 -1.351798589832718024e-35 -4.187968409212115054e-33 5.511521610893899137e-01 9.688298628882606315e-37 8.201728049331568593e-34 5.511521610893899137e-01 -2.212648313848077324e-35 -2.874605469841992836e-33 5.511521610893899137e-01 1.833731722420299415e-35 -1.725556898675415706e-33 5.511521610893899137e-01 2.356735283292187262e-36 -1.446351582126238043e-32 5.511521610893899137e-01 -4.396274526468345840e-35 6.788482342927266514e-33 5.511521610893899137e-01 2.910076078326331629e-35 -2.067960857596216102e-33 5.511521610893899137e-01 -9.839474111753336685e-36 -3.602261324782308961e-33 5.511521610893899137e-01 -6.132636074383660835e-36 -2.609067848005286795e-33 5.511521610893899137e-01 -1.013768860515183628e-35 -3.114936696831152682e-33 5.511521610893899137e-01 -1.096280944305474608e-35 1.294900492558985001e-33 5.511521610893899137e-01 4.592466625020779175e-36 5.787674294264362624e-33 5.511521610893899137e-01 9.540948615834967188e-36 1.336763904575895575e-33 5.511521610893899137e-01 -2.502762236464979207e-36 1.503785572341477963e-33 5.511521610893899137e-01 3.275855560540812230e-35 5.549710211502845341e-33 5.511521610893899137e-01 1.465587260610369653e-35 8.329951469600288070e-33 5.511521610893899137e-01 7.138082572971144980e-37 -1.258099185939569056e-35 5.511521610893899137e-01 1.221232805533752379e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -9.718413108749057898e-37 1.103671635066414801e-34 5.511521610893899137e-01 -1.868596250705185534e-37 -7.765458341713399787e-33 5.511521610893899137e-01 3.946115932493137485e-36 4.887847880882840826e-33 5.511521610893899137e-01 2.262990506617787507e-35 -2.271225877154838061e-33 5.511521610893899137e-01 1.301471940378096190e-35 1.525946530332796774e-32 5.511521610893899137e-01 1.159212928363959138e-35 3.575658482313705526e-33 5.511521610893899137e-01 8.723867927579395619e-35 1.681192735973695812e-32 5.511521610893899137e-01 7.454083659153999032e-36 1.396143913708608939e-32 5.511521610893899137e-01 1.109248066038083928e-34 6.997649623631846345e-34 5.511521610893899137e-01 5.120296241674980865e-35 1.693063388322277934e-33 5.511521610893899137e-01 6.057343973332397824e-35 3.318442495156327830e-33 5.511521610893899137e-01 3.678477219140497765e-35 -4.776960015542009270e-33 5.511521610893899137e-01 3.465568335247416883e-35 -2.303899171572938198e-33 5.511521610893899137e-01 4.684705414039010538e-35 4.852942590358737918e-34 5.511521610893899137e-01 6.277741512251677945e-37 2.187371392533901365e-33 5.511521610893899137e-01 1.022635762644438715e-35 -5.397317873062446844e-34 5.511521610893899137e-01 2.068001337598147530e-36 5.401325912133581821e-34 5.511521610893899137e-01 -3.348560208215807574e-37 -3.024365710429179756e-34 5.511521610893899137e-01 6.546199819497888909e-37 -3.087951667916717484e-32 6.360338597818152835e-32 5.511521610893899137e-01 -2.056035141828573141e-30 -1.169164896751050525e-32 5.511521610893899137e-01 8.602325660804059089e-31 -6.035698279568951195e-32 5.511521610893899137e-01 9.974204537119394011e-34 -1.626655540382835366e-31 5.511521610893899137e-01 2.585709822118868810e-33 -6.529366387302403171e-31 5.511521610893899137e-01 1.116281277743738823e-30 -5.425270860482072112e-31 5.511521610893899137e-01 1.022888264814794615e-30 -3.679037312075661956e-31 5.511521610893899137e-01 -8.015054378889686537e-33 1.590835927544738391e-32 5.511521610893899137e-01 -3.322949907144324724e-32 3.337013633395177682e-32 5.511521610893899137e-01 -1.663817809179103254e-32 4.046111375271736037e-32 5.511521610893899137e-01 -1.029310153751141003e-31 7.844407215426624090e-32 5.511521610893899137e-01 -3.465636496928655558e-32 -2.333621480863689133e-32 5.511521610893899137e-01 1.371231758106487328e-31 6.040893905112358474e-33 5.511521610893899137e-01 2.443462173703552736e-31 -3.471212633706204470e-32 5.511521610893899137e-01 -4.458331419928759206e-31 -3.780844115444033847e-32 5.511521610893899137e-01 -6.158866755208911626e-32 -5.080267819912953647e-32 5.511521610893899137e-01 -4.375963896546078666e-31 -3.588293650788802202e-32 5.511521610893899137e-01 8.131854037054789675e-33 -2.189571698349452027e-33 5.511521610893899137e-01 7.488278953200068596e-32 -3.209644749366706858e-32 5.511521610893899137e-01 -8.553194666936911631e-32 -7.316249016167142241e-33 5.511521610893899137e-01 7.384699519880633653e-34 -7.875778324710815202e-33 5.511521610893899137e-01 -4.145878512108949148e-32 -8.204140132451281058e-33 5.511521610893899137e-01 -1.631934737255446559e-33 -6.874544898834757194e-33 5.511521610893899137e-01 3.701144807132212868e-33 -6.725908666897916854e-33 5.511521610893899137e-01 3.806238379284469876e-35 -6.745765940825671730e-33 5.511521610893899137e-01 -1.149397111326550325e-32 -6.678975388591077954e-33 5.511521610893899137e-01 4.974156541421739841e-33 -6.650983152983377921e-33 5.511521610893899137e-01 7.229278327452296042e-33 -6.647770804372037280e-33 5.511521610893899137e-01 -2.526139414705666249e-34 -6.633283988610822863e-33 5.511521610893899137e-01 -7.866643019918072708e-33 -6.656379301612191533e-33 5.511521610893899137e-01 -8.846042154057230684e-34 -6.615915501249505788e-33 5.511521610893899137e-01 1.536472461577130125e-33 -6.631896083190416729e-33 5.511521610893899137e-01 -2.200977341096902360e-33 -6.678215563738392844e-33 5.511521610893899137e-01 -9.795447575970917515e-34 -6.605152057690446438e-33 5.511521610893899137e-01 -1.833000825212711464e-33 -6.644092292585463913e-33 5.511521610893899137e-01 -5.488415539653268128e-34 -6.640385454548091673e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.644390507078859872e-33 5.511521610893899137e-01 -7.025067205227635856e-34 -6.645215627916764870e-33 5.511521610893899137e-01 9.186809407640757886e-34 -6.629660351848689748e-33 5.511521610893899137e-01 -5.248658299956383594e-33 -6.624711869857873796e-33 5.511521610893899137e-01 -5.343456633476997506e-35 -6.636755580710174881e-33 5.511521610893899137e-01 -3.816486951666632537e-34 -6.601494262868301039e-33 5.511521610893899137e-01 -6.099584029340474043e-33 -6.619596945867604289e-33 5.511521610893899137e-01 1.702489949495875322e-33 -6.633539010216412493e-33 5.511521610893899137e-01 -4.238144151087907391e-34 -6.633031585668175678e-33 5.511521610893899137e-01 4.656554367195578838e-34 -6.635224659784586199e-33 5.511521610893899137e-01 1.039251585824396595e-33 -6.634439678098780364e-33 5.511521610893899137e-01 -6.044187035165903733e-33 -6.630306702541216629e-33 5.511521610893899137e-01 -2.454818997405439943e-33 -6.611622913407531602e-33 5.511521610893899137e-01 -1.618045741211125268e-32 -6.621238099069928713e-33 5.511521610893899137e-01 1.900398525897112685e-33 -6.622660689190070508e-33 5.511521610893899137e-01 3.876295643168201569e-33 -6.547014139197914505e-33 5.511521610893899137e-01 3.834641038867126558e-34 -6.626798734814556325e-33 5.511521610893899137e-01 -1.115196190849090322e-32 -6.523328011869899619e-33 5.511521610893899137e-01 -2.051601876692518513e-33 -6.583049856056960128e-33 5.511521610893899137e-01 8.253148751463969105e-33 -6.573679378740386803e-33 5.511521610893899137e-01 2.753110071300010349e-33 -6.597468046282303665e-33 5.511521610893899137e-01 2.193760082574472263e-33 -6.599597135121235618e-33 5.511521610893899137e-01 -2.616492699908066494e-33 -6.587405764333317821e-33 5.511521610893899137e-01 -1.922155322081634885e-34 -6.633625044322484132e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.624026460847265075e-33 5.511521610893899137e-01 -4.470025210314790508e-34 -6.632184817136112924e-33 5.511521610893899137e-01 -3.086406895955253009e-33 -6.634587674494530571e-33 5.511521610893899137e-01 -2.476738205291551856e-34 -6.633598198491759197e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 new file mode 100644 index 000000000..482d7addf --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 @@ -0,0 +1 @@ +1.352487795931679726e-02 7.186542654010139890e-32 -3.087951667916717484e-32 1.347902063489157289e-02 -1.213684258199182118e-33 -3.728381140245989968e-31 1.338685543897583097e-02 1.244596995661276363e-31 8.602325660804059089e-31 1.324747790975055843e-02 -2.087992992792915651e-32 8.946999429181815743e-34 1.305952273106762013e-02 -4.460480003079173007e-31 2.488065541890253012e-33 1.282115356961373992e-02 -5.639353396631397563e-31 -3.883274034149998349e-32 1.253004999888494148e-02 -2.189480928175688640e-33 -2.072726182018415883e-31 1.218339197809170660e-02 -1.584327791517241873e-32 -8.015054378889686537e-33 1.177784255895553481e-02 4.173696107403246719e-31 -3.739286663231091606e-31 1.130952976400348073e-02 8.250043336339598356e-33 -1.637762504560468589e-32 1.077402893447631897e-02 1.325657781777226577e-31 -1.024616453300777401e-31 1.016634730596309606e-02 -7.201034342071760486e-32 -3.423592817219442872e-32 9.480913152518841841e-03 -3.045699438262729040e-31 1.378729573303645284e-31 8.711572575220295767e-03 1.598646754024827250e-31 -2.739106803292798204e-31 7.851597920008378598e-03 5.877695377250037967e-32 -1.422649841052083157e-30 6.893712917308904807e-03 4.785335463493405947e-32 -6.211065456485531337e-32 5.830140935948133381e-03 -3.717161035784631260e-32 -5.941014464402095621e-33 4.652684221773038982e-03 -4.773168640395984564e-31 8.233692167385567721e-33 3.352843638102343416e-03 -8.804626882755259802e-33 -2.044450833364208714e-32 1.921990210406904947e-03 5.851738340679510622e-31 4.161269354804123170e-33 3.516102942855809602e-04 -4.312376629269142029e-32 7.384699519880633653e-34 -1.318661627856292182e-03 4.964972510955454857e-32 3.826778270568354555e-32 -2.935937593277878222e-03 -2.452733776768732580e-32 -2.046108960648619085e-32 -4.454672386246005464e-03 1.541488543426084813e-32 4.819037385987356555e-33 -5.837891719854305939e-03 1.910162887349980249e-32 6.802518210044378673e-32 -7.047443236038019448e-03 -8.178224631464165513e-33 2.093696177985284751e-32 -8.045462492872012053e-03 -2.807664107056711941e-33 -2.610260701230273283e-32 -8.873783900947061418e-03 3.467920591293596858e-32 -7.745957479682096357e-33 -9.607251679285428933e-03 3.053024431578994055e-33 -2.359966314515394046e-34 -1.023298829193812487e-02 8.201728049331568593e-34 6.198001694690810088e-33 -1.070679857478515698e-02 -2.867127436010369084e-33 -8.883432323215349447e-34 -1.092797606233513602e-02 1.175779569425675511e-32 -1.834351620456271303e-33 -1.087938741911360051e-02 1.213360347696233966e-32 -1.550654545379245638e-32 -1.059978046650929782e-02 -6.392130789727320208e-33 -9.760997463235280629e-34 -1.022755686683541644e-02 -2.067960857596216102e-33 -1.832145783597374523e-33 -9.778534213702446548e-03 9.553355987303608217e-33 -1.371131432061721193e-32 -9.256712514380977322e-03 6.984727551396627871e-34 -5.504532811563710908e-36 -8.602940094676136615e-03 3.566129554394723763e-33 -6.954293198329056395e-34 -7.774398462956922003e-03 1.280325088873296754e-33 9.113932389212317506e-34 -6.789031593146552766e-03 -2.181899047452207293e-32 -5.233523067078759587e-33 -5.672495644084359252e-03 1.328845589686397400e-33 -2.176130677677727609e-35 -4.580069517414722159e-03 1.503785572341477963e-33 -3.816486951666632537e-34 -3.585733154740905222e-03 5.585033999733046451e-33 2.374901702517955987e-32 -2.684713382523221895e-03 -2.247294735251245164e-32 1.693095957784343629e-33 -1.871636065657945967e-03 -1.258099185939569056e-35 3.552886551768134949e-33 -1.140775523399708679e-03 -1.057347131215684707e-33 2.137839695420103116e-33 -4.842435682554318372e-04 1.161280181184095254e-34 1.039971692650867576e-33 1.119323573328583152e-04 -7.765458341713399787e-33 1.163327806531134959e-32 6.528000019293365031e-04 -1.345281257200419890e-32 -1.162514922384895981e-32 1.141894984960377217e-03 -2.271225877154838061e-33 2.182707160412247852e-32 1.582625513495812758e-03 1.519796386896772351e-32 -1.779543582797102153e-32 1.978230732617202673e-03 4.437464367616908315e-32 -1.653144583875621915e-32 2.331750625361230303e-03 -2.537583025027992611e-32 3.834641038867126558e-34 2.646005493915771015e-03 -7.335786731453534159e-32 1.067786470441445521e-32 2.923576025638687566e-03 6.997649623631846345e-34 -2.041560424246895454e-33 3.164506702616855412e-03 1.693063388322277934e-33 8.253148751463969105e-33 3.367940257553658778e-03 3.318442495156327830e-33 2.753110071300010349e-33 3.537532214964285871e-03 -4.765168369280247943e-33 -8.529065203080492639e-34 3.676707819580757840e-03 -2.303899171572938198e-33 -2.753640792485927969e-32 3.788361396662062210e-03 4.789130473037411658e-34 -1.922155322081634885e-34 3.874873947815511439e-03 -1.068994561995716177e-32 -3.219181245466976190e-33 3.938129203028682690e-03 -5.414126743061319719e-34 -4.470025210314790508e-34 3.979527298419899099e-03 5.401325912133581821e-34 1.836432394629107871e-33 3.999995488184198041e-03 2.991771276139138977e-33 -2.476738205291551856e-34 7.186542654010139890e-32 5.511521610893899137e-01 7.375498813085575161e-32 -1.213684258199182118e-33 5.511521610893899137e-01 -8.272286034813847021e-36 1.244596995661276363e-31 5.511521610893899137e-01 -4.645761386030501723e-32 -2.087992992792915651e-32 5.511521610893899137e-01 -1.525890740551217365e-31 -4.460480003079173007e-31 5.511521610893899137e-01 -6.364509604051161469e-31 -5.639353396631397563e-31 5.511521610893899137e-01 -5.267743907574309209e-31 -2.189480928175688640e-33 5.511521610893899137e-01 -3.608619759140272951e-31 -1.584327791517241873e-32 5.511521610893899137e-01 2.350448134052349784e-32 4.173696107403246719e-31 5.511521610893899137e-01 4.087365953498534383e-32 8.250043336339598356e-33 5.511521610893899137e-01 5.607498410558167040e-32 1.325657781777226577e-31 5.511521610893899137e-01 1.029393762699179707e-31 -7.201034342071760486e-32 5.511521610893899137e-01 -7.335191642943090101e-33 -3.045699438262729040e-31 5.511521610893899137e-01 2.061863713553203280e-32 1.598646754024827250e-31 5.511521610893899137e-01 -2.527508507457796887e-32 5.877695377250037967e-32 5.511521610893899137e-01 -2.956074415232851600e-32 4.785335463493405947e-32 5.511521610893899137e-01 -4.054527244633425411e-32 -3.717161035784631260e-32 5.511521610893899137e-01 -1.841190115371379237e-32 -4.773168640395984564e-31 5.511521610893899137e-01 9.086881186520693920e-33 -8.804626882755259802e-33 5.511521610893899137e-01 -2.611642102858723248e-32 5.851738340679510622e-31 5.511521610893899137e-01 -2.392091115194412587e-33 -4.312376629269142029e-32 5.511521610893899137e-01 -5.124866483382541518e-33 4.964972510955454857e-32 5.511521610893899137e-01 -2.822608425174638128e-33 -2.452733776768732580e-32 5.511521610893899137e-01 -3.937328338794265109e-34 1.541488543426084813e-32 5.511521610893899137e-01 -9.854212492071863451e-35 1.910162887349980249e-32 5.511521610893899137e-01 -3.676796705212713091e-34 -8.178224631464165513e-33 5.511521610893899137e-01 -2.864370589056947016e-35 -2.807664107056711941e-33 5.511521610893899137e-01 1.079476628716805687e-36 3.467920591293596858e-32 5.511521610893899137e-01 -5.282435735143124604e-35 3.053024431578994055e-33 5.511521610893899137e-01 8.322677113748318996e-36 8.201728049331568593e-34 5.511521610893899137e-01 -1.403648611406368769e-36 -2.867127436010369084e-33 5.511521610893899137e-01 2.293290744152356518e-35 1.175779569425675511e-32 5.511521610893899137e-01 2.368845860874853977e-36 1.213360347696233966e-32 5.511521610893899137e-01 -3.907747851017218974e-35 -6.392130789727320208e-33 5.511521610893899137e-01 3.477580932090751575e-35 -2.067960857596216102e-33 5.511521610893899137e-01 -9.358698069952256031e-36 9.553355987303608217e-33 5.511521610893899137e-01 -2.808092664944338853e-36 6.984727551396627871e-34 5.511521610893899137e-01 -9.901252986523509488e-36 3.566129554394723763e-33 5.511521610893899137e-01 -1.601157296717469955e-35 1.280325088873296754e-33 5.511521610893899137e-01 -1.591880489703040532e-36 -2.181899047452207293e-32 5.511521610893899137e-01 3.856754900133666074e-35 1.328845589686397400e-33 5.511521610893899137e-01 1.088088186796546475e-35 1.503785572341477963e-33 5.511521610893899137e-01 2.809006259237977320e-35 5.585033999733046451e-33 5.511521610893899137e-01 6.576658607155353788e-35 -2.247294735251245164e-32 5.511521610893899137e-01 1.127123287379117144e-35 -1.258099185939569056e-35 5.511521610893899137e-01 4.214765391998244750e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -9.542231530344836445e-37 1.161280181184095254e-34 5.511521610893899137e-01 2.662515279297182688e-37 -7.765458341713399787e-33 5.511521610893899137e-01 2.845542920351362250e-35 -1.345281257200419890e-32 5.511521610893899137e-01 3.157711679438059934e-35 -2.271225877154838061e-33 5.511521610893899137e-01 6.954581489809369995e-35 1.519796386896772351e-32 5.511521610893899137e-01 6.773543025730291336e-35 4.437464367616908315e-32 5.511521610893899137e-01 1.253048372883305449e-34 -2.537583025027992611e-32 5.511521610893899137e-01 1.039975329884152657e-34 -7.335786731453534159e-32 5.511521610893899137e-01 1.680674174095080494e-34 6.997649623631846345e-34 5.511521610893899137e-01 7.110698947443247607e-35 1.693063388322277934e-33 5.511521610893899137e-01 1.043360195983289936e-34 3.318442495156327830e-33 5.511521610893899137e-01 7.619196683124056831e-35 -4.765168369280247943e-33 5.511521610893899137e-01 3.787149463010952633e-35 -2.303899171572938198e-33 5.511521610893899137e-01 5.508198811764115733e-35 4.789130473037411658e-34 5.511521610893899137e-01 6.646139580992910234e-36 -1.068994561995716177e-32 5.511521610893899137e-01 1.214399063642611036e-35 -5.414126743061319719e-34 5.511521610893899137e-01 2.239305191503285967e-36 5.401325912133581821e-34 5.511521610893899137e-01 -1.742649129219119721e-37 2.991771276139138977e-33 5.511521610893899137e-01 9.498153568094589724e-37 -3.087951667916717484e-32 6.712073531238204478e-32 5.511521610893899137e-01 -3.728381140245989968e-31 -6.642525104508523420e-33 5.511521610893899137e-01 8.602325660804059089e-31 -5.309186667877872954e-32 5.511521610893899137e-01 8.946999429181815743e-34 -1.592233268735954543e-31 5.511521610893899137e-01 2.488065541890253012e-33 -6.430852132235898647e-31 5.511521610893899137e-01 -3.883274034149998349e-32 -5.334086435759046387e-31 5.511521610893899137e-01 -2.072726182018415883e-31 -3.674962287325010129e-31 5.511521610893899137e-01 -8.015054378889686537e-33 1.687022852204978827e-32 5.511521610893899137e-01 -3.739286663231091606e-31 3.423940671651163152e-32 5.511521610893899137e-01 -1.637762504560468589e-32 4.944073128710795261e-32 5.511521610893899137e-01 -1.024616453300777401e-31 9.630512345144425289e-32 5.511521610893899137e-01 -3.423592817219442872e-32 -1.396944446141680104e-32 5.511521610893899137e-01 1.378729573303645284e-31 1.398438431705832596e-32 5.511521610893899137e-01 -2.739106803292798204e-31 -3.190933789305167571e-32 5.511521610893899137e-01 -1.422649841052083157e-30 -3.619499697080222284e-32 5.511521610893899137e-01 -6.211065456485531337e-32 -4.717952526480795000e-32 5.511521610893899137e-01 -5.941014464402095621e-33 -2.504615397218749921e-32 5.511521610893899137e-01 8.233692167385567721e-33 2.452628368046984347e-33 5.511521610893899137e-01 -2.044450833364208714e-32 -3.275067384706094479e-32 5.511521610893899137e-01 4.161269354804123170e-33 -9.026343933668122502e-33 5.511521610893899137e-01 7.384699519880633653e-34 -1.175911930185625041e-32 5.511521610893899137e-01 3.826778270568354555e-32 -9.456861243648348385e-33 5.511521610893899137e-01 -2.046108960648619085e-32 -7.027985652353137281e-33 5.511521610893899137e-01 4.819037385987356555e-33 -6.732794943394429127e-33 5.511521610893899137e-01 6.802518210044378673e-32 -7.001932488994980241e-33 5.511521610893899137e-01 2.093696177985284751e-32 -6.662896524364280337e-33 5.511521610893899137e-01 -2.610260701230273283e-32 -6.633173341844992805e-33 5.511521610893899137e-01 -7.745957479682096357e-33 -6.687077175825141172e-33 5.511521610893899137e-01 -2.359966314515394046e-34 -6.625930141359962350e-33 5.511521610893899137e-01 6.198001694690810088e-33 -6.635656467085117545e-33 5.511521610893899137e-01 -8.883432323215349447e-34 -6.611319911032185144e-33 5.511521610893899137e-01 -1.834351620456271303e-33 -6.631883972612834125e-33 5.511521610893899137e-01 -1.550654545379245638e-32 -6.673330296983881880e-33 5.511521610893899137e-01 -9.760997463235280629e-34 -6.599477009152801790e-33 5.511521610893899137e-01 -1.832145783597374523e-33 -6.643611516543662662e-33 5.511521610893899137e-01 -1.371131432061721193e-32 -6.637060911138651825e-33 5.511521610893899137e-01 -5.504532811563710908e-36 -6.644154071460231987e-33 5.511521610893899137e-01 -6.954293198329056395e-34 -6.650264391440884925e-33 5.511521610893899137e-01 9.113932389212317506e-34 -6.635844698963413904e-33 5.511521610893899137e-01 -5.233523067078759587e-33 -6.595685269472372474e-33 5.511521610893899137e-01 -2.176130677677727609e-35 -6.623371936605743876e-33 5.511521610893899137e-01 -3.816486951666632537e-34 -6.606162755881328832e-33 5.511521610893899137e-01 2.374901702517955987e-32 -6.568486232402154153e-33 5.511521610893899137e-01 1.693095957784343629e-33 -6.622981585599918193e-33 5.511521610893899137e-01 3.552886551768134949e-33 -6.630038053081710685e-33 5.511521610893899137e-01 2.137839695420103116e-33 -6.635207041626746140e-33 5.511521610893899137e-01 1.039971692650867576e-33 -6.633986566945780633e-33 5.511521610893899137e-01 1.163327806531134959e-32 -6.605797389270196464e-33 5.511521610893899137e-01 -1.162514922384895981e-32 -6.602675701679329246e-33 5.511521610893899137e-01 2.182707160412247852e-32 -6.564707003575615766e-33 5.511521610893899137e-01 -1.779543582797102153e-32 -6.566517388216407611e-33 5.511521610893899137e-01 -1.653144583875621915e-32 -6.508947981185377296e-33 5.511521610893899137e-01 3.834641038867126558e-34 -6.530255285485295334e-33 5.511521610893899137e-01 1.067786470441445521e-32 -6.466185401064200369e-33 5.511521610893899137e-01 -2.041560424246895454e-33 -6.563145828999277332e-33 5.511521610893899137e-01 8.253148751463969105e-33 -6.529916798875381264e-33 5.511521610893899137e-01 2.753110071300010349e-33 -6.558060851642467593e-33 5.511521610893899137e-01 -8.529065203080492639e-34 -6.596381323843599753e-33 5.511521610893899137e-01 -2.753640792485927969e-32 -6.579170830356066972e-33 5.511521610893899137e-01 -1.922155322081634885e-34 -6.627606678892715882e-33 5.511521610893899137e-01 -3.219181245466976190e-33 -6.622108827837283404e-33 5.511521610893899137e-01 -4.470025210314790508e-34 -6.632013513282207412e-33 5.511521610893899137e-01 1.836432394629107871e-33 -6.634427083386631005e-33 5.511521610893899137e-01 -2.476738205291551856e-34 -6.633303003116899471e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 new file mode 100644 index 000000000..7d06dc3d5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 @@ -0,0 +1 @@ +1.366656204287944494e-02 -7.134396634783323020e-32 -3.082174183584375122e-32 1.362186544593194625e-02 -6.067083750118049606e-31 5.610249228415866741e-33 1.353203334782232710e-02 -1.727618346397392621e-31 1.169325503883179940e-31 1.339618449607281325e-02 -3.103131708271034733e-31 8.946999429181815743e-34 1.321298848584204384e-02 1.129855520581791966e-31 2.820532177678916025e-31 1.298065577262019418e-02 -2.790333036934926304e-32 4.971992689522905098e-31 1.269692479289768333e-02 -6.597947278284737488e-32 4.788734921684516211e-32 1.235904663169389711e-02 -1.584327791517241873e-32 -7.870495053445142477e-33 1.196376786944822364e-02 -3.779407166869359818e-32 5.362704472460096848e-31 1.150731249622270053e-02 -2.050689120027880383e-31 -4.432411506951335326e-31 1.098536411592599543e-02 -6.689302491318191992e-32 -1.025601678309870529e-31 1.039305009707647970e-02 -7.218146662672772501e-32 3.374436752817847984e-31 9.724929881292360481e-03 3.869074434684825398e-31 8.294983175305971813e-31 8.974990358939317903e-03 -1.610855152810925171e-31 -3.313425548220183770e-32 8.136652084122550366e-03 5.877695377250037967e-32 3.638070269668059723e-31 7.202791145188095108e-03 4.794771755004121993e-32 1.449687626378026625e-31 6.165782738796785761e-03 -3.749616793116807751e-32 -5.941014464402095621e-33 5.017573903638333430e-03 -2.357519448523084983e-33 -5.113622590649885233e-32 3.749794412630991745e-03 -9.045619219375382885e-33 -2.044450833364208714e-32 2.353916413163103724e-03 5.847568746124586351e-31 4.057029490931012965e-33 8.214748930341094326e-04 -4.312376629269142029e-32 9.632701754114679024e-32 -8.402774866193213951e-04 -1.289132988155838495e-31 -5.097424163549574368e-32 -2.480909828515546860e-03 1.726233106828446219e-32 -2.049574107318268537e-32 -4.032243643174837633e-03 -2.387839061666339472e-32 4.819037385987356555e-33 -5.458098280921646825e-03 -1.801871852518050478e-32 -6.161004110428305843e-33 -6.720841420782373322e-03 3.575776222943790526e-32 -4.873442585609033859e-33 -7.782615217065468570e-03 -2.807664107056711941e-33 -1.021397376464776842e-33 -8.643586781484651274e-03 2.696027718034976488e-33 2.523697882540244466e-34 -9.404594565655547203e-03 3.046011347085767552e-33 -2.348277840360016398e-34 -1.006197496239105704e-02 8.201728049331568593e-34 1.563061441766223904e-33 -1.059251380753890338e-02 4.328350675908840005e-33 3.383235075161206022e-33 -1.089128701943809646e-02 -1.629880907234313314e-32 5.179799571193700419e-33 -1.092418393387812985e-02 -1.613789757140296833e-33 1.676760319096942015e-33 -1.069747082267891863e-02 -6.393946079633119551e-33 -9.760997463235280629e-34 -1.035048151228093113e-02 1.132544628211893051e-32 -8.530627082037335142e-33 -9.926118505544180570e-03 -3.764476433431380250e-33 6.268069765449794993e-33 -9.428761505219072220e-03 4.023148814668792818e-33 -5.504532811563710908e-36 -8.831330829500057267e-03 2.315748896178288668e-34 -6.954293198329056395e-34 -8.060102586323350526e-03 1.280325088873296754e-33 4.264900127547336508e-33 -7.127649161729271259e-03 5.312829288668759311e-33 1.553076664122386063e-33 -6.053502510666505278e-03 -1.242448515637765078e-32 1.373531694085295612e-32 -4.936383560452298203e-03 1.519290395529507966e-33 -3.797105922681595032e-34 -3.915422786098209096e-03 -2.293359984263769448e-32 -8.339482539759772360e-33 -2.989002605908963779e-03 -6.194287405139876844e-34 8.976200486547350384e-33 -2.151952979644487871e-03 -1.491023783572859234e-32 -3.902545441462505406e-33 -1.398677945971083664e-03 -1.057347131215684707e-33 2.133219758989594520e-33 -7.231344251934140660e-04 1.112717363552454929e-34 1.049684256177195556e-33 -1.120482336051193610e-04 -7.762903400619211630e-33 -4.429636593851766123e-33 4.426311403696781455e-04 1.950375715720784912e-32 4.850446186723344192e-33 9.444386677854262665e-04 -3.607962426292981500e-32 -1.419740505955672579e-33 1.396797706083545334e-03 1.518605591542135630e-32 -4.634094412326768154e-34 1.802974003988769974e-03 8.850310428880039942e-33 1.236975068910711962e-33 2.166041961975671056e-03 4.739728080661090458e-32 -1.891515429085440035e-33 2.488860863964215565e-03 3.832387832545956486e-32 1.372196332297391898e-33 2.774059100680896506e-03 7.069270408367962226e-34 2.712269162612777641e-33 3.023831589871018612e-03 1.685611295414068567e-33 -1.443887145343645982e-33 3.236652322032071601e-03 3.318442495156327830e-33 2.751178205633955512e-33 3.414210091042861606e-03 -2.484230417819268789e-32 -5.872190472536159764e-33 3.560027372072252679e-03 -2.303899171572938198e-33 3.008362282509692558e-33 3.677083403352577728e-03 4.810165638519463323e-34 -1.480619417983821228e-33 3.767830852629893562e-03 -2.840416255057275705e-34 1.984307027990159558e-33 3.834211282497319070e-03 -5.425012652783054140e-34 -4.470025210314790508e-34 3.877668460402704156e-03 1.857608603829714966e-33 -1.391631554808255105e-34 3.899158852862925038e-03 3.510474733419086596e-34 1.073102463723753950e-33 -7.134396634783323020e-32 5.511521610893899137e-01 7.370016823031501213e-32 -6.067083750118049606e-31 5.511521610893899137e-01 -1.033570866496180417e-33 -1.727618346397392621e-31 5.511521610893899137e-01 -4.581079108938876922e-32 -3.103131708271034733e-31 5.511521610893899137e-01 -1.536891070292911140e-31 1.129855520581791966e-31 5.511521610893899137e-01 -6.378134763139433223e-31 -2.790333036934926304e-32 5.511521610893899137e-01 -5.259685002585957695e-31 -6.597947278284737488e-32 5.511521610893899137e-01 -3.604605966067142658e-31 -1.584327791517241873e-32 5.511521610893899137e-01 2.256913192660706707e-32 -3.779407166869359818e-32 5.511521610893899137e-01 4.536898972670131666e-32 -2.050689120027880383e-31 5.511521610893899137e-01 5.964373176752747428e-32 -6.689302491318191992e-32 5.511521610893899137e-01 1.041649657761887850e-31 -7.218146662672772501e-32 5.511521610893899137e-01 -9.986639242867064905e-33 3.869074434684825398e-31 5.511521610893899137e-01 1.315194024202498009e-32 -1.610855152810925171e-31 5.511521610893899137e-01 -2.598415110504300076e-32 5.877695377250037967e-32 5.511521610893899137e-01 -3.563475423867367713e-32 4.794771755004121993e-32 5.511521610893899137e-01 -3.987871963990209838e-32 -3.749616793116807751e-32 5.511521610893899137e-01 -1.631194856726785084e-32 -2.357519448523084983e-33 5.511521610893899137e-01 7.418572790703306352e-33 -9.045619219375382885e-33 5.511521610893899137e-01 -2.391727801339516591e-32 5.847568746124586351e-31 5.511521610893899137e-01 -4.412523942666233873e-33 -4.312376629269142029e-32 5.511521610893899137e-01 -6.667175226338521208e-33 -1.289132988155838495e-31 5.511521610893899137e-01 -3.291857349116958804e-33 1.726233106828446219e-32 5.511521610893899137e-01 -5.585078699606674583e-34 -2.387839061666339472e-32 5.511521610893899137e-01 -1.182380714925217371e-34 -1.801871852518050478e-32 5.511521610893899137e-01 -3.887087285125440967e-34 3.575776222943790526e-32 5.511521610893899137e-01 -2.850461829078481743e-35 -2.807664107056711941e-33 5.511521610893899137e-01 -2.297822025990920700e-36 2.696027718034976488e-33 5.511521610893899137e-01 -5.506193210357685293e-35 3.046011347085767552e-33 5.511521610893899137e-01 8.964841219305158069e-36 8.201728049331568593e-34 5.511521610893899137e-01 -1.691139770251809627e-36 4.328350675908840005e-33 5.511521610893899137e-01 2.291445874382083696e-35 -1.629880907234313314e-32 5.511521610893899137e-01 1.983106821098385622e-36 -1.613789757140296833e-33 5.511521610893899137e-01 -3.890224275207955705e-35 -6.393946079633119551e-33 5.511521610893899137e-01 3.655242548207661351e-35 1.132544628211893051e-32 5.511521610893899137e-01 -1.052669591122636099e-35 -3.764476433431380250e-33 5.511521610893899137e-01 -2.259013236163149729e-36 4.023148814668792818e-33 5.511521610893899137e-01 -9.424867616837694123e-36 2.315748896178288668e-34 5.511521610893899137e-01 -1.653041701351388162e-35 1.280325088873296754e-33 5.511521610893899137e-01 -2.847933196720749754e-36 5.312829288668759311e-33 5.511521610893899137e-01 4.250788261074215558e-35 -1.242448515637765078e-32 5.511521610893899137e-01 1.307325185307763392e-35 1.519290395529507966e-33 5.511521610893899137e-01 3.043362934883631937e-35 -2.293359984263769448e-32 5.511521610893899137e-01 6.894800633473725781e-35 -6.194287405139876844e-34 5.511521610893899137e-01 1.297815138512067451e-35 -1.491023783572859234e-32 5.511521610893899137e-01 5.899594093370364673e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -2.505197991359449957e-36 1.112717363552454929e-34 5.511521610893899137e-01 -2.413852691743081970e-36 -7.762903400619211630e-33 5.511521610893899137e-01 3.011548806622389126e-35 1.950375715720784912e-32 5.511521610893899137e-01 3.791615587189680817e-35 -3.607962426292981500e-32 5.511521610893899137e-01 6.781707084506897065e-35 1.518605591542135630e-32 5.511521610893899137e-01 7.841859765923091749e-35 8.850310428880039942e-33 5.511521610893899137e-01 1.338168091979084000e-34 4.739728080661090458e-32 5.511521610893899137e-01 1.059670699522753937e-34 3.832387832545956486e-32 5.511521610893899137e-01 1.775916361844911737e-34 7.069270408367962226e-34 5.511521610893899137e-01 7.499044862713147347e-35 1.685611295414068567e-33 5.511521610893899137e-01 1.076798281036403395e-34 3.318442495156327830e-33 5.511521610893899137e-01 7.810114542282848248e-35 -2.484230417819268789e-32 5.511521610893899137e-01 4.011938740915588208e-35 -2.303899171572938198e-33 5.511521610893899137e-01 5.652826861667762090e-35 4.810165638519463323e-34 5.511521610893899137e-01 6.469262542570828636e-36 -2.840416255057275705e-34 5.511521610893899137e-01 1.256296601907252874e-35 -5.425012652783054140e-34 5.511521610893899137e-01 2.154077987855468232e-36 1.857608603829714966e-33 5.511521610893899137e-01 -1.808882583567832794e-37 3.510474733419086596e-34 5.511521610893899137e-01 9.771028344076606593e-37 -3.082174183584375122e-32 6.706591541184130530e-32 5.511521610893899137e-01 5.610249228415866741e-33 -7.667823684969890161e-33 5.511521610893899137e-01 1.169325503883179940e-31 -5.244504390786248153e-32 5.511521610893899137e-01 8.946999429181815743e-34 -1.603233598477648317e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.444477291324170401e-31 5.511521610893899137e-01 4.971992689522905098e-31 -5.326027530770694872e-31 5.511521610893899137e-01 4.788734921684516211e-32 -3.670948494251879836e-31 5.511521610893899137e-01 -7.870495053445142477e-33 1.593487910813335750e-32 5.511521610893899137e-01 5.362704472460096848e-31 3.873473690822760435e-32 5.511521610893899137e-01 -4.432411506951335326e-31 5.300947894905375650e-32 5.511521610893899137e-01 -1.025601678309870529e-31 9.753071295771505624e-32 5.511521610893899137e-01 3.374436752817847984e-31 -1.662089206134077721e-32 5.511521610893899137e-01 8.294983175305971813e-31 6.517687423551273252e-33 5.511521610893899137e-01 -3.313425548220183770e-32 -3.261840392351670760e-32 5.511521610893899137e-01 3.638070269668059723e-31 -4.226900705714738397e-32 5.511521610893899137e-01 1.449687626378026625e-31 -4.651297245837579426e-32 5.511521610893899137e-01 -5.941014464402095621e-33 -2.294620138574155767e-32 5.511521610893899137e-01 -5.113622590649885233e-32 7.843199722295974632e-34 5.511521610893899137e-01 -2.044450833364208714e-32 -3.055153083186887822e-32 5.511521610893899137e-01 4.057029490931012965e-33 -1.104677676113994345e-32 5.511521610893899137e-01 9.632701754114679024e-32 -1.330142804481222941e-32 5.511521610893899137e-01 -5.097424163549574368e-32 -9.926110167590669061e-33 5.511521610893899137e-01 -2.049574107318268537e-32 -7.192760688434378058e-33 5.511521610893899137e-01 4.819037385987356555e-33 -6.752490889966232080e-33 5.511521610893899137e-01 -6.161004110428305843e-33 -7.022961546986253242e-33 5.511521610893899137e-01 -4.873442585609033859e-33 -6.662757436764495475e-33 5.511521610893899137e-01 -1.021397376464776842e-33 -6.636550640499699985e-33 5.511521610893899137e-01 2.523697882540244466e-34 -6.689314750577287399e-33 5.511521610893899137e-01 -2.348277840360016398e-34 -6.625287977254405822e-33 5.511521610893899137e-01 1.563061441766223904e-33 -6.635943958243962459e-33 5.511521610893899137e-01 3.383235075161206022e-33 -6.611338359729888447e-33 5.511521610893899137e-01 5.179799571193700419e-33 -6.632269711652610758e-33 5.511521610893899137e-01 1.676760319096942015e-33 -6.673155061225788772e-33 5.511521610893899137e-01 -9.760997463235280629e-34 -6.597700392991632131e-33 5.511521610893899137e-01 -8.530627082037335142e-33 -6.644779514384937407e-33 5.511521610893899137e-01 6.268069765449794993e-33 -6.636511831709870927e-33 5.511521610893899137e-01 -5.504532811563710908e-36 -6.643677686090546381e-33 5.511521610893899137e-01 -6.954293198329056395e-34 -6.650783235487224035e-33 5.511521610893899137e-01 4.264900127547336508e-33 -6.637100751670431412e-33 5.511521610893899137e-01 1.553076664122386063e-33 -6.591744935862967059e-33 5.511521610893899137e-01 1.373531694085295612e-32 -6.621179566620632091e-33 5.511521610893899137e-01 -3.797105922681595032e-34 -6.603819189124871955e-33 5.511521610893899137e-01 -8.339482539759772360e-33 -6.565304812138970925e-33 5.511521610893899137e-01 8.976200486547350384e-33 -6.621274667088589029e-33 5.511521610893899137e-01 -3.902545441462505406e-33 -6.628353224380338190e-33 5.511521610893899137e-01 2.133219758989594520e-33 -6.636758016465070442e-33 5.511521610893899137e-01 1.049684256177195556e-33 -6.636666671165453940e-33 5.511521610893899137e-01 -4.429636593851766123e-33 -6.604137330407486697e-33 5.511521610893899137e-01 4.850446186723344192e-33 -6.596336662601813390e-33 5.511521610893899137e-01 -1.419740505955672579e-33 -6.566435747628640698e-33 5.511521610893899137e-01 -4.634094412326768154e-34 -6.555834220814479543e-33 5.511521610893899137e-01 1.236975068910711962e-33 -6.500436009275799911e-33 5.511521610893899137e-01 -1.891515429085440035e-33 -6.528285748521434735e-33 5.511521610893899137e-01 1.372196332297391898e-33 -6.456661182289216945e-33 5.511521610893899137e-01 2.712269162612777641e-33 -6.559262369846577832e-33 5.511521610893899137e-01 -1.443887145343645982e-33 -6.526572990370069597e-33 5.511521610893899137e-01 2.751178205633955512e-33 -6.556151673050880257e-33 5.511521610893899137e-01 -5.872190472536159764e-33 -6.594133431064553782e-33 5.511521610893899137e-01 3.008362282509692558e-33 -6.577724549857030199e-33 5.511521610893899137e-01 -1.480619417983821228e-33 -6.627783555931137886e-33 5.511521610893899137e-01 1.984307027990159558e-33 -6.621689852454636357e-33 5.511521610893899137e-01 -4.470025210314790508e-34 -6.632098740485854942e-33 5.511521610893899137e-01 -1.391631554808255105e-34 -6.634433706732066100e-33 5.511521610893899137e-01 1.073102463723753950e-33 -6.633275715639301544e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 new file mode 100644 index 000000000..ed9f8aacf --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 @@ -0,0 +1 @@ +1.372662556860645804e-02 -4.234909387065355032e-31 -3.082174183584375122e-32 1.368250134313573826e-02 -1.407929672620088487e-31 5.610249228415866741e-33 1.359382013840655830e-02 2.861196083528416018e-31 -1.124918802302745697e-31 1.345971303480244206e-02 1.383532944120539956e-31 3.373634044557071413e-31 1.327886820249941403e-02 1.129855520581791966e-31 2.820532177678916025e-31 1.304952099368350896e-02 -4.481514149333622327e-31 7.697851048780055403e-32 1.276944115022624407e-02 3.369625855135215789e-31 4.509048083474762383e-31 1.243591754746156859e-02 -2.080690987759162558e-31 -3.923450099092570303e-31 1.204574108108417974e-02 -3.781469365794795584e-32 1.712199934653671199e-31 1.159518655059983520e-02 1.401549715765712816e-31 -4.432411506951335326e-31 1.107999471590855392e-02 -6.702407059519766207e-32 -1.404105881611290480e-30 1.049535612333133208e-02 -7.218146662672772501e-32 3.170856825897740560e-32 9.835898834547770336e-03 1.002110816481828714e-31 -3.069254157667034924e-32 9.095682869211127453e-03 -1.611747089090130951e-31 5.036329973438976555e-31 8.268205010134541469e-03 5.893294032328412785e-32 1.128636633934494789e-31 7.346418636668792732e-03 4.794771755004121993e-32 1.451049954974098503e-31 6.322774453786263529e-03 -3.761512147649702738e-32 -5.822060919073145761e-33 5.189289362048942617e-03 4.074331537174483756e-31 3.588103600076651278e-31 3.937652228804391918e-03 -9.045619219375382885e-33 -2.044450833364208714e-32 2.559376891769624216e-03 1.139805610010468293e-33 4.136866302066588700e-33 1.046014208814335890e-03 -9.724626417845067894e-34 -3.006537149215019376e-32 -6.043510931653036386e-04 -4.966723939998276002e-32 8.452527606403699121e-33 -2.254711724937969418e-03 3.595002152441394013e-32 1.687099333444658131e-32 -3.820385152401972045e-03 1.149081342034187561e-32 2.251041459490394407e-32 -5.265609391688706731e-03 -1.219030138328765601e-33 1.063868427642343334e-32 -6.553037895144557708e-03 -8.298043273236419417e-33 1.114754354353311293e-32 -7.644934929571492628e-03 1.254423573264168420e-32 -1.023729783003776976e-33 -8.526640699927411429e-03 -7.308974140610414607e-35 1.175363941442336983e-33 -9.300665657292591509e-03 3.046011347085767552e-33 -2.328085677093609735e-34 -9.973183030349818193e-03 8.201728049331568593e-34 1.564967207729202690e-33 -1.052706126070216547e-02 -7.521508965686632846e-33 3.383235075161206022e-33 -1.086379137781360964e-02 3.089444169687299439e-34 5.180236623088838582e-33 -1.093683476224183160e-02 -1.613789757140296833e-33 -1.598212667134254304e-33 -1.074324977006893382e-02 3.341517456861851002e-33 -9.763083127474642577e-34 -1.040895024457869772e-02 -4.827709811742814172e-33 -2.069364644492637814e-33 -9.997088006653720438e-03 -3.762822323726171175e-33 6.269723875155004067e-33 -9.511824858411019670e-03 -2.467564896535629111e-33 -4.873435510858590279e-33 -8.938714131281061057e-03 2.313626672360081871e-34 -7.241216464710521799e-33 -8.197001809551801230e-03 1.283806772546079155e-33 -2.362484743593903962e-33 -7.292134036912215934e-03 5.309232886795139008e-33 1.553076664122386063e-33 -6.243322654470531523e-03 1.316078844173357344e-33 -1.374581106024906013e-32 -5.121114702556004220e-03 1.519290395529507966e-33 -3.797105922681595032e-34 -4.087138538648990571e-03 -1.318839184499497256e-33 -1.133705469035395649e-33 -3.148241764250317085e-03 -6.194287405139876844e-34 8.976200486547350384e-33 -2.299363236033038181e-03 3.189479783564930644e-34 -9.524898794123405551e-35 -1.534979514310427264e-03 -1.057347131215684707e-33 -1.790883860662348888e-33 -8.493228634136516754e-04 1.122874913807457415e-33 5.095448502410753181e-33 -2.309330246805747560e-04 5.859510230768103454e-34 -2.557270013157968081e-34 3.305228359053031238e-04 -6.337803416602524376e-33 -3.761447862556045790e-33 8.385836893343564732e-04 3.501322500868305334e-32 -1.416611970078555386e-33 1.296676703495337583e-03 -1.230984062605623877e-32 8.699671279390421501e-33 1.708077397523512708e-03 8.857377119388985032e-33 1.236975068910711962e-33 2.075874114203437194e-03 8.508319913520023044e-33 -1.895260153292766982e-33 2.402942767493330967e-03 -1.661787723690776538e-33 1.372196332297391898e-33 2.691929803638716361e-03 4.175259252398907391e-32 2.712269162612777641e-33 2.945241577443824879e-03 1.685611295414068567e-33 -1.441696868575432563e-33 3.162904441581655159e-03 3.318442495156327830e-33 -1.875698974822404893e-32 3.344642580183998168e-03 1.904539912238210777e-32 -5.872786610858634141e-33 3.493956875720598786e-03 -2.463931921576500387e-32 3.008362282509692558e-33 3.613865762678063892e-03 4.810165638519463323e-34 -1.480619417983821228e-33 3.706855086025015022e-03 5.452570944226181775e-33 1.985611099954181230e-33 3.774893236395615841e-03 -5.425012652783054140e-34 -4.473346272288253629e-34 3.819444246570224705e-03 -1.055789363071097072e-33 1.339889204642479047e-34 3.841478154082504735e-03 -1.427032489764166980e-35 -3.879995418785415766e-34 -4.234909387065355032e-31 5.511521610893899137e-01 7.270275224928160318e-32 -1.407929672620088487e-31 5.511521610893899137e-01 8.187588626082599818e-34 2.861196083528416018e-31 5.511521610893899137e-01 -4.525887518784714309e-32 1.383532944120539956e-31 5.511521610893899137e-01 -1.538896994440143548e-31 1.129855520581791966e-31 5.511521610893899137e-01 -6.382529027475184607e-31 -4.481514149333622327e-31 5.511521610893899137e-01 -5.246733380363877111e-31 3.369625855135215789e-31 5.511521610893899137e-01 -3.597766919155931200e-31 -2.080690987759162558e-31 5.511521610893899137e-01 2.229545200799540252e-32 -3.781469365794795584e-32 5.511521610893899137e-01 4.580070477138157673e-32 1.401549715765712816e-31 5.511521610893899137e-01 5.900889209891985732e-32 -6.702407059519766207e-32 5.511521610893899137e-01 9.873819647000943499e-32 -7.218146662672772501e-32 5.511521610893899137e-01 -1.087026475338805773e-32 1.002110816481828714e-31 5.511521610893899137e-01 1.226785684485853119e-32 -1.611747089090130951e-31 5.511521610893899137e-01 -3.055706132796271869e-32 5.893294032328412785e-32 5.511521610893899137e-01 -3.751508003890474092e-32 4.794771755004121993e-32 5.511521610893899137e-01 -4.681874872402894436e-32 -3.761512147649702738e-32 5.511521610893899137e-01 -2.074476256557377878e-32 4.074331537174483756e-31 5.511521610893899137e-01 5.142306152042979811e-33 -9.045619219375382885e-33 5.511521610893899137e-01 -2.335850462108051587e-32 1.139805610010468293e-33 5.511521610893899137e-01 -4.317197814033340453e-33 -9.724626417845067894e-34 5.511521610893899137e-01 -6.699108621916015964e-33 -4.966723939998276002e-32 5.511521610893899137e-01 -3.306746331437724547e-33 3.595002152441394013e-32 5.511521610893899137e-01 -5.610237211043197337e-34 1.149081342034187561e-32 5.511521610893899137e-01 -1.185481832216937445e-34 -1.219030138328765601e-33 5.511521610893899137e-01 -3.836072691644952449e-34 -8.298043273236419417e-33 5.511521610893899137e-01 -2.808432812971475788e-35 1.254423573264168420e-32 5.511521610893899137e-01 1.438904298163230538e-36 -7.308974140610414607e-35 5.511521610893899137e-01 -5.506408367809550110e-35 3.046011347085767552e-33 5.511521610893899137e-01 1.146833615355744859e-35 8.201728049331568593e-34 5.511521610893899137e-01 6.757733677485679143e-38 -7.521508965686632846e-33 5.511521610893899137e-01 2.308600771301224795e-35 3.089444169687299439e-34 5.511521610893899137e-01 1.812977777053995821e-36 -1.613789757140296833e-33 5.511521610893899137e-01 -3.904013942332606856e-35 3.341517456861851002e-33 5.511521610893899137e-01 3.648912484725514879e-35 -4.827709811742814172e-33 5.511521610893899137e-01 -1.065941382022208925e-35 -3.762822323726171175e-33 5.511521610893899137e-01 -3.598852698914864518e-36 -2.467564896535629111e-33 5.511521610893899137e-01 -9.385774252057225130e-36 2.313626672360081871e-34 5.511521610893899137e-01 -1.643727554979938561e-35 1.283806772546079155e-33 5.511521610893899137e-01 -1.420508505100495152e-36 5.309232886795139008e-33 5.511521610893899137e-01 4.367926809114917680e-35 1.316078844173357344e-33 5.511521610893899137e-01 5.525607584683205437e-36 1.519290395529507966e-33 5.511521610893899137e-01 3.090417360262301682e-35 -1.318839184499497256e-33 5.511521610893899137e-01 6.863476749759568873e-35 -6.194287405139876844e-34 5.511521610893899137e-01 9.890703958695879778e-36 3.189479783564930644e-34 5.511521610893899137e-01 5.215191442010362092e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -2.857070070711378891e-36 1.122874913807457415e-33 5.511521610893899137e-01 -2.329212285125192115e-36 5.859510230768103454e-34 5.511521610893899137e-01 3.009782217765291258e-35 -6.337803416602524376e-33 5.511521610893899137e-01 3.693426710451537334e-35 3.501322500868305334e-32 5.511521610893899137e-01 6.581809406505216634e-35 -1.230984062605623877e-32 5.511521610893899137e-01 7.650381101582838797e-35 8.857377119388985032e-33 5.511521610893899137e-01 1.284073521696871404e-34 8.508319913520023044e-33 5.511521610893899137e-01 1.016506807592022085e-34 -1.661787723690776538e-33 5.511521610893899137e-01 1.741240377890612296e-34 4.175259252398907391e-32 5.511521610893899137e-01 7.191170016566425111e-35 1.685611295414068567e-33 5.511521610893899137e-01 1.038236939594640267e-34 3.318442495156327830e-33 5.511521610893899137e-01 7.504580932864171131e-35 1.904539912238210777e-32 5.511521610893899137e-01 3.940389510467470156e-35 -2.463931921576500387e-32 5.511521610893899137e-01 5.513970573065718098e-35 4.810165638519463323e-34 5.511521610893899137e-01 5.818126286040120663e-36 5.452570944226181775e-33 5.511521610893899137e-01 1.225354253067425628e-35 -5.425012652783054140e-34 5.511521610893899137e-01 1.993086446614312619e-36 -1.055789363071097072e-33 5.511521610893899137e-01 -1.820987456794831188e-37 -1.427032489764166980e-35 5.511521610893899137e-01 9.827998333934936987e-37 -3.082174183584375122e-32 6.606849943080789634e-32 5.511521610893899137e-01 5.610249228415866741e-33 -5.815493955865449420e-33 5.511521610893899137e-01 -1.124918802302745697e-31 -5.189312800632085540e-32 5.511521610893899137e-01 3.373634044557071413e-31 -1.605239522624880726e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.448871555659921784e-31 5.511521610893899137e-01 7.697851048780055403e-32 -5.313075908548614289e-31 5.511521610893899137e-01 4.509048083474762383e-31 -3.664109447340668378e-31 5.511521610893899137e-01 -3.923450099092570303e-31 1.566119918952169294e-32 5.511521610893899137e-01 1.712199934653671199e-31 3.916645195290786442e-32 5.511521610893899137e-01 -4.432411506951335326e-31 5.237463928044613954e-32 5.511521610893899137e-01 -1.404105881611290480e-30 9.210394365153570626e-32 5.511521610893899137e-01 3.170856825897740560e-32 -1.750451757186176867e-32 5.511521610893899137e-01 -3.069254157667034924e-32 5.633604026384823671e-33 5.511521610893899137e-01 5.036329973438976555e-31 -3.719131414643642552e-32 5.511521610893899137e-01 1.128636633934494789e-31 -4.414933285737844775e-32 5.511521610893899137e-01 1.451049954974098503e-31 -5.345300154250263478e-32 5.511521610893899137e-01 -5.822060919073145761e-33 -2.737901538404748288e-32 5.511521610893899137e-01 3.588103600076651278e-31 -1.491946666430729078e-33 5.511521610893899137e-01 -2.044450833364208714e-32 -2.999275743955423092e-32 5.511521610893899137e-01 4.136866302066588700e-33 -1.095145063250705003e-32 5.511521610893899137e-01 -3.006537149215019376e-32 -1.333336144038972417e-32 5.511521610893899137e-01 8.452527606403699121e-33 -9.940999149911434804e-33 5.511521610893899137e-01 1.687099333444658131e-32 -7.195276539578029905e-33 5.511521610893899137e-01 2.251041459490394407e-32 -6.752801001695403809e-33 5.511521610893899137e-01 1.063868427642343334e-32 -7.017860087638204690e-33 5.511521610893899137e-01 1.114754354353311293e-32 -6.662337146603425389e-33 5.511521610893899137e-01 -1.023729783003776976e-33 -6.632813914175546366e-33 5.511521610893899137e-01 1.175363941442336983e-33 -6.689316902151806154e-33 5.511521610893899137e-01 -2.328085677093609735e-34 -6.622784482320153083e-33 5.511521610893899137e-01 1.564967207729202690e-33 -6.634185241136935342e-33 5.511521610893899137e-01 3.383235075161206022e-33 -6.611166810760696814e-33 5.511521610893899137e-01 5.180236623088838582e-33 -6.632439840696654862e-33 5.511521610893899137e-01 -1.598212667134254304e-33 -6.673292957897035791e-33 5.511521610893899137e-01 -9.763083127474642577e-34 -6.597763693626453831e-33 5.511521610893899137e-01 -2.069364644492637814e-33 -6.644912232293932868e-33 5.511521610893899137e-01 6.269723875155004067e-33 -6.637851671172622512e-33 5.511521610893899137e-01 -4.873435510858590279e-33 -6.643638592725765522e-33 5.511521610893899137e-01 -7.241216464710521799e-33 -6.650690094023509629e-33 5.511521610893899137e-01 -2.362484743593903962e-33 -6.635673326978810857e-33 5.511521610893899137e-01 1.553076664122386063e-33 -6.590573550382560385e-33 5.511521610893899137e-01 -1.374581106024906013e-32 -6.628727210889026751e-33 5.511521610893899137e-01 -3.797105922681595032e-34 -6.603348644871085193e-33 5.511521610893899137e-01 -1.133705469035395649e-33 -6.565618050976112473e-33 5.511521610893899137e-01 8.976200486547350384e-33 -6.624362114515013195e-33 5.511521610893899137e-01 -9.524898794123405551e-35 -6.629037627031698018e-33 5.511521610893899137e-01 -1.790883860662348888e-33 -6.637109888544422458e-33 5.511521610893899137e-01 5.095448502410753181e-33 -6.636582030758836324e-33 5.511521610893899137e-01 -2.557270013157968081e-34 -6.604154996296058093e-33 5.511521610893899137e-01 -3.761447862556045790e-33 -6.597318551369194285e-33 5.511521610893899137e-01 -1.416611970078555386e-33 -6.568434724408658176e-33 5.511521610893899137e-01 8.699671279390421501e-33 -6.557749007457881976e-33 5.511521610893899137e-01 1.236975068910711962e-33 -6.505845466304020807e-33 5.511521610893899137e-01 -1.895260153292766982e-33 -6.532602137714508006e-33 5.511521610893899137e-01 1.372196332297391898e-33 -6.460128780684646291e-33 5.511521610893899137e-01 2.712269162612777641e-33 -6.562341118308044819e-33 5.511521610893899137e-01 -1.441696868575432563e-33 -6.530429124514246401e-33 5.511521610893899137e-01 -1.875698974822404893e-32 -6.559207009145066910e-33 5.511521610893899137e-01 -5.872786610858634141e-33 -6.594848923369034342e-33 5.511521610893899137e-01 3.008362282509692558e-33 -6.579113112743050778e-33 5.511521610893899137e-01 -1.480619417983821228e-33 -6.628434692187669180e-33 5.511521610893899137e-01 1.985611099954181230e-33 -6.621999275943034141e-33 5.511521610893899137e-01 -4.473346272288253629e-34 -6.632259732027095841e-33 5.511521610893899137e-01 1.339889204642479047e-34 -6.634434917219388736e-33 5.511521610893899137e-01 -3.879995418785415766e-34 -6.633270018640315484e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 new file mode 100644 index 000000000..77afa96ca --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 @@ -0,0 +1 @@ +1.376153539822414125e-02 1.056572053411708736e-30 -3.089706694104596093e-32 1.371771874067423229e-02 -1.407929672620088487e-31 9.841555076915215953e-31 1.362965583224103917e-02 2.861196083528416018e-31 -4.735065036864974871e-31 1.349648408698318411e-02 1.383532944120539956e-31 -1.072245031109316571e-30 1.331690120491006539e-02 1.129855520581791966e-31 2.820532177678916025e-31 1.308915529338566808e-02 1.304571662274165895e-30 7.703793087215175515e-32 1.281103210298752647e-02 1.273864151648280798e-31 -1.225432765866856368e-30 1.247983978790464382e-02 5.891221791515320429e-31 4.048954469989395565e-31 1.209239178394603924e-02 1.508262249064671188e-31 9.259158617794845230e-31 1.164498863778779848e-02 -2.600040316987390054e-31 2.681439315858539969e-31 1.113339993875827813e-02 -6.705862409057813296e-32 -7.358412809530782214e-31 1.055284791580756755e-02 -7.218146662672772501e-32 3.172372878130401271e-32 9.897994790505838109e-03 -4.849212657601411213e-31 -3.066605061563230693e-32 9.162936642735578299e-03 -7.072200397230972715e-31 -4.245847554647640982e-32 8.341207371036911053e-03 -6.833146068375930820e-32 -2.530290086683952901e-31 7.425797331886956759e-03 4.794771755004121993e-32 1.451746311837644250e-31 6.409192428869707296e-03 -3.416135975891769074e-32 -4.477826413217854899e-31 5.283440785996493076e-03 -4.591318890068548846e-33 -4.653436733850406960e-31 4.040255642725729818e-03 -3.935518474402755398e-31 -4.049507365545422975e-31 2.671164673781398474e-03 3.604818972714993136e-31 -1.755341795286778428e-31 1.167717425232247608e-03 -1.112553309623048587e-33 6.725940148946867568e-33 -4.752819860221025412e-04 -4.966723939998276002e-32 3.558442974227194544e-32 -2.131182547778113362e-03 3.592269302088208612e-32 -2.027527509122277384e-32 -3.704820192637029320e-03 1.147862556285061438e-32 4.969040700605396538e-33 -5.160633143686203968e-03 -1.219030138328765601e-33 -5.989755266244782525e-33 -6.461401920645526258e-03 2.336612098669552867e-32 -1.259933869812144593e-32 -7.569429850991874972e-03 -2.592374176610800348e-33 -1.021460426195793077e-33 -8.463712003197735451e-03 -7.343497010401240768e-33 1.175363941442336983e-33 -9.244752719779801911e-03 6.555183801820643839e-33 5.030889140448438035e-33 -9.925356252983805541e-03 8.201728049331568593e-34 -1.367925418140472112e-34 -1.049044673279584880e-02 -8.876342765771785636e-34 6.700390352524380566e-33 -1.084701569037775648e-02 -1.315522384718889510e-33 3.117170545009075190e-32 -1.094091849549633060e-02 2.397068745533150407e-32 -1.598212667134254304e-33 -1.076623543209026881e-02 -2.985391692556573700e-33 -9.759118898684279460e-34 -1.043840459690959128e-02 1.460260361624653853e-33 -2.069364644492637814e-33 -1.003287783168555457e-02 -3.762822323726171175e-33 -3.538542410027737786e-33 -9.553706342736978038e-03 -2.467957188392308838e-33 -4.873435510858590279e-33 -8.991673383280822385e-03 3.399461316088347515e-33 -9.054167447995112694e-34 -8.264881821631254316e-03 -5.119313660667677494e-33 -7.618061496609576647e-34 -7.373877414191088581e-03 5.309232886795139008e-33 1.454031419757997548e-32 -6.337721753416431826e-03 7.924389906101558650e-33 1.268397333874021806e-32 -5.215133945614696190e-03 1.519290395529507966e-33 -1.386613460702025583e-32 -4.174295426105380756e-03 -1.316954674429814789e-33 -1.129936448896030714e-33 -3.228847122567313037e-03 -6.194287405139876844e-34 8.976200486547350384e-33 -2.373779647915001938e-03 -6.934621631196062400e-33 -9.524898794123405551e-35 -1.603602846860630645e-03 -8.511377957091233964e-33 -1.790883860662348888e-33 -9.125689642349054569e-04 -2.708426640480811327e-33 -2.568318074600126537e-33 -2.902838837517120684e-04 1.635461650469419602e-32 -8.139444115300032462e-33 2.747128084758758003e-04 3.801892638184811442e-33 -3.620691122421625000e-32 7.860337466820190586e-04 -1.505273556122659470e-32 3.196069507652787441e-32 1.247109834000481457e-03 4.850923037098799644e-33 8.699671279390421501e-33 1.661223206794162173e-03 4.138613390563257201e-35 1.236975068910711962e-33 2.031470794755687974e-03 8.506697469932747659e-33 -3.809846635976320450e-32 2.360738314678715189e-03 -1.662640508486751633e-33 1.368785193113492206e-33 2.651682617558633395e-03 3.751386120459172216e-33 2.712269162612777641e-33 2.906720571183749827e-03 1.685611295414068567e-33 -1.443564609773584029e-33 3.126650349335033906e-03 -6.588091281964322131e-33 -1.875698974822404893e-32 3.310497562430973675e-03 8.959283902301096644e-33 3.447167426946541175e-32 3.461573308801950497e-03 6.097665807270917610e-33 3.007322623965728181e-33 3.582917146455113794e-03 4.810165638519463323e-34 -1.481153287811754469e-33 3.677032758141057529e-03 2.044309607502370512e-34 1.985611099954181230e-33 3.745902933312134347e-03 -5.425012652783054140e-34 1.013551952675522389e-32 3.791002567515563103e-03 -1.055754318165421983e-33 2.794177620452879432e-33 3.813308966439189155e-03 -1.427032489764166980e-35 -3.879995418785415766e-34 1.056572053411708736e-30 5.511521610893899137e-01 7.068701298177106395e-32 -1.407929672620088487e-31 5.511521610893899137e-01 -1.567184847873423190e-33 2.861196083528416018e-31 5.511521610893899137e-01 -4.545423355492242495e-32 1.383532944120539956e-31 5.511521610893899137e-01 -1.517159406677904012e-31 1.129855520581791966e-31 5.511521610893899137e-01 -6.342380571885688336e-31 1.304571662274165895e-30 5.511521610893899137e-01 -5.211004789068694412e-31 1.273864151648280798e-31 5.511521610893899137e-01 -3.585546503855637706e-31 5.891221791515320429e-31 5.511521610893899137e-01 2.418015672626471617e-32 1.508262249064671188e-31 5.511521610893899137e-01 4.678595382418527072e-32 -2.600040316987390054e-31 5.511521610893899137e-01 5.887097748133637277e-32 -6.705862409057813296e-32 5.511521610893899137e-01 9.694122859313416736e-32 -7.218146662672772501e-32 5.511521610893899137e-01 -1.111307794880685589e-32 -4.849212657601411213e-31 5.511521610893899137e-01 1.144922944607209124e-32 -7.072200397230972715e-31 5.511521610893899137e-01 -3.231838547721487631e-32 -6.833146068375930820e-32 5.511521610893899137e-01 -3.754486458692319805e-32 4.794771755004121993e-32 5.511521610893899137e-01 -4.833001576365440140e-32 -3.416135975891769074e-32 5.511521610893899137e-01 -2.076643164464616413e-32 -4.591318890068548846e-33 5.511521610893899137e-01 6.153380524320890944e-33 -3.935518474402755398e-31 5.511521610893899137e-01 -2.136110690812948805e-32 3.604818972714993136e-31 5.511521610893899137e-01 -3.056391961751620659e-33 -1.112553309623048587e-33 5.511521610893899137e-01 -6.742755069106471805e-33 -4.966723939998276002e-32 5.511521610893899137e-01 -3.300678898400899102e-33 3.592269302088208612e-32 5.511521610893899137e-01 -5.343197290349816026e-34 1.147862556285061438e-32 5.511521610893899137e-01 -1.014428611499674110e-34 -1.219030138328765601e-33 5.511521610893899137e-01 -3.960708911661708158e-34 2.336612098669552867e-32 5.511521610893899137e-01 -2.657021517265820582e-35 -2.592374176610800348e-33 5.511521610893899137e-01 -4.964637578933830629e-37 -7.343497010401240768e-33 5.511521610893899137e-01 -5.602262879473437122e-35 6.555183801820643839e-33 5.511521610893899137e-01 1.144644256837599348e-35 8.201728049331568593e-34 5.511521610893899137e-01 1.501456517970947759e-37 -8.876342765771785636e-34 5.511521610893899137e-01 2.299967949213200169e-35 -1.315522384718889510e-33 5.511521610893899137e-01 1.777502719746697959e-36 2.397068745533150407e-32 5.511521610893899137e-01 -3.893670832227394999e-35 -2.985391692556573700e-33 5.511521610893899137e-01 3.627810392433023228e-35 1.460260361624653853e-33 5.511521610893899137e-01 -9.876011570360443886e-36 -3.762822323726171175e-33 5.511521610893899137e-01 -3.585508389890717887e-36 -2.467957188392308838e-33 5.511521610893899137e-01 -9.785480501058832114e-36 3.399461316088347515e-33 5.511521610893899137e-01 -1.646715491978906750e-35 -5.119313660667677494e-33 5.511521610893899137e-01 -1.492508691278042460e-36 5.309232886795139008e-33 5.511521610893899137e-01 4.505965243479946758e-35 7.924389906101558650e-33 5.511521610893899137e-01 8.234655014315482191e-36 1.519290395529507966e-33 5.511521610893899137e-01 3.019172645818915694e-35 -1.316954674429814789e-33 5.511521610893899137e-01 7.225177299326461897e-35 -6.194287405139876844e-34 5.511521610893899137e-01 1.272289193404573278e-35 -6.934621631196062400e-33 5.511521610893899137e-01 3.825409685401640750e-36 -8.511377957091233964e-33 5.511521610893899137e-01 -3.092690764262073980e-36 -2.708426640480811327e-33 5.511521610893899137e-01 -2.122304550573917473e-36 1.635461650469419602e-32 5.511521610893899137e-01 3.130586221767698324e-35 3.801892638184811442e-33 5.511521610893899137e-01 3.650580433319913701e-35 -1.505273556122659470e-32 5.511521610893899137e-01 6.821495601518767542e-35 4.850923037098799644e-33 5.511521610893899137e-01 7.892181242895256510e-35 4.138613390563257201e-35 5.511521610893899137e-01 1.305835635759968825e-34 8.506697469932747659e-33 5.511521610893899137e-01 1.049025502276222194e-34 -1.662640508486751633e-33 5.511521610893899137e-01 1.776058798569596914e-34 3.751386120459172216e-33 5.511521610893899137e-01 7.396871441847253618e-35 1.685611295414068567e-33 5.511521610893899137e-01 1.055902386070095799e-34 -6.588091281964322131e-33 5.511521610893899137e-01 7.654591600740086865e-35 8.959283902301096644e-33 5.511521610893899137e-01 4.040627677919829673e-35 6.097665807270917610e-33 5.511521610893899137e-01 5.576135709521746406e-35 4.810165638519463323e-34 5.511521610893899137e-01 5.909369603729218425e-36 2.044309607502370512e-34 5.511521610893899137e-01 1.255964006754921125e-35 -5.425012652783054140e-34 5.511521610893899137e-01 2.058604076816046383e-36 -1.055754318165421983e-33 5.511521610893899137e-01 -1.859802097249579627e-37 -1.427032489764166980e-35 5.511521610893899137e-01 9.968405903157467455e-37 -3.089706694104596093e-32 6.405276016329735712e-32 5.511521610893899137e-01 9.841555076915215953e-31 -8.201437666347132763e-33 5.511521610893899137e-01 -4.735065036864974871e-31 -5.208848637339613726e-32 5.511521610893899137e-01 -1.072245031109316571e-30 -1.583501934862641190e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.408723100070425514e-31 5.511521610893899137e-01 7.703793087215175515e-32 -5.277347317253431590e-31 5.511521610893899137e-01 -1.225432765866856368e-30 -3.651889032040374884e-31 5.511521610893899137e-01 4.048954469989395565e-31 1.754590390779100660e-32 5.511521610893899137e-01 9.259158617794845230e-31 4.015170100571155841e-32 5.511521610893899137e-01 2.681439315858539969e-31 5.223672466286265499e-32 5.511521610893899137e-01 -7.358412809530782214e-31 9.030697577466043863e-32 5.511521610893899137e-01 3.172372878130401271e-32 -1.774733076728056546e-32 5.511521610893899137e-01 -3.066605061563230693e-32 4.814976627598383718e-33 5.511521610893899137e-01 -4.245847554647640982e-32 -3.895263829568858315e-32 5.511521610893899137e-01 -2.530290086683952901e-31 -4.417911740539690489e-32 5.511521610893899137e-01 1.451746311837644250e-31 -5.496426858212809181e-32 5.511521610893899137e-01 -4.477826413217854899e-31 -2.740068446311986823e-32 5.511521610893899137e-01 -4.653436733850406960e-31 -4.808722941528179449e-34 5.511521610893899137e-01 -4.049507365545422975e-31 -2.799535972660320309e-32 5.511521610893899137e-01 -1.755341795286778428e-31 -9.690644780225330232e-33 5.511521610893899137e-01 6.725940148946867568e-33 -1.337700788758018001e-32 5.511521610893899137e-01 3.558442974227194544e-32 -9.934931716874609360e-33 5.511521610893899137e-01 -2.027527509122277384e-32 -7.168572547508691175e-33 5.511521610893899137e-01 4.969040700605396538e-33 -6.735695679623677796e-33 5.511521610893899137e-01 -5.989755266244782525e-33 -7.030323709639880047e-33 5.511521610893899137e-01 -1.259933869812144593e-32 -6.660823033646368896e-33 5.511521610893899137e-01 -1.021460426195793077e-33 -6.634749282231602523e-33 5.511521610893899137e-01 1.175363941442336983e-33 -6.690275447268445537e-33 5.511521610893899137e-01 5.030889140448438035e-33 -6.622806375905334715e-33 5.511521610893899137e-01 -1.367925418140472112e-34 -6.634102672821913552e-33 5.511521610893899137e-01 6.700390352524380566e-33 -6.611253138981576826e-33 5.511521610893899137e-01 3.117170545009075190e-32 -6.632475315753962829e-33 5.511521610893899137e-01 -1.598212667134254304e-33 -6.673189526795984090e-33 5.511521610893899137e-01 -9.759118898684279460e-34 -6.597974714549378854e-33 5.511521610893899137e-01 -2.069364644492637814e-33 -6.644128830044070885e-33 5.511521610893899137e-01 -3.538542410027737786e-33 -6.637838326863598256e-33 5.511521610893899137e-01 -4.873435510858590279e-33 -6.644038298974767647e-33 5.511521610893899137e-01 -9.054167447995112694e-34 -6.650719973393499081e-33 5.511521610893899137e-01 -7.618061496609576647e-34 -6.635745327164987983e-33 5.511521610893899137e-01 1.454031419757997548e-32 -6.589193166038910672e-33 5.511521610893899137e-01 1.268397333874021806e-32 -6.626018163459394917e-33 5.511521610893899137e-01 -1.386613460702025583e-32 -6.604061092015519181e-33 5.511521610893899137e-01 -1.129936448896030714e-33 -6.562001045480442869e-33 5.511521610893899137e-01 8.976200486547350384e-33 -6.621529926539663824e-33 5.511521610893899137e-01 -9.524898794123405551e-35 -6.630427408788306558e-33 5.511521610893899137e-01 -1.790883860662348888e-33 -6.637345509237973575e-33 5.511521610893899137e-01 -2.568318074600126537e-33 -6.636375123024284444e-33 5.511521610893899137e-01 -8.139444115300032462e-33 -6.602946956256034343e-33 5.511521610893899137e-01 -3.620691122421625000e-32 -6.597747014140510511e-33 5.511521610893899137e-01 3.196069507652787441e-32 -6.566037862458522111e-33 5.511521610893899137e-01 8.699671279390421501e-33 -6.555331006044757403e-33 5.511521610893899137e-01 1.236975068910711962e-33 -6.503669254897710980e-33 5.511521610893899137e-01 -3.809846635976320450e-32 -6.529350268246088145e-33 5.511521610893899137e-01 1.368785193113492206e-33 -6.456646938616747294e-33 5.511521610893899137e-01 2.712269162612777641e-33 -6.560284104055236748e-33 5.511521610893899137e-01 -1.443564609773584029e-33 -6.528662579866700827e-33 5.511521610893899137e-01 -1.875698974822404893e-32 -6.557706902466307432e-33 5.511521610893899137e-01 3.447167426946541175e-32 -6.593846541694511244e-33 5.511521610893899137e-01 3.007322623965728181e-33 -6.578491461378490388e-33 5.511521610893899137e-01 -1.481153287811754469e-33 -6.628343448869980164e-33 5.511521610893899137e-01 1.985611099954181230e-33 -6.621693178406158983e-33 5.511521610893899137e-01 1.013551952675522389e-32 -6.632194214396894022e-33 5.511521610893899137e-01 2.794177620452879432e-33 -6.634438798683434414e-33 5.511521610893899137e-01 -3.879995418785415766e-34 -6.633255977883392709e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 new file mode 100644 index 000000000..2290b4200 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 @@ -0,0 +1 @@ +1.377894896171173895e-02 6.064202065801056752e-31 -9.312791651478880243e-31 1.373529045637814083e-02 8.251745424238632282e-32 -1.695569550361220638e-30 1.364754549367405007e-02 6.630442007532069422e-32 1.285029956329312743e-30 1.351485477677841739e-02 1.383532944120539956e-31 -2.132847542082290999e-31 1.333592095490489064e-02 1.129721221400153403e-31 2.820532177678916025e-31 1.310899876018755197e-02 -1.104247062184055629e-30 7.701298943846059685e-32 1.283188225830649357e-02 1.273864151648280798e-31 -7.182327950798528679e-32 1.250188961847354015e-02 -1.435320737882880838e-31 3.854755368512528734e-32 1.211584598705594228e-02 1.508262249064671188e-31 -4.012272373923461683e-32 1.167006528972486419e-02 -2.600040316987390054e-31 -5.984043404151288114e-32 1.116033209929854011e-02 -3.756919171809059782e-31 1.901028214577663929e-31 1.058188511495570562e-02 -9.028371174250619079e-32 -1.130991000300852415e-31 9.929404321008859433e-03 3.286825917748208743e-31 -3.066605061563230693e-32 9.197004554564885276e-03 -8.132211801314553973e-32 -1.058363887783171700e-31 8.378239028153430107e-03 5.005036117991814020e-32 2.204809309226182362e-31 7.466117350174453215e-03 7.557031704580501511e-32 1.451746311837644250e-31 6.453143763116044908e-03 1.205095923235210117e-31 -3.530044101103742045e-32 5.331382676045966565e-03 -4.591318890068548846e-33 1.608677541118376665e-32 4.092560064867728671e-03 -3.358769446103082941e-32 -4.498658357529758704e-32 2.728210876118789072e-03 2.359186816329085369e-32 -7.097946384987224498e-33 1.229884061623049210e-03 -1.097111437127075297e-33 6.729800617070860891e-33 -4.088281395843180316e-04 2.455691295423150719e-32 -7.575179878904946086e-32 -2.067461321230328400e-03 -3.405225702143802442e-32 1.471219992993728143e-32 -3.645080634602862208e-03 1.147862556285061438e-32 -3.302133287085399590e-33 -5.106229758309582117e-03 3.019593915466053742e-32 -5.989755266244782525e-33 -6.413757319815078899e-03 -2.155827642017312870e-32 2.376570833403533010e-33 -7.529989691330842352e-03 1.174687468978895498e-32 2.765703730660371860e-32 -8.431078665774657463e-03 6.451089732483615126e-33 1.175363941442336983e-33 -9.215689638962978880e-03 1.988906132087914970e-32 -8.303428571324704753e-33 -9.900421325306668283e-03 8.197575625925496862e-34 2.576436369589415169e-32 -1.047095529356697335e-02 -8.876342765771785636e-34 -5.939629323683147762e-33 -1.083771538307339195e-02 -1.315522384718889510e-33 3.276588202493618830e-33 -1.094235380326372131e-02 -1.269217360213538421e-32 -1.598212667134254304e-33 -1.077789850274134785e-02 -1.509100948912604257e-32 -9.758211811869406914e-34 -1.045341460269087926e-02 1.460440062021556854e-33 2.202630217544366140e-32 -1.005117263897366796e-02 2.259967377911047252e-33 2.484247291609480641e-33 -9.575166733160179675e-03 -2.467957188392308838e-33 -4.873073355779610944e-33 -9.018558709909660007e-03 3.399829423258751042e-33 -9.052326912143095060e-34 -8.299530790594396648e-03 7.220547406051798895e-33 -7.618061496609576647e-34 -7.415760093088870353e-03 5.308454824225208040e-33 2.004170070854155516e-33 -6.386230086580635575e-03 -4.849951535559166044e-33 -1.286147757963710822e-32 -5.264148194509809912e-03 -1.153337882515834041e-32 1.224257923368843603e-32 -4.219785670721612134e-03 1.205648081427424040e-32 -1.128165484784436474e-33 -3.270969974676368568e-03 -7.482567298981486290e-33 -4.750076630387646826e-33 -2.412718568953263303e-03 -6.935607135575740282e-33 -9.524898794123405551e-35 -1.639558706638900550e-03 -1.252830580889936222e-33 -9.050213942090942589e-33 -9.457523472300477822e-04 -2.707319782988025475e-33 1.238311293794984630e-32 -3.214210080383905484e-04 -1.445376082115497785e-32 7.264744547624554477e-33 2.453933344820966966e-04 3.801892638184811442e-33 1.141415715969763644e-32 7.583888134402847793e-04 -2.787049445628177018e-33 -7.482427015187286489e-34 1.220998052689086216e-03 -3.570354852187196805e-33 -2.498403567798886132e-32 1.636506396934066156e-03 4.064239867531846595e-35 7.056499829787031305e-32 2.008015006096743483e-03 8.506697469932747659e-33 -2.460906709311838279e-33 2.338414463972164972e-03 -1.662433342116105311e-33 1.368785193113492206e-33 2.630366811209988373e-03 -5.625925439402529287e-33 2.714011105037866821e-33 2.886294175204549839e-03 -7.138375270547302707e-34 -1.444476861012998059e-33 3.107334782599794221e-03 -2.911933408127329889e-33 -1.875603800754054187e-32 3.292284287410564454e-03 -1.032022836526186273e-33 3.447266290821061273e-32 3.444281461139452136e-03 -4.061516595976628595e-33 2.332594296559100837e-32 3.566376523378684150e-03 -4.671046607573477556e-33 -1.480890420740072724e-33 3.661082164639476930e-03 -2.841474012123277531e-34 1.985611099954181230e-33 3.730388448310034341e-03 -5.424670519797801769e-34 -3.783639632501241327e-34 3.775775759052600166e-03 -1.055754318165421983e-33 -2.494134056632830348e-33 3.798225075990310524e-03 -1.340152645473097119e-33 -3.878602575525100379e-34 6.064202065801056752e-31 5.511521610893899137e-01 7.154332547762007387e-32 8.251745424238632282e-32 5.511521610893899137e-01 -2.159331316179330401e-33 6.630442007532069422e-32 5.511521610893899137e-01 -4.553398224457491757e-32 1.383532944120539956e-31 5.511521610893899137e-01 -1.528168683676282768e-31 1.129721221400153403e-31 5.511521610893899137e-01 -6.335724502694747699e-31 -1.104247062184055629e-30 5.511521610893899137e-01 -5.201272697232694243e-31 1.273864151648280798e-31 5.511521610893899137e-01 -3.583017733814280781e-31 -1.435320737882880838e-31 5.511521610893899137e-01 2.453060719620666870e-32 1.508262249064671188e-31 5.511521610893899137e-01 4.680821707099895665e-32 -2.600040316987390054e-31 5.511521610893899137e-01 5.911338788656846605e-32 -3.756919171809059782e-31 5.511521610893899137e-01 9.748890338359454700e-32 -9.028371174250619079e-32 5.511521610893899137e-01 -1.111489069725870190e-32 3.286825917748208743e-31 5.511521610893899137e-01 1.168381890479818342e-32 -8.132211801314553973e-32 5.511521610893899137e-01 -3.232048393658327839e-32 5.005036117991814020e-32 5.511521610893899137e-01 -3.742888522699395146e-32 7.557031704580501511e-32 5.511521610893899137e-01 -4.835215746690740518e-32 1.205095923235210117e-31 5.511521610893899137e-01 -2.067351790778555836e-32 -4.591318890068548846e-33 5.511521610893899137e-01 6.291746294872912818e-33 -3.358769446103082941e-32 5.511521610893899137e-01 -2.116190652677841877e-32 2.359186816329085369e-32 5.511521610893899137e-01 -2.940881873632561731e-33 -1.097111437127075297e-33 5.511521610893899137e-01 -6.763301249125649717e-33 2.455691295423150719e-32 5.511521610893899137e-01 -3.338050815085652377e-33 -3.405225702143802442e-32 5.511521610893899137e-01 -5.508182671909443971e-34 1.147862556285061438e-32 5.511521610893899137e-01 -1.033941548062041770e-34 3.019593915466053742e-32 5.511521610893899137e-01 -4.053818034089131357e-34 -2.155827642017312870e-32 5.511521610893899137e-01 -2.479122091683935377e-35 1.174687468978895498e-32 5.511521610893899137e-01 1.567842007869389214e-36 6.451089732483615126e-33 5.511521610893899137e-01 -5.803863815059445920e-35 1.988906132087914970e-32 5.511521610893899137e-01 1.190563908891027756e-35 8.197575625925496862e-34 5.511521610893899137e-01 9.472542134826449012e-37 -8.876342765771785636e-34 5.511521610893899137e-01 2.337968131264507603e-35 -1.315522384718889510e-33 5.511521610893899137e-01 1.815972682029053500e-36 -1.269217360213538421e-32 5.511521610893899137e-01 -3.889681105965282385e-35 -1.509100948912604257e-32 5.511521610893899137e-01 3.616566601704140078e-35 1.460440062021556854e-33 5.511521610893899137e-01 -1.012331976023168596e-35 2.259967377911047252e-33 5.511521610893899137e-01 -3.500248697524449140e-36 -2.467957188392308838e-33 5.511521610893899137e-01 -9.952833591698794073e-36 3.399829423258751042e-33 5.511521610893899137e-01 -1.633268419298944113e-35 7.220547406051798895e-33 5.511521610893899137e-01 -1.654258371941290799e-36 5.308454824225208040e-33 5.511521610893899137e-01 4.577296568609118834e-35 -4.849951535559166044e-33 5.511521610893899137e-01 9.743382582360134949e-36 -1.153337882515834041e-32 5.511521610893899137e-01 2.881297282473976975e-35 1.205648081427424040e-32 5.511521610893899137e-01 7.391799770079924616e-35 -7.482567298981486290e-33 5.511521610893899137e-01 1.341238106777642293e-35 -6.935607135575740282e-33 5.511521610893899137e-01 1.914486050150372402e-36 -1.252830580889936222e-33 5.511521610893899137e-01 -3.279769615464451954e-36 -2.707319782988025475e-33 5.511521610893899137e-01 -1.509571332885722117e-36 -1.445376082115497785e-32 5.511521610893899137e-01 3.296509455772354637e-35 3.801892638184811442e-33 5.511521610893899137e-01 3.558986254758442840e-35 -2.787049445628177018e-33 5.511521610893899137e-01 6.848022520939467857e-35 -3.570354852187196805e-33 5.511521610893899137e-01 7.989848297964953764e-35 4.064239867531846595e-35 5.511521610893899137e-01 1.280267621575875899e-34 8.506697469932747659e-33 5.511521610893899137e-01 1.055944472571503066e-34 -1.662433342116105311e-33 5.511521610893899137e-01 1.781931834372424351e-34 -5.625925439402529287e-33 5.511521610893899137e-01 7.279227397930132227e-35 -7.138375270547302707e-34 5.511521610893899137e-01 1.056993928380835180e-34 -2.911933408127329889e-33 5.511521610893899137e-01 7.666197139045511334e-35 -1.032022836526186273e-33 5.511521610893899137e-01 4.012154954288596230e-35 -4.061516595976628595e-33 5.511521610893899137e-01 5.597637315522439038e-35 -4.671046607573477556e-33 5.511521610893899137e-01 5.791675659046291598e-36 -2.841474012123277531e-34 5.511521610893899137e-01 1.256356950367158787e-35 -5.424670519797801769e-34 5.511521610893899137e-01 2.073877430217236620e-36 -1.055754318165421983e-33 5.511521610893899137e-01 -2.049317532704955566e-37 -1.340152645473097119e-33 5.511521610893899137e-01 1.012117222943897197e-36 -9.312791651478880243e-31 6.490907265914636703e-32 5.511521610893899137e-01 -1.695569550361220638e-30 -8.793584134653039289e-33 5.511521610893899137e-01 1.285029956329312743e-30 -5.216823506304862988e-32 5.511521610893899137e-01 -2.132847542082290999e-31 -1.594511211861019946e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.402067030879484877e-31 5.511521610893899137e-01 7.701298943846059685e-32 -5.267615225417431421e-31 5.511521610893899137e-01 -7.182327950798528679e-32 -3.649360261999017959e-31 5.511521610893899137e-01 3.854755368512528734e-32 1.789635437773295913e-32 5.511521610893899137e-01 -4.012272373923461683e-32 4.017396425252524434e-32 5.511521610893899137e-01 -5.984043404151288114e-32 5.247913506809474827e-32 5.511521610893899137e-01 1.901028214577663929e-31 9.085465056512081826e-32 5.511521610893899137e-01 -1.130991000300852415e-31 -1.774914351573241010e-32 5.511521610893899137e-01 -3.066605061563230693e-32 5.049566086324475904e-33 5.511521610893899137e-01 -1.058363887783171700e-31 -3.895473675505698522e-32 5.511521610893899137e-01 2.204809309226182362e-31 -4.406313804546765830e-32 5.511521610893899137e-01 1.451746311837644250e-31 -5.498641028538110106e-32 5.511521610893899137e-01 -3.530044101103742045e-32 -2.730777072625926520e-32 5.511521610893899137e-01 1.608677541118376665e-32 -3.425065236007956003e-34 5.511521610893899137e-01 -4.498658357529758704e-32 -2.779615934525213382e-32 5.511521610893899137e-01 -7.097946384987224498e-33 -9.575134692106270961e-33 5.511521610893899137e-01 6.729800617070860891e-33 -1.339755406759935792e-32 5.511521610893899137e-01 -7.575179878904946086e-32 -9.972303633559363318e-33 5.511521610893899137e-01 1.471219992993728143e-32 -7.185071085664653970e-33 5.511521610893899137e-01 -3.302133287085399590e-33 -6.737646973279914947e-33 5.511521610893899137e-01 -5.989755266244782525e-33 -7.039634621882622195e-33 5.511521610893899137e-01 2.376570833403533010e-33 -6.659044039390549718e-33 5.511521610893899137e-01 2.765703730660371860e-32 -6.632684976465839693e-33 5.511521610893899137e-01 1.175363941442336983e-33 -6.692291456624305668e-33 5.511521610893899137e-01 -8.303428571324704753e-33 -6.622347179384800096e-33 5.511521610893899137e-01 2.576436369589415169e-32 -6.633305564260227942e-33 5.511521610893899137e-01 -5.939629323683147762e-33 -6.610873137161064149e-33 5.511521610893899137e-01 3.276588202493618830e-33 -6.632436845791680282e-33 5.511521610893899137e-01 -1.598212667134254304e-33 -6.673149629533362824e-33 5.511521610893899137e-01 -9.758211811869406914e-34 -6.598087152456667215e-33 5.511521610893899137e-01 2.202630217544366140e-32 -6.644376138233942017e-33 5.511521610893899137e-01 2.484247291609480641e-33 -6.637753067171231735e-33 5.511521610893899137e-01 -4.873073355779610944e-33 -6.644205652065407136e-33 5.511521610893899137e-01 -9.052326912143095060e-34 -6.650585502666699955e-33 5.511521610893899137e-01 -7.618061496609576647e-34 -6.635907076845651856e-33 5.511521610893899137e-01 2.004170070854155516e-33 -6.588479852787619416e-33 5.511521610893899137e-01 -1.286147757963710822e-32 -6.624509435891349943e-33 5.511521610893899137e-01 1.224257923368843603e-32 -6.605439845648968424e-33 5.511521610893899137e-01 -1.128165484784436474e-33 -6.560334820772907601e-33 5.511521610893899137e-01 -4.750076630387646826e-33 -6.620840437405932634e-33 5.511521610893899137e-01 -9.524898794123405551e-35 -6.632338332423557793e-33 5.511521610893899137e-01 -9.050213942090942589e-33 -6.637532588089175775e-33 5.511521610893899137e-01 1.238311293794984630e-32 -6.635762389806596474e-33 5.511521610893899137e-01 7.264744547624554477e-33 -6.601287723915988079e-33 5.511521610893899137e-01 1.141415715969763644e-32 -6.598662955926125433e-33 5.511521610893899137e-01 -7.482427015187286489e-34 -6.565772593264315782e-33 5.511521610893899137e-01 -2.498403567798886132e-32 -6.554354335494060773e-33 5.511521610893899137e-01 7.056499829787031305e-32 -6.506226056316120850e-33 5.511521610893899137e-01 -2.460906709311838279e-33 -6.528658371216559844e-33 5.511521610893899137e-01 1.368785193113492206e-33 -6.456059635036464230e-33 5.511521610893899137e-01 2.714011105037866821e-33 -6.561460544494408636e-33 5.511521610893899137e-01 -1.444476861012998059e-33 -6.528553425635626996e-33 5.511521610893899137e-01 -1.875603800754054187e-32 -6.557590847083253765e-33 5.511521610893899137e-01 3.447266290821061273e-32 -6.594131268930824140e-33 5.511521610893899137e-01 2.332594296559100837e-32 -6.578276445318483846e-33 5.511521610893899137e-01 -1.480890420740072724e-33 -6.628461142814663070e-33 5.511521610893899137e-01 1.985611099954181230e-33 -6.621689248970037044e-33 5.511521610893899137e-01 -3.783639632501241327e-34 -6.632178941043492402e-33 5.511521610893899137e-01 -2.494134056632830348e-33 -6.634457750226980122e-33 5.511521610893899137e-01 -3.878602575525100379e-34 -6.633240701250765205e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener new file mode 100644 index 000000000..5fbefa515 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0661889008629074 +1 0.06647426016589354 +2 0.06697529215458661 +3 0.06769811048795421 +4 0.06865095284555046 +5 0.0698441545296568 +6 0.0712896123110296 +7 0.07300053792853292 +8 0.07499091120412098 +9 0.07727457573045982 +10 0.07986372993682027 +11 0.08276812093386218 +12 0.08599403010358495 +13 0.08954283840867194 +14 0.0934077973105164 +15 0.0975689208050062 +16 0.10199296029576237 +17 0.10663216503150544 +18 0.11142119975426476 +19 0.11627461504577619 +20 0.12108786698078905 +21 0.1257378776241308 +22 0.1300908657049122 +23 0.13405415055035094 +24 0.1375589084791528 +25 0.14054231608873866 +26 0.1429482501200824 +27 0.1447223736309907 +28 0.14581586041606556 +29 0.1461908979866841 +30 0.1458301542309095 +31 0.144787161074781 +32 0.1431509369239614 +33 0.14101759501455666 +34 0.1384864587589631 +35 0.135626607994573 +36 0.1324514769541923 +37 0.12897473945082955 +38 0.12521695630565963 +39 0.12120480594414136 +40 0.116992128264772 +41 0.11266843732548826 +42 0.10831567410704121 +43 0.10400353147677228 +44 0.09978860060153923 +45 0.09571660359025486 +46 0.09182368377574611 +47 0.08813725627969593 +48 0.08467277684336257 +49 0.08143820591821531 +50 0.07843817455899511 +51 0.07567447560855317 +52 0.07314611396405668 +53 0.07084997089325819 +54 0.06878171554530715 +55 0.06693636289825045 +56 0.06530836420926438 +57 0.06389196591851017 +58 0.06268155332674624 +59 0.06167185804744343 +60 0.06085809723238098 +61 0.06023613794123961 +62 0.05980268828196377 +63 0.05955516525759201 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz new file mode 100644 index 000000000..f2d1a60b5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.0695824750319134 -1.321091930945525e-16 4.6101616180197894e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.070917385620739 -1.9934935200041934e-16 -2.0481048764097164e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.073249939096383 -8.415275802989294e-17 -8.456720969152282e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0765906565452283 -3.5153537611166056e-17 -1.753421624541595e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.080952866624804 -6.665776359005689e-17 -9.92558767112015e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.0863532959256665 -4.0436545379531215e-17 -8.314368389892507e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.09281067305525 -1.7003874017972766e-17 -1.0591991704419853e-16 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.1003460942601073 -8.663254172978196e-18 -8.952302167191084e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.108982531926027 8.686959315558785e-18 -4.8336169607493295e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.118743413792699 1.2745224647980062e-17 -4.799677406836546e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.129649427524559 2.2668686296751706e-17 -4.8570263871007197e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.1417191772339454 2.0509143252621473e-17 -6.403035533497795e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.154969628863613 6.077867451706769e-17 -7.423276291226134e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.169415521127418 1.298535453207906e-17 -6.451426516722831e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.185063964358866 2.819156995135487e-17 -3.974959798032766e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.201911701494095 8.585775685847163e-17 3.045943637090697e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.2199504134198094 5.0240929036071634e-17 -2.988375355040894e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.239166193896984 1.0738593622452807e-16 -2.5369230966807917e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.2595342198647255 1.4436800705362121e-16 5.276445880251723e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.281013578211365 1.312447406915148e-16 1.0023226164593702e-16 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.303554533220748 6.429223795301395e-17 1.0523558707746308e-16 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.3271021703471417 5.966095837696054e-17 7.992359253402385e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.351591699338289 3.4922720718198633e-17 4.264157703220939e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.3769389717097305 1.911840503101732e-17 2.303056189182704e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.403050568927475 1.3072241409110677e-17 1.400621581024728e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.4298271623108074 4.789744044909626e-18 1.0594743883740396e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.457163387219769 7.22671222457911e-18 5.715650063986625e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.4849427892851907 2.8370112660284305e-18 4.041684243245267e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.513042384206452 7.851886055775445e-18 -8.400715471120835e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.541337114612673 7.338351623716453e-18 -3.514009487563341e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.569701892597987 3.9507572980053295e-18 -2.957310062870981e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.5980141841579845 2.1416871205201262e-18 -2.1371518184508387e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.626155557806009 -7.272423299783032e-18 -5.560432615556654e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.6540103904537737 -6.61786122740746e-18 -2.4401329465963064e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.681466192359639 -1.0761856636790291e-17 -1.4141278823410162e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.708420883533942 -2.7918601529734327e-18 -2.2551959734068473e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.734784344966453 -2.0933469540621586e-18 -1.6527634672725395e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.7604721823776264 5.876032616701535e-19 -1.6203711032979904e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7854062775364117 4.1932568623054767e-19 -4.999605624524417e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.80951890510272 -4.304902704323426e-18 3.6725333135503016e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.8327584737140246 -1.4556374065439704e-18 5.301049741753215e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.855081284731687 -7.952227041180378e-18 5.665439279558301e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.876450568407593 -1.0073811879829654e-18 3.1468731680026815e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.896838003120462 -3.917306117769094e-18 2.4765153191642078e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9162283670006377 1.0345630060001847e-18 -1.3213692026538376e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9346113737881425 -1.2042347780042088e-18 -1.6090422978900795e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9519796523222266 3.295729090839009e-19 -2.3656970731006255e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.968327773623951 1.828103864311354e-18 -1.963690218050901e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.983658515751084 -4.448053636917232e-19 1.7385643197693848e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 2.9979786438425 6.015174847061272e-18 1.41953145755536e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0112950313501243 -2.065441054131125e-18 2.0370043291356116e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.023615193065709 5.472471524447925e-18 1.3123213503683292e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0349494121015907 -3.809043454134746e-18 -7.446445094627161e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0453099568395836 5.253822277176958e-18 -2.4615914754261227e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0547089300977954 -4.062078553462646e-18 1.9075253747497964e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.0631574181550847 4.118426017717481e-18 -1.2323472033685116e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.0706665358949365 -3.593007805825208e-18 5.719864452506733e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.0772470534828558 1.8376832847303266e-18 -1.5305019290526255e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.082908879239535 -2.936985718639248e-18 -5.035551910619007e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.0876609824032335 1.5142254358496714e-18 -9.821046681780307e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.0915114721982144 -4.610038050889887e-19 -7.333802130010478e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.094467409429444 1.0856141503767438e-18 -1.288480926814136e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.0965343488289987 -1.3222642609112827e-18 4.813672015693527e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.09771729893857 1.1878160987894626e-19 8.545668624862993e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener new file mode 100644 index 000000000..5a85746ed --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.049212276192543675 +1 0.0493727740424248 +2 0.04967605629579452 +3 0.0501311047606533 +4 0.050750961829094804 +5 0.051552840547655784 +6 0.05255806778082637 +7 0.053792082293934486 +8 0.0552842580055289 +9 0.057067465581002126 +10 0.059177189019982424 +11 0.06165058265050006 +12 0.06452507446730768 +13 0.06783632467406664 +14 0.07161500148547112 +15 0.07588303366119621 +16 0.08065024324998213 +17 0.08591001391422491 +18 0.09163408572481874 +19 0.09776229283744474 +20 0.1041918990781323 +21 0.11078045669258897 +22 0.11734425291354399 +23 0.12365755236622873 +24 0.1294607903434953 +25 0.13455939493408156 +26 0.13884495015502188 +27 0.14222452221725151 +28 0.1446141094172517 +29 0.14593480440316134 +30 0.14612686239506376 +31 0.14520222178767364 +32 0.14330660426831154 +33 0.14061604296363822 +34 0.13730812359076108 +35 0.13346666988099654 +36 0.12909879510449512 +37 0.12422238622896949 +38 0.11887570366914746 +39 0.11318925978679491 +40 0.10733318171379257 +41 0.10145332506158518 +42 0.09567019042282474 +43 0.09007981266960467 +44 0.08475090343114401 +45 0.07972188634446903 +46 0.0750168274028329 +47 0.07065001052294281 +48 0.06662690386606146 +49 0.06294615895305478 +50 0.059601413896843966 +51 0.056582476305207074 +52 0.05387525712261223 +53 0.051461227986673894 +54 0.049322341796792554 +55 0.04744218379244872 +56 0.045805899717679906 +57 0.04440024144305188 +58 0.04321360868371972 +59 0.0422360409612827 +60 0.041459191285774175 +61 0.040876320907218266 +62 0.04048231642601388 +63 0.04027358936215093 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz new file mode 100644 index 000000000..eee9865bc --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9747998182935025 2.3413452595916256e-18 1.9236610799633632e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.975960856358668 -2.0879806668123462e-17 4.7043319375347046e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.978128189061158 -5.4917171884487776e-17 -3.542573416048433e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.981318446828468 -3.664762989360992e-17 3.443985104657598e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9855545482718417 8.045137495581667e-18 -1.8340871724780148e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9908659092173828 -3.556555278265181e-19 5.33868512769177e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9972876498176761 2.2556592221353193e-17 5.2535216800269096e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.0048605559242043 1.7556845395523136e-17 -1.0400487827842166e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.013630519321497 -1.6374107627191435e-17 -1.1006227494455923e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.0236473866407367 3.7742717048168865e-18 -2.3808553091679628e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0349627645276955 1.4971313775839925e-17 -2.305573639135014e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.0476294094927368 7.936353650144929e-18 -3.6492687448230546e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.061700207115946 3.023145076949245e-17 -2.7500438533356724e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.0772262877414436 3.7438955869523425e-17 -2.4610748639638392e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.094252401245818 7.412362684820381e-17 2.2078690852435755e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.112813153653018 1.3399428066034368e-16 6.133091777017182e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.1329334154878707 8.228348584474181e-17 5.793095405547348e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.1546261971338665 2.851954494392917e-17 5.288276272848316e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.1778883377508853 1.0682773691268094e-16 2.0425531302350915e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.202696467442651 2.3294267075304505e-16 -1.9937415430715226e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.2290092461801163 2.3077058529100733e-16 1.1347268398344582e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.2567686685924575 1.460966251913758e-16 1.1834013243736439e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2858983695596407 7.826858891291837e-17 5.313013153224716e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.316300321267139 4.0139566199035594e-17 3.492887125255356e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.347860104613817 2.835888981171186e-17 2.9546401651094027e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.3804487457948778 2.2573535490438847e-17 6.3781554653107745e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.413923134773627 2.0669859305469454e-17 3.67631065172657e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.4481238798908325 1.0279676057098725e-17 2.394990422652913e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.4828790823780036 4.521960616013313e-18 -2.0581140618700734e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.518009345042883 2.2429118403966965e-18 -3.766521061882187e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.5533319921357442 3.714050534621025e-18 -1.0283868142392317e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.5886659751498478 8.22059253082117e-18 -1.2868179785107676e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.6238353425351666 1.8029507024234053e-18 -2.532035496868189e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.6586700855176786 -4.2743695835194354e-18 -3.94023132625152e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.6930076163543184 -1.2321506019883392e-17 -1.0906852839154659e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.7266974077497994 -4.959502884786761e-18 -2.106264772755008e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.7596030549167905 1.1611387533964197e-18 -8.088990820207083e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.791601136637689 4.5955213600736825e-18 1.8291953724380552e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.8225829680268535 5.531091322099494e-19 3.1791936324490246e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.8524575897500566 -8.494322511837476e-18 4.5252366370157864e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.881155087269166 -3.078681797506936e-18 -1.807039095304326e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.9086221035504827 -2.2289527148546533e-18 4.705547259923817e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.9348194256204785 3.54359574991542e-18 9.01108365428819e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.959720678451936 -9.566970436270318e-19 4.099396596601949e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.983312851734609 -8.330291345894043e-20 -2.4719213244582227e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 3.005591125329148 -8.420091698287096e-19 -2.226143104163662e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.026556777191456 -8.182704485774988e-19 -1.5149528885274374e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.046215712114616 5.290312807109392e-19 -2.1448476575558015e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0645805725764044 -2.1849514582032866e-18 2.645381499375215e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0816679915133562 5.473483423857046e-18 -2.7054198116554523e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0974961232950764 -8.801982948533646e-19 3.7755042389793954e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.1120843574943637 5.408081391591355e-18 -1.5499356091026515e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.125453862266544 -4.812448761136174e-18 1.3759188579104977e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1376268007103323 2.1664784883982008e-18 -3.799195398756738e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.1486249513795403 -3.491694156208152e-18 1.986978603031939e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1584690002809204 4.183809634475182e-18 -2.2696586596742585e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.167178781827028 -1.722221691912002e-18 1.212071111035693e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.174772879858774 1.934238302287272e-18 -1.600521731083773e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.181268197605641 -2.6459534504195567e-18 -1.9490419769903468e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1866797711799695 9.024797110283616e-19 -3.260234755536654e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1910206870321804 -3.003335576927157e-19 1.6537809569243012e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.194301897533666 7.084791016239853e-19 -2.892029494920417e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1965319308186526 -6.568423616884774e-19 4.218309064572069e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1977172989385703 2.041165007056945e-19 3.9102099430650353e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener new file mode 100644 index 000000000..4f23c0046 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.047915165445753465 +1 0.04802231351691342 +2 0.048239719461782744 +3 0.04857359109038855 +4 0.049033311488364366 +5 0.04963154230555014 +6 0.050384340402776485 +7 0.051311268786300504 +8 0.052435475555697775 +9 0.05378370520437249 +10 0.055386195179487493 +11 0.05727639680489201 +12 0.0594904455746757 +13 0.06206629026694555 +14 0.0650423753741142 +15 0.06845575305892444 +16 0.07233945913039769 +17 0.07671901401468893 +18 0.0816079443211183 +19 0.08700228487145303 +20 0.09287423442674834 +21 0.09915875532610371 +22 0.10574351235340454 +23 0.11246981896117804 +24 0.11913059360211073 +25 0.12547100728346633 +26 0.13121172893889496 +27 0.13617795168389776 +28 0.1402539718077934 +29 0.14333885382495576 +30 0.14533785432318114 +31 0.14616982718314578 +32 0.14578902132130592 +33 0.14428923094501506 +34 0.14185657791087153 +35 0.13869008110148298 +36 0.134941346543859 +37 0.13063373635553316 +38 0.1257833346636765 +39 0.12042219536906727 +40 0.11465716422975336 +41 0.10867396151296281 +42 0.1026372456157865 +43 0.09668288482253863 +44 0.09091912095272867 +45 0.0854257968016882 +46 0.08024828555399126 +47 0.07541378572647194 +48 0.07093818140076627 +49 0.06682800809037619 +50 0.0630822986922996 +51 0.05969427060379134 +52 0.056652831989178296 +53 0.05394301735753944 +54 0.051545513954305 +55 0.04944156947339861 +56 0.04761421591555752 +57 0.046048332504746284 +58 0.04473068132966597 +59 0.043649923607138014 +60 0.04279662300754023 +61 0.04216324119762606 +62 0.04174412965490374 +63 0.041535520841955234 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz new file mode 100644 index 000000000..ad3c2b1cb --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9650132679969041 -1.027236473519677e-17 -9.69477580597205e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9658515958024922 -1.1629165275975635e-17 -4.922760317699093e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.967534841132966 -1.3756823493947977e-17 -5.926727309443253e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9700757519587975 -5.556146655316031e-17 -3.927718963015162e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.973493213557263 -7.580400487008263e-17 -8.546491321322492e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.977812201969367 -8.699329086965011e-17 -6.477453000556222e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9830637040052395 -6.748869966946929e-17 -5.0556680685806e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9892845899205776 -1.7510152462594275e-17 -1.046030331119537e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9965174233235843 -2.812415030282433e-17 2.047996806959193e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.0048101874625672 5.339633478649469e-18 8.171212430132518e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0142159007819123 -1.1464068905633786e-17 6.67604788088329e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.0247920860887367 -3.3482646729339375e-17 -4.709732875022879e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.036600056988615 -5.72805324135138e-17 -3.6084565197956685e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.0497039788018565 -3.827140930259664e-17 -3.3978980459807274e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0641696532154734 -1.5718293890837777e-17 -3.4785164027707723e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.0800629370695853 -1.5957759434596076e-17 -2.1910911233590822e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0974475411792692 7.595901689357475e-18 -3.524981885173811e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.116382064732366 2.72805788657125e-17 -2.3377178984354452e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.1369161084716124 1.2389246873642163e-17 -2.476612490768133e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.159085237912167 1.4930237293291557e-17 -1.4912973947975367e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1829058617995534 3.391737679052517e-18 -1.1407041218305458e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.2083720310075656 5.529880581304536e-18 -1.942968273117341e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2354530299111173 4.708064471677194e-18 -1.133069899923335e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2640918877702085 3.628015467615387e-18 -1.2445503635326376e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.294205778690126 2.1242570679962214e-18 -3.088664319660688e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.325688583006839 9.650562165422795e-19 -1.43177955654866e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3584129714025956 3.731346684832844e-19 -4.2901125350651685e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.392231073786434 7.842829073112183e-19 -1.675526087106893e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.426974757485298 3.607230549812257e-19 -1.2615457891709938e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4624568580652424 -7.652202747082546e-19 -1.63249126385454e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4984759515244073 -1.395022120638157e-18 -1.5074181086141033e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.5348227978200537 -1.7323521230324066e-18 -6.266845284245738e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5712888729031746 -1.3268865228142278e-18 -2.4575245876928464e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.6076702505373506 9.839232491590123e-20 -1.0664047419270732e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.6437703234060304 1.8112062959192348e-18 -2.8432929249766787e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6794021202127105 2.022296537243831e-18 -2.7394262214239845e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.71438987639957 1.1533145734731116e-18 -3.594047199342841e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.7485727100990425 -1.4274852510393468e-20 -2.340872079886466e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7818080776901253 -8.777825404214683e-19 -1.3954765361613596e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.8139744306958527 -1.2692742986861906e-18 -1.7756856349594444e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.8449726869292506 -1.1136582487972903e-18 4.896650380928023e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8747251541795853 -4.704371250968053e-19 -1.1470326333763167e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.90317291752343 -5.364748402383727e-19 5.815460893402686e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.930273232977083 -6.497947454557528e-19 -8.534575704694247e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.955997084368415 -7.002779053804548e-19 2.919407278444437e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.980326957220312 -4.351138875497886e-19 -5.02703159995171e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 3.0032548859985413 2.5504485583094813e-22 -8.192721279917134e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 3.024780720017808 5.739209914474032e-19 -4.86923915793121e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.044910581332539 8.206412058102072e-19 -1.6829667386892113e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.06365550747457 3.365392879078636e-19 5.074552031352709e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.081030256568861 -7.878472771334817e-20 -1.3181929772080142e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.097052256665566 -6.00572278933951e-19 2.3779544130001417e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.111740688661126 -8.219130754820186e-19 1.4029057957464382e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.1251156816792283 -1.0597546396341848e-18 2.6991475490634047e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.137197590141381 -2.890805767445367e-19 -3.8108916270328837e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.148006383366377 2.3019405686521205e-19 1.6520454553963294e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1575611432179076 2.1354148004543236e-19 -7.578499780267394e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.16587965566705 2.405391141606282e-19 3.2214775547068836e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1729780825291383 6.491842917699723e-19 -1.3740971105475293e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1788707009092145 4.880758975582393e-19 -3.4494286115983707e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1835696996208727 2.6512381195549234e-19 -1.1407351242836571e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.18708502351656 2.077536522276986e-19 -2.250246840904706e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1894242581456305 -1.525101016235837e-19 4.775697337160917e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1905925486021225 -7.21047028132917e-19 4.428198138859339e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener new file mode 100644 index 000000000..a84bd3ad9 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.047635908894093054 +1 0.047736658930441475 +2 0.047940966348182706 +3 0.048254478149858324 +4 0.04868574357260001 +5 0.049246299382256956 +6 0.04995076690253158 +7 0.050816944832442625 +8 0.051865875874096856 +9 0.05312185787640378 +10 0.054612361481113945 +11 0.056367806151610536 +12 0.058421135263512176 +13 0.060807119223252895 +14 0.06356130449337603 +15 0.06671851773466381 +16 0.07031083087588776 +17 0.07436489874757661 +18 0.07889860095054747 +19 0.08391695992141349 +20 0.08940731511096373 +21 0.095332107673981 +22 0.101613619044304 +23 0.10813167536592573 +24 0.11472245344322811 +25 0.12117654707403866 +26 0.12724002241909602 +27 0.1326656507692956 +28 0.1373160706576441 +29 0.14108452461342894 +30 0.1438770092004632 +31 0.1456035703665189 +32 0.14619092368373748 +33 0.14561017563640133 +34 0.14397768037281183 +35 0.14147439678842552 +36 0.13829089398224598 +37 0.13455763180714708 +38 0.13029331393519364 +39 0.12551807150539487 +40 0.12026757024434293 +41 0.11465011902507723 +42 0.10884234623099907 +43 0.1029990587591007 +44 0.0972474606142983 +45 0.09168845452857409 +46 0.08639727236948326 +47 0.08141769099262364 +48 0.07677477429976638 +49 0.07248301187526605 +50 0.06854823449180729 +51 0.0649693795034727 +52 0.06174009754549972 +53 0.05885017744163621 +54 0.05628677955537999 +55 0.054034733493071134 +56 0.05207709731954445 +57 0.050398330669674495 +58 0.04898478374525714 +59 0.04782473558511518 +60 0.04690841406250522 +61 0.046228003937556855 +62 0.04577764789727002 +63 0.045553444301691885 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz new file mode 100644 index 000000000..72921e371 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9627999281414616 5.615666700743669e-18 -7.802698369529588e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9636033023206545 1.5631917922237036e-17 -3.5457764159104476e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9652156744583082 2.3135711135276877e-17 -2.908611619611816e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9676482692761101 2.1015556645079148e-17 -1.6293010205487683e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9709178745614298 5.264482388067828e-17 -2.4224867804184815e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9750467779119738 3.9764496981714424e-17 -2.239581594383687e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9800626707357945 2.6836147913233013e-17 -1.3452193008536546e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9859985093443238 6.113780007669188e-18 -3.0047957261304e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9928923200142923 1.7497876008183134e-17 -1.506032625542496e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.000786931616427 3.4223903242204847e-17 -2.964891655861859e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0097296158161195 4.503572926744883e-17 -3.541718869957726e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.019771610900813 2.480314109708142e-17 -4.0048418682697444e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0309675012097457 2.6005339674697617e-17 -4.182420433961385e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.043374419784329 1.6949426484700302e-17 -1.8044552934180284e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.057051037410491 1.5841557990729574e-17 -2.641422062326616e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.0720562966919926 1.0334126593527581e-17 -3.395549031073205e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.088447845963114 2.5109082217226552e-17 -2.161455039230948e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.10628012530331 2.625167014033862e-17 -5.158080107740414e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.125602055315431 4.076629767143062e-17 5.84362280576552e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.146454278053514 4.3193217971089304e-17 5.519632826307303e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1688656564057935 2.741686143348235e-17 7.560159924238478e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.192848608889898 1.181487879034784e-17 6.85959824003222e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2183950705385933 7.396757967977502e-18 2.9362410165355818e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2454742009314272 5.470917796575176e-18 -8.159672496524388e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.2740308428880067 7.19458899661785e-18 4.92673085055146e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.3039849162205006 -1.4634150309778754e-19 3.0342402578471095e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.335232531136875 -1.5066209032132934e-18 2.511319598937541e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.3676487944647193 -4.474024344559759e-18 -2.5689740806138534e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.401089321673525 1.1871163331441292e-18 -3.0892342979165742e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4353910948375144 3.927162490401126e-18 -3.645187667030783e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.470373418636353 1.909977579405276e-18 -2.9629148064070795e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.5058413756347697 5.110630872084528e-19 -1.0947366000092544e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.541591882407717 -3.2584898743361756e-18 -1.6747351392518235e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.5774213685598757 1.8398283990652606e-18 1.065871168625251e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.6131306344897287 -1.0904472208626752e-18 -6.954737597111917e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6485274926989413 7.125549320577437e-19 1.8337477648230484e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.683428475515728 -4.0524855431092898e-19 2.6465594795725192e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.717660527150706 1.2818655262485988e-18 -3.8297385308453583e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7510647209411916 2.066204177466895e-18 -1.3604078123000448e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.783499830062095 -2.5323639924527423e-18 -1.2181012883237012e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.8148465102208258 7.000553213216148e-19 2.819398627291298e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.845008945597195 -2.208252670923779e-18 3.9567079456696047e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.8739123782714886 2.6596430373372376e-18 2.8876181301389232e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.9015003828514594 -1.6690054277732773e-18 -9.4367419832238e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9277322612068843 4.040390429549002e-19 3.7618949274070425e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.952580573656623 -7.47173805446551e-19 -5.54547974486856e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.976028822493278 -1.6148921133437665e-19 -6.919257596163026e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.998069559473256 2.6929088856901298e-18 1.452422041239706e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0187027342820625 -1.7093620428203487e-18 9.237444753942063e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0379342077254545 2.2613186790724866e-18 3.7645809106935985e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.055774426656581 -4.709642589244995e-18 -1.0758640321438875e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0722372536606155 2.4095746657481957e-18 1.874656641636463e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.087338941630731 -3.323285900934374e-18 -4.140687038240485e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.101097264133858 4.943232690277298e-18 1.0201937998787694e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.113530804537935 -2.1733641078259865e-18 -1.1203428766215571e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.124658238323579 1.9211680989809644e-18 2.8452966989972284e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.134497714814392 -3.5475170164822086e-18 -1.4935515521127142e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.143066356534775 1.5944491405118208e-18 5.348207466252733e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1503798577082947 -6.831153260411624e-19 -1.3356915953181697e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1564521658541627 1.362003297347536e-18 7.423528537219815e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.161295232807656 -9.60049011021391e-19 -1.7317499257869902e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.164918823770258 2.9150528435514447e-19 1.7486105210360682e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1673303751628734 -2.2129296097256366e-19 -1.5710555680452162e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1685348940912927 1.3715065825250453e-19 2.1483667757638298e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener new file mode 100644 index 000000000..1984839bc --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04718852646213532 +1 0.047283160956172146 +2 0.04747511085420086 +3 0.04776977222179043 +4 0.04817532181699391 +5 0.048702807749296195 +6 0.049366255340950724 +7 0.05018277372745354 +8 0.05117264315183499 +9 0.05235935607724003 +10 0.05376957702399705 +11 0.05543297641806465 +12 0.0573818829113346 +13 0.05965068711633906 +14 0.06227491847629948 +15 0.06528990770908924 +16 0.06872894243048229 +17 0.0726208267543743 +18 0.07698677168847542 +19 0.08183657801729873 +20 0.08716413405331548 +21 0.09294206740748163 +22 0.09910890618412568 +23 0.10556009621595032 +24 0.11214892032667909 +25 0.11868411890989643 +26 0.1249297209467017 +27 0.13062086061936332 +28 0.135582035058129 +29 0.13970273151662863 +30 0.14288650458207605 +31 0.14504373842671953 +32 0.14609427346508827 +33 0.14598358456335261 +34 0.14476500856408567 +35 0.14260685330748896 +36 0.13969591304956003 +37 0.13620454668076543 +38 0.1321842062167212 +39 0.12764912184641014 +40 0.12262792998593118 +41 0.11718419552185473 +42 0.11147942830232825 +43 0.1056789135155068 +44 0.09992039979763345 +45 0.0943148745135693 +46 0.08894827611828168 +47 0.08387811232739326 +48 0.07913543918746634 +49 0.07473893706476613 +50 0.07069792536693773 +51 0.06701418041650571 +52 0.06368360931825462 +53 0.060697753863787604 +54 0.05804511314512036 +55 0.055712246510686576 +56 0.0536837711960523 +57 0.051943918084662845 +58 0.05047870977730197 +59 0.04927612126902506 +60 0.04832611164129625 +61 0.04762064094372308 +62 0.04715367769874584 +63 0.04692120114181102 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz new file mode 100644 index 000000000..8ccf5405c --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9591623897087491 2.070134595143028e-18 -6.783760938766883e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9599417509336194 1.5657871252664371e-18 -7.40912264689174e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.96150599254328 2.649335438522403e-18 -1.2560155795064998e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9638661371677213 4.27565993671242e-18 -5.388788981756545e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.967038677202195 7.401396410287035e-18 -6.887649545389201e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9710455184310463 5.224496278926808e-18 -1.1654374798988975e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9759138938407643 5.547843945403008e-18 -1.1894908566735771e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.981676237819601 2.0088448187928323e-18 -1.073606321281065e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.988370008046551 6.306272069412626e-18 -8.567391431742155e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9960374392078217 4.170387035260211e-18 -4.290004338645201e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.004725209214497 4.291772126818076e-18 2.385083727871297e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.0144839948322617 8.313034338403398e-18 9.742121691392556e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.025367889603238 1.3320577380955647e-17 1.3983843714884325e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.0374336527222745 8.175636905851956e-18 1.0896885535579161e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.050739753279555 1.3032647267658943e-17 2.6470260596752186e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.0653451702368053 2.7775635598627867e-18 1.0878461595797976e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0813079050346377 -6.496414834018879e-18 1.0921062166316429e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.098683161334266 -1.9292284308612504e-17 4.647423249378435e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.117521145803438 -1.685634833150637e-17 4.737451252291701e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1378644460045604 -1.2390799560837449e-17 -2.4809363991027904e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.159744947529074 -4.896826835741241e-18 -4.500756595315238e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.1831802365350215 -2.84984795398319e-18 -2.795721454616494e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2081691534984906 -1.921449511774351e-18 -1.8688730986320665e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2346887854848823 -3.642543202173335e-19 -1.0003429249525633e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.2626928171563434 -6.028137458323294e-19 -1.3792288783795987e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.2921106890576133 9.668263066562822e-19 -5.365580164859738e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.322847764984687 1.5344569997899088e-19 -9.840334175992458e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.3547868322334535 9.732191014961078e-19 2.306202689523431e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.387790905613603 -2.3784745551563042e-20 -2.094329168817619e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.421704637705814 -2.3200171578979375e-19 -5.489898439244999e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.456355886292428 -2.407158432039951e-19 -3.195871263255272e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.491557636479438 -1.3248215336109345e-18 -5.339278512798408e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5271123722753113 -1.9787540708548694e-19 4.146618048738028e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.562817935706392 -1.0441478069224949e-18 -7.879366834690151e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.598474256401861 7.68543442429244e-19 -4.970616645056197e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6338872879275166 -1.083795443859572e-19 -7.763724889080983e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.668871475681362 1.0495466337728284e-19 5.00131964233327e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.7032517080925986 1.0020421915087044e-21 1.1186574316191638e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.736865321333763 -1.5372039177542188e-19 7.071745194078075e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7695655118629543 1.2379173373589056e-18 7.063144903159402e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.801224258680319 -1.6792148689602195e-19 -7.955353390905458e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.831735012212891 9.301170204693042e-19 4.047240060712058e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.8610132120529315 -1.1135558607642494e-18 -3.970977002219774e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8889937559728893 -7.51979331251582e-20 6.833437605083813e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9156283589471013 -7.887792725835566e-19 -2.467763755253983e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.940883057096827 7.420338528205208e-20 -5.49193801066067e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9647358875990797 6.737963799975154e-19 -5.579571452709694e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.987174756287578 -3.7536693144354833e-19 -4.90229849295237e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.0081956454717558 6.196062671159742e-19 1.010771075958298e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.027801057127224 -1.2167075646167704e-18 -4.9261404432017096e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0459986188884542 1.577466411785048e-18 9.78359929333458e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.062799847258894 -7.946468116502053e-19 -8.023100636470702e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0782190596156394 1.2933669270871441e-18 4.727962327033744e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0922724246231175 -1.693294412970421e-18 -8.441487634997011e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.104977143938317 7.220789580341456e-19 3.610071324180944e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1163507608169834 -8.24222751011127e-19 -6.211882397052009e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.12641055072195 9.327036456363698e-19 4.374508912433152e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.135172975630471 -6.7651400495527e-19 -2.60141522429332e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1426532383943475 3.6614387332279455e-19 4.164695698805335e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1488649278701555 -3.1668225657813854e-19 -6.368054093416723e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.153819740337267 3.6657845904974868e-19 1.5372418993555608e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.157527265087609 -4.602067317279346e-20 5.955629206820233e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.159994824330749 1.798197357343166e-20 -4.14579951653377e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.161227359702318 -6.554049029427552e-20 -1.1761102323255732e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener new file mode 100644 index 000000000..caa49a382 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.047036854765933556 +1 0.04712900790101059 +2 0.047315930542456676 +3 0.0476028898307433 +4 0.047997869685386794 +5 0.04851166259751311 +6 0.04915797781803408 +7 0.04995355222838543 +8 0.050918244845668405 +9 0.05207508936003967 +10 0.05345027118229685 +11 0.05507298616288022 +12 0.0569751275905025 +13 0.05919073674965188 +14 0.06175514111536677 +15 0.06470369471440168 +16 0.06807002963436441 +17 0.07188372949569241 +18 0.0761673494842717 +19 0.08093273905728887 +20 0.08617667944375318 +21 0.09187587020690466 +22 0.09797612894449244 +23 0.10438049481285447 +24 0.11095040890210024 +25 0.11750346019655901 +26 0.12381277704619206 +27 0.12961471829131488 +28 0.13471194133926062 +29 0.1389906438288615 +30 0.14235280546648552 +31 0.1447094850599291 +32 0.14597828453910686 +33 0.14609855818334724 +34 0.14509266838326926 +35 0.14311679012306955 +36 0.14035470358888175 +37 0.13698820383232263 +38 0.1330950671307344 +39 0.12868831059937463 +40 0.12379390210321599 +41 0.11846088739219184 +42 0.11283150314354558 +43 0.1070750673236984 +44 0.10133404517523462 +45 0.09572409113342542 +46 0.09033565698980993 +47 0.08523311836794935 +48 0.08045177478094767 +49 0.07601245157361881 +50 0.07192630503415656 +51 0.06819665462749051 +52 0.06482068009588983 +53 0.061790953751580564 +54 0.05909679467706789 +55 0.05672544347371355 +56 0.05466271320439372 +57 0.05289320471183739 +58 0.05140282968680471 +59 0.050179456032365045 +60 0.04921294562019397 +61 0.04849517579438169 +62 0.04802005029660842 +63 0.047783503910963754 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz new file mode 100644 index 000000000..86d6d7209 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9579016196103356 1.9061681691180945e-18 -4.429263672163551e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9586693800630925 9.236287765412034e-18 -5.894202949517587e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9602103505813253 6.414121357685495e-18 -3.242634139832782e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9625354159063504 1.0538689384431185e-18 -4.119747017369274e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9656608647109681 1.8330881035885337e-18 -9.914472816614703e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9696083371705981 6.948885083516049e-18 -7.217414171911495e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.97440474437409 4.572250982324322e-18 -6.2797750605372646e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9800821500581967 3.45523003086403e-18 -1.3808282286374264e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9866776023342545 -1.8962804285780227e-18 -1.2465895521431162e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9942328999926282 -1.8716183419198823e-18 5.43475830759884e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0027942745895326 1.4055548571304785e-18 9.876766033570556e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.012411965840516 1.2081179993556865e-18 2.6747347678271915e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0231396638921497 1.850379308993011e-18 7.38709429055637e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.035033787892219 2.413443762450223e-18 8.206420580080375e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.048152566073836 6.978045199711779e-18 2.913355951021742e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.062554878535755 9.612997932721302e-18 8.422060714036835e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0782988203951884 8.272994870065851e-18 7.085410910580019e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0954399405101456 5.829277844705627e-18 6.561772401992629e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.1140291102138513 1.3734003861532918e-18 1.0315532680630012e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1341099783954602 4.762844467970076e-18 1.3629911668069608e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1557159749894486 5.437042480656109e-18 6.553779945197074e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.1788668359306556 3.0752497883457786e-18 2.8441943413378477e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2035645793494307 1.2238234554997648e-18 5.721625276266621e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.229789992371192 5.135502732562802e-19 2.7434462711898953e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.257500839442421 1.0983998253699747e-18 -5.0186618951263285e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.2866309102739657 4.828755110817989e-19 -5.101342536101578e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3170900349991457 9.587958752488802e-19 -4.551209335414568e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.3487652341322893 2.3215195735623688e-21 -1.323974143173429e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.3815231597338884 6.139111203801745e-19 -4.0463899326435914e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4152120473454475 5.394040489766463e-19 -4.571253565152978e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.449663236757119 2.0630158953819175e-19 -3.034119481431522e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4846932597853146 -3.31978525464747e-20 -1.5037657706164457e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5201074101394667 -9.858593055536743e-19 1.7106435017246197e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.555705271726889 1.1678372459113928e-19 4.564450595796579e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.591286844063972 -2.944444015281836e-19 -3.529784755159539e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.626657540619206 6.85179124814894e-19 -5.313182419613488e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.66163080618566 -9.245280282850101e-20 -2.3522830249114407e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.696030347654437 1.2546670431874163e-19 1.6684727217366112e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7296920199656576 4.694242302963509e-19 3.4414607201511627e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.762466727128341 3.4593335592561516e-19 4.89072781216662e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.7942234312141343 7.697789035573366e-19 -4.94778371378389e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8248513924493666 -6.458613793038746e-19 -1.5728278231965856e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.854261542060634 2.378822289433945e-19 -7.160443110529563e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8823847528288686 -6.224231367072708e-19 2.355974231319551e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.909169192439375 3.7176731787946437e-19 -3.0705202771249276e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9345778074528672 -2.809499953671749e-19 1.2399665482896128e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9585859834386703 2.090724713636861e-20 9.194715388403889e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9811794021343614 1.9168903632537383e-19 -2.042568591124577e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 3.002352143090754 -3.5726657945829336e-19 -4.352713589832338e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0221050845855286 5.402523046309122e-19 -2.1093295320455642e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0404444802240986 -4.992189225456046e-19 1.243713330573259e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.05738069334046 1.066171311909805e-18 -3.580588586493431e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0729270815007035 -7.391901245212495e-19 3.0903456362466613e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.087099021210521 6.482583804228898e-19 -1.5139554108725306e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.099913061714251 -9.80685033443872e-19 -3.0171770703061235e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1113861963360527 6.670425371609362e-19 -2.2833392370223716e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.121535245294919 -6.281693158081014e-19 2.1600999218439759e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1303763215184026 5.834331410351728e-19 7.271653504769241e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.137924365449716 -4.755754249422687e-19 8.716144125332354e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.144192771989401 2.9360502745278936e-19 -1.2053473395263049e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.149193097011349 -2.2299214678317457e-19 1.1613723140089775e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1529348310353877 2.3762954993171736e-19 -1.4241430848595206e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.155425229934803 -6.566991541911426e-20 1.2085685013997288e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.156669194747217 -5.461125389136238e-22 -3.1104405605022144e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener new file mode 100644 index 000000000..e02e5d375 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.04693910738858697 +1 0.04702980456583738 +2 0.04721378114324349 +3 0.047496236149067006 +4 0.04788505188615871 +5 0.048390886643731375 +6 0.049027284553195195 +7 0.04981078927928397 +8 0.05076104303212698 +9 0.051900845974555625 +10 0.05325614332999277 +11 0.0548558983281081 +12 0.05673179869928445 +13 0.058917733174138856 +14 0.06144896321853982 +15 0.06436090549595162 +16 0.06768743456102094 +17 0.0714586163225178 +18 0.07569779531578565 +19 0.08041798845364473 +20 0.0856175913478734 +21 0.09127546878457823 +22 0.09734126485078005 +23 0.10372214926914533 +24 0.11028378600873942 +25 0.1168482676905463 +26 0.1231932662941457 +27 0.12905698275767444 +28 0.1342298517128384 +29 0.13859503984688984 +30 0.14205339733960604 +31 0.14451604283399902 +32 0.14589946756435343 +33 0.14614055258610756 +34 0.14524679948428623 +35 0.143366245376424 +36 0.14068134036882401 +37 0.13737678259985578 +38 0.13354505983282428 +39 0.1291997293147799 +40 0.12436544553922278 +41 0.11908620949231671 +42 0.11349294779449233 +43 0.1077565678390871 +44 0.10202209593826703 +45 0.09640768491548528 +46 0.09100612688308532 +47 0.08588494968779788 +48 0.08108204125881675 +49 0.07661932604473261 +50 0.07250888910228245 +51 0.0687548199003612 +52 0.0653549236989942 +53 0.06230227046440701 +54 0.059586566577641775 +55 0.057195346925673636 +56 0.05511483131692187 +57 0.05332995526609639 +58 0.0518265643965543 +59 0.05059245897813065 +60 0.049617440637068785 +61 0.048893336120786966 +62 0.04841400988906687 +63 0.04817536992595923 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz new file mode 100644 index 000000000..a7ecdf5e5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9570812373194448 3.4613998125189112e-18 2.7569970655419043e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9578426571265128 5.641312302922459e-18 -8.639118321937047e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.959370913686764 3.0363227196505125e-18 -1.3791760913524557e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.96167682715805 3.761014146766771e-18 -3.2599330918637953e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.9647765912510777 2.6350467923621485e-18 -3.410845604165115e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9686917232051742 3.747910229164567e-18 -2.280962388146549e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9734489865884228 2.934832414924557e-19 -4.26634485998336e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9790802775663097 1.7143211691380835e-18 -3.4335483817050715e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9856224625109657 -5.805213526974288e-19 -4.580902186768157e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.993117151784829 -2.8827692391488186e-18 -3.4597063951901553e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.001610391196647 -4.6164543411878645e-18 -3.470312281081654e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.0111522489912974 -2.245300019369533e-18 -1.2941067318404066e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.021796272321911 -3.984065126395423e-18 -1.7256126871142437e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.0335987830331232 -5.9741061095624735e-18 -1.0957432233051892e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0466179783964202 -1.4060557706871595e-18 -1.1014032872449696e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.0609127983994746 -2.8220124883946853e-18 -2.0556464579657143e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.076541517644615 7.733777915892759e-20 -3.553867491188848e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.093560017341825 1.6207185380534471e-18 -4.569901837850818e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.112019691967707 3.6403359674448875e-18 -4.266397913289836e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1319649468024684 5.496707726977625e-18 -1.5459564542601485e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1534302479166163 4.1289337473667774e-18 8.736587099996707e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.1764366966794237 2.443491691602077e-18 -3.055098961424749e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.2009881098366715 1.1449722559888372e-18 -3.6418634790138536e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2270673627144797 4.971643553439287e-19 -3.8783937647586044e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.254634456798141 5.568840902533679e-19 -9.975513339989968e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.283625496143147 3.789734413963083e-19 -2.923970748221835e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3139526113377813 3.939113650491096e-19 1.7819229063500376e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.345505001302656 2.817131210797504e-20 -1.2483238024697495e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.378151188444916 1.0149812832337465e-19 1.2987361626195926e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4117411600672436 1.3468250823667386e-19 1.324606693001994e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4461078734445723 1.2932618429225422e-19 1.2699329380899498e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4810693381889166 1.4106346156819812e-19 3.159296387774661e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.516431945160656 -1.7536011267159122e-19 -1.0615519771067498e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.551995833853758 -2.2554345134429535e-20 1.411134985540963e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.5875608830388437 -1.7305661938966297e-19 -2.9489952346896916e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6229319671022213 1.2295518070333714e-19 -6.524094257958254e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.6579217620954987 5.69159786327443e-20 -1.918814321765516e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.6923529998543083 7.527783238820891e-20 -6.685787892949857e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7260604398034323 4.421125355248132e-20 2.0748331592498523e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7588935365277623 -1.4133533790042903e-19 -1.3769533583622606e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.7907194837433695 8.470574435904066e-20 2.1782413614092067e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.821425503709742 -7.133798828723469e-20 -1.0524735169828038e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.850920230829894 1.6829324999843436e-19 2.210525323325204e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8791324867785155 -1.6266636563477185e-19 -2.1046300299295986e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.906008642436634 -3.2587839633490265e-20 8.399028328520588e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.931510088341715 -9.935198919415627e-20 -9.787309897059742e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.955610877027743 -2.6618533165392198e-20 -3.297340751362329e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.978295565243762 6.607015330341073e-20 -1.0587938975691151e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9995572849847876 -7.672756342019721e-20 -2.873928612209421e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.019396111296506 1.9919619053666685e-19 1.9539815016664438e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.037817622782657 -1.1754534909696447e-19 -2.213897559031275e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.0548316204469166 2.0732676516955801e-19 3.954677797519834e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.07045099750202 -2.0161074861931864e-19 -2.3692067984317944e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0846907504602603 1.564595013088054e-19 3.245609280486287e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.097567120515525 -1.7455686147516119e-19 -2.860929615362772e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.1090968537001777 1.3733492790560464e-19 2.571447505517765e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1192965685834397 -1.2692590729804976e-19 -1.98221903047547e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1281822196936773 1.2111016584959142e-19 1.798108910238904e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1357686298979393 -5.419754090004404e-20 -1.4461922865961387e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.142069108403626 4.9340771466658974e-20 6.963662744266813e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1470951499852076 -5.446893206820623e-20 -1.2091966777226828e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1508562028522267 1.7652615054588938e-20 5.188389475084607e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1533594948926074 -8.215723139761796e-21 1.0541554084006846e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.1546099102411356 1.1743560519040893e-20 2.9762549237258776e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener new file mode 100644 index 000000000..2500df79b --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.046892856495516666 +1 0.046982837939309005 +2 0.047165365471269594 +3 0.04744560302999105 +4 0.047831380497831574 +5 0.04833328679943668 +6 0.048964780496905405 +7 0.049742304778124906 +8 0.05068538859593769 +9 0.051816709378514694 +10 0.05316208504162121 +11 0.05475035394450371 +12 0.05661309107464164 +13 0.058784097536286176 +14 0.06129858918781147 +15 0.06419200044821873 +16 0.06749831309270628 +17 0.0712478204964421 +18 0.0754642496458234 +19 0.08016119191035755 +20 0.08533784567085377 +21 0.09097414882467499 +22 0.09702162652488346 +23 0.1033895766196234 +24 0.10994581487520075 +25 0.11651474370418288 +26 0.12287638323024674 +27 0.12877028427973788 +28 0.13398088556707574 +29 0.13838948382953603 +30 0.1418963620724326 +31 0.14441264078366234 +32 0.1458543400846629 +33 0.14615723518902515 +34 0.14532173446256647 +35 0.14349102880392256 +36 0.14084682250493796 +37 0.1375747876803251 +38 0.1337750799815571 +39 0.12946196017531197 +40 0.12465941554690191 +41 0.11940930658670187 +42 0.11383633778859738 +43 0.10811190162229885 +44 0.10238230505455916 +45 0.09676695991912386 +46 0.0913598456347534 +47 0.08623001697449988 +48 0.0814168247104995 +49 0.07694276862594737 +50 0.0728204172619373 +51 0.06905426428547713 +52 0.06564244649996731 +53 0.06257830068259038 +54 0.05985174375919278 +55 0.05745047335995536 +56 0.05536089797915914 +57 0.053568176567279184 +58 0.05205813490274401 +59 0.050818541516791056 +60 0.04983916959518793 +61 0.04911182190049014 +62 0.04863034421783403 +63 0.04839063176652785 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz new file mode 100644 index 000000000..631c22a0b --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9566908547471318 1.3270148201500092e-18 -1.3658261339670626e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.957449038142771 -1.5279056755579428e-19 -1.8980182626182348e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9589708042761471 -2.2257753379654846e-19 -1.6469712142104544e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9612669384759813 -1.2598659764499453e-18 -1.2817918745317667e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.964353583176818 -1.3462573176986951e-18 1.333542352728821e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.968252189112954 -2.094385825212704e-18 6.9992985166327795e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.972989439838959 -1.226062754408062e-18 -1.8284408258882989e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9785971403051106 -1.5028791101875017e-18 -3.2024243569837923e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.985112057467045 -2.0679266408338403e-18 -8.818672903492848e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.9925756978943763 -2.6272911108753343e-18 -2.8186669228508543e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0010340040313586 -2.0617627400151947e-18 9.053793162589453e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.0105369471498165 -1.067030245779205e-18 6.295038814467923e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0211379911435214 -2.7783399054658263e-19 -1.8421985795063552e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.0328933972111667 -5.000145413524618e-19 1.284733982472238e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0458613352979396 -8.831365859871112e-20 -9.241452918357839e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.06010076412527 5.599991675407429e-19 1.656378393724355e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0756700380727575 1.1881515713627643e-19 1.0374729568680148e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0926251965615386 -4.780907328754561e-19 -9.853860338101394e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.111017890593853 -5.001479027584727e-19 4.522208001386865e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1308929026150905 -7.239353060840805e-19 5.377856590143728e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1522852210331793 -8.085742267683841e-19 -7.863386600348849e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.1752166409618394 -7.18368789414544e-19 -2.833789840704206e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.199691878951898 -5.437793929010782e-19 -1.4910359537454398e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2256948650663633 -3.7658829406267235e-19 -6.87298308264175e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.253186733943231 -1.6630000773385772e-19 -4.438476408145894e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.282104764506107 1.0383064947861717e-19 -1.5351720668345353e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3123622569749633 1.8727897178887516e-19 -2.959257671190708e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.3438495191159325 1.545794643804289e-19 2.054137690077618e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.376436054026389 3.277091755101114e-20 1.13113686996481e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.409972762302373 -1.0407886939290028e-19 1.550726258402408e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4442934485507495 -5.501013830039914e-20 8.488511833744991e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4792168800365006 1.2288501202090663e-19 -8.32632099445811e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.514550015490968 2.2362129090260996e-19 2.1421119053851698e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.5500932844380015 1.4017802873180892e-19 -6.309153037492794e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.58564654198128 -2.2684284674630273e-21 2.758113230281882e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.621014416899657 -1.0213818861670205e-19 -7.133164384951394e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.6560092215325186 -5.877241218094842e-20 1.0987073814104286e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.6904532157843857 5.475243669575857e-20 3.2350085492278005e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.724180596962584 1.4207466159004384e-19 -1.755305161762538e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7570400849729735 7.31949969097352e-20 1.327137098166742e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.788897972989133 -1.0982793155180968e-19 -2.716361342631266e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8196404519699647 -1.806361870145589e-19 1.1566729586680891e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.8491750273679655 -1.0657362317347546e-19 -2.387985212952573e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8774294962210876 9.52033126585427e-20 1.8470553761824525e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.904349331308226 1.5065823742800477e-19 -1.9661693998391334e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.92989514495213 3.90765327608637e-20 -7.447634146999935e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9540403225814837 -1.1503087669390111e-19 -1.242450908554121e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.976768855301224 -1.7626402180437e-19 -2.063609059227559e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.9980733985953716 -1.171233794899945e-19 1.31078530376537e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0179536228771986 -1.7872855954159816e-20 -2.418193598078979e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0364147660399157 9.728931316087653e-20 2.2548657622086383e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.05346634461535 1.042206704839422e-19 -4.442031316486179e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.069121016318706 6.092089588416818e-20 2.565109679207636e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.083393584400338 -5.0828775279216396e-20 -3.4511888433616e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.096300132876587 -5.2512887698873054e-20 3.861560850034923e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.107857281151254 -1.8218512730271168e-20 -1.9584802225719488e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.118081546569734 2.163266715682127e-20 2.1296159691566633e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1269888031072175 2.0678440778340384e-20 -2.3650116900554497e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1345938136673186 3.8457002353436175e-20 1.4133423717535013e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1409098436947183 2.4296982115559543e-20 -8.857012671706477e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1459483567186157 5.4653214611257706e-21 1.0430370721501559e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.1497187792833 -1.1399642539869383e-20 -4.8755956170048943e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1522283249293204 -1.5075363976053877e-20 3.5997819363002793e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.153481869117152 -1.0794290931167938e-20 -2.516565386940169e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener new file mode 100644 index 000000000..b9f1d6719 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0468675862599136 +1 0.04695718403016402 +2 0.04713893499638353 +3 0.04741798470122928 +4 0.047802135560618735 +5 0.04830194018370214 +6 0.04893081238110813 +7 0.04970514286594315 +8 0.050644401548013994 +9 0.051771202023001936 +10 0.05311129620966222 +11 0.05469345803989541 +12 0.05654920478537778 +13 0.05871229341582533 +14 0.06121791814977299 +15 0.0641015254862787 +16 0.06739715669094927 +17 0.07113522813838814 +18 0.07533967143336269 +19 0.08002438340353833 +20 0.08518898746585474 +21 0.09081398541841777 +22 0.09685188039493388 +23 0.10321309743973481 +24 0.10976657529697155 +25 0.11633791766763717 +26 0.12270836098740698 +27 0.12861822480753152 +28 0.13384882831041867 +29 0.13828036194236445 +30 0.1418127967438358 +31 0.1443572267707269 +32 0.1458294352457013 +33 0.14616463312868416 +34 0.14535968397161714 +35 0.14355507472074472 +36 0.14093213364843651 +37 0.1376769436640077 +38 0.13389365055365746 +39 0.1295970066095933 +40 0.12481065365439488 +41 0.11957546273717595 +42 0.11401288156719806 +43 0.10829448161877818 +44 0.10256724734521462 +45 0.09695125420077028 +46 0.09154110548516632 +47 0.08640662522590538 +48 0.08158794796378174 +49 0.07710787751879086 +50 0.07297923349859223 +51 0.06920671872246592 +52 0.06578864085574675 +53 0.06271847352390512 +54 0.05998624102713974 +55 0.05757972341514071 +56 0.05548541601328643 +57 0.053688595647025265 +58 0.052175081004713 +59 0.05093262316019239 +60 0.049950979727129065 +61 0.04922194037713555 +62 0.04873934072494175 +63 0.048499069047973055 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz new file mode 100644 index 000000000..68ce56e03 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9564769528235888 -4.081266917441785e-20 2.7908590995563204e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9572334263205735 5.793139237674196e-19 2.4185003162589166e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.958751763695091 -1.1359567387731722e-19 3.155591492681714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9610427325580506 4.263983379745125e-19 5.047032241637723e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.964122449291171 -3.0677902327976046e-19 -4.650172702221773e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9680123308996569 -7.45538526892937e-20 -6.970257247008592e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9727390204616129 -3.808551907426885e-19 -1.0826990762924036e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9783342769467933 -3.0348861952035195e-19 -1.2358742897106272e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9848348174402097 -4.584095695768042e-19 -9.271971209596813e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.992282096803991 -1.5086226825266906e-19 -6.183559315633063e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0007220065116598 -6.156031683827155e-19 -4.634132022778111e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.010204470788343 -1.0480581203642447e-18 4.266881407114594e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0207829143103897 -1.3140177167600518e-18 7.245521823821627e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.032513571624667 -5.258368060764154e-19 9.405987362224346e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0454546042753683 -5.640551456381032e-19 1.6491301631013408e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.059664987584168 4.983155605782578e-19 -3.4250313702765564e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0752031254526586 4.67436026454736e-19 -2.845095461161012e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0921251489161405 9.110050220091565e-19 -6.180607952836432e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.110482853138887 6.3557012491399515e-19 -5.077314010018871e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1303212289824893 3.306162067628708e-19 -8.972585851203428e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1516755503443252 3.06529810397258e-19 1.0230296390897176e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.174567988550856 3.1634112764565127e-20 3.211158236815306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.1990037421619237 7.938725892671158e-20 4.764275669257918e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2249673020424345 -6.359958136967343e-20 -1.3487347900221808e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.2524204022209573 4.0368983843111056e-20 4.247511852849374e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.2813009397482813 -8.223640698136658e-20 -2.385478682073356e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3115228265771175 7.151344222945072e-20 2.265934918916512e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.342976946334549 -2.2465718725286376e-20 -6.026096826208427e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.3755333115441912 1.365798958746426e-19 -1.0922892997824771e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4090432941993125 1.5421807062298458e-20 -7.603164867851816e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4433411330757084 1.2263465489498636e-19 -1.4644186229431397e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4782459771560252 -1.3111974826278987e-20 -5.459195156603685e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5135650638013027 8.593769432463794e-20 1.8351203506167365e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.5490989536591657 -1.376732419270732e-20 -1.17665121469279e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.5846474722769193 6.89376852033929e-20 4.485389457303741e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6200151047052884 -2.974868320905954e-20 -7.041753229592538e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.6550139581737247 1.7207084550365028e-20 8.204738077442038e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.689466031649674 -5.0994329962374406e-20 -1.3743625254957537e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7232052107021776 -1.915821745618279e-20 9.992582484315834e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7560798156790374 -3.508406739959154e-20 -1.232616938052844e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.7879556560926417 -2.6694536815958284e-21 -1.3907961273724353e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8187183738450803 1.0055554470722832e-21 -1.6001873827387636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.848274886621655 1.2119052308771354e-20 1.1243050791743687e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8765524574110763 1.2822923481728442e-20 3.1870319452721283e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9034960916674586 -1.1583124770536357e-20 2.3594503082335707e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9290659974092295 -7.968957792852064e-21 1.5564002084628535e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9532352140127287 -3.729091858099146e-21 -1.6708185489246323e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9759874394174197 -1.5155235662274669e-21 -2.0160886778735562e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.997315082213753 1.2243512419222811e-20 -7.785392353887547e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0172176036086396 3.3528726826537933e-21 3.079652244187743e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0357000656683986 8.646308670597711e-21 9.952897799961877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.052771838413057 -9.995445386668589e-21 -7.35603676816985e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0684454585289456 8.897607318654096e-21 -2.2618389133440714e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0827356301736373 -1.7577403791920215e-20 -2.6072419043289368e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0956583569753633 9.135256775001372e-21 1.7420561007689692e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.107230193751229 -7.915614285908413e-21 8.11223834059773e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1174676064867515 1.0705356297191669e-20 5.7106549073573374e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1263864287271423 -4.738709226491207e-21 -1.3325369170643531e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1340013932700996 8.819486705005479e-21 -5.913187693657786e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1403257436809935 -5.116068399802934e-21 -6.03541893106877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1453709279398856 4.66690879611828e-21 1.4256347447713127e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.149146361861662 -4.713953894693887e-21 -5.082605521005283e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1516592519153455 -2.4143343021733654e-21 4.162980272149272e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.15291446930372 1.702097554911546e-22 4.571800149560974e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 new file mode 100644 index 000000000..b7c4a075c --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 @@ -0,0 +1 @@ +1.378510022033408410e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.374149649158943470e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.365386164323188767e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.352133750286003099e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.334262841121765589e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.311599136371373493e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.283922326557654890e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.250964570367895864e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.212408781770814986e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.167886809118204652e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.116977619527808295e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.059205642513455330e-02 0.000000000000000000e+00 0.000000000000000000e+00 9.940394789238792342e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.208912470912980139e-03 0.000000000000000000e+00 0.000000000000000000e+00 8.391169197007053437e-03 0.000000000000000000e+00 0.000000000000000000e+00 7.480181041022698069e-03 0.000000000000000000e+00 0.000000000000000000e+00 6.468458364070799396e-03 0.000000000000000000e+00 0.000000000000000000e+00 5.348070950090709139e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.110748886856484957e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.748029305969009600e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.251460587409648079e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.856572806540479320e-04 0.000000000000000000e+00 0.000000000000000000e+00 -2.045253061764250313e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.624265238991826107e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.087272944572949693e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.397147251201249635e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.516221353232781580e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.419755849999087730e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.205605456844467155e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.891765945738735868e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.046411621116077016e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.083438326205651663e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094271005320850837e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.078186079621248905e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.045852056796305746e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.005739908480898434e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.582470944891540929e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.027644602088387427e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.311261768819506665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.429950574283877666e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.402668266896000340e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.280878871200076624e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.235299504634637557e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.285322439935869226e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.425974145285831121e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.651787645496867810e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.570280415647277467e-04 0.000000000000000000e+00 0.000000000000000000e+00 -3.319806470703911411e-04 0.000000000000000000e+00 0.000000000000000000e+00 2.354599461292655738e-04 0.000000000000000000e+00 0.000000000000000000e+00 7.490319701981655587e-04 0.000000000000000000e+00 0.000000000000000000e+00 1.212168733365171988e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.628156766571992042e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.000098758112630465e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.330887030369986276e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.623185465408864325e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.879418048553359158e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.100817716734189863e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.286142250638482767e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.438452727564343669e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.560803084098245266e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.655709148902988939e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.725163518119613271e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.770648486958304985e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.793146312772643566e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -3.761581922631320025e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.394689268473244043e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener new file mode 100644 index 000000000..b9f1d6719 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener @@ -0,0 +1,65 @@ +#Bead Energy (eV) +0 0.0468675862599136 +1 0.04695718403016402 +2 0.04713893499638353 +3 0.04741798470122928 +4 0.047802135560618735 +5 0.04830194018370214 +6 0.04893081238110813 +7 0.04970514286594315 +8 0.050644401548013994 +9 0.051771202023001936 +10 0.05311129620966222 +11 0.05469345803989541 +12 0.05654920478537778 +13 0.05871229341582533 +14 0.06121791814977299 +15 0.0641015254862787 +16 0.06739715669094927 +17 0.07113522813838814 +18 0.07533967143336269 +19 0.08002438340353833 +20 0.08518898746585474 +21 0.09081398541841777 +22 0.09685188039493388 +23 0.10321309743973481 +24 0.10976657529697155 +25 0.11633791766763717 +26 0.12270836098740698 +27 0.12861822480753152 +28 0.13384882831041867 +29 0.13828036194236445 +30 0.1418127967438358 +31 0.1443572267707269 +32 0.1458294352457013 +33 0.14616463312868416 +34 0.14535968397161714 +35 0.14355507472074472 +36 0.14093213364843651 +37 0.1376769436640077 +38 0.13389365055365746 +39 0.1295970066095933 +40 0.12481065365439488 +41 0.11957546273717595 +42 0.11401288156719806 +43 0.10829448161877818 +44 0.10256724734521462 +45 0.09695125420077028 +46 0.09154110548516632 +47 0.08640662522590538 +48 0.08158794796378174 +49 0.07710787751879086 +50 0.07297923349859223 +51 0.06920671872246592 +52 0.06578864085574675 +53 0.06271847352390512 +54 0.05998624102713974 +55 0.05757972341514071 +56 0.05548541601328643 +57 0.053688595647025265 +58 0.052175081004713 +59 0.05093262316019239 +60 0.049950979727129065 +61 0.04922194037713555 +62 0.04873934072494175 +63 0.048499069047973055 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz new file mode 100644 index 000000000..68ce56e03 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9564769528235888 -4.081266917441785e-20 2.7908590995563204e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9572334263205735 5.793139237674196e-19 2.4185003162589166e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.958751763695091 -1.1359567387731722e-19 3.155591492681714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 1.9610427325580506 4.263983379745125e-19 5.047032241637723e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 1.964122449291171 -3.0677902327976046e-19 -4.650172702221773e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 1.9680123308996569 -7.45538526892937e-20 -6.970257247008592e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 1.9727390204616129 -3.808551907426885e-19 -1.0826990762924036e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 1.9783342769467933 -3.0348861952035195e-19 -1.2358742897106272e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 1.9848348174402097 -4.584095695768042e-19 -9.271971209596813e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 1.992282096803991 -1.5086226825266906e-19 -6.183559315633063e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.0007220065116598 -6.156031683827155e-19 -4.634132022778111e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.010204470788343 -1.0480581203642447e-18 4.266881407114594e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.0207829143103897 -1.3140177167600518e-18 7.245521823821627e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.032513571624667 -5.258368060764154e-19 9.405987362224346e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.0454546042753683 -5.640551456381032e-19 1.6491301631013408e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.059664987584168 4.983155605782578e-19 -3.4250313702765564e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 2.0752031254526586 4.67436026454736e-19 -2.845095461161012e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 2.0921251489161405 9.110050220091565e-19 -6.180607952836432e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 2.110482853138887 6.3557012491399515e-19 -5.077314010018871e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 2.1303212289824893 3.306162067628708e-19 -8.972585851203428e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 2.1516755503443252 3.06529810397258e-19 1.0230296390897176e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 2.174567988550856 3.1634112764565127e-20 3.211158236815306e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 2.1990037421619237 7.938725892671158e-20 4.764275669257918e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 2.2249673020424345 -6.359958136967343e-20 -1.3487347900221808e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 2.2524204022209573 4.0368983843111056e-20 4.247511852849374e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 2.2813009397482813 -8.223640698136658e-20 -2.385478682073356e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 2.3115228265771175 7.151344222945072e-20 2.265934918916512e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 2.342976946334549 -2.2465718725286376e-20 -6.026096826208427e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 2.3755333115441912 1.365798958746426e-19 -1.0922892997824771e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 2.4090432941993125 1.5421807062298458e-20 -7.603164867851816e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 2.4433411330757084 1.2263465489498636e-19 -1.4644186229431397e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 2.4782459771560252 -1.3111974826278987e-20 -5.459195156603685e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 2.5135650638013027 8.593769432463794e-20 1.8351203506167365e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 2.5490989536591657 -1.376732419270732e-20 -1.17665121469279e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 2.5846474722769193 6.89376852033929e-20 4.485389457303741e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 2.6200151047052884 -2.974868320905954e-20 -7.041753229592538e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 2.6550139581737247 1.7207084550365028e-20 8.204738077442038e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 2.689466031649674 -5.0994329962374406e-20 -1.3743625254957537e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 2.7232052107021776 -1.915821745618279e-20 9.992582484315834e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 2.7560798156790374 -3.508406739959154e-20 -1.232616938052844e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 2.7879556560926417 -2.6694536815958284e-21 -1.3907961273724353e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 2.8187183738450803 1.0055554470722832e-21 -1.6001873827387636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 2.848274886621655 1.2119052308771354e-20 1.1243050791743687e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 2.8765524574110763 1.2822923481728442e-20 3.1870319452721283e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 2.9034960916674586 -1.1583124770536357e-20 2.3594503082335707e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 2.9290659974092295 -7.968957792852064e-21 1.5564002084628535e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 2.9532352140127287 -3.729091858099146e-21 -1.6708185489246323e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 2.9759874394174197 -1.5155235662274669e-21 -2.0160886778735562e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 2.997315082213753 1.2243512419222811e-20 -7.785392353887547e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 3.0172176036086396 3.3528726826537933e-21 3.079652244187743e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 3.0357000656683986 8.646308670597711e-21 9.952897799961877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 3.052771838413057 -9.995445386668589e-21 -7.35603676816985e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 3.0684454585289456 8.897607318654096e-21 -2.2618389133440714e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 3.0827356301736373 -1.7577403791920215e-20 -2.6072419043289368e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 3.0956583569753633 9.135256775001372e-21 1.7420561007689692e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 3.107230193751229 -7.915614285908413e-21 8.11223834059773e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 3.1174676064867515 1.0705356297191669e-20 5.7106549073573374e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 3.1263864287271423 -4.738709226491207e-21 -1.3325369170643531e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 3.1340013932700996 8.819486705005479e-21 -5.913187693657786e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 3.1403257436809935 -5.116068399802934e-21 -6.03541893106877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 3.1453709279398856 4.66690879611828e-21 1.4256347447713127e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 3.149146361861662 -4.713953894693887e-21 -5.082605521005283e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 3.1516592519153455 -2.4143343021733654e-21 4.162980272149272e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 3.15291446930372 1.702097554911546e-22 4.571800149560974e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz new file mode 100644 index 000000000..8820085f7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014611936430597623 2.2493990815306725e-20 -1.5381880240164548e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014716052244532903 -3.192901210335874e-19 -1.332961675901475e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0014924029593322138 6.260850114788895e-20 -1.7392110707068206e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0015235318203782654 -2.3501036545957663e-19 -2.781682727066459e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0015648987221995733 1.6908192165753224e-19 2.562952734268418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0016163595466335936 4.109051702724425e-20 3.841672345037767e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0016777013154903107 2.0990916143994459e-19 5.967319357080445e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0017486190765485462 1.6726840851467758e-19 6.811547856088269e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.001828686987556224 2.526534249363127e-19 5.110266969727889e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0019173230282346844 8.314806517430583e-20 3.4080820800355915e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0020137467556785617 3.392910166276092e-19 2.5541118791277015e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.002116929563476926 5.776394979860374e-19 -2.351700908643346e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.002225537035612983 7.242237043020484e-19 -3.993385011419628e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0023378632373813497 2.8981609204935877e-19 -5.184130261869439e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0024517572016108137 3.1088021249203115e-19 -9.08921653311002e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002564542504158233 -2.7464769811717756e-19 1.8877134415268786e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0026729317428155724 -2.57628376151565e-19 1.5680805119245061e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002772939010492642 -5.021023866436339e-19 3.40645543005207e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002859795159836294 -3.502958478702019e-19 2.7983725891513367e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029278728541802888 -1.822198368485328e-19 4.9452600824508524e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002970631119575876 -1.6894456743876968e-19 -5.638449964427965e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0029805936552266933 -1.7435209614335524e-20 -1.769836801820751e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002950549355517977 -4.375445932042005e-20 -2.625840831137101e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028765367472441757 3.5053046716276013e-20 7.433580942571695e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0027564702782450746 -2.2249452686113325e-20 -2.3410253369507314e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.00259006520418934 4.5324773428006787e-20 1.3147617308573999e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023791715308467774 -3.941478823170301e-20 -1.2488749274487472e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0021279561042676334 1.2382029425867962e-20 3.3212962886986883e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0018407278857366192 -7.527630477267312e-20 6.0201760810992874e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0015204033673949903 -8.499762290289411e-21 4.1905007480354537e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0011709323311505221 -6.759035506982326e-20 8.071174887746598e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0007984595854487692 7.226693261653342e-21 3.008847208370852e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00041309628336367693 -4.73647459460636e-20 -1.0114305471015333e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -2.632158010756249e-05 7.58789048122888e-21 6.48513859826387e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0003514479392866044 -3.799515418035005e-20 -2.4721320927205225e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0007144815622053725 1.6396051040236813e-20 3.881077510348118e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0010583946671436592 -9.483721835981538e-21 -4.5220591225545855e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0013793310819489055 2.8105635162068076e-20 7.574828760472563e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0016723679995712852 1.0559092953595619e-20 -5.5074334310946574e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0019316075893473525 1.933665956709069e-20 6.793594892032116e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002152523445352028 1.4712751655395693e-21 7.665402912360721e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0023323328744871826 -5.542140577490966e-22 8.819467341444442e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0024728325817852145 -6.6794418703346916e-21 -6.196631741107309e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002579048706398306 -7.067381988438514e-21 -1.7565395440976557e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026558895881718626 6.384064249449157e-21 -1.3004161363659598e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.00270793751809628 4.3921083091605496e-21 -8.578133384142787e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027393913275684635 2.055297036492193e-21 9.208752540280499e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002754014849551081 8.352840887081676e-22 1.1111716317578613e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027550125591259086 -6.748038329179437e-21 4.290935820773934e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002745189951901616 -1.8479430249022187e-21 -1.697356989787864e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027270454674050365 -4.765431709245858e-21 -5.4855611315508225e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027027845406573134 5.509011325913366e-21 4.0542955618298244e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026743380144968504 -4.903935502200977e-21 1.2466174051256622e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002643383201947176 9.687824086257663e-21 1.43698701005371e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026113660634847326 -5.0349165136484965e-21 -9.601379846777734e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002579523353149828 4.36270792002847e-21 -4.471077692692645e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025489057197806944 -5.9002802584290984e-21 -3.147439793425727e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0025204179388653466 2.61174983095486e-21 7.344306015714114e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002494810582195423 -4.860879157162912e-21 3.2590661762866744e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0024726756271440243 2.8197321548325237e-21 3.326434186938368e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0024544702245190087 -2.572176868587673e-21 -7.857416705048298e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002440536745005933 2.5981058763362823e-21 2.8012890168669263e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0024311185055215356 1.3306655682350944e-21 -2.2944355735675678e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002426371366965546 -9.381147457744651e-23 -2.5197575324993267e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..f7baf95d6 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0026355399409262463 7.281226727383812e-17 -2.5409005387429654e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0026446076540015554 1.0987182616680062e-16 1.128817428770933e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002660172499311446 4.6380974449808005e-17 4.66094003787824e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0026818437317423795 1.9374948224331323e-17 9.66402117666969e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0027090366619222516 3.67385704560455e-17 5.4705090950200755e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0027409604589312088 2.2286689372917813e-17 4.582482106182566e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002776589554789488 9.371721911897417e-18 5.837799118131893e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0028146424001432306 4.774771259503609e-18 4.934080686172595e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0028535511809479855 -4.787836400065832e-18 2.6640584337953218e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.00289142523004571 -7.02455810830397e-18 2.6453525753098815e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0029260110679633347 -1.2493895441512142e-17 2.6769605897187536e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.002954672729056098 -1.1303658625774205e-17 3.529046871819464e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0029743690174441678 -3.349829780823049e-17 4.091354770272915e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0029816280621087015 -7.156906212867277e-18 3.5557176668011836e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0029726689511456613 -1.5537844703191943e-17 2.1908076829292036e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002944330256715138 -4.7320688238834025e-17 -1.678778418139014e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.002893994269121237 -2.769039661336956e-17 1.647049535077062e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0028194481132226773 -5.918599082075604e-17 1.3982306472532055e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0027190463429294085 -7.956873907977161e-17 -2.9081245497719456e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.002591901805995665 -7.233582246374498e-17 -5.5243227617035364e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0024379992284310702 -3.543480588907693e-17 -5.800082124125445e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0022582735577981743 -3.288226614212594e-17 -4.405006074715507e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002054470988140502 -1.9247732994956387e-17 -2.35019973335619e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0018277658938875502 -1.0537150249427461e-17 -1.2693343957783423e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0015793438085661402 -7.204794102913561e-18 -7.719556112502169e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0013109582887076757 -2.6398777814169762e-18 -5.839315987712115e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0010250172914050533 -3.983018060147889e-18 -3.150192884796938e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.000725760446410476 -1.5636248903065155e-18 -2.2275830051055642e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.00041881592732740525 -4.327583968268283e-18 4.630072486605321e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.00011024031340721465 -4.044548356245156e-18 1.936753923159155e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 0.0001940327810420433 -2.1774684227353165e-18 1.6299278321627406e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 0.0004903057712242876 -1.1803954848519803e-18 1.1778958433152993e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 0.0007760012391585212 4.00821181803225e-18 3.064644452655979e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.001048770617166731 3.647448517275304e-18 1.3448845468619752e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0013065363673899978 5.9314205427011624e-18 7.793996384090136e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.001546952205283094 1.5387397567706622e-18 1.2429561344232743e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0017669495024581422 1.1537526976412505e-18 9.109241567568532e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.001963955268883572 -3.238588075326794e-19 8.930710353494864e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0021360876126270694 -2.3111225816625776e-19 2.7555434445513014e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.002282208262707771 2.372656428767415e-18 -2.0241246724360266e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.00240292880353722 8.022777023792641e-19 -2.9216850212096367e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.002500864541177828 4.38288711922005e-18 -3.122519102449274e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002578713799343934 5.552203187976084e-19 -1.7344059472188928e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0026390457266596014 2.159031732457124e-18 -1.3649367701283333e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026842808580573377 -5.702016365401373e-19 7.282754916396266e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027166455711104074 6.637166003560214e-19 8.868271397663553e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027381676411985926 -1.81644821078109e-19 1.303859054322254e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002750676474082126 -1.0075633955110675e-18 1.0822921073888494e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027557693581975982 2.451554374628453e-19 -9.582134820338015e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027548505483420372 -3.3152766162883606e-18 -7.823778305660084e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002749179057536834 1.1383723005871172e-18 -1.1226993381515351e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027398794504428186 -3.016164507199622e-18 -7.232887482992511e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0027279484296395913 2.09936253142976e-18 4.104124306337246e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0027142618754023686 -2.89565550204566e-18 1.3567114614003274e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026995855924574984 2.2388233732558e-18 -1.0513367326261986e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002684586162024586 -2.2698793999517594e-18 6.79210824349021e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0026698379152378187 1.98029401699161e-18 -3.1525156541374656e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002655830942588051 -1.0128431137769682e-18 8.435394457488346e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002642979033630866 1.6187260259166963e-18 2.7753553178154723e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002631626099976083 -8.345686213450697e-19 5.412891102822998e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0026220513510873036 2.54083243445228e-19 4.0420408929572456e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0026144742738465464 -5.983385850893643e-19 7.101490473360711e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0026090595909962332 7.287688049325184e-19 -2.653065734225007e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0026059177089612275 -6.546674098245806e-20 -4.709963730547034e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..5967ed44c --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0017040356077180907 -1.290437499680323e-18 -1.0602299614253574e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0017187621132378087 1.15079505682649e-17 -2.5928027138540892e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0017460397330079126 3.0267717965052924e-17 1.952496994072916e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0017856866034763699 2.0198420414667235e-17 -1.898159833191704e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0018373976522990066 -4.434094916951118e-18 1.0108611087375865e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0019007233740780487 1.960203127649731e-19 -2.9424278455031046e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.001975028767073319 -1.2432114549610934e-17 -2.8954898272767934e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.002059453668350271 -9.67649328165488e-18 5.7322513426991045e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0021528586050979285 9.024624804636823e-18 6.066106069010843e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0022537565911957087 -2.080198006648363e-18 1.3122135488890702e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.002360229289917847 -8.25147194190153e-18 1.2707218937599922e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0024698557976868874 -4.374138465447047e-18 2.011302355105192e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.002579632478589823 -1.6662129424473265e-17 1.515692612856549e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0026858840808502765 -2.0634561436418134e-17 1.3564267298764462e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0027841645247606043 -4.085339712517105e-17 -1.2168718177344511e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002869189636911521 -7.385123735956667e-17 -3.380266787062586e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.002934814403922884 -4.535072104529767e-17 -3.1928770521644364e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002974015260099788 -1.5718608829132548e-17 -2.914644896218094e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002978921343928923 -5.88783380637129e-17 -1.1257575718689688e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029425593968443763 -1.28386856395475e-16 1.0988549601175646e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002861423670647863 -1.2718970679900206e-16 -6.254071500208956e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0027338858806801713 -8.052147070209337e-17 -6.5223419736457995e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0025602227955980935 -4.3137901924772025e-17 -2.9282786812961563e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.002342893729954132 -2.2123008655789097e-17 -1.925112287525796e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0020865338610468946 -1.5630063405820873e-17 -1.6284563122415592e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0017952106337264433 -1.2441452868983412e-17 -3.515334168470137e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0014719134981196745 -1.1392237625623125e-17 -2.026206560535043e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0011207246624111225 -5.665665674168821e-18 -1.3200041472335445e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0007481925173778033 -2.4922883658768463e-18 1.1343340129681533e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0003644739508006735 -1.2361857079676202e-18 2.0759262230450714e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 1.9246289748108995e-05 -2.047006978551582e-18 5.667976151037855e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 0.00039339236157420184 -4.530797338797385e-18 7.092325097848898e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 0.0007528117376026694 -9.937001759782934e-19 1.3955368360539495e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.0010933308205277519 2.3558280332514925e-18 2.1716670106556385e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0014111866582478241 6.7910246707346586e-18 6.011335512984039e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0017012447810224938 2.7334407328792872e-18 1.1608723813303753e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.001957600495216532 -6.39964133259077e-19 4.45826477158937e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0021756311257432556 -2.5328315289370625e-18 -1.0081649825739456e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.002352470915719751 -3.0484729353579074e-19 -1.7522194410459077e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0024902468036651316 4.68166420938948e-18 -2.494093951932134e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0025938241675139313 1.6968221260025154e-18 9.959535025499953e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0026679183633578902 1.2284921057582048e-18 -2.5934725414152688e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0027169547694362623 -1.9530604555930606e-18 -4.966478229818212e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0027450119026566733 5.272856431028689e-19 -2.2593912933796543e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0027557242624618025 4.591258077793744e-20 1.3624047800180964e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027521705440829098 4.640751736081764e-19 1.2269435827540452e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002737091372190672 4.509915260890729e-19 8.349695584605107e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027129406098358585 -2.915767336477218e-19 1.1821374216693957e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0026818928597740857 1.2042407180641552e-18 -1.4580077302865402e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002645858711784296 -3.0167222177457646e-18 1.4910979758479527e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0026065075176801584 4.851231923956279e-19 -2.0808773205156463e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002565288673166457 -2.9806757463228907e-18 8.542503605063263e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0025234736336506346 2.6523915348321596e-18 -7.58340652021016e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002482216388323892 -1.194059300834343e-18 2.093934754425643e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002442476613695741 1.9244547800573167e-18 -1.0951275510994303e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0024050292339066943 -2.305915721627607e-18 1.2509272752147157e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0023704925753636192 9.492062073723253e-19 -6.680356122413402e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023393548732066646 -1.0660596203675025e-18 8.82131010957353e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0023119975114129707 1.4583229623406668e-18 1.0742186976721667e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0022887140061305243 -4.974036430726096e-19 1.7968854311727656e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.002269725419375324 1.6552948937000524e-19 -9.114849483773078e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002255193342441301 -3.90479787946729e-19 1.5939483060596448e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002245230740057281 3.62020087139663e-19 -2.3249301570818586e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0022399072221180364 -1.1249925047794747e-19 -2.1551206604335144e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..bef6012c3 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015767615217615813 5.6616360233021385e-18 5.343296636738627e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0015878831372825902 6.409439573519663e-18 2.7131899876249473e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0016100901339404312 7.582102998414718e-18 3.266528564787154e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001643298970113794 3.062282236407016e-17 2.164770794617584e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0016873678742179632 4.177954110337668e-17 4.7104171614786075e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0017420800461406206 4.794654026308556e-17 3.570062219611515e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0018071205252277332 3.7196542671940794e-17 2.7864423817488193e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0018820461040286972 9.650758370763538e-18 5.765218775615829e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.001966247591316877 1.5500686218204455e-17 -1.1287578660597293e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.002058903648450959 -2.9429505311829116e-18 -4.503581389588023e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0021589254071171667 6.318446352217739e-18 -3.6795182170850673e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.002264891148273813 1.8454033103867986e-17 2.5957794522226054e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0023749706353666804 3.1570289228058976e-17 1.9888086090824815e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0024868391424786186 2.109336994506272e-17 1.8727588512036932e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.002597581936904036 8.663171646573396e-18 1.917191832772002e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0027035908925868335 8.795153598522228e-18 1.2076246077831372e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0028004560295166276 -4.186497631511921e-18 1.942801383814498e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002882859504851784 -1.5035749997606982e-17 1.2884382717400426e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002944484274817157 -6.828360188677846e-18 1.3649903264678332e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029779558575730143 -8.228832549775045e-18 8.219317819696395e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0029749244720921595 -1.8693635516581064e-18 6.2870154191048e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0029285977207323213 -3.047805632952247e-18 1.0708711626567424e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0028354450204368512 -2.594859908113062e-18 6.244939240080849e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0026938020314434177 -1.999588565441954e-18 6.85936622445599e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0025041735655045223 -1.1707888737355286e-18 1.7023240146606783e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002269543341910667 -5.318928193200276e-19 7.891283967954023e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0019949655247256328 -2.0565397891193528e-19 2.3645047950178487e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.001683987100373184 -4.322592192700476e-19 9.234698238706135e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0013401423751859076 -1.9881329130766935e-19 6.953036880148131e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0009685295733146603 4.217528081148711e-19 8.997510880329792e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0005781722309308463 7.6886945655722375e-19 8.308167482279437e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.00018098608387649576 9.547896163771036e-19 3.4539853216248905e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H 0.00021084975318314025 7.313163745694478e-19 1.3544699874372243e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.0005893946284363669 -5.422914251200839e-20 5.877512781090795e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0009497399484314434 -9.982502641745953e-19 1.567087040211069e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0012875735625377106 -1.1145931068655273e-18 1.5098406820827706e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0015981855860858704 -6.356518195855934e-19 1.980866880975076e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0018750088160655793 7.867615810335664e-21 1.2901767056632408e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.002112509452690515 4.837917441198271e-19 7.691199086548695e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0023068713330692326 6.995632727361137e-19 9.786729751232834e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0024586585266080673 6.137951505396521e-19 -2.698799439547664e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0025729907489399767 2.592824381537839e-19 6.321895147254109e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0026551039568063067 2.9567926756746428e-19 -3.2052038391297245e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0027099101310231397 3.581357782224682e-19 4.703849843623236e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.002741927906511207 3.8595968091358893e-19 -1.6090376306147457e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027552015699685265 2.3981395944307175e-19 2.770659330178038e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002753153262087851 -1.4056852346595895e-22 4.51543603862936e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002738800741322868 -3.163177947308016e-19 2.6836916847548675e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027148381243411015 -4.522981740612986e-19 9.275707550701215e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0026836489726233446 -1.854843558219034e-19 -2.796850318640599e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0026473249574448083 4.3422372940051e-20 7.265249081210539e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0026076878848335086 3.3100670942482695e-19 -1.3106147136970798e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0025663133638370505 4.529991677795415e-19 -7.732145611304797e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002524577343866377 5.840860598588886e-19 -1.4876410047654256e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0024837207370865884 1.593273846017186e-19 2.1003811559166352e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002444771507799964 -1.2687195191119553e-19 -9.105284229595923e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0024085544923971003 -1.1769384820926685e-19 4.1769065317098406e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0023757250106996915 -1.325736525961577e-19 -1.7755243161776625e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002346797795052037 -3.577993253543053e-19 7.573365920249572e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0023221714529145935 -2.690040857148673e-19 1.9011600338060158e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023021487349026287 -1.4612356191552667e-19 6.287186289795114e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0022869528947317523 -1.1450387439950962e-19 1.2402284093492013e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0022767404131783233 8.405627209780064e-20 -2.632135908085084e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002271610323431136 3.9740662780253934e-19 -2.440610973964339e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..de5ff07e8 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015472019870115203 -3.0950868380725977e-18 4.3004740686948913e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0015579640991543135 -8.615565344812908e-18 1.9542623343688345e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001579450479108368 -1.2751297190547713e-17 1.603087579918763e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0016115806441290086 -1.1582769461431862e-17 8.979927785406021e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.001654221899564664 -2.9015308452006155e-17 1.3351588242381245e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0017071746683306169 -2.1916288446104426e-17 1.2343502356805905e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0017701523676223172 -1.4790800917692898e-17 7.4142052480465e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00184275537775613 -3.36962306365198e-18 1.6560996580889328e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0019244385713394583 -9.643992176384323e-18 8.300531362388747e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.002014471827563704 -1.8862578232855378e-17 1.6341064435241634e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0021118929636457567 -2.482153951199111e-17 1.9520260091482727e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.002215452596327338 -1.3670304817461486e-17 2.2072772505181393e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0023235506344377716 -1.4332899161573243e-17 2.3051500607622415e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.002434164436865787 -9.341713036268313e-18 9.945294345565358e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0025447692013757374 -8.731108921613499e-18 1.4558254780005074e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0026522519405060576 -5.695676204994062e-18 1.871464186560981e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.002752821530307497 -1.3838924926995584e-17 1.191290615969689e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0028419188659465034 -1.4468664730053435e-17 2.842886998453322e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0029141331982367393 -2.246843306122235e-17 -3.2207253379889103e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029631333272904957 -2.3806035429170945e-17 -3.042157560639207e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0029816255495970024 -1.5110862429352147e-17 -4.166798480425436e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.002961906175003916 -6.511795978309409e-18 -3.780682394198734e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0028991087711357963 -4.076739139105965e-18 -1.618315581742893e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0027905997506822984 -3.0153081667248117e-18 4.497221130241074e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002635464303306933 -3.965313273635874e-18 -2.715378355387205e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0024348773501266393 8.065643568941524e-20 -1.6723280753768624e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0021923757845175662 8.303773667484552e-19 -1.3841192241405657e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.001912606536981902 2.465868186270652e-18 1.415895616312954e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0015984840811887953 -6.54281732476899e-19 1.7026381594081842e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0012536518324158252 -2.164464093533771e-18 2.0090530602604076e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0008835241453577341 -1.0526882705214998e-18 1.6330168986750132e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0004976197891723839 -2.8167352496795407e-19 6.0336644291875165e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0001074789060270249 1.7959237361282775e-18 9.230338912509829e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.0002756106263102932 -1.0140253981784508e-18 -5.874571980306807e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0006449497574223665 6.0100234233238275e-19 3.8331186564578637e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0009959323266346208 -3.927261906985289e-19 -1.0106740434750614e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0013244966167842444 2.233536164868195e-19 -1.458656976618005e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0016259194888878414 -7.065029550179033e-19 2.1107686676827245e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0018939773313488408 -1.1387928976628045e-18 7.497917057120588e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.002123650198958841 1.3957178871052845e-18 6.713591574853779e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.00231161348999244 -3.8583700322853526e-19 -1.5539176464040583e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0024588162086068054 1.2170832318110582e-18 -2.180748135055363e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0025702609900481095 -1.4658680077547674e-18 -1.5915169728269708e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002650986126152824 9.198759483871636e-19 5.201080737696773e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0027057082293819594 -2.226869916890821e-19 -2.0733765190316052e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027387588221744917 4.1180645758124993e-19 3.0564031456617452e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027540285645266 8.900512781956289e-20 3.813563777259429e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002754827453338919 -1.484202551964936e-18 -8.005055468431271e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027440495225975027 9.421185839846095e-19 -5.091237639079016e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002724275727161085 -1.2463306768826055e-18 -2.074856904524641e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.00269778766742136 2.595729691021009e-18 5.929647863544485e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002666585974106742 -1.3280422843333624e-18 -1.0332210593385144e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.00263241169045787 1.8316362062178808e-18 2.2821486095210683e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002596768970751707 -2.7244733800140516e-18 -5.622820175331804e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002560947858883892 1.1978543248624063e-18 6.174793976110749e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025260665611373176 -1.0588559495693535e-18 -1.5681914245928298e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.00249310157874141 1.955221670135554e-18 8.2317416564533505e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002462845587963383 -8.787840895402104e-19 -2.9476761029796035e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024359279212715994 3.765004882208698e-19 7.361693093085441e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002412841215707965 -7.506710607439694e-19 -4.0914937961974585e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0023939636278156036 5.291330871761712e-19 9.544577140638902e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0023795768523545966 -1.60663767441315e-19 -9.637504675726731e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0023698801885218904 1.2196609367389849e-19 8.658906715196399e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002365000875167163 -7.559088169070024e-20 -1.1840769912748795e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..5fa61646e --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001498004723636759 -1.1409591558589891e-18 3.738884501715156e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0015086099724527533 -8.629869578965402e-19 4.083553958610724e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001529789503587304 -1.460186952392329e-18 6.922557010069498e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0015614769325713684 -2.3565392142023744e-18 2.9700426929498125e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0016035614334734423 -4.079295626608952e-18 3.796142931767612e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0016558739060537717 -2.879492414733986e-18 6.423333856608498e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0017181679856933725 -3.0577061798955556e-18 6.555904562517117e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0017900954495346868 -1.1071791631708934e-18 5.917204441332888e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0018711754929809196 -3.475715479474428e-18 4.721936302503411e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.001960757301804675 -2.298517827062839e-18 2.3644451623271616e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0020579753421199882 -2.3654194825989898e-18 -1.3145440509954037e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0021616968549538545 -4.5817468408213395e-18 -5.36939142380683e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0022704612031086368 -7.341665010472152e-18 -7.707225683794779e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.002382411013452219 -4.5060199489424786e-18 -6.005842012078169e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.002495215536020697 -7.182971706285959e-18 -1.4589141332499293e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002605987361372238 -1.530860158581514e-18 -5.995687617851988e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.002711194668420134 3.580513075102675e-18 -6.019167014356874e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002806572591554353 1.0632984189042708e-17 -2.561437367391999e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002887039172189373 9.290412810985269e-18 -2.6110564957562076e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029466237541833674 6.829215955581023e-18 1.3673734578908321e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002978418614464766 2.698896692999304e-18 2.480601724045318e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0029746554866321184 1.5706998586140115e-18 1.5408679215158534e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0029291314253995747 1.0590110508385866e-18 1.030033447112888e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028386452430462132 2.0075955577393002e-19 5.513411649180866e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002701654469845306 3.3224209874987857e-19 7.601649769558112e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0025185602920289093 -5.328684083116833e-19 2.9572511033608097e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002292016956077984 -8.457192915329497e-20 5.423521446940024e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0020267408103642973 -5.363918110030541e-19 -1.2710685962410022e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0017262453112123152 1.3109013911705225e-20 1.1542940474263765e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0013937051880026261 1.2786824703399129e-19 3.02576938895115e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0010336070406796749 1.3267105719033664e-19 1.7614113533066217e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0006537121487424882 7.301782513074265e-19 2.942754890986986e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0002650071063964484 1.090594582416089e-19 -2.2854174987742333e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 0.00012081744400595359 5.754843202820801e-19 4.342730058955542e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0004950508170668607 -4.23584379185957e-19 2.739566105869616e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0008527725833816364 5.973362010620376e-20 4.2789937507204675e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0011897466542456275 -5.78459895367989e-20 -2.7564881291707963e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0015019612816959138 -5.522777193527708e-22 -6.165504609556085e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0017835855408659383 8.472332613053145e-20 -3.8976076463896383e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0020290496724759167 -6.822808157353842e-19 -3.892867577463814e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002234341327466293 9.255029039608618e-20 4.384610213627349e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.00239802067093716 -5.126360058976813e-19 -2.2306451059090046e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002524008022069715 6.13738719153972e-19 2.188612556409696e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0026174094176017026 4.144550335138637e-20 -3.766263903711449e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026830541293773507 4.347374007069442e-19 1.3601133267663014e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002725414581598514 -4.0897356158351636e-20 3.0268935031445936e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002748560033437357 -3.7136433096983837e-19 3.0751928641136146e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027560469343421694 2.0688429546660455e-19 2.701912408695958e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027509085501931426 -3.41497333145499e-19 -5.570886628810639e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027358467210110526 6.705910036523416e-19 2.715052951100467e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027132591102102285 -8.694240219012547e-19 -5.392251893753982e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.002685255341486825 4.379713075438041e-19 4.421949254428487e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026536769810497807 -7.12841976945623e-19 -2.6058266540938686e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002620119544580052 9.332628750692373e-19 4.652544152837966e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0025859551359443842 -3.9797537819769424e-19 -1.989698612009163e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025523556293887777 4.542721504388248e-19 3.4236924075683544e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025203386642577885 -5.140616299484378e-19 -2.4110200407923286e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0024907686771973437 3.7286215583833526e-19 1.4337756227601035e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002464336442922112 -2.0180098705149805e-19 -2.2953810346762476e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.002441584415193866 1.7454011009170573e-19 3.509766775520762e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0024229302188362037 -2.020405099140874e-19 -8.472541949469758e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002408685765458635 2.5364393473973627e-20 -3.2824579079860607e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002399072213307275 -9.91080359564916e-21 2.284966362980935e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.0023942309797528125 3.612278286454814e-20 6.482156962255841e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..e822a3a9d --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014807743308649837 -1.0505887058092435e-18 2.441198244947668e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001491277907657113 -5.090599962350335e-18 3.2486026935260745e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0015122568333512942 -3.535156847777973e-18 1.7871848137910728e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0015436503450411978 -5.80842142927906e-19 2.270607471764644e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.001585356412891211 -1.0103104697600718e-18 5.464383118939204e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0016372183508290353 -3.829893030941696e-18 3.97789341832621e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0016990064284137661 -2.520006009951136e-18 3.4611115957703676e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0017703940445564785 -1.9043574985716695e-18 7.610464623067518e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0018509279438980774 1.0451390562422918e-18 6.870605256551332e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0019399919051437552 1.0315464938836838e-18 -2.995378786231616e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.002036763322180707 -7.746745970371519e-19 -5.4436009439766935e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.00214016215384005 -6.658568461958768e-19 -1.4741858476288841e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.002248791864308612 -1.01984055498659e-18 -4.0714129824112367e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0023608722497397133 -1.3301747453421489e-18 -4.5229864375197436e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.002474164493851269 -3.8459646920005905e-18 -1.6057024284282678e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002585889473015419 -5.298224585167183e-18 -4.641836963367452e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0026926413062906404 -4.5596790013182304e-18 -3.905139535572519e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0027902994913835103 -3.2128190817000078e-18 -3.6165350399349546e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002873944756646831 -7.569525908693894e-19 -5.685428129717458e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.002937786051255617 -2.625052021454353e-18 -7.512155271314056e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0029751089146787396 -2.996637713148432e-18 -3.6121299800996703e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0029782799400507372 -1.6949305667364648e-18 -1.5675838577865686e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0029405549586621056 -6.745129422905802e-19 -3.1534861359580254e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028583983704381184 -2.830443429332456e-19 -1.5120563411989394e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002729992794480249 -6.053854374928701e-19 2.766046349275849e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.0025553890162547713 -2.661378814698771e-19 2.811615963229614e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.002336827153079211 -5.284424186870134e-19 2.508408860783945e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002078789016114934 -1.2795105299802182e-21 7.297112102365087e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.001785190920051589 -3.3835844071434177e-19 2.2301765559868664e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0014590334696496976 -2.9729370729384573e-19 2.5194562813216424e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0011044990232914565 -1.1370356691015064e-19 1.6722615091944026e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.000728474045527725 1.8297068174516436e-20 8.288037542475059e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00034153060121826516 5.433584867859928e-19 -9.428248628290457e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 4.4729928613702004e-05 -6.436560218847456e-20 -2.515706810059038e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0004206576385423998 1.6228366822293045e-19 1.945448495986563e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0007810092548342092 -3.7763795537506564e-19 2.9283719728321277e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0011214761084325387 5.0955562077699595e-20 1.2964658726738278e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0014381870586274454 -6.915124523003794e-20 -9.195823463038295e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0017257679959563953 -2.5872417899555723e-19 -1.8967685132155614e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0019784520254129546 -1.906619167113079e-19 -2.6955352029756163e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002191961800823003 -4.2426530625664714e-19 2.726981686454879e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0023640404835000932 3.5596789496750467e-19 8.66867453776319e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0024975723795376565 -1.3110930456691292e-19 3.9464936947260026e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0025976550899817646 3.4304985690824906e-19 -1.2985002890626848e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026691543067650296 -2.0490036067167298e-19 1.6923238864061963e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002716595567977665 1.5484619710467253e-19 -6.834102427683714e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002744112826027325 -1.1523074441639517e-20 -5.0676872569206734e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027553751654994644 -1.0564982662787236e-19 1.1257660931716211e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027534950663157982 1.9690824735345263e-19 2.3990075016392493e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002741226217730074 -2.9776122523085073e-19 1.1625615300365842e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027210171183558703 2.7514558801772675e-19 -6.854752899211345e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0026950259351253758 -5.87622622650599e-19 1.9734491374178583e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026651396277085886 4.0740623458582193e-19 -1.703250675930513e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026329954258671622 -3.572890073143836e-19 8.344197964953706e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026000031993246514 5.405066755306106e-19 1.662923662688574e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025673676362961673 -3.6764193589479966e-19 1.2584673549850789e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002536118332888804 3.4621687593767855e-19 -1.1905437400933294e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0025071454620700095 -3.215604365327064e-19 -4.007787543846804e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024811713600440513 2.6211442321793636e-19 -4.803921671043517e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0024587643220408645 -1.618210453873145e-19 6.643297910432695e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0024403626283037117 1.229026036055091e-19 -6.400928606954336e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0024262941279157868 -1.309700399835651e-19 7.849195389208352e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002416791585373269 3.6194115801802275e-20 -6.661051413710259e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002412003988990305 3.0099110602025726e-22 1.7143260368608886e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..7c352c65c --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001469513250334811 -1.9077579870642073e-18 -1.519524890790527e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014799662699669614 -3.1092214671358762e-18 4.761468733042548e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0015008456791890858 -1.6734758287001937e-18 7.601358832717238e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0015320939868741657 -2.072891074878274e-18 1.796719168587548e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0015736142621623583 -1.4523117341820631e-18 1.879894925877849e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0016252569776441324 -2.065668822373082e-18 1.2571573495905862e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00168680193561582 -1.617539227920863e-19 2.3514051895324394e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0017579348408543025 -9.448518171717444e-19 1.8924076107817274e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0018382180027824004 3.1995559809772377e-19 2.5247741399763817e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0019270545965308244 1.5888444960788877e-18 1.906824656443837e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.002023645900443283 2.5443687867161873e-18 1.912670113373204e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0021269409768929406 1.2375019579695672e-18 7.132497219341677e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0022355784007285604 2.195826104333711e-18 9.510751617062847e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0023478199006256007 3.292641492862685e-18 6.03921245523709e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0024614762083283712 7.749506766264357e-19 6.070408019960232e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0025738260648993454 1.5553582815999777e-18 1.132973987743553e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0026815302773517467 -4.2624884117296916e-20 1.958721747994062e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0027805440260846755 -8.93262524765794e-19 2.518711273897853e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0028660323664113003 -2.0063790355486845e-18 2.351434429976957e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029322961069643974 -3.0295223426004665e-18 8.520572407155714e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0029727180116830856 -2.2756707578561126e-18 -4.8151888607088714e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.002979748597363763 -1.3467357264304537e-18 1.683824394931201e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0029463641546814694 -6.310539332756418e-19 2.0072209268510097e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028687998643541113 -2.7401320886441965e-19 2.1375851050023198e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0027450860458521457 -3.069278698194426e-19 5.49802573531151e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002575083608944631 -2.088720312210586e-19 1.611552796844625e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.00236081255281684 -2.1710510012448834e-19 -9.821106607295098e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.002106587850051324 -1.5526679549034137e-20 6.880163614705272e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.001816552497616313 -5.594091277195617e-20 -7.158012427127298e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0014936492637529376 -7.423055547558235e-20 -7.30059841441519e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0011419265506866884 -7.127840595812063e-20 -6.999262832668743e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0007678435737205471 -7.77474316940625e-20 -1.7412530316439076e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0003817285543659254 9.66501050678264e-20 5.850766662910998e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H 4.878511036097551e-06 1.2430876062796804e-20 -7.777500968697467e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.00038187429561860125 9.538052976743676e-20 1.625345096641536e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0007437643685096538 -6.776701356178071e-20 3.595768649424572e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0010861963306547985 -3.1369364623954565e-20 1.0575586601703361e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0014053162978807977 -4.1489540002886215e-20 3.684886445784592e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.001695999926795101 -2.4367127939921048e-20 -1.1435487796204823e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0019523958406140983 7.789727692212061e-20 7.589108191806531e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002170085526198702 -4.6685754060170665e-20 -1.200542433714979e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0023464961143062797 3.9318086412278984e-20 5.800730533744231e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.002483915977636879 -9.275518843339408e-20 -1.2183358090935084e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.00258741617017359 8.965391895616138e-20 1.1599713892893256e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026618870542830827 1.7960858239232632e-20 -4.6291426143151284e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.002711886681986388 5.475806355288895e-20 5.394297001016051e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.002741586000131436 1.4670862079135512e-20 1.8173364809614602e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002754709192323633 -3.6414707776682117e-20 5.835565447934759e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002754418830742935 4.2288562394164914e-20 1.5839719654358535e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027434979185450904 -1.097874108950578e-19 -1.076941127372152e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027244233032035913 6.478537318079874e-20 1.2201944240906124e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0026993799489194773 -1.1426859467487435e-19 -2.1796292145152853e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002670279666386048 1.111181998003872e-19 1.3057934470233581e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026387823626486677 -8.623299226931632e-20 -1.7888245689917968e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.002606318308355086 9.620739143501636e-20 1.5768075402318288e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.0025741103034123618 -7.569244230822956e-20 -1.417258849794037e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025431990534028085 6.99554881055517e-20 1.0925043023990706e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.002514483948458246 -6.675012963789674e-20 -9.910316117522598e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002488703407097418 2.987109179278987e-20 7.970720041082682e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0024664389571649446 -2.71942728236668e-20 -3.838037770600325e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0024481394139077763 3.0020669621623035e-20 6.664513621089672e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002434140727385383 -9.729276936215794e-21 -2.8595920717663266e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0024246815451951214 4.528113563391822e-21 -5.810000314641057e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002419914685433458 -6.472488758953425e-21 -1.6403693331644548e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..75829badd --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014641409867470743 -7.313870859233257e-19 7.527780254083132e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001474566715457001 8.421085150245046e-20 1.0460968672291696e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0014953923256271356 1.226740887619144e-19 9.077317439641083e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001526561930799192 6.943778556033818e-19 7.064623617150034e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0015679811054285613 7.419926300320412e-19 -7.349847496107192e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.001619503847654326 1.1543252737209672e-18 -3.857678503551918e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0016809146674556146 6.757471367232133e-19 1.0077491126124049e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00175190536523897 8.283150694359409e-19 1.765023105076917e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0018320459850228092 1.1397422370698937e-18 4.860430628700528e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0019207493721286164 1.4480371735698845e-18 1.553514365920429e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0020172287516125593 1.1363449898129566e-18 -4.990017667617521e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.0021204477901374777 5.880960259089517e-19 -3.4695242467355865e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0022290627370541724 1.5312880431383814e-19 1.015331728250732e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.002341356495030327 2.7558409504252944e-19 -7.080839108645524e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0024551648913380794 4.8674263790390215e-20 5.093446747558772e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0025677960629525553 -3.086447513983398e-19 -9.129165312829506e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.002675944797077883 -6.548523062583422e-20 -5.718054622496059e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.0027756049558465136 2.6350074062111787e-19 5.430976420417609e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.0028619848327576967 2.7565759746965823e-19 -2.4924247128601015e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.002929432500402341 3.9899850843714993e-19 -2.964017281686533e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.0029713809438389367 4.456474324845773e-19 4.333922518263619e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.002980328467868274 3.959305107449948e-19 1.5618493947772814e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.0029491266593209896 2.997051875533057e-19 8.217876881687788e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028738847213551993 2.0755745211360853e-19 3.7880594791288175e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.002752557212400065 9.165660865169794e-20 2.446275864293882e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.002584909667264986 -5.722648684745478e-20 8.461134022799195e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023728506286044082 -1.0321921002803744e-19 1.6310012606971138e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0021205993745061743 -8.519680585331376e-20 -1.1321424270614465e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0018324084911967777 -1.806176202912201e-20 -6.234285303689933e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0015112012415662568 5.736329378963735e-20 -8.546861285765509e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0011609606783859953 3.0318956606091205e-20 -4.678461641601412e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0007879372163655696 -6.772833994081835e-20 4.589069810019545e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.0004023185934962377 -1.232493577465726e-19 -1.180629605948347e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -1.5604783895120383e-05 -7.725942347278707e-20 3.477303331257842e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.00036189162912327635 1.2502492521189403e-21 -1.5201400673990977e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.000724525821591206 5.629368338585106e-20 3.9314589661718296e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.001067924479747515 3.2392541985966105e-20 -6.055549476692223e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0013882340600252937 -3.017692380977735e-20 -1.7829819530495543e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0016804632478722506 -7.830475677139641e-20 9.67440233276784e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.001938728716055943 -4.034158072773177e-20 -7.314544797165016e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.0021585412978674936 6.05319018227575e-20 1.4971284242908992e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0023371868303834896 9.955802484402133e-20 -6.37502800843576e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0024766309828081266 5.873828272718727e-20 1.3161432107683175e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.0025819174740124794 -5.247151151462468e-20 -1.0180085622347348e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026579482152969095 -8.303561314436324e-20 1.0836585137891672e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.0027092969541693307 -2.1537115479030374e-20 4.10477965512215e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027401527608871385 6.339951628185074e-20 6.847795032970798e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.0027542660130321505 9.714829653978589e-20 1.137362592636912e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.002754826473340431 6.45528037200032e-20 -7.224421528944962e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.0027446317631218643 9.850663183974554e-21 1.332792627513757e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.002726172819643158 -5.362121519951952e-20 -1.2427741378077653e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027016479768145513 -5.744144776740994e-20 2.448235159708105e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.002672981484317526 -3.3576683422061017e-20 -1.4137657431266002e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.0026418446322668274 2.8014389340667076e-20 1.9021301893463377e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026096779574539195 2.894259154027833e-20 -2.1283076076749293e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002577713394439793 1.0041172663123516e-20 1.079420607121359e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.002546998002406411 -1.1922891253609511e-20 -1.1737424436911705e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0025184347511586864 -1.1396967322941268e-20 1.3034813039757315e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.0024927701196040815 -2.11956599561161e-20 -7.789667025511462e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0024705925065677706 -1.3391334200940898e-20 4.881561674807136e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.00245235621031585 -3.0122237343476905e-21 -5.748721364119083e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.0024384014056686425 6.282937621495552e-21 2.687195060910205e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.002428969813430238 8.308819434611232e-21 -1.9840275936424475e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002424216254766057 5.949296774140813e-21 1.3870104515348308e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz new file mode 100644 index 000000000..8820085f7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz @@ -0,0 +1,192 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014611936430597623 2.2493990815306725e-20 -1.5381880240164548e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014716052244532903 -3.192901210335874e-19 -1.332961675901475e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0014924029593322138 6.260850114788895e-20 -1.7392110707068206e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0015235318203782654 -2.3501036545957663e-19 -2.781682727066459e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0015648987221995733 1.6908192165753224e-19 2.562952734268418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0016163595466335936 4.109051702724425e-20 3.841672345037767e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0016777013154903107 2.0990916143994459e-19 5.967319357080445e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0017486190765485462 1.6726840851467758e-19 6.811547856088269e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.001828686987556224 2.526534249363127e-19 5.110266969727889e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.0019173230282346844 8.314806517430583e-20 3.4080820800355915e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0020137467556785617 3.392910166276092e-19 2.5541118791277015e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.002116929563476926 5.776394979860374e-19 -2.351700908643346e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.002225537035612983 7.242237043020484e-19 -3.993385011419628e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0023378632373813497 2.8981609204935877e-19 -5.184130261869439e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0024517572016108137 3.1088021249203115e-19 -9.08921653311002e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.002564542504158233 -2.7464769811717756e-19 1.8877134415268786e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H -0.0026729317428155724 -2.57628376151565e-19 1.5680805119245061e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H -0.002772939010492642 -5.021023866436339e-19 3.40645543005207e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H -0.002859795159836294 -3.502958478702019e-19 2.7983725891513367e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H -0.0029278728541802888 -1.822198368485328e-19 4.9452600824508524e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H -0.002970631119575876 -1.6894456743876968e-19 -5.638449964427965e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H -0.0029805936552266933 -1.7435209614335524e-20 -1.769836801820751e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H -0.002950549355517977 -4.375445932042005e-20 -2.625840831137101e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H -0.0028765367472441757 3.5053046716276013e-20 7.433580942571695e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H -0.0027564702782450746 -2.2249452686113325e-20 -2.3410253369507314e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H -0.00259006520418934 4.5324773428006787e-20 1.3147617308573999e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H -0.0023791715308467774 -3.941478823170301e-20 -1.2488749274487472e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H -0.0021279561042676334 1.2382029425867962e-20 3.3212962886986883e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H -0.0018407278857366192 -7.527630477267312e-20 6.0201760810992874e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H -0.0015204033673949903 -8.499762290289411e-21 4.1905007480354537e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H -0.0011709323311505221 -6.759035506982326e-20 8.071174887746598e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H -0.0007984595854487692 7.226693261653342e-21 3.008847208370852e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 +H -0.00041309628336367693 -4.73647459460636e-20 -1.0114305471015333e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 +H -2.632158010756249e-05 7.58789048122888e-21 6.48513859826387e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 +H 0.0003514479392866044 -3.799515418035005e-20 -2.4721320927205225e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 +H 0.0007144815622053725 1.6396051040236813e-20 3.881077510348118e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 +H 0.0010583946671436592 -9.483721835981538e-21 -4.5220591225545855e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 +H 0.0013793310819489055 2.8105635162068076e-20 7.574828760472563e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 +H 0.0016723679995712852 1.0559092953595619e-20 -5.5074334310946574e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 +H 0.0019316075893473525 1.933665956709069e-20 6.793594892032116e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 +H 0.002152523445352028 1.4712751655395693e-21 7.665402912360721e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 +H 0.0023323328744871826 -5.542140577490966e-22 8.819467341444442e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 +H 0.0024728325817852145 -6.6794418703346916e-21 -6.196631741107309e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 +H 0.002579048706398306 -7.067381988438514e-21 -1.7565395440976557e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 +H 0.0026558895881718626 6.384064249449157e-21 -1.3004161363659598e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 +H 0.00270793751809628 4.3921083091605496e-21 -8.578133384142787e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 +H 0.0027393913275684635 2.055297036492193e-21 9.208752540280499e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 +H 0.002754014849551081 8.352840887081676e-22 1.1111716317578613e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 +H 0.0027550125591259086 -6.748038329179437e-21 4.290935820773934e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 +H 0.002745189951901616 -1.8479430249022187e-21 -1.697356989787864e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 +H 0.0027270454674050365 -4.765431709245858e-21 -5.4855611315508225e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 +H 0.0027027845406573134 5.509011325913366e-21 4.0542955618298244e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 +H 0.0026743380144968504 -4.903935502200977e-21 1.2466174051256622e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 +H 0.002643383201947176 9.687824086257663e-21 1.43698701005371e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 +H 0.0026113660634847326 -5.0349165136484965e-21 -9.601379846777734e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 +H 0.002579523353149828 4.36270792002847e-21 -4.471077692692645e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 +H 0.0025489057197806944 -5.9002802584290984e-21 -3.147439793425727e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 +H 0.0025204179388653466 2.61174983095486e-21 7.344306015714114e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 +H 0.002494810582195423 -4.860879157162912e-21 3.2590661762866744e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 +H 0.0024726756271440243 2.8197321548325237e-21 3.326434186938368e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 +H 0.0024544702245190087 -2.572176868587673e-21 -7.857416705048298e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 +H 0.002440536745005933 2.5981058763362823e-21 2.8012890168669263e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 +H 0.0024311185055215356 1.3306655682350944e-21 -2.2944355735675678e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 +H 0.002426371366965546 -9.381147457744651e-23 -2.5197575324993267e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst1D.dat b/drivers/py/pes/friction/onheH/080K/inst1D.dat new file mode 100644 index 000000000..cf099ac41 --- /dev/null +++ b/drivers/py/pes/friction/onheH/080K/inst1D.dat @@ -0,0 +1,64 @@ +1.9564769528235888 0.0468675862599136 +1.9572334263205735 0.04695718403016402 +1.958751763695091 0.04713893499638353 +1.9610427325580506 0.04741798470122928 +1.964122449291171 0.047802135560618735 +1.9680123308996569 0.04830194018370214 +1.9727390204616129 0.04893081238110813 +1.9783342769467933 0.04970514286594315 +1.9848348174402097 0.050644401548013994 +1.992282096803991 0.051771202023001936 +2.0007220065116598 0.05311129620966222 +2.010204470788343 0.05469345803989541 +2.0207829143103897 0.05654920478537778 +2.032513571624667 0.05871229341582533 +2.0454546042753683 0.06121791814977299 +2.059664987584168 0.0641015254862787 +2.0752031254526586 0.06739715669094927 +2.0921251489161405 0.07113522813838814 +2.110482853138887 0.07533967143336269 +2.1303212289824893 0.08002438340353833 +2.1516755503443252 0.08518898746585474 +2.174567988550856 0.09081398541841777 +2.1990037421619237 0.09685188039493388 +2.2249673020424345 0.10321309743973481 +2.2524204022209573 0.10976657529697155 +2.2813009397482813 0.11633791766763717 +2.3115228265771175 0.12270836098740698 +2.342976946334549 0.12861822480753152 +2.3755333115441912 0.13384882831041867 +2.4090432941993125 0.13828036194236445 +2.4433411330757084 0.1418127967438358 +2.4782459771560252 0.1443572267707269 +2.5135650638013027 0.1458294352457013 +2.5490989536591657 0.14616463312868416 +2.5846474722769193 0.14535968397161714 +2.6200151047052884 0.14355507472074472 +2.6550139581737247 0.14093213364843651 +2.689466031649674 0.1376769436640077 +2.7232052107021776 0.13389365055365746 +2.7560798156790374 0.1295970066095933 +2.7879556560926417 0.12481065365439488 +2.8187183738450803 0.11957546273717595 +2.848274886621655 0.11401288156719806 +2.8765524574110763 0.10829448161877818 +2.9034960916674586 0.10256724734521462 +2.9290659974092295 0.09695125420077028 +2.9532352140127287 0.09154110548516632 +2.9759874394174197 0.08640662522590538 +2.997315082213753 0.08158794796378174 +3.0172176036086396 0.07710787751879086 +3.0357000656683986 0.07297923349859223 +3.052771838413057 0.06920671872246592 +3.0684454585289456 0.06578864085574675 +3.0827356301736373 0.06271847352390512 +3.0956583569753633 0.05998624102713974 +3.107230193751229 0.05757972341514071 +3.1174676064867515 0.05548541601328643 +3.1263864287271423 0.053688595647025265 +3.1340013932700996 0.052175081004713 +3.1403257436809935 0.05093262316019239 +3.1453709279398856 0.049950979727129065 +3.149146361861662 0.04922194037713555 +3.1516592519153455 0.04873934072494175 +3.15291446930372 0.048499069047973055 diff --git a/drivers/py/pes/friction/onheH/100K/RESTART b/drivers/py/pes/friction/onheH/100K/RESTART new file mode 100644 index 000000000..0624e1b48 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/RESTART @@ -0,0 +1,117 @@ + + + [ step, potential{electronvolt} ] + + 3 + 30 + + + + + + + + + 3.16681520e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 2.79915077e-03, 2.93159032e-03, 3.20556392e-03, 3.62736154e-03, 4.17095710e-03, + 4.73835527e-03, 5.17352631e-03, 5.36853225e-03, 5.27057363e-03, 4.96114929e-03, + 4.53120212e-03, 4.03844310e-03, 3.58057871e-03, 3.21975741e-03, 2.97766434e-03, + 2.85719331e-03 ] + + + [ -2.87396815e-03, -5.37414453e-20, -6.41607759e-21, -2.92494073e-03, -2.53298931e-20, + -1.14366358e-20, -2.97859217e-03, -2.60754711e-20, 2.50041085e-21, -2.93335423e-03, + -2.37109486e-20, -5.15399210e-20, -2.66789111e-03, -1.22007511e-19, -6.95833096e-20, + -2.11246435e-03, -1.30689373e-20, -6.30037116e-21, -1.28637073e-03, -2.44616489e-21, + -1.16182059e-21, -2.72269841e-04, -3.93318013e-22, -5.93092551e-22, 7.35590685e-04, + -1.21677978e-22, -5.13779713e-22, 1.59390638e-03, -1.90789800e-22, -1.19120265e-22, + 2.21026542e-03, -2.57606535e-22, -5.41705134e-23, 2.55266004e-03, -1.01489108e-22, + -5.06284095e-22, 2.70428771e-03, -5.49079385e-22, -1.04189815e-22, 2.75185424e-03, + -3.82201049e-22, 3.42997163e-22, 2.75434545e-03, 3.12271209e-22, 4.78006580e-22, + 2.74722290e-03, -8.71588324e-22, -3.21571256e-22 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00 ] + + + [ 3.86869172e-03, 0.00000000e+00, 0.00000000e+00, 2.82102908e-03, 0.00000000e+00, + 0.00000000e+00, 6.59392600e-04, 0.00000000e+00, 0.00000000e+00, -2.52241459e-03, + 0.00000000e+00, 0.00000000e+00, -5.85003384e-03, 0.00000000e+00, 0.00000000e+00, + -8.46716753e-03, 0.00000000e+00, 0.00000000e+00, -1.02935239e-02, 0.00000000e+00, + 0.00000000e+00, -1.09155442e-02, 0.00000000e+00, 0.00000000e+00, -1.00310700e-02, + 0.00000000e+00, 0.00000000e+00, -8.52814351e-03, 0.00000000e+00, 0.00000000e+00, + -6.07253176e-03, 0.00000000e+00, 0.00000000e+00, -3.54021984e-03, 0.00000000e+00, + 0.00000000e+00, -1.71585513e-03, 0.00000000e+00, 0.00000000e+00, -4.76917239e-04, + 0.00000000e+00, 0.00000000e+00, 3.00530116e-04, 0.00000000e+00, 0.00000000e+00, + 6.76375315e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, + -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, 5.51152161e-01, 0.00000000e+00, + -6.58276836e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, + 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, + 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, + -3.32077154e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, 5.51152161e-01, + 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, + 5.51152161e-01, 0.00000000e+00, -3.29138418e-33, 5.51152161e-01 ] + + True + + + + + [ 2.11403516e+00, 9.75074564e-20, 1.16412092e-20, 2.12926823e+00, 4.59580763e-20, + 2.07504146e-20, 2.16000451e+00, 4.73108389e-20, -4.53669790e-21, 2.20652827e+00, + 4.30206943e-20, 9.35130526e-20, 2.26859970e+00, 2.21368107e-19, 1.26250634e-19, + 2.34481170e+00, 2.37120313e-20, 1.14312736e-20, 2.43222029e+00, 4.43827506e-21, + 2.10798518e-21, 2.52644695e+00, 7.13628723e-22, 1.07609585e-21, 2.62211671e+00, + 2.20770209e-22, 9.32192140e-22, 2.71388777e+00, 3.46165385e-22, 2.16129543e-22, + 2.79721092e+00, 4.67396398e-22, 9.82859495e-23, 2.86881941e+00, 1.84139907e-22, + 9.18592234e-22, 2.92689838e+00, 9.96239194e-22, 1.89040019e-22, 2.97064403e+00, + 6.93458315e-22, -6.22327531e-22, 2.99980410e+00, -5.66578943e-22, -8.67286048e-22, + 3.01436529e+00, 1.58139328e-21, 5.83452771e-22 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/onheH/100K/control.in b/drivers/py/pes/friction/onheH/100K/control.in new file mode 100644 index 000000000..687e6ee90 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/control.in @@ -0,0 +1,181 @@ +# Physical settings +xc pbe +spin none +relativistic atomic_zora scalar +charge 0.0 +#vdw_correction_hirshfeld + +# k-grid settings (to be adjusted) +k_grid 12 12 12 + +# accuracy requirements +sc_iter_limit 200 +sc_init_iter 200 + +#Mixing settings + mixer pulay + n_max_pulay 10 + charge_mix_param 0.05 + + +# occupation gaussian broadening +occupation_type gaussian 0.1 + +final_forces_cleaned .true. +compute_forces .true. + + +# IPI + output_level MD_light +# use_pimd_wrapper localhost 41000 + use_pimd_wrapper drag092 41111 + +#=============================================================================== + +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for Pd atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species Pd +# global species definitions + nucleus 46 + mass 106.42 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 62 5.0 + radial_multiplier 2 + angular_grids specified + division 0.5211 50 + division 0.9161 110 + division 1.2296 194 + division 1.5678 302 +# division 1.9785 434 +# division 2.0474 590 +# division 2.1195 770 +# division 2.1568 974 +# division 2.7392 1202 +# outer_grid 974 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 5 s 1. + valence 4 p 6. + valence 4 d 9. +# ion occupancy + ion_occ 5 s 0. + ion_occ 4 p 6. + ion_occ 4 d 8. +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A +# +################################################################################ +# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV + ionic 5 p auto + hydro 4 f 8 +# hydro 5 g 10 + hydro 3 s 2.6 + hydro 3 d 2.5 +# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV +# hydro 5 f 17.2 +# hydro 6 h 14 +# hydro 4 d 4 +# hydro 5 f 7.6 +# hydro 3 p 3.3 +# hydro 4 s 9.4 +# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV +# hydro 4 f 20 +# hydro 5 g 12.8 +# hydro 5 d 9.8 +# hydro 6 h 15.2 +# hydro 5 s 10 +# hydro 6 p 9.8 +# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV +# hydro 5 f 9.2 +# hydro 2 s 5.6 +# hydro 5 f 43.2 +# hydro 5 d 13.2 +# hydro 5 g 14 +# hydro 4 p 4.7 +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for H atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species H +# global species definitions + nucleus 1 + mass 1.00794 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 24 5.0 + radial_multiplier 2 + angular_grids specified + division 0.2421 50 + division 0.3822 110 + division 0.4799 194 + division 0.5341 302 +# division 0.5626 434 +# division 0.5922 590 +# division 0.6542 770 +# division 0.6868 1202 +# outer_grid 770 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 1 s 1. +# ion occupancy + ion_occ 1 s 0.5 +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A +# +################################################################################ +# "First tier" - improvements: -1014.90 meV to -62.69 meV + hydro 2 s 2.1 + hydro 2 p 3.5 +# "Second tier" - improvements: -12.89 meV to -1.83 meV +# hydro 1 s 0.85 +# hydro 2 p 3.7 +# hydro 2 s 1.2 +# hydro 3 d 7 +# "Third tier" - improvements: -0.25 meV to -0.12 meV +# hydro 4 f 11.2 +# hydro 3 p 4.8 +# hydro 4 d 9 +# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/100K/geometry.in b/drivers/py/pes/friction/onheH/100K/geometry.in new file mode 100644 index 000000000..cd6ad1f1f --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/geometry.in @@ -0,0 +1,11 @@ +#=======================================# +# iterations/iteration0105/aims-chain-node-0.56500/geometry.in +#=======================================# +lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 +lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 +lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 +atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd +atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd +atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd +atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd +atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/100K/get1D.sh b/drivers/py/pes/friction/onheH/100K/get1D.sh new file mode 100755 index 000000000..5cd175503 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/get1D.sh @@ -0,0 +1,6 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 +xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/onheH/100K/hessian.dat b/drivers/py/pes/friction/onheH/100K/hessian.dat new file mode 100644 index 000000000..536cf2c98 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/hessian.dat @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 diff --git a/drivers/py/pes/friction/onheH/100K/init.xyz b/drivers/py/pes/friction/onheH/100K/init.xyz new file mode 100644 index 000000000..223399063 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/onheH/100K/input.xml b/drivers/py/pes/friction/onheH/100K/input.xml new file mode 100644 index 000000000..bb0d37e40 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/input.xml @@ -0,0 +1,37 @@ + + + [ step, potential{electronvolt}] + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + + + 100 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + true + 0.1 + + + +
diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 new file mode 100644 index 000000000..1733d1ce7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 @@ -0,0 +1 @@ +2.323982344186707391e-03 3.527994179292482739e-35 8.819985448231206847e-36 1.365079083143116252e-03 0.000000000000000000e+00 2.071054543382666004e-35 -7.191903135960085128e-04 -3.847557903766458361e-37 0.000000000000000000e+00 -3.620808285761435881e-03 -9.321541887042361518e-37 -2.982893403853555686e-35 -6.599159614588017038e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.895670439563999402e-03 -7.444103960595957545e-37 0.000000000000000000e+00 -1.053646522664873283e-02 6.225071440410660378e-38 -8.866991759720944843e-34 -1.082883742452135818e-02 -2.266974622120167170e-38 9.067898488480668681e-38 -9.843690630716179363e-03 0.000000000000000000e+00 9.738388466915072345e-39 -8.244750383091021054e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.731049368633099085e-03 6.631144365552691460e-34 -2.653015219475852029e-33 -3.335517703435208602e-03 -7.428786968842975345e-34 0.000000000000000000e+00 -1.623403739839834187e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.713952810114227857e-04 0.000000000000000000e+00 1.393447426386403838e-38 2.370765132173587660e-04 1.531525652046075765e-34 -4.763687875726518946e-37 5.573111738564566877e-04 0.000000000000000000e+00 -1.584654554123033909e-37 3.527994179292482739e-35 5.511521610893899137e-01 -6.757307989119387383e-36 0.000000000000000000e+00 5.511521610893899137e-01 -1.955924989020113250e-35 -3.847557903766458361e-37 5.511521610893899137e-01 1.331353186255454648e-37 -9.321541887042361518e-37 5.511521610893899137e-01 -6.412958209326077841e-37 0.000000000000000000e+00 5.511521610893899137e-01 4.997986953781574199e-35 -7.444103960595957545e-37 5.511521610893899137e-01 1.038915404592981723e-37 6.225071440410660378e-38 5.511521610893899137e-01 4.559131623307001418e-39 -2.266974622120167170e-38 5.511521610893899137e-01 -5.718641564800994941e-40 0.000000000000000000e+00 5.511521610893899137e-01 1.148042823678469121e-40 0.000000000000000000e+00 5.511521610893899137e-01 3.505248973832915832e-40 6.631144365552691460e-34 5.511521610893899137e-01 -1.920649576964299505e-38 -7.428786968842975345e-34 5.511521610893899137e-01 -9.675741736153982565e-39 0.000000000000000000e+00 5.511521610893899137e-01 -2.830887319619275506e-39 0.000000000000000000e+00 5.511521610893899137e-01 1.986584622925215256e-40 1.531525652046075765e-34 5.511521610893899137e-01 -7.690496624136721897e-39 0.000000000000000000e+00 5.511521610893899137e-01 -2.597914167207186500e-39 8.819985448231206847e-36 -6.641010126462829524e-33 5.511521610893899137e-01 2.071054543382666004e-35 -6.653812068363911227e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634119683155083895e-33 5.511521610893899137e-01 -2.982893403853555686e-35 -6.634894114294641858e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.584272948935894259e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634148926933250339e-33 5.511521610893899137e-01 -8.866991759720944843e-34 -6.634248259342086451e-33 5.511521610893899137e-01 9.067898488480668681e-38 -6.634253390337866719e-33 5.511521610893899137e-01 9.738388466915072345e-39 -6.634252703669427652e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252467948811814e-33 5.511521610893899137e-01 -2.653015219475852029e-33 -6.634272024969478722e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634262494215445877e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634255649361028698e-33 5.511521610893899137e-01 1.393447426386403838e-38 -6.634252619815247219e-33 5.511521610893899137e-01 -4.763687875726518946e-37 -6.634260508970333666e-33 5.511521610893899137e-01 -1.584654554123033909e-37 -6.634255416387877452e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 new file mode 100644 index 000000000..c311a0108 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 @@ -0,0 +1 @@ +3.964726446082260554e-03 -4.507098883084088552e-32 -7.201562167118422077e-35 2.904798445378655065e-03 0.000000000000000000e+00 2.071054543382666004e-35 7.188445207921641180e-04 -1.711404482112230359e-34 -6.830227696833855974e-34 -2.503634477509287127e-03 -9.321541887042361518e-37 2.275023201476989070e-31 -5.865553316661879790e-03 5.119578043412289853e-33 -1.023915608682457971e-32 -8.494028656009469658e-03 -2.234298728957662959e-35 0.000000000000000000e+00 -1.032114921615769412e-02 6.225071440410660378e-38 6.875599358897587131e-33 -1.090661791063039787e-02 -6.557019384149806738e-34 3.630841650546278385e-37 -9.995255263113346847e-03 1.704250490834644575e-37 1.296605944787125089e-34 -8.456377757354440611e-03 -6.400763224832467466e-38 1.280152644966493493e-37 -5.950231351785508979e-03 -1.637245688330365260e-34 2.308018812853982003e-33 -3.427819305695332681e-03 4.618597612920159235e-35 -1.973278332012501673e-37 -1.614983753456245485e-03 0.000000000000000000e+00 -1.537677698253533473e-33 -3.841376043916996637e-04 -4.549760815274697375e-38 3.668327834023752787e-38 3.892106891732055596e-04 5.289190910915635562e-34 2.398885884329825534e-37 7.630001130318074445e-04 -1.776319618418504809e-37 1.967984682713975918e-37 -4.507098883084088552e-32 5.511521610893899137e-01 -2.756839242978528887e-34 0.000000000000000000e+00 5.511521610893899137e-01 -1.244838884869908586e-33 -1.711404482112230359e-34 5.511521610893899137e-01 -1.489524580823529361e-33 -9.321541887042361518e-37 5.511521610893899137e-01 -3.148915379699196130e-33 5.119578043412289853e-33 5.511521610893899137e-01 2.419231148981757026e-30 -2.234298728957662959e-35 5.511521610893899137e-01 9.751053198461824091e-35 6.225071440410660378e-38 5.511521610893899137e-01 8.464288150576921194e-37 -6.557019384149806738e-34 5.511521610893899137e-01 -1.980638065000206113e-38 1.704250490834644575e-37 5.511521610893899137e-01 1.697807501951614750e-39 -6.400763224832467466e-38 5.511521610893899137e-01 1.999618410828042082e-39 -1.637245688330365260e-34 5.511521610893899137e-01 -4.168430555639474700e-38 4.618597612920159235e-35 5.511521610893899137e-01 -8.024547853602340285e-39 0.000000000000000000e+00 5.511521610893899137e-01 -2.967387558350777435e-39 -4.549760815274697375e-38 5.511521610893899137e-01 7.368411478388321833e-40 5.289190910915635562e-34 5.511521610893899137e-01 -2.759828427987090464e-38 -1.776319618418504809e-37 5.511521610893899137e-01 -1.754118053366753629e-38 -7.201562167118422077e-35 -6.909936742771563360e-33 5.511521610893899137e-01 2.071054543382666004e-35 -7.879091703343619014e-33 5.511521610893899137e-01 -6.830227696833855974e-34 -8.123777399297238250e-33 5.511521610893899137e-01 2.275023201476989070e-31 -9.783168198172905019e-33 5.511521610893899137e-01 -1.023915608682457971e-32 2.412596896163283396e-30 5.511521610893899137e-01 0.000000000000000000e+00 -6.536742286489091973e-33 5.511521610893899137e-01 6.875599358897587131e-33 -6.633406389658652478e-33 5.511521610893899137e-01 3.630841650546278385e-37 -6.634272624854359864e-33 5.511521610893899137e-01 1.296605944787125089e-34 -6.634251120666207604e-33 5.511521610893899137e-01 1.280152644966493493e-37 -6.634250818855298377e-33 5.511521610893899137e-01 2.308018812853982003e-33 -6.634294502779264823e-33 5.511521610893899137e-01 -1.973278332012501673e-37 -6.634260843021563942e-33 5.511521610893899137e-01 -1.537677698253533473e-33 -6.634255785861267154e-33 5.511521610893899137e-01 3.668327834023752787e-38 -6.634252081632561747e-33 5.511521610893899137e-01 2.398885884329825534e-37 -6.634280416757989064e-33 5.511521610893899137e-01 1.967984682713975918e-37 -6.634270359654244149e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 new file mode 100644 index 000000000..62c897f78 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 @@ -0,0 +1 @@ +3.844010724974936122e-03 -4.515875968214880805e-32 -8.298697808467432324e-35 2.797043896882088487e-03 2.780749780104256225e-31 1.391060774738578121e-31 6.368058476286238105e-04 3.040114182730749323e-31 1.513939394226116981e-31 -2.539512766159894921e-03 -1.759317311544811775e-31 5.157152114740642549e-32 -5.859941045523098767e-03 1.145596502561510285e-31 -1.024286271574577431e-32 -8.471258306207396852e-03 7.602143579118029893e-32 4.752736173654367060e-33 -1.029501419982028522e-02 6.225071440410660378e-38 2.262838224170177394e-33 -1.091549545464691635e-02 3.045775685312478879e-32 -7.778001613719888408e-33 -1.003161068998537769e-02 5.658233454695210541e-37 6.881545100256363342e-34 -8.530502626867756191e-03 2.266791127423502213e-34 -9.069748345652900767e-34 -6.078339722733646679e-03 -1.637245688330365260e-34 -6.248605527877912460e-35 -3.547069841625597689e-03 4.618597612920159235e-35 3.280512313334996993e-37 -1.723130633169183334e-03 1.530175809955914616e-33 -7.780068362451346796e-36 -4.844238294980786168e-04 -1.704911233983017143e-34 3.668327834023752787e-38 2.928034064822703777e-04 5.284082135940964089e-34 7.507660859001154124e-37 6.685482535697628804e-04 1.226145692801611834e-33 1.967984682713975918e-37 -4.515875968214880805e-32 5.511521610893899137e-01 5.667959160145914721e-35 2.780749780104256225e-31 5.511521610893899137e-01 -6.404961486201141219e-34 3.040114182730749323e-31 5.511521610893899137e-01 -1.016399360798333807e-33 -1.759317311544811775e-31 5.511521610893899137e-01 -3.027569273706007140e-33 1.145596502561510285e-31 5.511521610893899137e-01 2.419266634082155738e-30 7.602143579118029893e-32 5.511521610893899137e-01 9.684555902679981271e-35 6.225071440410660378e-38 5.511521610893899137e-01 8.016584457975148506e-37 3.045775685312478879e-32 5.511521610893899137e-01 -2.272037214615348434e-37 5.658233454695210541e-37 5.511521610893899137e-01 5.756735514881372416e-41 2.266791127423502213e-34 5.511521610893899137e-01 -3.847902738474696566e-40 -1.637245688330365260e-34 5.511521610893899137e-01 -6.823693024797313431e-38 4.618597612920159235e-35 5.511521610893899137e-01 -3.011147319032063144e-38 1.530175809955914616e-33 5.511521610893899137e-01 -1.174717736219976340e-38 -1.704911233983017143e-34 5.511521610893899137e-01 3.420570303464206679e-39 5.284082135940964089e-34 5.511521610893899137e-01 -9.060455265737533392e-38 1.226145692801611834e-33 5.511521610893899137e-01 -4.229313988286238627e-38 -8.298697808467432324e-35 -6.577573226872251409e-33 5.511521610893899137e-01 1.391060774738578121e-31 -7.274748967093824978e-33 5.511521610893899137e-01 1.513939394226116981e-31 -7.650652179272043380e-33 5.511521610893899137e-01 5.157152114740642549e-32 -9.661822092179716713e-33 5.511521610893899137e-01 -1.024286271574577431e-32 2.412632381263682107e-30 5.511521610893899137e-01 4.752736173654367060e-33 -6.537407259446910124e-33 5.511521610893899137e-01 2.262838224170177394e-33 -6.633451160027912889e-33 5.511521610893899137e-01 -7.778001613719888408e-33 -6.634480022195171308e-33 5.511521610893899137e-01 6.881545100256363342e-34 -6.634252760906354292e-33 5.511521610893899137e-01 -9.069748345652900767e-34 -6.634253203263982560e-33 5.511521610893899137e-01 -6.248605527877912460e-35 -6.634321055403956282e-33 5.511521610893899137e-01 3.280512313334996993e-37 -6.634282929946901194e-33 5.511521610893899137e-01 -7.780068362451346796e-36 -6.634264565651071176e-33 5.511521610893899137e-01 3.668327834023752787e-38 -6.634249397903405505e-33 5.511521610893899137e-01 7.507660859001154124e-37 -6.634343423026366683e-33 5.511521610893899137e-01 1.967984682713975918e-37 -6.634295111613593346e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener new file mode 100644 index 000000000..9bcf3e815 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.07534249265191222 +1 0.07903029912539845 +2 0.08666367678379965 +3 0.09842268087661127 +4 0.11355434606037879 +5 0.12924298041403828 +6 0.14109517869918695 +7 0.146140043383778 +8 0.14303598618102292 +9 0.13423453145300682 +10 0.12212727591480516 +11 0.10840238888887122 +12 0.09580063281316811 +13 0.08594397358858961 +14 0.07935544881777104 +15 0.07608283680265102 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz new file mode 100644 index 000000000..e3d52ef16 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.110494974775892 5.058669140865308e-18 1.9606891733268663e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.126155541613857 7.801381380050172e-18 3.355966630510679e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.157704226665703 4.3298416648170244e-20 -3.967470566801518e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.205378520917434 -1.7837992996077455e-19 -5.169917424945932e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.2688502454488075 -8.861818192669872e-18 1.0538814065371978e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.346586337943941 -2.9659072207340265e-19 9.478529014219023e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.435503246905292 -6.33556523929927e-20 3.2181073634091064e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.531085569707033 -2.937344635272306e-20 1.1821375471170196e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6278358705896463 -2.600367617345723e-20 -1.1078025012559222e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7203764018785046 -1.5647105147559552e-20 -1.9975808226574186e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.804172276380411 -4.7441934416986817e-20 9.932786887499549e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.8760334676810873 1.637783975177227e-20 7.285184485641294e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.9342346319581067 -1.3759115625467283e-20 -1.170783605563105e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.978034425752113 3.064612126372387e-20 -6.811846768202467e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.0072183105726227 4.3231314000195417e-20 2.6547104460322904e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.0217907296879614 -4.893692094788283e-20 -9.882285136444108e-20 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener new file mode 100644 index 000000000..849997f3a --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.07633813908845237 +1 0.07993815435275359 +2 0.0873832447059137 +3 0.09884012387294204 +4 0.11359729072786186 +5 0.12899194663969443 +6 0.14079673546292057 +7 0.14608586326175726 +8 0.14342508415573038 +9 0.13502380813500559 +10 0.12335299140664559 +11 0.10997629362632595 +12 0.09754155731894167 +13 0.0877386892032888 +14 0.08116002983587733 +15 0.07788600094393765 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz new file mode 100644 index 000000000..69bb35902 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.1147584518052622 3.0103876675006253e-18 5.06130803055962e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1299607126443263 2.0830878459365805e-18 1.3409642544856974e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.1606376698723784 1.7078210554274936e-18 1.3878163871833735e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.207075636123037 1.1320317308081352e-18 1.0240182279487162e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.2690396555788586 9.855198069255856e-19 -1.4753318395096646e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.3451282701340035 2.613441947735528e-19 2.3747347183564723e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4324037719447276 5.455806573085085e-20 3.2586333684400432e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5264953062128064 1.3549272166282897e-20 -3.180639543779679e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6220325230017405 3.5224712846901064e-21 8.353361943577026e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.713680417711326 -2.178250929842398e-22 2.6683725915310473e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7968935733616647 4.746469169016884e-21 -4.779897132401548e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.8684062503516645 3.5718627346856325e-21 -8.414056287571892e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.926406653572097 -5.500711929380195e-21 3.210427358056133e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.9700923135882906 1.8090598442687e-21 6.6792453101594045e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.9992115703737214 1.354611426904172e-20 -1.712606242435436e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.0137517720767093 -6.7391613152366666e-21 1.2438590283385887e-20 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener new file mode 100644 index 000000000..5cec63935 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.07616876475967577 +1 0.07977262815370123 +2 0.08722782891656054 +3 0.0987055255809182 +4 0.11349751279157776 +5 0.12893720191932592 +6 0.1407788079506119 +7 0.14608518936328682 +8 0.14341959972447607 +9 0.1349997355984417 +10 0.12330027818100008 +11 0.1098916237176952 +12 0.09743250000501565 +13 0.08761405341172465 +14 0.08102636597965586 +15 0.07774818265397825 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz new file mode 100644 index 000000000..22e17c2f9 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.114035157351104 9.750745638242172e-20 1.1641209164344636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1292682319969654 4.595807627492749e-20 2.0750414587060597e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.1600045051184527 4.731083888923977e-20 -4.536697897238496e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.2065282692947035 4.302069425091302e-20 9.351305263315544e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.2685996980556125 2.2136810724253764e-19 1.2625063374363074e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.344811698784781 2.371203134878708e-20 1.1431273613249786e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4322202905834622 4.438275058440399e-21 2.1079851772798616e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5264469455800507 7.136287229651099e-22 1.0760958457380333e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6221167134697954 2.207702091513337e-22 9.32192140065788e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.71388777020622 3.4616538460897865e-22 2.1612954272935584e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7972109236591995 4.673963977601391e-22 9.828594945432954e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.8688194109793805 1.8413990671180204e-22 9.185922344926029e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.9268983793088643 9.962391940347706e-22 1.8904001945221255e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.9706440276607315 6.934583146904018e-22 -6.223275306221227e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.9998041025256246 -5.665789427174645e-22 -8.672860482793619e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.014365293736699 1.5813932809068404e-21 5.834527710486858e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 new file mode 100644 index 000000000..f2a95dfe9 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 @@ -0,0 +1 @@ +3.868691719503261281e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.821029077693668410e-03 0.000000000000000000e+00 0.000000000000000000e+00 6.593926001579718948e-04 0.000000000000000000e+00 0.000000000000000000e+00 -2.522414591955846053e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.850033844056849730e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.467167532291274695e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.029352393377242977e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.091554418500154458e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.003107003647626429e-02 0.000000000000000000e+00 0.000000000000000000e+00 -8.528143509325784855e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.072531757908734840e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.540219842558230481e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.715855127579213324e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.769172385684240095e-04 0.000000000000000000e+00 0.000000000000000000e+00 3.005301162559669004e-04 0.000000000000000000e+00 0.000000000000000000e+00 6.763753154811862067e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.320771541072962210e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener new file mode 100644 index 000000000..5cec63935 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.07616876475967577 +1 0.07977262815370123 +2 0.08722782891656054 +3 0.0987055255809182 +4 0.11349751279157776 +5 0.12893720191932592 +6 0.1407788079506119 +7 0.14608518936328682 +8 0.14341959972447607 +9 0.1349997355984417 +10 0.12330027818100008 +11 0.1098916237176952 +12 0.09743250000501565 +13 0.08761405341172465 +14 0.08102636597965586 +15 0.07774818265397825 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz new file mode 100644 index 000000000..22e17c2f9 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.114035157351104 9.750745638242172e-20 1.1641209164344636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.1292682319969654 4.595807627492749e-20 2.0750414587060597e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.1600045051184527 4.731083888923977e-20 -4.536697897238496e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.2065282692947035 4.302069425091302e-20 9.351305263315544e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.2685996980556125 2.2136810724253764e-19 1.2625063374363074e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.344811698784781 2.371203134878708e-20 1.1431273613249786e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4322202905834622 4.438275058440399e-21 2.1079851772798616e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5264469455800507 7.136287229651099e-22 1.0760958457380333e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6221167134697954 2.207702091513337e-22 9.32192140065788e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.71388777020622 3.4616538460897865e-22 2.1612954272935584e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7972109236591995 4.673963977601391e-22 9.828594945432954e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.8688194109793805 1.8413990671180204e-22 9.185922344926029e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.9268983793088643 9.962391940347706e-22 1.8904001945221255e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.9706440276607315 6.934583146904018e-22 -6.223275306221227e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.9998041025256246 -5.665789427174645e-22 -8.672860482793619e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.014365293736699 1.5813932809068404e-21 5.834527710486858e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz new file mode 100644 index 000000000..dfdbd6fef --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0028739681524728193 -5.3741445307501155e-20 -6.416077588622157e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002924940734903256 -2.5329893058437305e-20 -1.1436635843159249e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0029785921715432036 -2.6075471096756448e-20 2.5004108502726884e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0029333542294848348 -2.371094860795661e-20 -5.1539921048829485e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0026678911141586933 -1.2200751070299244e-19 -6.958330962670714e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0021124643512878106 -1.3068937321703359e-20 -6.300371155946738e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0012863707334477366 -2.4461648899685643e-21 -1.1618205860021964e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00027226984101747013 -3.933180128776819e-22 -5.930925509178318e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0007355906847663502 -1.2167797787791417e-22 -5.137797125478023e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.001593906377818842 -1.907897998215784e-22 -1.1912026455054611e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0022102654197531614 -2.5760653471089673e-22 -5.417051344647627e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002552660041369951 -1.0148910752700834e-22 -5.062840952005297e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027042877108995745 -5.490793847542158e-22 -1.0418981525346726e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0027518542412458074 -3.8220104876702117e-22 3.429971634078064e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027543454479608148 3.1227120870647223e-22 4.780065797918473e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0027472228972053887 -8.715883243040457e-22 -3.215712556570762e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..871f37ff0 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00285984498398131 -2.788096429224122e-18 -1.0806380751036718e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0029158243787779595 -4.29974820709718e-18 -1.849648260949839e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002976886684984842 -2.3864015907387848e-20 2.1866799769512033e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0029362131405775618 9.83144838928549e-20 2.8494111614126444e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0026664239842264675 4.884210248071271e-18 -5.8084901474490246e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0020973977238561863 1.6346661742981848e-19 -5.224111750135299e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0012524916466683767 3.49186047336261e-20 -1.773666827960608e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00022167771070979563 1.6189238435946575e-20 -6.515376637984559e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0007927520592887092 1.433198231926963e-20 6.105677426274331e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0016487613283913875 8.623935816870365e-21 1.1009709873583576e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0022516464237361125 2.6147724680183393e-20 -5.474476958685732e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0025773392545781625 -9.026681773165003e-21 -4.015245173196095e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027160824611352457 7.583366311655086e-21 6.452799143741332e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0027546378417424686 -1.6890675963508918e-20 3.7543640673045666e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002751402634522497 -2.3827032137941705e-20 -1.463149399397275e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002741499340473659 2.6971689737486256e-20 5.446642809452727e-20 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..8e6a3c8c3 --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0028767485041119186 -1.6591816686598174e-18 -2.7895508589820186e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002926877633671666 -1.1480983680269885e-18 -7.390753468034148e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002978995374561016 -9.41269265452826e-19 -7.648980009913858e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0029319641844365095 -6.239217348566662e-19 -5.643898593288624e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002665312989009937 -5.431713713834349e-19 8.131323316697366e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0021097825936162015 -1.4404041773761006e-19 -1.3088401720361735e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0012844817902281074 -3.006979583241543e-20 -1.7960028232137282e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0002717419607504435 -7.467710635635139e-21 1.7530163582005415e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0007347461187670165 -1.9414176609322718e-21 -4.603973487564344e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.001592137556816463 1.200547707377611e-22 -1.4706793204140327e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0022083364568336334 -2.6160267400478163e-21 2.634450634308091e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0025511945317676326 -1.9686398653366444e-21 4.6374253064230176e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002703440403219433 3.0317292674080823e-21 -1.7694339764131384e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0027515869778020475 -9.970672427087293e-22 -3.681280487140528e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027545189433933422 -7.465970153746164e-21 9.439066316134703e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002747633066039702 3.7143033228227046e-21 -6.855555915593619e-21 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..dfdbd6fef --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0028739681524728193 -5.3741445307501155e-20 -6.416077588622157e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002924940734903256 -2.5329893058437305e-20 -1.1436635843159249e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0029785921715432036 -2.6075471096756448e-20 2.5004108502726884e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0029333542294848348 -2.371094860795661e-20 -5.1539921048829485e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0026678911141586933 -1.2200751070299244e-19 -6.958330962670714e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0021124643512878106 -1.3068937321703359e-20 -6.300371155946738e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0012863707334477366 -2.4461648899685643e-21 -1.1618205860021964e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00027226984101747013 -3.933180128776819e-22 -5.930925509178318e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0007355906847663502 -1.2167797787791417e-22 -5.137797125478023e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.001593906377818842 -1.907897998215784e-22 -1.1912026455054611e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0022102654197531614 -2.5760653471089673e-22 -5.417051344647627e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002552660041369951 -1.0148910752700834e-22 -5.062840952005297e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027042877108995745 -5.490793847542158e-22 -1.0418981525346726e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0027518542412458074 -3.8220104876702117e-22 3.429971634078064e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0027543454479608148 3.1227120870647223e-22 4.780065797918473e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0027472228972053887 -8.715883243040457e-22 -3.215712556570762e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst1D.dat b/drivers/py/pes/friction/onheH/100K/inst1D.dat new file mode 100644 index 000000000..882931acc --- /dev/null +++ b/drivers/py/pes/friction/onheH/100K/inst1D.dat @@ -0,0 +1,16 @@ +2.114035157351104 0.07616876475967577 +2.1292682319969654 0.07977262815370123 +2.1600045051184527 0.08722782891656054 +2.2065282692947035 0.0987055255809182 +2.2685996980556125 0.11349751279157776 +2.344811698784781 0.12893720191932592 +2.4322202905834622 0.1407788079506119 +2.5264469455800507 0.14608518936328682 +2.6221167134697954 0.14341959972447607 +2.71388777020622 0.1349997355984417 +2.7972109236591995 0.12330027818100008 +2.8688194109793805 0.1098916237176952 +2.9268983793088643 0.09743250000501565 +2.9706440276607315 0.08761405341172465 +2.9998041025256246 0.08102636597965586 +3.014365293736699 0.07774818265397825 diff --git a/drivers/py/pes/friction/onheH/120K/RESTART b/drivers/py/pes/friction/onheH/120K/RESTART new file mode 100644 index 000000000..93d3fdee5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/RESTART @@ -0,0 +1,117 @@ + + + [ step, potential{electronvolt} ] + + 14 + 30 + + + + + + + + + 3.80017824e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 5.09653038e-03, 5.11916391e-03, 5.16082725e-03, 5.21482601e-03, 5.27230650e-03, + 5.32348663e-03, 5.35919650e-03, 5.37241437e-03, 5.35978776e-03, 5.32393395e-03, + 5.27156666e-03, 5.21107730e-03, 5.15103533e-03, 5.09904304e-03, 5.06096826e-03, + 5.04084489e-03 ] + + + [ -1.48599383e-03, 1.64164289e-19, 8.19075971e-20, -1.43119487e-03, -7.70735038e-22, + -4.54701995e-22, -1.32209699e-03, -5.75957152e-21, 4.10131505e-20, -1.16020840e-03, + -5.28009047e-20, 1.07917949e-19, -9.49148954e-04, 3.85694163e-20, 8.24277519e-20, + -6.96120076e-04, 5.23474386e-21, -1.22026449e-21, -4.12365953e-04, 1.41603696e-21, + -2.25412955e-22, -1.12626617e-04, 4.51869787e-22, -8.90261063e-23, 1.86769891e-04, + 1.53257608e-22, -1.22408190e-22, 4.71870632e-04, 2.08295855e-22, -3.41087647e-23, + 7.31421501e-04, 1.62779005e-22, -1.12473926e-22, 9.56625653e-04, -3.81140907e-23, + 3.11850559e-23, 1.14132565e-03, -2.36371954e-22, 2.31713988e-22, 1.28175179e-03, + 1.12629310e-22, 1.37900803e-22, 1.37591552e-03, 2.70876305e-22, -4.61846477e-23, + 1.42305306e-03, 8.31207096e-23, 1.05017290e-22 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00 ] + + + [ -9.95565823e-03, 0.00000000e+00, 0.00000000e+00, -1.00538687e-02, 0.00000000e+00, + 0.00000000e+00, -1.02369953e-02, 0.00000000e+00, 0.00000000e+00, -1.04787058e-02, + 0.00000000e+00, 0.00000000e+00, -1.07175044e-02, 0.00000000e+00, 0.00000000e+00, + -1.08894754e-02, 0.00000000e+00, 0.00000000e+00, -1.09426612e-02, 0.00000000e+00, + 0.00000000e+00, -1.08412047e-02, 0.00000000e+00, 0.00000000e+00, -1.06105486e-02, + 0.00000000e+00, 0.00000000e+00, -1.03358938e-02, 0.00000000e+00, 0.00000000e+00, + -1.00362979e-02, 0.00000000e+00, 0.00000000e+00, -9.73361271e-03, 0.00000000e+00, + 0.00000000e+00, -9.45217139e-03, 0.00000000e+00, 0.00000000e+00, -9.21497425e-03, + 0.00000000e+00, 0.00000000e+00, -9.03459492e-03, 0.00000000e+00, 0.00000000e+00, + -8.93605286e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + -3.33840396e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, + 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -9.02779661e-33, + 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, + -6.67680791e-33, 5.51152161e-01, 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, + 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, + 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, + -6.63272687e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, 5.51152161e-01, + 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, + 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, 5.51152161e-01 ] + + True + + + + + [ 2.41251065e+00, -2.97856563e-19, -1.48611587e-19, 2.41798778e+00, 1.39840700e-21, + 8.25002653e-22, 2.42874003e+00, 1.04500570e-20, -7.44134804e-20, 2.44436524e+00, + 9.58009574e-20, -1.95804275e-19, 2.46426669e+00, -6.99796155e-20, -1.49555346e-19, + 2.48766642e+00, -9.49781972e-21, 2.21402469e-21, 2.51363181e+00, -2.56923054e-21, + 4.08984979e-22, 2.54111699e+00, -8.19863949e-22, 1.61527274e-22, 2.56901719e+00, + -2.78067690e-22, 2.22095091e-22, 2.59622889e+00, -3.77928038e-22, 6.18862941e-23, + 2.62170120e+00, -2.95343130e-22, 2.04070552e-22, 2.64447738e+00, 6.91534814e-23, + -5.65815724e-23, 2.66372727e+00, 4.28868779e-22, -4.20417454e-22, 2.67876999e+00, + -2.04352478e-22, -2.50204594e-22, 2.68908783e+00, -4.91472816e-22, 8.37965466e-23, + 2.69433365e+00, -1.50812635e-22, -1.90541374e-22 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/onheH/120K/clean.sh b/drivers/py/pes/friction/onheH/120K/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/onheH/120K/control.in b/drivers/py/pes/friction/onheH/120K/control.in new file mode 100644 index 000000000..687e6ee90 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/control.in @@ -0,0 +1,181 @@ +# Physical settings +xc pbe +spin none +relativistic atomic_zora scalar +charge 0.0 +#vdw_correction_hirshfeld + +# k-grid settings (to be adjusted) +k_grid 12 12 12 + +# accuracy requirements +sc_iter_limit 200 +sc_init_iter 200 + +#Mixing settings + mixer pulay + n_max_pulay 10 + charge_mix_param 0.05 + + +# occupation gaussian broadening +occupation_type gaussian 0.1 + +final_forces_cleaned .true. +compute_forces .true. + + +# IPI + output_level MD_light +# use_pimd_wrapper localhost 41000 + use_pimd_wrapper drag092 41111 + +#=============================================================================== + +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for Pd atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species Pd +# global species definitions + nucleus 46 + mass 106.42 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 62 5.0 + radial_multiplier 2 + angular_grids specified + division 0.5211 50 + division 0.9161 110 + division 1.2296 194 + division 1.5678 302 +# division 1.9785 434 +# division 2.0474 590 +# division 2.1195 770 +# division 2.1568 974 +# division 2.7392 1202 +# outer_grid 974 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 5 s 1. + valence 4 p 6. + valence 4 d 9. +# ion occupancy + ion_occ 5 s 0. + ion_occ 4 p 6. + ion_occ 4 d 8. +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A +# +################################################################################ +# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV + ionic 5 p auto + hydro 4 f 8 +# hydro 5 g 10 + hydro 3 s 2.6 + hydro 3 d 2.5 +# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV +# hydro 5 f 17.2 +# hydro 6 h 14 +# hydro 4 d 4 +# hydro 5 f 7.6 +# hydro 3 p 3.3 +# hydro 4 s 9.4 +# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV +# hydro 4 f 20 +# hydro 5 g 12.8 +# hydro 5 d 9.8 +# hydro 6 h 15.2 +# hydro 5 s 10 +# hydro 6 p 9.8 +# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV +# hydro 5 f 9.2 +# hydro 2 s 5.6 +# hydro 5 f 43.2 +# hydro 5 d 13.2 +# hydro 5 g 14 +# hydro 4 p 4.7 +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for H atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species H +# global species definitions + nucleus 1 + mass 1.00794 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 24 5.0 + radial_multiplier 2 + angular_grids specified + division 0.2421 50 + division 0.3822 110 + division 0.4799 194 + division 0.5341 302 +# division 0.5626 434 +# division 0.5922 590 +# division 0.6542 770 +# division 0.6868 1202 +# outer_grid 770 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 1 s 1. +# ion occupancy + ion_occ 1 s 0.5 +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A +# +################################################################################ +# "First tier" - improvements: -1014.90 meV to -62.69 meV + hydro 2 s 2.1 + hydro 2 p 3.5 +# "Second tier" - improvements: -12.89 meV to -1.83 meV +# hydro 1 s 0.85 +# hydro 2 p 3.7 +# hydro 2 s 1.2 +# hydro 3 d 7 +# "Third tier" - improvements: -0.25 meV to -0.12 meV +# hydro 4 f 11.2 +# hydro 3 p 4.8 +# hydro 4 d 9 +# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/120K/geometry.in b/drivers/py/pes/friction/onheH/120K/geometry.in new file mode 100644 index 000000000..cd6ad1f1f --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/geometry.in @@ -0,0 +1,11 @@ +#=======================================# +# iterations/iteration0105/aims-chain-node-0.56500/geometry.in +#=======================================# +lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 +lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 +lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 +atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd +atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd +atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd +atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd +atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/120K/get1D.sh b/drivers/py/pes/friction/onheH/120K/get1D.sh new file mode 100755 index 000000000..5cd175503 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/get1D.sh @@ -0,0 +1,6 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 +xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/onheH/120K/init.xyz b/drivers/py/pes/friction/onheH/120K/init.xyz new file mode 100644 index 000000000..223399063 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/onheH/120K/input.xml b/drivers/py/pes/friction/onheH/120K/input.xml new file mode 100644 index 000000000..0a64e3dd1 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/input.xml @@ -0,0 +1,37 @@ + + + [ step, potential{electronvolt}] + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + + + 120 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + true + 0.1 + + + +
diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 new file mode 100644 index 000000000..6d4dbd7ca --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 @@ -0,0 +1 @@ +-1.844793918450345679e-03 -1.567081242456171078e-34 -3.917703106140427695e-35 -2.570225761388031382e-03 0.000000000000000000e+00 1.590514041389915588e-34 -4.075415944452323407e-03 0.000000000000000000e+00 -5.922790753146902056e-33 -6.042250189395489621e-03 -5.687396467330943605e-35 0.000000000000000000e+00 -7.976676983024812845e-03 -4.523074012535564999e-35 9.046148025071129997e-35 -9.567185658640033757e-03 -6.872189503342208881e-36 2.748875801336883553e-35 -1.074537748060947970e-02 -2.092676769397021175e-32 -2.168576963105721394e-36 -1.079626042460744319e-02 1.877088961120179563e-33 1.675473633847229671e-36 -9.956807313834512008e-03 0.000000000000000000e+00 3.062093205163796203e-37 -8.715297745290527531e-03 0.000000000000000000e+00 2.495895880555952630e-37 -6.855665941515712118e-03 -8.540912010442597253e-35 0.000000000000000000e+00 -4.800640890364525279e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.193136728024198283e-03 3.502833213263491982e-37 8.757083033158729956e-38 -2.092590758752521825e-03 3.877766069386422763e-36 1.558900932416652391e-37 -1.424062368170926933e-03 5.904403259294428043e-37 -3.690252037059017527e-38 -1.135659604461088405e-03 7.346839692639293793e-38 0.000000000000000000e+00 -1.567081242456171078e-34 5.511521610893899137e-01 6.526926698720301987e-35 0.000000000000000000e+00 5.511521610893899137e-01 3.983397484861065938e-35 0.000000000000000000e+00 5.511521610893899137e-01 1.127472601085943167e-35 -5.687396467330943605e-35 5.511521610893899137e-01 -5.284942574926353738e-35 -4.523074012535564999e-35 5.511521610893899137e-01 -2.064856016153178020e-34 -6.872189503342208881e-36 5.511521610893899137e-01 -2.459798374890074132e-35 -2.092676769397021175e-32 5.511521610893899137e-01 -2.573034422499837086e-36 1.877088961120179563e-33 5.511521610893899137e-01 -1.005958140899873610e-37 0.000000000000000000e+00 5.511521610893899137e-01 -1.073317348486594660e-38 0.000000000000000000e+00 5.511521610893899137e-01 -4.882604914406672795e-39 -8.540912010442597253e-35 5.511521610893899137e-01 1.683457570236023556e-39 0.000000000000000000e+00 5.511521610893899137e-01 -4.302518470835672672e-40 3.502833213263491982e-37 5.511521610893899137e-01 8.377429489516783288e-40 3.877766069386422763e-36 5.511521610893899137e-01 5.298580927293940932e-41 5.904403259294428043e-37 5.511521610893899137e-01 -2.756084885677734129e-40 7.346839692639293793e-38 5.511521610893899137e-01 -2.967057124982023712e-40 -3.917703106140427695e-35 -6.568983551486505912e-33 5.511521610893899137e-01 1.590514041389915588e-34 -6.594418843625099245e-33 5.511521610893899137e-01 -5.922790753146902056e-33 -6.622978092462850400e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.687102244222972672e-33 5.511521610893899137e-01 9.046148025071129997e-35 -6.840738420089027717e-33 5.511521610893899137e-01 2.748875801336883553e-35 -6.658850802222610742e-33 5.511521610893899137e-01 -2.168576963105721394e-36 -6.636825852896209214e-33 5.511521610893899137e-01 1.675473633847229671e-36 -6.634353414287800141e-33 5.511521610893899137e-01 3.062093205163796203e-37 -6.634263551647194515e-33 5.511521610893899137e-01 2.495895880555952630e-37 -6.634257701078623401e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634251135016138842e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253248725555988e-33 5.511521610893899137e-01 8.757083033158729956e-38 -6.634251980730760317e-33 5.511521610893899137e-01 1.558900932416652391e-37 -6.634252765487899621e-33 5.511521610893899137e-01 -3.690252037059017527e-38 -6.634253094082198617e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253115179421646e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 new file mode 100644 index 000000000..8e3563e3a --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 @@ -0,0 +1 @@ +-5.588390290769351676e-03 -4.778513800279664441e-32 -1.280360420288502258e-34 -6.063077975271012436e-03 0.000000000000000000e+00 4.844034999488235731e-32 -6.942625465958104578e-03 1.288405268714821519e-32 6.855654944762391513e-33 -8.011497376157403205e-03 -5.687396467330943605e-35 -7.372960950250175947e-33 -9.085523438151939940e-03 -7.511081608314641372e-32 1.044245727624339665e-34 -1.009517101919659744e-02 -1.450168842677023220e-32 2.748875801336883553e-35 -1.082180817044043133e-02 2.003708318577403735e-32 -2.168576963105721394e-36 -1.087084760805652299e-02 -3.333201850120244361e-33 1.137609402274975671e-36 -1.033115342074771362e-02 2.379920901475597774e-37 8.670734016379291138e-34 -9.580266204448264350e-03 1.832668450667747749e-37 -2.691526726601033275e-34 -8.619038565384082307e-03 -8.498981806694408055e-35 -2.021035820662732586e-34 -7.400538407583383618e-03 0.000000000000000000e+00 8.525398206091710987e-35 -6.129311879437550695e-03 -7.603312752195839482e-35 5.791888512844881668e-38 -5.084022199422479071e-03 -1.401250545444867159e-35 5.719429193773650986e-37 -4.389808817031836535e-03 1.368977683040576938e-36 6.041464926830159670e-38 -4.059981138815007932e-03 -6.861152144017795913e-35 -1.726717621603182061e-35 -4.778513800279664441e-32 5.511521610893899137e-01 3.186564605354679273e-34 0.000000000000000000e+00 5.511521610893899137e-01 3.815214333743800534e-34 1.288405268714821519e-32 5.511521610893899137e-01 1.027316827045447180e-34 -5.687396467330943605e-35 5.511521610893899137e-01 -5.499608519387215664e-36 -7.511081608314641372e-32 5.511521610893899137e-01 -3.420903972049480002e-34 -1.450168842677023220e-32 5.511521610893899137e-01 -5.519892177093527527e-35 2.003708318577403735e-32 5.511521610893899137e-01 -5.095259606690337328e-36 -3.333201850120244361e-33 5.511521610893899137e-01 -2.927493276716108073e-37 2.379920901475597774e-37 5.511521610893899137e-01 -2.443421671223132694e-38 1.832668450667747749e-37 5.511521610893899137e-01 -7.946927264339651014e-39 -8.498981806694408055e-35 5.511521610893899137e-01 1.269612685861984643e-38 0.000000000000000000e+00 5.511521610893899137e-01 8.254575165101612846e-40 -7.603312752195839482e-35 5.511521610893899137e-01 6.032203647050997826e-40 -1.401250545444867159e-35 5.511521610893899137e-01 -2.626615475226316841e-40 1.368977683040576938e-36 5.511521610893899137e-01 7.887136323419749746e-40 -6.861152144017795913e-35 5.511521610893899137e-01 2.018025521613015468e-40 -1.280360420288502258e-34 -6.315596357938240705e-33 5.511521610893899137e-01 4.844034999488235731e-32 -6.252731385099330503e-33 5.511521610893899137e-01 6.855654944762391513e-33 -6.531521135769165475e-33 5.511521610893899137e-01 -7.372960950250175947e-33 -6.639752426993095832e-33 5.511521610893899137e-01 1.044245727624339665e-34 -6.976343215678657274e-33 5.511521610893899137e-01 2.748875801336883553e-35 -6.689451740244644624e-33 5.511521610893899137e-01 -2.168576963105721394e-36 -6.639348078080399951e-33 5.511521610893899137e-01 1.137609402274975671e-36 -6.634545567801381471e-33 5.511521610893899137e-01 8.670734016379291138e-34 -6.634277252690421925e-33 5.511521610893899137e-01 -2.691526726601033275e-34 -6.634260765400973514e-33 5.511521610893899137e-01 -2.021035820662732586e-34 -6.634240122346850702e-33 5.511521610893899137e-01 8.525398206091710987e-35 -6.634251993016193013e-33 5.511521610893899137e-01 5.791888512844881668e-38 -6.634252215253343970e-33 5.511521610893899137e-01 5.719429193773650986e-37 -6.634253081135255886e-33 5.511521610893899137e-01 6.041464926830159670e-38 -6.634252029760077951e-33 5.511521610893899137e-01 -1.726717621603182061e-35 -6.634252616671156318e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 new file mode 100644 index 000000000..ab5b2d082 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 @@ -0,0 +1 @@ +-9.868424351732116295e-03 -3.548057813447413177e-35 1.057204235843220507e-35 -9.972850903232455960e-03 -3.666650222755512891e-33 4.220669574700557876e-33 -1.016753795575492218e-02 1.926904837446843288e-32 9.787059999616584956e-34 -1.042589833455151611e-02 -2.041559602436486337e-32 1.418125748222338838e-34 -1.068744477503295875e-02 -1.390106159976721131e-32 -8.009988745498082086e-33 -1.087860946893375036e-02 -3.921780115208360533e-33 2.644713646397102897e-33 -1.094345264966271707e-02 -6.279089046424808836e-33 1.611924869161138926e-33 -1.084323678100362030e-02 -2.160711591356828380e-33 7.931660293339623856e-33 -1.060443774369900297e-02 -2.566755108049649413e-34 -2.749160826401761437e-34 -1.031832066398938666e-02 1.586000964559292196e-34 -1.845197102313470686e-37 -1.000508510632024117e-02 2.436929091858534570e-35 -1.180874172115725650e-34 -9.687858797289929103e-03 2.570848761038722167e-35 -1.749003081274201022e-36 -9.392430431187341264e-03 -7.234286005944159204e-37 1.744655943962980417e-35 -9.140319920980683258e-03 -1.699053234513510460e-35 1.461401482440981960e-35 -8.945781037850016396e-03 -8.575384152753861906e-35 7.352467819174687019e-36 -8.839591082546980477e-03 -1.051599344710931691e-34 -2.056272651151197458e-35 -3.548057813447413177e-35 5.511521610893899137e-01 6.489376348244147693e-34 -3.666650222755512891e-33 5.511521610893899137e-01 4.364299210739124307e-34 1.926904837446843288e-32 5.511521610893899137e-01 7.872399146080112182e-35 -2.041559602436486337e-32 5.511521610893899137e-01 -2.168762090578114450e-34 -1.390106159976721131e-32 5.511521610893899137e-01 5.035195578982973858e-34 -3.921780115208360533e-33 5.511521610893899137e-01 -4.329942488997114095e-35 -6.279089046424808836e-33 5.511521610893899137e-01 -4.822466296116420288e-36 -2.160711591356828380e-33 5.511521610893899137e-01 -1.096253633029353021e-38 -2.566755108049649413e-34 5.511521610893899137e-01 -9.644405122985997766e-38 1.586000964559292196e-34 5.511521610893899137e-01 -1.907512028985034036e-38 2.436929091858534570e-35 5.511521610893899137e-01 2.237482371597695967e-38 2.570848761038722167e-35 5.511521610893899137e-01 2.228092124972535550e-39 -7.234286005944159204e-37 5.511521610893899137e-01 3.675539151339159917e-39 -1.699053234513510460e-35 5.511521610893899137e-01 -2.212782360892837514e-40 -8.575384152753861906e-35 5.511521610893899137e-01 -1.842227195882815748e-39 -1.051599344710931691e-34 5.511521610893899137e-01 -4.338619853977773670e-39 1.057204235843220507e-35 -5.985315183649293948e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.197822897399796971e-33 5.511521610893899137e-01 9.787059999616584956e-34 -6.555528827012909039e-33 5.511521610893899137e-01 1.418125748222338838e-34 -6.851129027531519222e-33 5.511521610893899137e-01 -8.009988745498082086e-33 -6.130733260575411503e-33 5.511521610893899137e-01 2.644713646397102897e-33 -6.677552243363678474e-33 5.511521610893899137e-01 1.611924869161138926e-33 -6.639075284769825143e-33 5.511521610893899137e-01 7.931660293339623856e-33 -6.634263781010041219e-33 5.511521610893899137e-01 -2.749160826401761437e-34 -6.634349262524938567e-33 5.511521610893899137e-01 -1.845197102313470686e-37 -6.634271893593999492e-33 5.511521610893899137e-01 -1.180874172115725650e-34 -6.634230443649994890e-33 5.511521610893899137e-01 -1.749003081274201022e-36 -6.634250590381583760e-33 5.511521610893899137e-01 1.744655943962980417e-35 -6.634249142934555330e-33 5.511521610893899137e-01 1.461401482440981960e-35 -6.634253039751945423e-33 5.511521610893899137e-01 7.352467819174687019e-36 -6.634254660700904691e-33 5.511521610893899137e-01 -2.056272651151197458e-35 -6.634257157093563315e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 new file mode 100644 index 000000000..87a7466c7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 @@ -0,0 +1 @@ +-9.902225311777477709e-03 -3.313619214813977840e-35 1.057204235843220507e-35 -1.000424263411727951e-02 -3.666650222755512891e-33 4.221304425127935075e-33 -1.019444909176740396e-02 -1.555230515475229183e-32 9.783307294203369453e-34 -1.044653067832154551e-02 -4.597429405224906494e-34 1.408265893441419145e-34 -1.069922636128692837e-02 4.515179624381203403e-33 -8.009988745498082086e-33 -1.088291440408851486e-02 -1.236002367509094764e-32 -5.793529913485485918e-33 -1.094320237598424631e-02 9.612867604888131957e-34 -2.008262020286574087e-33 -1.084247289875383755e-02 5.349677571661660807e-33 -3.333923451188110439e-33 -1.060679346043170469e-02 -2.566718766330127720e-34 -1.131599436920947112e-33 -1.032509547090884779e-02 2.555148544398688306e-35 -1.845197102313470686e-37 -1.001712566604915332e-02 2.436929091858534570e-35 -3.281438086179620585e-36 -9.705517438841501643e-03 -1.609499566480919435e-36 3.714564081674987251e-36 -9.415495349050248194e-03 -7.552091815329605462e-36 -7.640498037222970814e-37 -9.169388105667050301e-03 -8.681079483287195783e-37 -1.763215202221119121e-35 -8.980348698408916613e-03 -2.594007811748756996e-35 7.353034774278100313e-36 -8.877128641047032920e-03 3.908723177560353526e-35 8.286812241818128385e-36 -3.313619214813977840e-35 5.511521610893899137e-01 6.489454424063876771e-34 -3.666650222755512891e-33 5.511521610893899137e-01 4.346963640910233066e-34 -1.555230515475229183e-32 5.511521610893899137e-01 7.841310941351819464e-35 -4.597429405224906494e-34 5.511521610893899137e-01 -2.164953996824901285e-34 4.515179624381203403e-33 5.511521610893899137e-01 5.038810291345607107e-34 -1.236002367509094764e-32 5.511521610893899137e-01 -4.325958259240211516e-35 9.612867604888131957e-34 5.511521610893899137e-01 -4.823004916107075133e-36 5.349677571661660807e-33 5.511521610893899137e-01 -1.338110841226935728e-38 -2.566718766330127720e-34 5.511521610893899137e-01 -9.627062442468288483e-38 2.555148544398688306e-35 5.511521610893899137e-01 -1.907262634969884568e-38 2.436929091858534570e-35 5.511521610893899137e-01 2.237472591300034591e-38 -1.609499566480919435e-36 5.511521610893899137e-01 2.228063793142444568e-39 -7.552091815329605462e-36 5.511521610893899137e-01 3.675333325085929988e-39 -8.681079483287195783e-37 5.511521610893899137e-01 -2.205002509875821821e-40 -2.594007811748756996e-35 5.511521610893899137e-01 -1.843590006970669522e-39 3.908723177560353526e-35 5.511521610893899137e-01 -4.340247687646438361e-39 1.057204235843220507e-35 -5.985307376067321041e-33 5.511521610893899137e-01 4.221304425127935075e-33 -6.199556454382685497e-33 5.511521610893899137e-01 9.783307294203369453e-34 -6.555839709060191432e-33 5.511521610893899137e-01 1.408265893441419145e-34 -6.850748218156197264e-33 5.511521610893899137e-01 -8.009988745498082086e-33 -6.130371789339148092e-33 5.511521610893899137e-01 -5.793529913485485918e-33 -6.677512401066109555e-33 5.511521610893899137e-01 -2.008262020286574087e-33 -6.639075823389815632e-33 5.511521610893899137e-01 -3.333923451188110439e-33 -6.634266199582123324e-33 5.511521610893899137e-01 -1.131599436920947112e-33 -6.634349089098133200e-33 5.511521610893899137e-01 -1.845197102313470686e-37 -6.634271891100059076e-33 5.511521610893899137e-01 -3.281438086179620585e-36 -6.634230443747798406e-33 5.511521610893899137e-01 3.714564081674987251e-36 -6.634250590409916263e-33 5.511521610893899137e-01 -7.640498037222970814e-37 -6.634249143140381989e-33 5.511521610893899137e-01 -1.763215202221119121e-35 -6.634253038973960663e-33 5.511521610893899137e-01 7.353034774278100313e-36 -6.634254662063715343e-33 5.511521610893899137e-01 8.286812241818128385e-36 -6.634257158721397276e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 new file mode 100644 index 000000000..2d6466b57 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 @@ -0,0 +1 @@ +-9.927765048111537177e-03 -2.011443977082432045e-32 1.057204235843220507e-35 -1.002796292767989088e-02 -3.668813239811254479e-33 -6.228501348291273059e-33 -1.021478570532052300e-02 7.173998783854400067e-33 9.776913982830087745e-34 -1.046198571121990419e-02 -4.589029963377228221e-34 1.399866451593740872e-34 -1.070802588159989327e-02 4.513907831831956221e-33 -8.009988745498082086e-33 -1.088609898280738265e-02 9.669381705138771170e-33 -5.793605008952298009e-33 -1.094297781330335825e-02 9.612902155313571246e-34 -2.008265475329118016e-33 -1.084188785224268758e-02 -4.446268509585000742e-33 -3.333916026608279781e-33 -1.060858654161535991e-02 8.622478687203358323e-34 1.106246253302304640e-33 -1.033024540530419998e-02 2.555361093407560977e-35 -2.318225550698562030e-34 -1.002626950122548384e-02 -5.057609226129689394e-35 -3.280993074047588057e-36 -9.718918835472604295e-03 -1.609499566480919435e-36 3.714693069388648126e-36 -9.432991884363148630e-03 -7.552091815329605462e-36 -7.640498037222970814e-37 -9.191237679210394196e-03 -8.669849802658733879e-37 3.413392443590057546e-36 -9.006341826282560775e-03 -6.420003605293732501e-36 4.639318379866577390e-35 -8.905359836724715400e-03 -1.739817698861146911e-35 8.287711018351045615e-36 -2.011443977082432045e-32 5.511521610893899137e-01 6.489497506316585527e-34 -3.668813239811254479e-33 5.511521610893899137e-01 4.336230070454203546e-34 7.173998783854400067e-33 5.511521610893899137e-01 7.754870471406684682e-35 -4.589029963377228221e-34 5.511521610893899137e-01 -2.186929582723609186e-34 4.513907831831956221e-33 5.511521610893899137e-01 5.002341631531596640e-34 9.669381705138771170e-33 5.511521610893899137e-01 -4.339732010458073995e-35 9.612902155313571246e-34 5.511521610893899137e-01 -4.820953346342914101e-36 -4.446268509585000742e-33 5.511521610893899137e-01 -6.520250876990983877e-39 8.622478687203358323e-34 5.511521610893899137e-01 -9.664527733186605890e-38 2.555361093407560977e-35 5.511521610893899137e-01 -1.909671807794442559e-38 -5.057609226129689394e-35 5.511521610893899137e-01 2.237348104706866034e-38 -1.609499566480919435e-36 5.511521610893899137e-01 2.227411979858108288e-39 -7.552091815329605462e-36 5.511521610893899137e-01 3.665744771525854780e-39 -8.669849802658733879e-37 5.511521610893899137e-01 -2.233203552044558186e-40 -6.420003605293732501e-36 5.511521610893899137e-01 -1.846928196204592839e-39 -1.739817698861146911e-35 5.511521610893899137e-01 -4.341200892215121563e-39 1.057204235843220507e-35 -5.985303067842050422e-33 5.511521610893899137e-01 -6.228501348291273059e-33 -6.200629811428288876e-33 5.511521610893899137e-01 9.776913982830087745e-34 -6.556704113759642320e-33 5.511521610893899137e-01 1.399866451593740872e-34 -6.852945776746067541e-33 5.511521610893899137e-01 -8.009988745498082086e-33 -6.134018655320549139e-33 5.511521610893899137e-01 -5.793605008952298009e-33 -6.677650138578287533e-33 5.511521610893899137e-01 -2.008265475329118016e-33 -6.639073771820051074e-33 5.511521610893899137e-01 -3.333916026608279781e-33 -6.634259338724587569e-33 5.511521610893899137e-01 1.106246253302304640e-33 -6.634349463751040877e-33 5.511521610893899137e-01 -2.318225550698562030e-34 -6.634271915191787133e-33 5.511521610893899137e-01 -3.280993074047588057e-36 -6.634230444992664614e-33 5.511521610893899137e-01 3.714693069388648126e-36 -6.634250591061729423e-33 5.511521610893899137e-01 -7.640498037222970814e-37 -6.634249152728935052e-33 5.511521610893899137e-01 3.413392443590057546e-36 -6.634253041794064243e-33 5.511521610893899137e-01 4.639318379866577390e-35 -6.634254665401905240e-33 5.511521610893899137e-01 8.287711018351045615e-36 -6.634257159674601819e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 new file mode 100644 index 000000000..4d6a187bf --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 @@ -0,0 +1 @@ +-9.947237777778353274e-03 5.942941363318341162e-33 -1.301895911251038061e-32 -1.004604899092387607e-02 -3.669723799009453785e-33 1.411202530068950833e-32 -1.023029296949770801e-02 -2.231557415983261837e-32 8.350219208675602801e-33 -1.047368956605003627e-02 -4.589029963377228221e-34 -3.366285101580438693e-32 -1.071467427217841391e-02 8.770422656780930550e-32 -2.810526891852891199e-33 -1.088848664192529347e-02 -4.624854170692089522e-33 -5.793620817872429769e-33 -1.094278556624544117e-02 7.093149863425347645e-33 1.057664348617876903e-33 -1.084143706669317246e-02 8.259577284912190470e-33 -1.574561393229840796e-34 -1.060996135469805327e-02 -2.043096127988904558e-33 -1.648423983509208477e-34 -1.033419017538862381e-02 2.555361093407560977e-35 -6.320827581804725141e-36 -1.003326835710795749e-02 4.669842643405745424e-35 -2.759981016748212965e-35 -9.729171297781105329e-03 1.690523431433361121e-35 -9.139666366609560198e-37 -9.446372711405734424e-03 7.873352822768833946e-36 -8.476621312824330679e-36 -9.207828972218895167e-03 -8.669849802658733879e-37 3.072633107337287694e-35 -9.026085339755495970e-03 -6.420003605293732501e-36 -2.960122463394963572e-35 -8.926806212912368962e-03 -6.626416797158785423e-35 -1.614604124063672952e-35 5.942941363318341162e-33 5.511521610893899137e-01 6.499518141831884914e-34 -3.669723799009453785e-33 5.511521610893899137e-01 4.327658922299856640e-34 -2.231557415983261837e-32 5.511521610893899137e-01 7.721335999416937925e-35 -4.589029963377228221e-34 5.511521610893899137e-01 -2.175416811628642725e-34 8.770422656780930550e-32 5.511521610893899137e-01 4.998345527272736732e-34 -4.624854170692089522e-33 5.511521610893899137e-01 -4.337124101218126969e-35 7.093149863425347645e-33 5.511521610893899137e-01 -4.821435788287172786e-36 8.259577284912190470e-33 5.511521610893899137e-01 -8.262803156480014818e-39 -2.043096127988904558e-33 5.511521610893899137e-01 -9.661981138638058929e-38 2.555361093407560977e-35 5.511521610893899137e-01 -1.910060411491565170e-38 4.669842643405745424e-35 5.511521610893899137e-01 2.237279115575144408e-38 1.690523431433361121e-35 5.511521610893899137e-01 2.227404581589329578e-39 7.873352822768833946e-36 5.511521610893899137e-01 3.665831794595633924e-39 -8.669849802658733879e-37 5.511521610893899137e-01 -2.251777149969329604e-40 -6.420003605293732501e-36 5.511521610893899137e-01 -1.839271603128838281e-39 -6.626416797158785423e-35 5.511521610893899137e-01 -4.342829140066460901e-39 -1.301895911251038061e-32 -5.984301004290520226e-33 5.511521610893899137e-01 1.411202530068950833e-32 -6.201486926243723310e-33 5.511521610893899137e-01 8.350219208675602801e-33 -6.557039458479539499e-33 5.511521610893899137e-01 -3.366285101580438693e-32 -6.851794499636571536e-33 5.511521610893899137e-01 -2.810526891852891199e-33 -6.134418265746435216e-33 5.511521610893899137e-01 -5.793620817872429769e-33 -6.677624059485888015e-33 5.511521610893899137e-01 1.057664348617876903e-33 -6.639074254261995709e-33 5.511521610893899137e-01 -1.574561393229840796e-34 -6.634261081276867327e-33 5.511521610893899137e-01 -1.648423983509208477e-34 -6.634349438285094723e-33 5.511521610893899137e-01 -6.320827581804725141e-36 -6.634271919077824517e-33 5.511521610893899137e-01 -2.759981016748212965e-35 -6.634230445682556417e-33 5.511521610893899137e-01 -9.139666366609560198e-37 -6.634250591069127293e-33 5.511521610893899137e-01 -8.476621312824330679e-36 -6.634249152641912227e-33 5.511521610893899137e-01 3.072633107337287694e-35 -6.634253043651423777e-33 5.511521610893899137e-01 -2.960122463394963572e-35 -6.634254657745311697e-33 5.511521610893899137e-01 -1.614604124063672952e-35 -6.634257161302849054e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 new file mode 100644 index 000000000..896386303 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 @@ -0,0 +1 @@ +-7.683657746373033677e-03 -1.094945353551483560e-32 -1.280360420288502258e-34 -7.962467496073178178e-03 3.812607808704935272e-32 -8.922594239432022975e-33 -8.458554478949668193e-03 -3.946520307165209774e-33 -1.387981493967323468e-32 -9.099575968968671297e-03 -1.448628551933536654e-34 -7.284972059730131856e-33 -9.804278265406802043e-03 3.902233661171743658e-32 5.710651891302211812e-32 -1.047008730431828703e-02 4.423339771679886227e-33 -3.776590587781366374e-32 -1.088852913870834264e-02 1.542681171952462410e-33 -1.479769018802036493e-32 -1.088220466351342425e-02 -1.016292372329106661e-33 9.249513501601398014e-37 -1.049362424202665567e-02 -4.822490262525445139e-37 -3.396033766334288079e-33 -9.967819292644321261e-03 -6.145479154705127814e-37 1.147866935888757052e-35 -9.354944348125910497e-03 -8.498981806694408055e-35 1.288075658851413165e-34 -8.648136870087103772e-03 7.467320170963018569e-38 -1.572845770919617473e-34 -7.865510929246021313e-03 1.237449874791266767e-34 5.791888512844881668e-38 -7.137952698451108073e-03 -1.369913730645784263e-35 8.853110673681947254e-37 -6.581917083017876924e-03 8.286100351770668826e-35 1.139779229859905753e-36 -6.282451551294998895e-03 8.942045094506440456e-35 -1.726717621603182061e-35 -1.094945353551483560e-32 5.511521610893899137e-01 5.539548097867806985e-34 3.812607808704935272e-32 5.511521610893899137e-01 5.057060334819437823e-34 -3.946520307165209774e-33 5.511521610893899137e-01 1.001990968931475965e-34 -1.448628551933536654e-34 5.511521610893899137e-01 -1.936608545986047418e-34 3.902233661171743658e-32 5.511521610893899137e-01 5.356394824785680908e-34 4.423339771679886227e-33 5.511521610893899137e-01 -3.867990610953107801e-35 1.542681171952462410e-33 5.511521610893899137e-01 -4.611181636514234458e-36 -1.016292372329106661e-33 5.511521610893899137e-01 -2.554483517429373363e-37 -4.822490262525445139e-37 5.511521610893899137e-01 -9.098647707496867706e-38 -6.145479154705127814e-37 5.511521610893899137e-01 -1.910753757336841326e-38 -8.498981806694408055e-35 5.511521610893899137e-01 2.234961981161564830e-38 7.467320170963018569e-38 5.511521610893899137e-01 2.247744037615646491e-39 1.237449874791266767e-34 5.511521610893899137e-01 3.829313839379017580e-39 -1.369913730645784263e-35 5.511521610893899137e-01 6.068960590942114352e-40 8.286100351770668826e-35 5.511521610893899137e-01 -2.100266994217835838e-39 8.942045094506440456e-35 5.511521610893899137e-01 -5.210747280761544654e-39 -1.280360420288502258e-34 -6.080298008686928105e-33 5.511521610893899137e-01 -8.922594239432022975e-33 -6.128546784991766646e-33 5.511521610893899137e-01 -1.387981493967323468e-32 -6.534053721580562661e-33 5.511521610893899137e-01 -7.284972059730131856e-33 -6.827913673072313802e-33 5.511521610893899137e-01 5.710651891302211812e-32 -6.098613335995141311e-33 5.511521610893899137e-01 -3.776590587781366374e-32 -6.672932724583239785e-33 5.511521610893899137e-01 -1.479769018802036493e-32 -6.638864000110223981e-33 5.511521610893899137e-01 9.249513501601398014e-37 -6.634508266825452658e-33 5.511521610893899137e-01 -3.396033766334288079e-33 -6.634343804950784516e-33 5.511521610893899137e-01 1.147866935888757052e-35 -6.634271926011282367e-33 5.511521610893899137e-01 1.288075658851413165e-34 -6.634230468853898231e-33 5.511521610893899137e-01 -1.572845770919617473e-34 -6.634250570729671462e-33 5.511521610893899137e-01 5.791888512844881668e-38 -6.634248989159868898e-33 5.511521610893899137e-01 8.853110673681947254e-37 -6.634252211577649148e-33 5.511521610893899137e-01 1.139779229859905753e-36 -6.634254918740704556e-33 5.511521610893899137e-01 -1.726717621603182061e-35 -6.634258029220988589e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 new file mode 100644 index 000000000..caf73a56a --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 @@ -0,0 +1 @@ +-8.607620007990621908e-03 -1.094945353551483560e-32 -8.801392983525031840e-35 -8.803611330394513212e-03 -4.362219561358649930e-33 1.595458035601567978e-32 -9.168216954730351934e-03 -3.946520307165209774e-33 1.329042368203254227e-32 -9.650342484902834153e-03 2.858342955172657378e-32 2.405026697192608925e-32 -1.018237501028397898e-02 3.896906606343959799e-32 1.821901867020004546e-32 -1.066735212525686712e-02 4.410419393623789935e-33 -1.067510318869429580e-32 -1.092581521299340608e-02 1.751268505101788635e-32 -8.232263563212553530e-34 -1.086506618421353466e-02 2.005693642144614116e-32 9.249513501601398014e-37 -1.052638568155694031e-02 -4.822490262525445139e-37 5.622328503261207836e-34 -1.008976858099529250e-02 -5.758285667671030088e-37 5.516377453350961148e-35 -9.592150790658303394e-03 -2.760591546153103335e-35 -7.216985524453955627e-35 -9.065241372394693131e-03 1.531045243189696841e-37 -3.382714301785297943e-36 -8.497863276321937151e-03 1.351183689514408751e-35 5.791888512844881668e-38 -7.965690107146381274e-03 -1.378534355504053636e-35 8.853110673681947254e-37 -7.556174453969249916e-03 -8.016935091118023348e-36 -1.200308055819063675e-34 -7.334239346563627832e-03 -1.448963511156928913e-34 -1.726717621603182061e-35 -1.094945353551483560e-32 5.511521610893899137e-01 6.444573335237415048e-34 -4.362219561358649930e-33 5.511521610893899137e-01 5.051404972309055377e-34 -3.946520307165209774e-33 5.511521610893899137e-01 8.740274420353453862e-35 2.858342955172657378e-32 5.511521610893899137e-01 -1.948918230574975244e-34 3.896906606343959799e-32 5.511521610893899137e-01 4.705336735613113510e-34 4.410419393623789935e-33 5.511521610893899137e-01 -4.110785565369038095e-35 1.751268505101788635e-32 5.511521610893899137e-01 -4.743568074250794867e-36 2.005693642144614116e-32 5.511521610893899137e-01 -5.842808582389982516e-38 -4.822490262525445139e-37 5.511521610893899137e-01 -9.395047090619620727e-38 -5.758285667671030088e-37 5.511521610893899137e-01 -1.898898373541692040e-38 -2.760591546153103335e-35 5.511521610893899137e-01 2.230068039787943873e-38 1.531045243189696841e-37 5.511521610893899137e-01 2.214395134855836464e-39 1.351183689514408751e-35 5.511521610893899137e-01 3.895248133874028789e-39 -1.378534355504053636e-35 5.511521610893899137e-01 1.598451939997100758e-40 -8.016935091118023348e-36 5.511521610893899137e-01 -1.671030369686858874e-39 -1.448963511156928913e-34 5.511521610893899137e-01 -4.100999843812265794e-39 -8.801392983525031840e-35 -5.989795484949967384e-33 5.511521610893899137e-01 1.595458035601567978e-32 -6.129112321242804634e-33 5.511521610893899137e-01 1.329042368203254227e-32 -6.546850074270176274e-33 5.511521610893899137e-01 2.405026697192608925e-32 -6.829144641531206242e-33 5.511521610893899137e-01 1.821901867020004546e-32 -6.163719144912397623e-33 5.511521610893899137e-01 -1.067510318869429580e-32 -6.675360674127399334e-33 5.511521610893899137e-01 -8.232263563212553530e-34 -6.638996386547960276e-33 5.511521610893899137e-01 9.249513501601398014e-37 -6.634311246559533651e-33 5.511521610893899137e-01 5.622328503261207836e-34 -6.634346768944616169e-33 5.511521610893899137e-01 5.516377453350961148e-35 -6.634271807457444605e-33 5.511521610893899137e-01 -7.216985524453955627e-35 -6.634230517793312442e-33 5.511521610893899137e-01 -3.382714301785297943e-36 -6.634250604078574231e-33 5.511521610893899137e-01 5.791888512844881668e-38 -6.634248923225573966e-33 5.511521610893899137e-01 8.853110673681947254e-37 -6.634252658628514718e-33 5.511521610893899137e-01 -1.200308055819063675e-34 -6.634254489504079720e-33 5.511521610893899137e-01 -1.726717621603182061e-35 -6.634256919473551726e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 new file mode 100644 index 000000000..537f1d14f --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 @@ -0,0 +1 @@ +-9.086077053294748518e-03 3.280508577441292417e-34 3.007597648259515112e-34 -9.246680607691263806e-03 -5.614275836456797716e-32 -9.962270431011574462e-33 -9.545795766419363018e-03 -3.938665219294184879e-33 -7.937488707153012805e-34 -9.942147027570933521e-03 -3.667836341889934025e-33 7.914323518118598763e-33 -1.038078477738539444e-02 -4.036061275108907966e-32 -2.143803262801122709e-32 -1.075601370660111793e-02 -9.183456427301159067e-33 3.702641030586628948e-34 -1.093729447168807246e-02 3.028562236622764671e-33 2.797783570786699195e-33 -1.085854873774397093e-02 -1.138183708133174051e-32 4.288027900952963527e-33 -1.055498419606750241e-02 -4.822490262525445139e-37 -9.669756109447400492e-34 -1.017295308595549640e-02 7.251029725829586714e-35 -9.104912568492838343e-35 -9.743245562094398141e-03 -2.761715234916612875e-35 3.375466604770666261e-35 -9.300261471325137544e-03 1.531045243189696841e-37 -3.914772531501313417e-35 -8.852677378349259676e-03 -4.598084298829680887e-35 9.380108047431184401e-38 -8.430800244879084471e-03 -1.378534355504053636e-35 5.349316749885212737e-35 -8.104918681414894147e-03 -8.065179494806608274e-36 2.629447080557124472e-35 -7.927897784512999424e-03 4.317616698614554330e-35 -1.722231158862203099e-35 3.280508577441292417e-34 5.511521610893899137e-01 6.444586021620585211e-34 -5.614275836456797716e-32 5.511521610893899137e-01 4.473082730082651198e-34 -3.938665219294184879e-33 5.511521610893899137e-01 8.559425618313060533e-35 -3.667836341889934025e-33 5.511521610893899137e-01 -2.134001213973662245e-34 -4.036061275108907966e-32 5.511521610893899137e-01 4.952920114455928441e-34 -9.183456427301159067e-33 5.511521610893899137e-01 -4.121487496508556945e-35 3.028562236622764671e-33 5.511521610893899137e-01 -4.747176326028734115e-36 -1.138183708133174051e-32 5.511521610893899137e-01 -5.743299189525879091e-38 -4.822490262525445139e-37 5.511521610893899137e-01 -9.415543327697148624e-38 7.251029725829586714e-35 5.511521610893899137e-01 -1.907694018287814270e-38 -2.761715234916612875e-35 5.511521610893899137e-01 2.228642707909145308e-38 1.531045243189696841e-37 5.511521610893899137e-01 2.232931740499949373e-39 -4.598084298829680887e-35 5.511521610893899137e-01 3.679050850107518655e-39 -1.378534355504053636e-35 5.511521610893899137e-01 -2.397448533929844929e-40 -8.065179494806608274e-36 5.511521610893899137e-01 -1.882297546228780559e-39 4.317616698614554330e-35 5.511521610893899137e-01 -4.404971737055055346e-39 3.007597648259515112e-34 -5.989794216311650025e-33 5.511521610893899137e-01 -9.962270431011574462e-33 -6.186944545465444453e-33 5.511521610893899137e-01 -7.937488707153012805e-34 -6.548658562290580432e-33 5.511521610893899137e-01 7.914323518118598763e-33 -6.847652939871074301e-33 5.511521610893899137e-01 -2.143803262801122709e-32 -6.138960807028116216e-33 5.511521610893899137e-01 3.702641030586628948e-34 -6.675467693438794458e-33 5.511521610893899137e-01 2.797783570786699195e-33 -6.638999994799738652e-33 5.511521610893899137e-01 4.288027900952963527e-33 -6.634310251465605014e-33 5.511521610893899137e-01 -9.669756109447400492e-34 -6.634346973906986617e-33 5.511521610893899137e-01 -9.104912568492838343e-35 -6.634271895413892081e-33 5.511521610893899137e-01 3.375466604770666261e-35 -6.634230532046630720e-33 5.511521610893899137e-01 -3.914772531501313417e-35 -6.634250585541968244e-33 5.511521610893899137e-01 9.380108047431184401e-38 -6.634249139422857588e-33 5.511521610893899137e-01 5.349316749885212737e-35 -6.634253058218561751e-33 5.511521610893899137e-01 2.629447080557124472e-35 -6.634254700771255968e-33 5.511521610893899137e-01 -1.722231158862203099e-35 -6.634257223445445190e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 new file mode 100644 index 000000000..828fe741b --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 @@ -0,0 +1 @@ +-9.371858484379335524e-03 -1.852889974128036437e-32 -1.413101194175751078e-34 -9.511839615010377058e-03 2.743675540454953152e-33 -9.962270431011574462e-33 -9.772647453376257301e-03 -3.929645200666078991e-33 -7.937488707153012805e-34 -1.011849586029082114e-02 -3.667836341889934025e-33 -4.310261054838937576e-33 -1.049917340334565082e-02 4.769304901532531838e-33 -2.142906805182756210e-32 -1.080524779499867499e-02 -9.183456427301159067e-33 2.105009780875418151e-32 -1.094186384529378248e-02 3.028659871111240576e-33 2.797734753542461414e-33 -1.085332768490145441e-02 7.208817435389728047e-33 -5.007192395309128500e-33 -1.057186835357476658e-02 -4.392462018071927464e-37 1.116812253203671448e-33 -1.022352380055014873e-02 -3.572261486948745331e-35 -9.881864971267005870e-36 -9.835199408554314709e-03 -2.761715234916612875e-35 -3.633124608876359252e-35 -9.437286601298005770e-03 1.512974561806539015e-37 6.762831684178967506e-35 -9.054221486334102648e-03 -1.480842556865533425e-36 4.459380151190558909e-35 -8.696291322380049829e-03 -1.376959549320059187e-35 -6.919762769329016876e-37 -8.419120682922996354e-03 -8.038075651905559881e-36 -1.114290328114514210e-36 -8.268358297383593403e-03 -9.791981235189324550e-35 -1.717186611871211465e-35 -1.852889974128036437e-32 5.511521610893899137e-01 6.445232484160883299e-34 2.743675540454953152e-33 5.511521610893899137e-01 4.289167000832361793e-34 -3.929645200666078991e-33 5.511521610893899137e-01 7.891130626148302022e-35 -3.667836341889934025e-33 5.511521610893899137e-01 -2.142119279263547776e-34 4.769304901532531838e-33 5.511521610893899137e-01 5.074267034631560581e-34 -9.183456427301159067e-33 5.511521610893899137e-01 -4.500376817632599210e-35 3.028659871111240576e-33 5.511521610893899137e-01 -4.822002265240567423e-36 7.208817435389728047e-33 5.511521610893899137e-01 5.425157647933234206e-38 -4.392462018071927464e-37 5.511521610893899137e-01 -9.931351087080197144e-38 -3.572261486948745331e-35 5.511521610893899137e-01 -1.909233122530658661e-38 -2.761715234916612875e-35 5.511521610893899137e-01 2.222961148690479262e-38 1.512974561806539015e-37 5.511521610893899137e-01 2.223335777034155559e-39 -1.480842556865533425e-36 5.511521610893899137e-01 3.681830753002855573e-39 -1.376959549320059187e-35 5.511521610893899137e-01 -2.316020346714874476e-40 -8.038075651905559881e-36 5.511521610893899137e-01 -1.856914268606710023e-39 -9.791981235189324550e-35 5.511521610893899137e-01 -4.235986828191193432e-39 -1.413101194175751078e-34 -5.989729570057620131e-33 5.511521610893899137e-01 -9.962270431011574462e-33 -6.205336118390473052e-33 5.511521610893899137e-01 -7.937488707153012805e-34 -6.555341512212227761e-33 5.511521610893899137e-01 -4.310261054838937576e-33 -6.848464746400062383e-33 5.511521610893899137e-01 -2.142906805182756210e-32 -6.126826115010552916e-33 5.511521610893899137e-01 2.105009780875418151e-32 -6.679256586650035004e-33 5.511521610893899137e-01 2.797734753542461414e-33 -6.639074820738949858e-33 5.511521610893899137e-01 -5.007192395309128500e-33 -6.634198566897230464e-33 5.511521610893899137e-01 1.116812253203671448e-33 -6.634352131984579857e-33 5.511521610893899137e-01 -9.881864971267005870e-36 -6.634271910804934709e-33 5.511521610893899137e-01 -3.633124608876359252e-35 -6.634230588862223586e-33 5.511521610893899137e-01 6.762831684178967506e-35 -6.634250595137931493e-33 5.511521610893899137e-01 4.459380151190558909e-35 -6.634249136642955126e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253050075743641e-33 5.511521610893899137e-01 -1.114290328114514210e-36 -6.634254675387978213e-33 5.511521610893899137e-01 -1.717186611871211465e-35 -6.634257054460537002e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 new file mode 100644 index 000000000..034ddf354 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 @@ -0,0 +1 @@ +-9.553630321826211969e-03 8.721535201734810339e-33 1.835321613649817518e-35 -9.680559196989051846e-03 2.751639046152152281e-33 4.216751462851557953e-33 -9.917096654661851016e-03 -3.929645200666078991e-33 -2.720947173642478541e-33 -1.023090766060057687e-02 1.398925429899489530e-32 -4.308717063002554098e-33 -1.057106606169064614e-02 4.769304901532531838e-33 -2.143023579452411139e-32 -1.083408663833263647e-02 5.735690802932153798e-33 -8.788747743143823605e-33 -1.094348213546939529e-02 -9.765938184179825558e-33 2.797709421843075081e-33 -1.084985912194225133e-02 7.208817435389728047e-33 -5.007246670725276420e-33 -1.058338802230642146e-02 -4.278560452653223183e-37 1.116778082734045801e-33 -1.025728877465494245e-02 -3.572261486948745331e-35 -3.237516199746703272e-34 -9.896005928326649312e-03 -2.761715234916612875e-35 -3.631816879968349363e-35 -9.527274981629625314e-03 1.512974561806539015e-37 2.362825692489420443e-36 -9.179959720420032346e-03 -2.968433122342335515e-35 -3.598608957408384762e-35 -8.862237342780986127e-03 -1.376959549320059187e-35 -6.919762769329016876e-37 -8.615703610758895445e-03 5.200257219755122757e-36 -1.434906737574305550e-35 -8.481459242568314613e-03 4.270173642693946453e-36 3.392312687858148133e-35 8.721535201734810339e-33 5.511521610893899137e-01 6.445155346308582710e-34 2.751639046152152281e-33 5.511521610893899137e-01 4.335006249794280957e-34 -3.929645200666078991e-33 5.511521610893899137e-01 7.833162807595248057e-35 1.398925429899489530e-32 5.511521610893899137e-01 -2.118924417524417287e-34 4.769304901532531838e-33 5.511521610893899137e-01 5.097191741483386808e-34 5.735690802932153798e-33 5.511521610893899137e-01 -4.562140702455634110e-35 -9.765938184179825558e-33 5.511521610893899137e-01 -4.829023698641043760e-36 7.208817435389728047e-33 5.511521610893899137e-01 7.184529163198608359e-38 -4.278560452653223183e-37 5.511521610893899137e-01 -1.001037806687179133e-37 -3.572261486948745331e-35 5.511521610893899137e-01 -1.901484066976878335e-38 -2.761715234916612875e-35 5.511521610893899137e-01 2.231927541084822217e-38 1.512974561806539015e-37 5.511521610893899137e-01 2.221701661625430430e-39 -2.968433122342335515e-35 5.511521610893899137e-01 3.681165906354641304e-39 -1.376959549320059187e-35 5.511521610893899137e-01 -2.249470688975192070e-40 5.200257219755122757e-36 5.511521610893899137e-01 -1.861230274418028611e-39 4.270173642693946453e-36 5.511521610893899137e-01 -4.231639208890335665e-39 1.835321613649817518e-35 -5.989737283842850361e-33 5.511521610893899137e-01 4.216751462851557953e-33 -6.200752193494281392e-33 5.511521610893899137e-01 -2.720947173642478541e-33 -6.555921190397758375e-33 5.511521610893899137e-01 -4.308717063002554098e-33 -6.846145260226149548e-33 5.511521610893899137e-01 -2.143023579452411139e-32 -6.124533644325370636e-33 5.511521610893899137e-01 -8.788747743143823605e-33 -6.679874225498265470e-33 5.511521610893899137e-01 2.797709421843075081e-33 -6.639081842172350878e-33 5.511521610893899137e-01 -5.007246670725276420e-33 -6.634180973182078041e-33 5.511521610893899137e-01 1.116778082734045801e-33 -6.634352922254378055e-33 5.511521610893899137e-01 -3.237516199746703272e-34 -6.634271833314379032e-33 5.511521610893899137e-01 -3.631816879968349363e-35 -6.634230499198299405e-33 5.511521610893899137e-01 2.362825692489420443e-36 -6.634250596772046665e-33 5.511521610893899137e-01 -3.598608957408384762e-35 -6.634249137307801456e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253043420777440e-33 5.511521610893899137e-01 -1.434906737574305550e-35 -6.634254679703984325e-33 5.511521610893899137e-01 3.392312687858148133e-35 -6.634257050112918199e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 new file mode 100644 index 000000000..2dddda7e7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 @@ -0,0 +1 @@ +-9.675994700830898784e-03 8.725153104000310727e-33 1.835321613649817518e-35 -9.794163419385508787e-03 5.237681014342732527e-33 4.220669574700557876e-33 -1.001440857753501182e-02 1.476134084230946998e-33 -2.723262437473258206e-33 -1.030670572822080071e-02 -1.078878790396505221e-32 -4.308717063002554098e-33 -1.061764264784230416e-02 4.769304901532531838e-33 9.050328248238460216e-33 -1.085228552049427760e-02 5.736777425983735391e-33 1.216134469134623593e-32 -1.094393325567382877e-02 -7.743453337211273130e-34 1.178930227230177333e-32 -1.084737814788290511e-02 -2.160723073086249598e-33 1.373205170417753286e-32 -1.059138057924124444e-02 -1.059772494183510065e-33 -1.001933421597295691e-33 -1.028058222311836745e-02 -3.573026705062310408e-35 3.355143935862735681e-34 -9.937772244992140389e-03 7.960028006841248327e-36 3.483940082189706412e-35 -9.588895240323785235e-03 1.475732557662078691e-37 2.362825692489420443e-36 -9.262800022019075652e-03 -1.243238793526867021e-37 4.307879652875249860e-35 -8.971788132543154909e-03 -1.376147720670687359e-35 -6.919762769329016876e-37 -8.745622053529260656e-03 5.203750921988232234e-36 -1.433509256681061759e-35 -8.622362921700278335e-03 4.270173642693946453e-36 3.393613299020143254e-35 8.725153104000310727e-33 5.511521610893899137e-01 6.489660406808336632e-34 5.237681014342732527e-33 5.511521610893899137e-01 4.344934883254713123e-34 1.476134084230946998e-33 5.511521610893899137e-01 7.826217910763135596e-35 -1.078878790396505221e-32 5.511521610893899137e-01 -2.130797690980879791e-34 4.769304901532531838e-33 5.511521610893899137e-01 5.007527201593661052e-34 5.736777425983735391e-33 5.511521610893899137e-01 -4.409242883156549477e-35 -7.743453337211273130e-34 5.511521610893899137e-01 -4.821165950706719759e-36 -2.160723073086249598e-33 5.511521610893899137e-01 1.970778879727482225e-38 -1.059772494183510065e-33 5.511521610893899137e-01 -9.783961764716394357e-38 -3.573026705062310408e-35 5.511521610893899137e-01 -1.908132521111938316e-38 7.960028006841248327e-36 5.511521610893899137e-01 2.233080335705438867e-38 1.475732557662078691e-37 5.511521610893899137e-01 2.212535364741841454e-39 -1.243238793526867021e-37 5.511521610893899137e-01 3.681172664484861473e-39 -1.376147720670687359e-35 5.511521610893899137e-01 -2.179126760025143967e-40 5.203750921988232234e-36 5.511521610893899137e-01 -1.848992929809236915e-39 4.270173642693946453e-36 5.511521610893899137e-01 -4.290757406275453805e-39 1.835321613649817518e-35 -5.985286777792875054e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.199759330148238175e-33 5.511521610893899137e-01 -2.723262437473258206e-33 -6.555990639366079318e-33 5.511521610893899137e-01 -4.308717063002554098e-33 -6.847332587571795970e-33 5.511521610893899137e-01 9.050328248238460216e-33 -6.133500098314343468e-33 5.511521610893899137e-01 1.216134469134623593e-32 -6.678345247305274191e-33 5.511521610893899137e-01 1.178930227230177333e-32 -6.639073984424416382e-33 5.511521610893899137e-01 1.373205170417753286e-32 -6.634233110684913248e-33 5.511521610893899137e-01 -1.001933421597295691e-33 -6.634350658091355943e-33 5.511521610893899137e-01 3.355143935862735681e-34 -6.634271899798920354e-33 5.511521610893899137e-01 3.483940082189706412e-35 -6.634230487670353373e-33 5.511521610893899137e-01 2.362825692489420443e-36 -6.634250605938343615e-33 5.511521610893899137e-01 4.307879652875249860e-35 -6.634249137301042654e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253036386385047e-33 5.511521610893899137e-01 -1.433509256681061759e-35 -6.634254667466639157e-33 5.511521610893899137e-01 3.393613299020143254e-35 -6.634257109231115396e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 new file mode 100644 index 000000000..bf6967518 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 @@ -0,0 +1 @@ +-9.761566529290667885e-03 3.468444610366646860e-35 2.174547694704099639e-35 -9.873618727809820028e-03 -2.200076546241211121e-32 4.220669574700557876e-33 -1.008248808191321635e-02 -2.225129075007191590e-33 9.782721151626834629e-34 -1.035976222799318142e-02 6.179135442191293317e-33 2.962427835669273619e-32 -1.064923218181832755e-02 4.767147172568817375e-33 1.222357284003711593e-33 -1.086435699964922313e-02 5.736267905118815280e-33 -2.184215260472968458e-33 -1.094390967556694259e-02 -7.743449672981820209e-34 -6.676482019585860112e-33 -1.084557834102142966e-02 -2.160723073086249598e-33 1.373202637753849358e-32 -1.059711561127673826e-02 3.942621837307290288e-34 -2.749160826401761437e-34 -1.029719673283884321e-02 -1.110605340996019837e-34 1.095199955206983212e-34 -9.967457139994665913e-03 7.953998141874483841e-36 3.483940082189706412e-35 -9.632588378195217418e-03 -7.414083595345841188e-35 2.362825692489420443e-36 -9.320164164231193454e-03 6.178632241741609018e-35 -4.978717291640066673e-35 -9.047349137447497497e-03 1.365375818171412813e-35 -6.919762769329016876e-37 -8.835312553158072846e-03 5.203750921988232234e-36 1.108771528341890199e-35 -8.719677068908847709e-03 4.264069739138928570e-36 -1.513925159214408198e-35 3.468444610366646860e-35 5.511521610893899137e-01 6.489366001378982617e-34 -2.200076546241211121e-32 5.511521610893899137e-01 4.371226880393788960e-34 -2.225129075007191590e-33 5.511521610893899137e-01 7.822235702157035972e-35 6.179135442191293317e-33 5.511521610893899137e-01 -2.159951811081868561e-34 4.767147172568817375e-33 5.511521610893899137e-01 5.001843964221268940e-34 5.736267905118815280e-33 5.511521610893899137e-01 -4.344985535380994505e-35 -7.743449672981820209e-34 5.511521610893899137e-01 -4.821418746832991481e-36 -2.160723073086249598e-33 5.511521610893899137e-01 -2.967796250072596161e-39 3.942621837307290288e-34 5.511521610893899137e-01 -9.709761495844309539e-38 -1.110605340996019837e-34 5.511521610893899137e-01 -1.905830572756574118e-38 7.953998141874483841e-36 5.511521610893899137e-01 2.237494597622734718e-38 -7.414083595345841188e-35 5.511521610893899137e-01 2.229448834505853501e-39 6.178632241741609018e-35 5.511521610893899137e-01 3.676245823515707394e-39 1.365375818171412813e-35 5.511521610893899137e-01 -2.212085880431606416e-40 5.203750921988232234e-36 5.511521610893899137e-01 -1.814485657454794019e-39 4.264069739138928570e-36 5.511521610893899137e-01 -4.322018856888928386e-39 2.174547694704099639e-35 -5.985316218335810456e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.197130130434330506e-33 5.511521610893899137e-01 9.782721151626834629e-34 -6.556030461452140261e-33 5.511521610893899137e-01 2.962427835669273619e-32 -6.850247999581895061e-33 5.511521610893899137e-01 1.222357284003711593e-33 -6.134068422051582593e-33 5.511521610893899137e-01 -2.184215260472968458e-33 -6.677702673827518059e-33 5.511521610893899137e-01 -6.676482019585860112e-33 -6.639074237220542341e-33 5.511521610893899137e-01 1.373202637753849358e-32 -6.634255786269960504e-33 5.511521610893899137e-01 -2.749160826401761437e-34 -6.634349916088667544e-33 5.511521610893899137e-01 1.095199955206983212e-34 -6.634271876779437419e-33 5.511521610893899137e-01 3.483940082189706412e-35 -6.634230443527734335e-33 5.511521610893899137e-01 2.362825692489420443e-36 -6.634250589024873682e-33 5.511521610893899137e-01 -4.978717291640066673e-35 -6.634249142227883525e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253039682296510e-33 5.511521610893899137e-01 1.108771528341890199e-35 -6.634254632959366149e-33 5.511521610893899137e-01 -1.513925159214408198e-35 -6.634257140492566518e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 new file mode 100644 index 000000000..e08716fab --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 @@ -0,0 +1 @@ +-9.823156452711789485e-03 -3.412515338615880321e-35 9.054607347997894087e-35 -9.930811794884558674e-03 -3.668118341954914236e-33 4.220669574700557876e-33 -1.013150373698043331e-02 -7.207469828588667671e-33 9.782721151626834629e-34 -1.039796929762655878e-02 -5.242541807784502411e-33 6.779631957945763150e-33 -1.067143203180545043e-02 4.767147172568817375e-33 2.932729164998733533e-32 -1.087268828496573518e-02 -3.921678222871888738e-33 2.644815538733574351e-33 -1.094370675954036386e-02 -7.743449672981820209e-34 1.611924869161138926e-33 -1.084424169137210292e-02 -2.160711591356828380e-33 -3.495723050610696676e-33 -1.060131263806711813e-02 3.942621837307290288e-34 -2.749160826401761437e-34 -1.030931796982789868e-02 -1.110540127309965361e-34 5.880249670497912543e-35 -9.989064740979903059e-03 2.437049758294346058e-35 -3.082386416124920706e-35 -9.664342998821663644e-03 -2.413089103496522391e-35 1.486412313384328262e-35 -9.361697357595046010e-03 -7.253720111570022379e-37 2.305538843889616761e-36 -9.101128238756774763e-03 1.365332659165783395e-35 -5.304379208551471537e-36 -8.899196952880215547e-03 5.203750921988232234e-36 -3.812108468412848647e-35 -8.789015791726152368e-03 7.031686243789819521e-35 1.371873102111947292e-36 -3.412515338615880321e-35 5.511521610893899137e-01 6.489366124813236225e-34 -3.668118341954914236e-33 5.511521610893899137e-01 4.349507292650420647e-34 -7.207469828588667671e-33 5.511521610893899137e-01 7.833017348681447167e-35 -5.242541807784502411e-33 5.511521610893899137e-01 -2.169312630531359094e-34 4.767147172568817375e-33 5.511521610893899137e-01 5.021130803352440524e-34 -3.921678222871888738e-33 5.511521610893899137e-01 -4.338274731066182737e-35 -7.743449672981820209e-34 5.511521610893899137e-01 -4.821770916639442773e-36 -2.160711591356828380e-33 5.511521610893899137e-01 -7.189427832043905682e-39 3.942621837307290288e-34 5.511521610893899137e-01 -9.667755907171409761e-38 -1.110540127309965361e-34 5.511521610893899137e-01 -1.907426303618680688e-38 2.437049758294346058e-35 5.511521610893899137e-01 2.237844055071614868e-38 -2.413089103496522391e-35 5.511521610893899137e-01 2.227881652008690740e-39 -7.253720111570022379e-37 5.511521610893899137e-01 3.675639730684902685e-39 1.365332659165783395e-35 5.511521610893899137e-01 -2.213090800425620216e-40 5.203750921988232234e-36 5.511521610893899137e-01 -1.815012434537468510e-39 7.031686243789819521e-35 5.511521610893899137e-01 -4.325154764052979677e-39 9.054607347997894087e-35 -5.985316205992385352e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.199302089208666995e-33 5.511521610893899137e-01 9.782721151626834629e-34 -6.555922644986895807e-33 5.511521610893899137e-01 6.779631957945763150e-33 -6.851184081526843472e-33 5.511521610893899137e-01 2.932729164998733533e-32 -6.132139738138465093e-33 5.511521610893899137e-01 2.644815538733574351e-33 -6.677635565784369289e-33 5.511521610893899137e-01 1.611924869161138926e-33 -6.639074589390348281e-33 5.511521610893899137e-01 -3.495723050610696676e-33 -6.634260007901542982e-33 5.511521610893899137e-01 -2.749160826401761437e-34 -6.634349496032780969e-33 5.511521610893899137e-01 5.880249670497912543e-35 -6.634271892736745577e-33 5.511521610893899137e-01 -3.082386416124920706e-35 -6.634230440033160077e-33 5.511521610893899137e-01 1.486412313384328262e-35 -6.634250590592056326e-33 5.511521610893899137e-01 2.305538843889616761e-36 -6.634249142833976585e-33 5.511521610893899137e-01 -5.304379208551471537e-36 -6.634253039782789042e-33 5.511521610893899137e-01 -3.812108468412848647e-35 -6.634254633486143527e-33 5.511521610893899137e-01 1.371873102111947292e-36 -6.634257143628474055e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener new file mode 100644 index 000000000..c07edf1a8 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.10477158290065992 +1 0.10744501822385662 +2 0.11300882313036195 +3 0.12088811927480793 +4 0.12983177509709246 +5 0.13806731035276731 +6 0.14397224775558426 +7 0.1461906211205283 +8 0.1441380352245253 +9 0.1389060169711805 +10 0.1320037780160444 +11 0.12429404670839665 +12 0.1167128725071067 +13 0.11034615568268052 +14 0.10592987924526506 +15 0.10381457027019807 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz new file mode 100644 index 000000000..bab9eda60 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.2314111304138016 -2.0720960222545002e-17 -6.4272290331349665e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.2425786660405866 4.3444895621471185e-18 1.936798892363187e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.2664508462922726 -7.634272735525148e-18 -3.33045863292617e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.3025873919086854 -1.6810159972323087e-17 7.844861033290449e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.3500486627389208 -1.9267629798484935e-17 3.1865025342351917e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4072465809637817 -4.5258203105397435e-18 1.5151694593895694e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.471865591640838 -1.2397896353034163e-18 3.997688274709011e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.540765170017398 -2.9230785062510994e-19 1.1135500180399448e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6103666995696186 -1.8676051583342008e-19 2.990254333197622e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6771892705994413 -1.5826011466070713e-19 1.4938669827476168e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.7382592849745993 5.859635932227071e-20 1.1798877684079438e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.7911598920265517 6.135684446945961e-20 -3.361445839340712e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.8342411546326534 -1.59591820690246e-19 -3.046079789258153e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.866597463100933 -3.79809465527035e-21 -9.226324605050476e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.887810832437855 2.2797099367376865e-19 -8.579071844326224e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.89771729893857 4.0733571376581154e-20 -5.2719959947984444e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener new file mode 100644 index 000000000..d49fe4ca2 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.11961083636815938 +1 0.12168664029273195 +2 0.1255549427255412 +3 0.13060817863957394 +4 0.13602533286215157 +5 0.1409345190007944 +6 0.14452697809661688 +7 0.1461442184491367 +8 0.1454354510180322 +9 0.14271315839304216 +10 0.1387234297430708 +11 0.13420235556590562 +12 0.12967299880986025 +13 0.12566666393990525 +14 0.12267865294765164 +15 0.12108534451897582 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz new file mode 100644 index 000000000..f8a2aa2f0 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.2964741963960535 1.1250224008516622e-17 2.5347922334140933e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.3064728657055276 -8.124071803199816e-18 -1.266189391009803e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.3261322365883506 3.0603483018393216e-18 7.293094119523713e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.354709755510847 -5.415863801687177e-18 1.3577819196099127e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.3910817754629496 2.786845573832564e-17 2.7496659030031324e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4338240116241874 7.825591421541225e-19 7.439519406333787e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4812685029863206 2.0716522369086573e-19 1.981246070282136e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.531525553248844 9.526933753475788e-20 5.460918763637898e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.582586265674274 -4.144040823026011e-20 1.046539029799044e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.632418627555133 -1.0016624547477843e-19 2.7153116076340105e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.679061999371246 -6.086076974973631e-20 -6.521735990999064e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.720644998937365 -2.4242593982606744e-20 -6.167032521851262e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.7555377188627794 -7.876887222783042e-20 -3.658226338929138e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.782553593684067 -1.646780009415375e-20 -3.3437334762005515e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.800923683435276 3.2929345873575937e-20 -2.246972944912625e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.810203633592583 9.4802234997972e-20 -2.857350647107775e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener new file mode 100644 index 000000000..336697e7e --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13825442026320256 +1 0.1389040946390757 +2 0.1401002315596406 +3 0.1416510227482043 +4 0.1433029796649878 +5 0.14477564076741753 +6 0.1458055693283537 +7 0.1461907015533089 +8 0.14583437327466642 +9 0.1448127891709189 +10 0.1433201379712033 +11 0.14159759293629584 +12 0.13988999449203338 +13 0.13841295304625958 +14 0.13733071104703284 +15 0.13675839994459582 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz new file mode 100644 index 000000000..8d38e1c22 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4088232600045867 3.3127263357103638e-19 1.5374143858766957e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.414444841795172 4.986533594282553e-19 -1.6849869755890178e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4254816369464045 2.491535207100146e-19 -8.510857558665978e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4415224583815425 -1.6826019027073732e-19 1.8591772284305991e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.461956418296231 -1.9209653375056683e-19 -3.3205594473582895e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.485985722618923 -1.1150361721468898e-19 6.341470062460917e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5126523765235573 -3.047443325100038e-20 1.6824057234217925e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5408808070446716 -8.518964416085272e-21 4.480900082625935e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5695342948146234 -2.401227490059242e-21 1.0774640730245576e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.597477740454726 -6.615923628952089e-22 4.682587442088025e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6236310715347564 -2.7952003732255252e-22 2.29405520041107e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6470120336207694 -4.0118102924512483e-22 -6.79365227747363e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6667694147167564 -9.678030446416557e-22 -3.8041341749135715e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.682206027915257 1.2571670915357352e-22 3.291863834166481e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.692792493590954 1.533251316624766e-21 -3.41748871084566e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.6981743499688213 1.0335153354004477e-21 -2.1512629149732395e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener new file mode 100644 index 000000000..e572b0eb5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13843798807718916 +1 0.13907321886927496 +2 0.14024266827316792 +3 0.14175865144134214 +4 0.14337305405007456 +5 0.14481150965902675 +6 0.14581653147666265 +7 0.14619076120971633 +8 0.14583986374121108 +9 0.1448379005798483 +10 0.14337412761413224 +11 0.14168422613012305 +12 0.14000806203932517 +13 0.13855756708960315 +14 0.13749505653531466 +15 0.13693331300523848 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz new file mode 100644 index 000000000..8639f1232 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4103879587655714 -2.5175179673562646e-19 -8.162373584587352e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.415948259267538 -2.5297643475351457e-19 -2.433717157371553e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.426864337276964 1.5985022249506033e-20 9.387069832978715e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4427288270300047 -9.715659845896502e-20 3.7795604375818335e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.462936832705059 -1.4142552698113295e-19 2.4995320827281956e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4866989669250428 -4.4780277169957704e-20 1.3397763118436336e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.51306799936174 -1.1517243462947556e-20 3.643471410087461e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5409809772224903 -3.0715311991177423e-21 1.0312901107394793e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5693147528261733 -6.047340805757477e-22 3.0526260448239648e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.596947636307444 -4.198540453629936e-22 8.961821225788733e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6228119540715324 -3.6908631552091693e-22 2.902544910135212e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.645936282702593 -4.687240213536109e-22 -4.044742456895848e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6654783370728565 -1.0094110163805668e-21 -2.2912605714156402e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6807478386977954 -3.6264218950599274e-23 -2.2145247384420802e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.69122035442006 7.448216526723192e-22 -2.1815848443854905e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.696544506572592 3.04402827808409e-22 -5.71320673253198e-23 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener new file mode 100644 index 000000000..8fa917134 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13857720350738936 +1 0.13920147528547158 +2 0.14035067732942832 +3 0.14184025371377681 +4 0.1434261657376552 +5 0.1448386808264598 +6 0.14582482368880598 +7 0.14619080064837642 +8 0.1458440396815485 +9 0.14485698814815814 +10 0.14341517595541123 +11 0.14175012343604315 +12 0.14009791466568178 +13 0.13866763008996588 +14 0.1376200995624207 +15 0.13706637744723488 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz new file mode 100644 index 000000000..c992c1b83 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4115867892485627 -2.616637259673376e-21 1.5687396676687763e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.41710012093894 3.847946797998936e-19 -9.657063191477644e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4279236821653103 2.1609875818739528e-19 -1.4449092476558132e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4436530464497332 2.885450801374802e-19 6.305856797634129e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.463687923025897 3.854916929837994e-19 -1.9376039604903876e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4872453766920484 7.411947453185423e-20 2.537103429475601e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5133864254396627 2.004923837199771e-20 7.08933128129098e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.541057776015262 5.548989709995593e-21 2.289411685300011e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5691466630040836 1.6096087038406888e-21 3.865831204243368e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.59654165523611 3.8245224399855923e-22 -6.484939965479694e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6221845686771514 -1.573268895579877e-22 3.719638703383037e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.645112275212686 7.568609077159702e-23 -1.0110838494181428e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6644893330112693 2.651377220310474e-22 -4.434849814321756e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6796307655291547 4.0635141055499034e-22 -3.8602566835267076e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6900159412156204 4.596091999015609e-22 4.350246188219603e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.695295860197247 5.263190431668783e-22 -2.9434956885943397e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener new file mode 100644 index 000000000..fa95db28a --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13868364218205256 +1 0.13929953199849185 +2 0.14043324893922068 +3 0.14190263010814 +4 0.1434667535392989 +5 0.14485943590355374 +6 0.14583115071922406 +7 0.1461908273222357 +8 0.14584723976488212 +9 0.14487160785265998 +10 0.14344662157500512 +11 0.14180062236336408 +12 0.14016679741347038 +13 0.13875201523568115 +14 0.13771594786456398 +15 0.13716836312327987 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz new file mode 100644 index 000000000..b191b4464 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4125106547770754 -2.978565633872773e-19 -1.4861158650795324e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4179877800408174 1.3984069957626917e-21 8.250026531755031e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.428740027602391 1.0450057043818443e-20 -7.441348036137495e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4443652431526677 9.58009574165853e-20 -1.958042752424339e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.464266693430515 -6.997961547142052e-20 -1.495553455235778e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4876664223743847 -9.497819715326151e-21 2.214024686735877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.513631805015641 -2.569230535404628e-21 4.0898497914854945e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.541116986243635 -8.198639490299509e-22 1.61527274274553e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.569017191901633 -2.780676899773558e-22 2.2209509148251033e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5962288872597017 -3.779280375630499e-22 6.188629412074027e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.621701195179552 -2.953431302606707e-22 2.0407055173296035e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6444773783435984 6.915348144068967e-23 -5.658157235236707e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.663727270955861 4.288687788250292e-22 -4.2041745363635273e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6787699878040856 -2.04352477993163e-22 -2.5020459406651618e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6890878342505045 -4.914728160451446e-22 8.37965465766285e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.694333651918987 -1.5081263476245136e-22 -1.9054137367354605e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener new file mode 100644 index 000000000..64e8cf537 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.12779616982302405 +1 0.12927261128951345 +2 0.13199397848856598 +3 0.1355289962813415 +4 0.13931026693386392 +5 0.14271834751259405 +6 0.14516485858535155 +7 0.1461800180989455 +8 0.1455336484410895 +9 0.14344736417476336 +10 0.1404219679841424 +11 0.13700769126672943 +12 0.13363368660354177 +13 0.13066864482140672 +14 0.12846247921255227 +15 0.12728607542923076 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz new file mode 100644 index 000000000..61a11af99 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.3383229909201058 -7.245283369895973e-18 -8.09877712631356e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.3467591438588884 1.0183585989727869e-17 -6.865802668587907e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.3633241263303937 3.3016675200365894e-18 -2.2830326410253755e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.387401744643219 4.934393604054129e-18 -4.278891219416674e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4180853337302946 -8.618164562264624e-18 3.091116786537841e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.454193505435375 -1.5645579657138974e-18 -3.4937066288575346e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.494285819702685 -3.930485679856878e-19 -6.703688606352345e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.536720778489076 -7.245204808472365e-20 1.7555638506085636e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.579763295160865 -2.263646841743886e-21 2.1329619693337123e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.621689750840832 1.8221478563758953e-20 -8.469193349575455e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6608738833057255 1.7683302548866813e-20 -9.96837697137709e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6958474986376935 -1.2555855816039059e-20 -1.6864171197535938e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.7253380509903704 -1.1518150784407953e-20 -1.1383175670446963e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.748315635392064 3.389057298464379e-21 -8.444367808311736e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7640275209327925 5.192706921920604e-21 4.2213425287676253e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.771996661108405 2.189683156615292e-20 2.0189609982788494e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener new file mode 100644 index 000000000..4ef16b492 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13187359656973582 +1 0.13302276355392886 +2 0.13514219636313662 +3 0.1378982595231344 +4 0.1408489747603094 +5 0.14350789443825132 +6 0.14540880473620935 +7 0.14618454715952503 +8 0.14565557531940132 +9 0.14398063812620526 +10 0.14153591997260637 +11 0.13875511794245843 +12 0.13602615366862078 +13 0.1336461309861989 +14 0.131882765111852 +15 0.13094428756242057 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz new file mode 100644 index 000000000..15c98ee10 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.362559790325972 -6.143274580653494e-20 -8.938234665209195e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.3699913434136475 9.82603488830841e-18 -5.850880540578698e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.3845920731376613 -2.2261138853682223e-19 3.1243721204822144e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.405837369664595 4.4925748978777975e-18 -2.5595937323623892e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4329401296541517 3.771700831972277e-18 2.4329937312982053e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4648576903962214 1.7470954650836736e-18 -7.720397361248471e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.500315421199589 4.630643587483599e-19 -2.178166299630976e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.537863216109959 1.2349080203039983e-19 -5.901710155457842e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5759620968205703 2.8841116624621814e-20 -2.069738881470252e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6130804818461972 4.5787407506831465e-21 -6.128541988228817e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6477727490121725 8.634682005023885e-21 -6.0548556645327875e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6787382663232036 2.7108313857655273e-21 -3.2194550875133427e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.7048609705440354 -9.084070125445272e-21 6.578768249638381e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.7252364265376077 -1.0290104769424924e-20 1.2585991662258684e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7391893913324643 -3.680747935643482e-21 1.1581936589932861e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.7462755459549046 -2.0162188575810158e-20 3.593111885221937e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener new file mode 100644 index 000000000..bedbf041c --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13421326823764756 +1 0.1351795392085013 +2 0.13696105552450846 +3 0.1392761105466777 +4 0.1417518970955967 +5 0.14397701268094557 +6 0.1455578347640275 +7 0.14618765218496788 +8 0.14571754153674715 +9 0.14427461526220658 +10 0.14216655784301252 +11 0.1397565709764386 +12 0.13739139176528584 +13 0.1353400505811195 +14 0.13382579035928036 +15 0.13302155143351582 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz new file mode 100644 index 000000000..0acf82211 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.378036400008956 -5.2677393387650104e-20 -1.6843123827553497e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.384861189353958 1.183269274760024e-18 -2.5115572893812397e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.398269038777232 1.0950147412485515e-18 -6.487350180881853e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4177751963363625 3.529902437536716e-19 -3.760182337779692e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.442652702068164 -9.671645957208038e-19 -2.459675841651522e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4719410673011186 1.1002398303393508e-18 -6.784129715598233e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5044706908063903 2.928347479808325e-19 -1.859345754684388e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.538916117261639 7.441958539783295e-20 -5.556776969643256e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5738712487118307 1.5158028612680962e-20 -1.8407620671769603e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6079350325127546 -1.3998458567492364e-21 -1.4460900230008096e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.639782187769053 4.0136897677432984e-21 -4.751431126824183e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6682171464200013 3.4806004621151892e-22 -6.914565770728537e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.692213438339977 9.234116692420712e-22 -3.160720044593336e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.7109374554792636 4.719047356248118e-21 8.82585647211388e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7237639775230047 6.775178464953001e-21 2.8205429549215483e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.730279661360899 -5.499082653432982e-21 -5.341739555557236e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener new file mode 100644 index 000000000..cb4711f2b --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13564405043411262 +1 0.13649841426965775 +2 0.13807297203647503 +3 0.14011772609588732 +4 0.1423022840552975 +5 0.14426122133649408 +6 0.14564664125016716 +7 0.14618905209117888 +8 0.14575820657043093 +9 0.14446243010868962 +10 0.14256825314380392 +11 0.14039548084490452 +12 0.1382576361339662 +13 0.13640900160779257 +14 0.13504775007123526 +15 0.13432577976813345 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz new file mode 100644 index 000000000..a487443eb --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.3882471491078743 1.6367392899796402e-18 -2.8830476351521246e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.3946727651671735 -8.239366989732026e-19 8.15023507249094e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.407294025353667 -8.116983152407859e-19 6.097092365289808e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.425650604577382 3.5602527716738367e-20 5.235538878845954e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4490540348157928 5.3698220048514165e-20 1.6545885658021632e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.476597495314023 -7.866401491471966e-19 2.0590402857540293e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5071814982899006 -2.0552797061145034e-19 5.552660170944418e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5395635957654803 -5.4101153935503534e-20 1.4209275570418195e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.572427116951356 -1.446792411027231e-20 3.097891471934784e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6044592355440788 -4.692416801937402e-21 -3.2937437013317725e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.634415951321537 -1.3037402837486014e-21 -1.4053577480625311e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.661172356516093 -1.2458288722219286e-22 4.388866292579513e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.68376025727045 1.5317323205262155e-21 -1.5405249873293975e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.701391888142795 8.579889941855248e-22 1.5878000986070268e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7134739896370617 4.414010018826434e-22 1.4700084667312025e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.7196128599165963 2.3240131895773706e-21 1.8771590843858792e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener new file mode 100644 index 000000000..03f5c3e84 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.1365818193223151 +1 0.13736278574418653 +2 0.13880161156750337 +3 0.140669111785199 +4 0.14266260690530444 +5 0.14444690811922556 +6 0.14570436670541514 +7 0.1461898028223269 +8 0.14578512548453018 +9 0.1445867977651491 +10 0.14283492868599137 +11 0.1408209840856736 +12 0.13883448387904088 +13 0.13711867560507696 +14 0.13585742980979526 +15 0.13518915267680912 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz new file mode 100644 index 000000000..7db3b5e82 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.3953147492954914 1.1354138442716729e-18 1.3452460467240761e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4014645377655004 5.6836250058901005e-19 1.7151544728192184e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.41354215900941 7.365178259583208e-20 4.327564544552418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.431104010062697 -9.56669745136322e-19 -9.486765531133864e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.453488096319528 -9.452686839195054e-19 1.0270049837485955e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.479824751692141 -3.142916432380436e-19 -2.6633421647022933e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.509063080278922 -8.430946493667463e-20 -7.119386152706069e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.540018069444007 -2.1865425096716667e-20 -1.8291067959852063e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5714350397483274 -5.704122469353905e-21 -4.606419343160747e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.6020623714203284 -1.5908183187371046e-21 3.9215522448598815e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.630712459023694 2.7941631180428607e-21 3.530115113280738e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6563093955288153 2.510864230083157e-21 2.759406851715817e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.677925094093369 1.2671536823366167e-21 -8.600606627875617e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6948030081598775 -6.377396447727068e-22 -1.0052103108530288e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.7063716705919854 1.2663436426667167e-21 1.2751301173514087e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.712250707845954 3.928031607670342e-23 1.3931647594680634e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener new file mode 100644 index 000000000..5581bbec5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13722404023181523 +1 0.13795465417635913 +2 0.13930038643648315 +3 0.14104636184684624 +4 0.1429088409727804 +5 0.14457349627604588 +6 0.1457434810510513 +7 0.1461902179764247 +8 0.14580388429634314 +9 0.14467301295294807 +10 0.14301988083095427 +11 0.14111659274354277 +12 0.1392356597507 +13 0.13761113034787423 +14 0.13641849551656487 +15 0.13578702216633456 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz new file mode 100644 index 000000000..b35875c8e --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.400352966342781 3.705080054085656e-21 -8.144355022852245e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4063058921463854 4.114950196243128e-19 4.092968478922562e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.417995542008848 1.0022567725176017e-19 -9.987232519488031e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4349903036030343 -1.5102726919082078e-19 -3.8852521284262793e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4566471379055352 8.061840740291998e-19 -6.989070419138168e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4821230470510693 3.6347165881749154e-19 3.884379480972989e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.510401783923569 9.683469658065607e-20 1.0113196308500409e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.540339241349826 2.5064216374269038e-20 2.78997724888931e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.570724874221731 6.33311973195195e-21 7.262580626347625e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.600350651544698 1.8512660042995024e-21 1.491974668551002e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.6280691582966282 1.455041320960942e-21 2.0899946020014155e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.65283944094868 1.0134187889831264e-21 1.4720392640817571e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6737620505765087 1.2649770909650768e-21 -1.5096365306430996e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.690102572405443 9.699893585515925e-22 -1.22792014188941e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.701305120202562 2.2403020914494856e-21 2.610078347465771e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.706998866870694 3.2355534073305635e-21 -2.2274148903523467e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener new file mode 100644 index 000000000..fc9f82209 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13767919451611116 +1 0.13837408163317105 +2 0.13965377385530112 +3 0.1413135670178166 +4 0.14308310727487317 +5 0.14466295487892517 +6 0.14577102141725787 +7 0.14619046139930714 +8 0.14581728208356529 +9 0.14473451003171922 +10 0.14315193341478116 +11 0.1413279729791101 +12 0.13952296903138908 +13 0.13796334126038326 +14 0.13681940341969137 +15 0.13621403614864838 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz new file mode 100644 index 000000000..2bfdbbc41 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.404032100911285 -2.0282268050288074e-21 -2.1641022585014107e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.409841185153556 -5.944729732524944e-19 -1.8219398345405767e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4212473931737875 3.672027788892918e-20 -2.4724748214074044e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.437827934609895 -6.578309138290831e-19 4.845134072227357e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.4589536824660145 -6.053038753015063e-19 -2.079867907569171e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.483801210720456 -3.344281511517376e-20 1.0749240083830885e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.5113795703334794 -9.06623628448783e-21 4.345892880759563e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5405744625939253 -2.5780238874519974e-21 2.6816676615101177e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5702074755603874 1.4481409558617227e-22 1.6656686440302081e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.599102319808863 3.585863503906688e-22 4.5531230166272615e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.626140871972916 -8.473309097270604e-22 -3.1154683554961573e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6503076864328157 -1.0705880315334471e-21 2.814457103399993e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.670724249013737 4.280971053617609e-22 -5.625630823545308e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.686672292656817 1.2946157625539998e-22 4.878474857866354e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6976073881595712 -1.2067249806578498e-21 1.0839524312384036e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.703165755140378 1.4123473722349123e-21 3.6139615439771107e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener new file mode 100644 index 000000000..f90b21968 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13800978452383972 +1 0.13867869566020163 +2 0.1399103802922583 +3 0.14150754045133687 +4 0.14320952161738285 +5 0.14472776790822098 +6 0.1457909115617625 +7 0.1461906089910128 +8 0.14582708477455458 +9 0.14477942528250837 +10 0.14324842740350557 +11 0.14148259255038342 +12 0.13973336916861442 +13 0.13822110782060923 +14 0.13711260487553908 +15 0.13652622588053687 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz new file mode 100644 index 000000000..95bb43bcc --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.406765439020562 -1.2907325287685857e-21 -1.3383089635469271e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.412467577892283 -1.4623024628474392e-21 -4.43560204294263e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.4236630750642565 -8.303654609684162e-20 -1.0965636010836057e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.439935742618978 -4.412161354489423e-19 -1.7995954259846706e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.46066684080276 2.862394284404205e-21 4.171803897747424e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.485047546120633 -2.126119427439803e-19 -5.908513472885527e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.512105708833543 -5.607450195676556e-20 -1.5121171601660274e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.5407491379645237 -1.5590650796075587e-20 -4.7239469921762226e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5698232312525535 -5.416107817654631e-21 -9.915875156784967e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.598175221167789 -2.1325580904562842e-21 4.997506326941626e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.624708707508375 -6.022273437012621e-22 1.0418461090635023e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6484271848863394 -2.658991505306806e-22 6.45594534864603e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.6684677093581595 -3.0024536118282338e-24 -3.9019685168415576e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6841240275599705 2.2348815873479076e-22 3.587979321349706e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6948602791935357 -3.082722539359822e-22 1.0146914570043515e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.700317978159024 -5.736908401162131e-22 5.460726860644675e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 new file mode 100644 index 000000000..572ae78a4 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 @@ -0,0 +1 @@ +-9.955658228090165721e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.005386865121865592e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.023699533760124084e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.047870577647010658e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.071750438255832799e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.088947539896496959e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094266115035419547e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.084120473908624024e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.061054858418189993e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.033589383703061026e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.003629785448136372e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.733612707468091915e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.452171390866088291e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.214974249881300455e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.034594917525935395e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.936052858402520824e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -9.027796614315168061e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.676807912670593045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.632726874514757264e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener new file mode 100644 index 000000000..fa95db28a --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.13868364218205256 +1 0.13929953199849185 +2 0.14043324893922068 +3 0.14190263010814 +4 0.1434667535392989 +5 0.14485943590355374 +6 0.14583115071922406 +7 0.1461908273222357 +8 0.14584723976488212 +9 0.14487160785265998 +10 0.14344662157500512 +11 0.14180062236336408 +12 0.14016679741347038 +13 0.13875201523568115 +14 0.13771594786456398 +15 0.13716836312327987 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz new file mode 100644 index 000000000..b191b4464 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.4125106547770754 -2.978565633872773e-19 -1.4861158650795324e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.4179877800408174 1.3984069957626917e-21 8.250026531755031e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.428740027602391 1.0450057043818443e-20 -7.441348036137495e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.4443652431526677 9.58009574165853e-20 -1.958042752424339e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.464266693430515 -6.997961547142052e-20 -1.495553455235778e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.4876664223743847 -9.497819715326151e-21 2.214024686735877e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.513631805015641 -2.569230535404628e-21 4.0898497914854945e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.541116986243635 -8.198639490299509e-22 1.61527274274553e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.569017191901633 -2.780676899773558e-22 2.2209509148251033e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.5962288872597017 -3.779280375630499e-22 6.188629412074027e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.621701195179552 -2.953431302606707e-22 2.0407055173296035e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.6444773783435984 6.915348144068967e-23 -5.658157235236707e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 2.663727270955861 4.288687788250292e-22 -4.2041745363635273e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 2.6787699878040856 -2.04352477993163e-22 -2.5020459406651618e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 2.6890878342505045 -4.914728160451446e-22 8.37965465766285e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 2.694333651918987 -1.5081263476245136e-22 -1.9054137367354605e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz new file mode 100644 index 000000000..ea129efa5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001485993830167969 1.6416428860555675e-19 8.190759706678125e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014311948685495474 -7.70735037797129e-22 -4.547019952021589e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0013220969902539678 -5.759571523207936e-21 4.101315051535468e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001160208397751648 -5.2800904714583604e-20 1.0791794945040917e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0009491489537623587 3.8569416299277926e-20 8.242775188779033e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0006961200758143405 5.234743861739422e-21 -1.220264490799738e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0004123659528442293 1.416036961925111e-21 -2.254129551108221e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011262661668046895 4.518697873071388e-22 -8.902610629129851e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00018676989113939298 1.5325760826015415e-22 -1.2240818963793133e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0004718706315723419 2.082958546391471e-22 -3.410876474645961e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.000731421500803685 1.6277900450607386e-22 -1.1247392560232525e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0009566256532785221 -3.811409074289113e-23 3.118505587984279e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.001141325646813254 -2.363719542731824e-22 2.317139881313742e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0012817517884265895 1.126293098699038e-22 1.3790080273425396e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00137591552463838 2.7087630467996967e-22 -4.618464773753651e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0014230530554878943 8.31207095689099e-23 1.0501728987711588e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..6b6e5529a --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0028520081672789646 1.1420402006502963e-17 3.542381171428807e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0028040999945881215 -2.3944748110076815e-18 -1.0674708951215072e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0026803580213167737 4.207645916530494e-18 1.8355894729560742e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002444990903897951 9.264955997004228e-18 -4.323712111943975e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002067771697709855 1.0619395802505298e-17 -1.7562477580605434e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0015381459075631484 2.4944156448562332e-18 -8.350889219592038e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0008674384310822318 6.833127367937046e-19 -2.203334531967586e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011644115055508473 1.6110610357542393e-19 -6.137354989238447e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0006168730496398377 1.029334619077587e-19 -1.648085137948782e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0012671648238777183 8.722540420950337e-20 -8.233480159214353e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.001794665653987321 -3.229551007243993e-20 -6.502976934009758e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002172859138419669 -3.3816957426968244e-20 1.8526681387375716e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0024099733865889593 8.795937686561949e-20 1.6788534587003444e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0025447118120052064 2.0933280772743152e-21 5.0851087449857815e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002613976732072058 -1.2564670582899322e-19 4.7283739871415364e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0026413497719772455 -2.245039589309162e-20 2.905671985787771e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..6e6a2732b --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0024884103610560617 -6.200585275033675e-18 -1.3970562173587787e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.002416704479852049 4.477599731178956e-18 6.978630192035114e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0022660124812034364 -1.6867175802449868e-18 -4.019604585003816e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0020274127246601137 2.9849650384656863e-18 -7.483444392811037e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0016949643903153597 -1.5359759606402185e-17 -1.515484304713985e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0012698421997955126 -4.3130916237850372e-19 -4.100307198267322e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0007656819282577569 -1.1417956073978754e-19 -1.0919680532858607e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00021688361640288107 -5.2507901267836336e-20 -3.009797178112627e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00032986912497209495 2.2839970552534398e-20 -5.768022479381364e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0008382501453689153 5.520684266163445e-20 -1.4965498605785906e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0012844419664059658 3.3543544773130936e-20 3.594468885493588e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.001651010963806505 1.3361358063926347e-20 3.3989733019268737e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0019275754827721213 4.341363415494276e-20 2.0162393524549216e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002117430914164494 9.076263610280899e-21 1.842905931514872e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002232558759293777 -1.8149080141481365e-20 1.238423994497984e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002286045941283969 -5.2250456695236464e-20 1.574834984143617e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz new file mode 100644 index 000000000..c0f4e08b5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015225794472987595 -1.8258162790245027e-19 -8.473492612658581e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014667037146868078 -2.7483387668336725e-19 9.286842130033623e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0013553652923911572 -1.3732150138235464e-19 4.690777536182723e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0011899392623869072 9.273696749302881e-20 -1.024689547297707e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0009738826604090946 1.0587441971440585e-19 1.8301335154373117e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007144150736436023 6.145545959715992e-20 -3.495114929409003e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.000423083863262697 1.6796049744263222e-20 -9.272615502930793e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011518727698175578 4.6952456481690104e-21 -2.4696577641649102e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00019225540648472875 1.3234417204134027e-21 -5.938466523436612e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0004847700953483179 3.646380605699303e-22 -2.5808181881968534e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0007507668544313775 1.5405807263811176e-22 -1.2643734813649147e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0009812518548847388 2.211117912565163e-22 3.744336134419447e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0011700097718558122 5.334067395631399e-22 2.0966567715776183e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.001313315670366571 -6.928903593503833e-23 -1.814317866212861e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.001409258412286268 -8.450547766508923e-22 1.8835562884811786e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0014572304770987356 -5.696242106249825e-22 1.1856732046589614e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz new file mode 100644 index 000000000..b30b0560f --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00150708544762243 1.3875354682897734e-19 4.498709840764269e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014516631615128857 1.394285087190886e-19 1.3413484707656584e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0013412694242621015 -8.810179557877231e-21 -5.1737038247432375e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0011773368952913798 5.354806920475266e-20 -2.0831129031411877e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0009633929847211708 7.794698482885725e-20 -1.3776225091079087e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007066528969108947 2.468074653640406e-20 -7.38420609648991e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00041853561843238347 6.347753624396195e-21 -2.0081071415371107e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011410118454349398 1.6928810582472289e-21 -5.6839777324418025e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0001899267699573457 3.3330049539372864e-22 -1.6824614416024853e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00047929671941810797 2.314034644439367e-22 -4.939327135890225e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00074256165186701 2.0342272042787383e-22 -1.5997438998800313e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0009708111355885283 2.5833825732355204e-22 2.229268546168155e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.001157853636304411 5.56339063105587e-22 1.2628332155546406e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0012999449675001645 1.9987102644841597e-23 1.2205400953782684e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0013951400543292102 -4.105100634965197e-22 1.2023852015829236e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0014427621476056501 -1.6777227638832607e-22 3.1488462373854535e-23 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz new file mode 100644 index 000000000..1fd1330e7 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014951837402547787 1.4421652804560004e-21 -8.646142580222974e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014401123353742459 -2.1208041934741117e-19 5.322511247759705e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001330448443239614 -1.1910329758371642e-19 7.96364854423546e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0011676677249281464 -1.5903224448948341e-19 -3.4754866015362695e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0009553502901262226 -2.1246457967002865e-19 1.067914610159638e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.000700704626102099 -4.0851108567041455e-20 -1.3983300380627802e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00041505108892649577 -1.1050181056922858e-20 -3.9073002563621375e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011326854064507488 -3.058337670526858e-21 -1.2618141979764032e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00018814357453294432 -8.871393156300872e-22 -2.130661222625531e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.00047510283532131925 -2.107893807932926e-22 3.574188676509087e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0007362713168218143 8.67110551773567e-23 -2.050086909841297e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0009628026736743013 -4.171455249317344e-23 5.572610486493887e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0011485243690178587 -1.4613122848372971e-22 2.4442770592703154e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0012896776825021194 -2.2396145808910483e-22 2.127588813485506e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0013842926973099397 -2.5331460378231066e-22 -2.3976475879081147e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.00143164250232438 -2.9008187806392486e-22 1.6223140099260722e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz new file mode 100644 index 000000000..ea129efa5 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001485993830167969 1.6416428860555675e-19 8.190759706678125e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014311948685495474 -7.70735037797129e-22 -4.547019952021589e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0013220969902539678 -5.759571523207936e-21 4.101315051535468e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001160208397751648 -5.2800904714583604e-20 1.0791794945040917e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0009491489537623587 3.8569416299277926e-20 8.242775188779033e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0006961200758143405 5.234743861739422e-21 -1.220264490799738e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0004123659528442293 1.416036961925111e-21 -2.254129551108221e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011262661668046895 4.518697873071388e-22 -8.902610629129851e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00018676989113939298 1.5325760826015415e-22 -1.2240818963793133e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0004718706315723419 2.082958546391471e-22 -3.410876474645961e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.000731421500803685 1.6277900450607386e-22 -1.1247392560232525e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0009566256532785221 -3.811409074289113e-23 3.118505587984279e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.001141325646813254 -2.363719542731824e-22 2.317139881313742e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0012817517884265895 1.126293098699038e-22 1.3790080273425396e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00137591552463838 2.7087630467996967e-22 -4.618464773753651e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0014230530554878943 8.31207095689099e-23 1.0501728987711588e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..b8eab3e53 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.002166858546834956 3.993253587023183e-18 4.4636585153490375e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00209592629951815 -5.6127054258781484e-18 3.7841019784055255e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0019514228556452755 -1.819721188866813e-18 1.2582983739387532e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0017299294859733924 -2.7196016985400964e-18 2.3583201426479155e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0014302139909061825 4.7499200231161436e-18 -1.7036756970800215e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.001056571821247607 8.623095039528342e-19 1.9255639587071574e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0006239424958838306 2.1662956765840184e-19 3.6947524626614164e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00016034811206562042 3.993210287724784e-20 -9.675828101933207e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0003002459331580581 1.247613848770315e-21 -1.1755865989197566e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0007313066410677047 -1.0042807288659739e-20 4.667814217302401e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0011142931528157654 -9.74619041500546e-21 5.494092510328192e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0014365587871789187 6.920187067336713e-21 9.294724400503379e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0016900396650620874 6.3482536965798955e-21 6.273861870827008e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0018730419873846378 -1.867886254104412e-21 4.654131566584688e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.001989711277020876 -2.8619716419203746e-21 -2.3266020574288268e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002046012487730462 -1.2068486038695553e-20 -1.1127547173565799e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..397c113f2 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0019582373873393696 3.385879061292689e-20 4.926327352054148e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0018913990442878878 -5.415640363630923e-18 3.2247254542158074e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0017564337051345822 1.2269274787517942e-19 -1.7220044462512123e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001552019390593871 -2.4760923638212936e-18 1.4107256171023883e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0012789568881082286 -2.0787810645241706e-18 -1.3409497529219445e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.000942813205141391 -9.629154412103394e-19 4.255113690120919e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0005580641841206654 -2.552189220476311e-19 1.2005010632536922e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0001479354517033912 -6.80622224137169e-20 3.252740306303789e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00026023305337602123 -1.5895843755891443e-20 1.1407410574130662e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0006444411092603016 -2.523582859807072e-21 3.3777591611393794e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0009886250971433402 -4.7590236473885805e-21 3.3371467845915798e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0012814594665516929 -1.494080576613616e-21 1.77440962901321e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0015160282351308857 5.006704881126728e-21 -3.625902338094457e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0016892001617319285 5.6714134815047854e-21 -6.936796504106917e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0018020300366504995 2.0286521791552157e-21 -6.383409381141777e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0018573676729341658 1.1112433805849577e-20 -1.9803513805760424e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..c75830fbb --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001817615719236009 2.903325920615929e-20 9.283124097052306e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0017539023281922604 -6.521614179346622e-19 1.3842502277422805e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0016258761844349056 -6.035197410638782e-19 3.575517071936678e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0014333317626334986 -1.9455133568830664e-19 2.0724326215574317e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0011781327642435997 5.330548570606671e-19 1.3556556557056004e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0008666243060632932 -6.063995602081569e-19 3.739087753862715e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.000512616776821824 -1.6139650419170269e-19 1.024782430906683e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0001365024732318459 -4.101651531939204e-20 3.0626296355106314e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0002381641846318971 -8.354380227733919e-21 1.0145399913759543e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0005920966945850301 7.715280691393701e-22 7.970156413067018e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0009107710967726742 -2.2121537894340906e-21 2.6187615338165436e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.001183610300480748 -1.9183404665835156e-22 3.810977867531756e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0014040637128960743 -5.089403370779285e-22 1.74203768317617e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0015686483930317224 -2.6009131486793223e-21 -4.864389868070343e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0016770083120976565 -3.7341542527251414e-21 -1.554548345050465e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0017305539349000204 3.030831288448765e-21 2.9441113000220476e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..73393b131 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001721922023661441 -9.020923968121923e-19 1.5889979346377484e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0016605761926864401 4.541144922399388e-19 -4.492019673589922e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001537678172351954 4.473692805975761e-19 -3.3604256334910973e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001353644476948642 -1.962241009132525e-20 -2.885578567543469e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0011109240617137276 -2.959589002639219e-20 -9.119300637556566e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0008163104475442856 4.3355841820215737e-19 -1.1348445032634484e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00048295549042645235 1.1327718516681746e-19 -3.0603606530109977e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00012947517686072796 2.981796790898253e-20 -7.831472938150661e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00022289701377494405 7.974027639853873e-21 -1.7074095795772475e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0005565618015498926 2.5862356611199628e-21 1.8153539590635725e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0008579930912378993 7.18559274887336e-22 7.745659599483824e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0011171265991116372 6.866412752726734e-23 -2.418933141887577e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0013275267392284945 -8.442175786684897e-22 8.490636759788026e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0014856373586363963 -4.72882488336264e-22 -8.751194557252092e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0015903756622600868 -2.432791160946408e-22 -8.101983432586028e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0016423569986714764 -1.2808848918358138e-21 -1.034600286067858e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..a212b10b1 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0016544007842064763 -6.257857940011445e-19 -7.414352658489329e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0015948280359958493 -3.1325422048180257e-19 -9.453110942964455e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0014757148269767028 -4.059333914577877e-20 -2.3851465509838864e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.001297851188992573 5.272705974807197e-19 5.2286513242327634e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.001064051304636144 5.2098687795235885e-19 -5.660360162426122e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007813460723396459 1.7322251838298325e-19 1.4679067897961629e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00046236443154317646 4.646734380013837e-20 3.9238650636938275e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00012454420147408297 1.2051176295193574e-20 1.0081161634705365e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00021239747578720731 3.143839426102952e-21 2.538837975867014e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0005319764740789759 8.767829542725452e-22 -2.1613719945794727e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.000821343309502934 -1.5400090409455907e-21 -1.9456305735789955e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0010707958325609042 -1.383868246612379e-21 -1.5208530496480423e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0012739601763008114 -6.983944904522047e-22 4.740242929633377e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0014272451404046813 3.514915834288572e-22 5.540238351759843e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0015291841864186614 -6.979480353375711e-22 -7.027907198483962e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0015799152059467324 -2.1649431093949397e-23 -7.678457679344032e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..ca65acb9a --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001605651022755263 -2.0420628788185028e-21 4.488778871524242e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0015474110200183054 -2.2679636934346094e-19 -2.2558484224289233e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0014311168300680853 -5.523959861395533e-20 5.504484786418061e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0012577963050988286 8.323900579794991e-20 2.1413651069592957e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0010305097299662478 -4.443300946370421e-19 3.852041265513929e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007564043148941275 -2.0032819025200587e-19 -2.1408841454295456e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0004477137482070312 -5.337065228886395e-20 -5.573910000951241e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00012106032836118718 -1.3814197020690454e-20 -1.537701990115574e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00020487584242076583 -3.490512626703175e-21 -4.002787007297428e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0005143789971546132 -1.0203292590209905e-21 -8.22305062862511e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0007950747889023309 -8.019491685219838e-22 -1.1519050415582396e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0010375228016033051 -5.585479556366425e-22 -8.1131762160709555e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0012353987367211688 -6.971948574139719e-22 8.320394363234335e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0013850738266852631 -5.346117311994213e-22 6.767708398475387e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0014848740515976064 -1.234747339195464e-21 -1.4385503218183832e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0015346319270509831 -1.7832822527703793e-21 1.2276445304603824e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz new file mode 100644 index 000000000..da7a4d466 --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015697369058946 1.117861586771056e-21 1.1927496365914823e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001512504884774409 3.276450639173474e-19 1.0041660771818843e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0013983300794534273 -2.0238460514286258e-20 1.3627098410577945e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0012283991225769688 3.625649297883074e-19 -2.670406114675944e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0010059468014039933 3.3361453898820777e-19 1.1463236920372164e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007381721456860701 1.843207982364093e-20 -5.924466902272087e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0004370129420549762 4.996875721142508e-21 -2.3952482530936272e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011850921793083539 1.4208834369092385e-21 -1.4780069269648319e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00019939290898938987 -7.981460173852433e-23 -9.180368728160828e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0005015246796828759 -1.976356419549743e-22 -2.5094635903199573e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0007758546776170932 4.670082620539081e-22 1.7170971169373149e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.001013135452477347 5.900569072160953e-22 -1.5511941148322908e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.001207085927457777 -2.3594664477624673e-22 3.1005785858880805e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0013540388881603301 -7.135302753120254e-23 -2.688781960733295e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0014522034332599529 6.650890809301261e-22 -5.974227249951444e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0015012084305935827 -7.78418306416193e-22 -1.991842715056933e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz new file mode 100644 index 000000000..08d0f1ebe --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015428868980090107 7.113900226191793e-22 7.376118774641905e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0014864226727866637 8.059511625647034e-22 2.4446916517003435e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001373855589352785 4.5765771830673006e-20 6.04373398509193e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0012064821996132322 2.431772265601935e-19 9.918509081180324e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0009876649486536898 -1.5776147957392954e-21 -2.299298733884633e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0007246211293814278 1.1718153171675837e-19 3.256489969406634e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.00042906629524346745 3.090558293548256e-20 8.33406640645857e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00011661499599453697 8.592820879047078e-21 2.6036135936096485e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00019531941495264636 2.9850995283934894e-21 5.465156021754627e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0004919669250026473 1.1753640002036437e-21 -2.754386412151776e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0007615486940610629 3.3191890194807336e-22 -5.742157345329215e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0009949616405223872 1.4655089144681762e-22 -3.558208230781254e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0011859608861268486 1.6548087967297755e-24 2.150578380559986e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0013308468007275807 -1.231759816645685e-22 -1.9775225569059333e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0014277563695201808 1.6990491896071378e-22 -5.592493893668901e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0014761792737331475 3.161909463272385e-22 -3.0096914103631925e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst1D.dat b/drivers/py/pes/friction/onheH/120K/inst1D.dat new file mode 100644 index 000000000..98a44396c --- /dev/null +++ b/drivers/py/pes/friction/onheH/120K/inst1D.dat @@ -0,0 +1,16 @@ +2.4125106547770754 0.13868364218205256 +2.4179877800408174 0.13929953199849185 +2.428740027602391 0.14043324893922068 +2.4443652431526677 0.14190263010814 +2.464266693430515 0.1434667535392989 +2.4876664223743847 0.14485943590355374 +2.513631805015641 0.14583115071922406 +2.541116986243635 0.1461908273222357 +2.569017191901633 0.14584723976488212 +2.5962288872597017 0.14487160785265998 +2.621701195179552 0.14344662157500512 +2.6444773783435984 0.14180062236336408 +2.663727270955861 0.14016679741347038 +2.6787699878040856 0.13875201523568115 +2.6890878342505045 0.13771594786456398 +2.694333651918987 0.13716836312327987 diff --git a/drivers/py/pes/friction/template.agr b/drivers/py/pes/friction/template.agr new file mode 100644 index 000000000..6d0383c1a --- /dev/null +++ b/drivers/py/pes/friction/template.agr @@ -0,0 +1,1502 @@ +# Grace project file +# +@version 50125 +@page size 792, 612 +@page scroll 5% +@page inout 5% +@link page off +@map font 8 to "Courier", "Courier" +@map font 10 to "Courier-Bold", "Courier-Bold" +@map font 11 to "Courier-BoldOblique", "Courier-BoldOblique" +@map font 9 to "Courier-Oblique", "Courier-Oblique" +@map font 14 to "Courier-Regular", "Courier-Regular" +@map font 15 to "Dingbats-Regular", "Dingbats-Regular" +@map font 4 to "Helvetica", "Helvetica" +@map font 6 to "Helvetica-Bold", "Helvetica-Bold" +@map font 7 to "Helvetica-BoldOblique", "Helvetica-BoldOblique" +@map font 5 to "Helvetica-Oblique", "Helvetica-Oblique" +@map font 20 to "NimbusMonoL-Bold", "NimbusMonoL-Bold" +@map font 21 to "NimbusMonoL-BoldOblique", "NimbusMonoL-BoldOblique" +@map font 22 to "NimbusMonoL-Regular", "NimbusMonoL-Regular" +@map font 23 to "NimbusMonoL-RegularOblique", "NimbusMonoL-RegularOblique" +@map font 24 to "NimbusRomanNo9L-Medium", "NimbusRomanNo9L-Medium" +@map font 25 to "NimbusRomanNo9L-MediumItalic", "NimbusRomanNo9L-MediumItalic" +@map font 26 to "NimbusRomanNo9L-Regular", "NimbusRomanNo9L-Regular" +@map font 27 to "NimbusRomanNo9L-RegularItalic", "NimbusRomanNo9L-RegularItalic" +@map font 28 to "NimbusSansL-Bold", "NimbusSansL-Bold" +@map font 29 to "NimbusSansL-BoldCondensed", "NimbusSansL-BoldCondensed" +@map font 30 to "NimbusSansL-BoldCondensedItalic", "NimbusSansL-BoldCondensedItalic" +@map font 31 to "NimbusSansL-BoldItalic", "NimbusSansL-BoldItalic" +@map font 32 to "NimbusSansL-Regular", "NimbusSansL-Regular" +@map font 33 to "NimbusSansL-RegularCondensed", "NimbusSansL-RegularCondensed" +@map font 34 to "NimbusSansL-RegularCondensedItalic", "NimbusSansL-RegularCondensedItalic" +@map font 35 to "NimbusSansL-RegularItalic", "NimbusSansL-RegularItalic" +@map font 36 to "StandardSymbolsL-Regular", "StandardSymbolsL-Regular" +@map font 12 to "Symbol", "Symbol" +@map font 2 to "Times-Bold", "Times-Bold" +@map font 3 to "Times-BoldItalic", "Times-BoldItalic" +@map font 1 to "Times-Italic", "Times-Italic" +@map font 0 to "Times-Roman", "Times-Roman" +@map font 42 to "URWBookmanL-DemiBold", "URWBookmanL-DemiBold" +@map font 43 to "URWBookmanL-DemiBoldItalic", "URWBookmanL-DemiBoldItalic" +@map font 44 to "URWBookmanL-Light", "URWBookmanL-Light" +@map font 45 to "URWBookmanL-LightItalic", "URWBookmanL-LightItalic" +@map font 46 to "URWChanceryL-MediumItalic", "URWChanceryL-MediumItalic" +@map font 47 to "URWGothicL-Book", "URWGothicL-Book" +@map font 48 to "URWGothicL-BookOblique", "URWGothicL-BookOblique" +@map font 49 to "URWGothicL-Demi", "URWGothicL-Demi" +@map font 50 to "URWGothicL-DemiOblique", "URWGothicL-DemiOblique" +@map font 51 to "URWPalladioL-Bold", "URWPalladioL-Bold" +@map font 52 to "URWPalladioL-BoldItalic", "URWPalladioL-BoldItalic" +@map font 53 to "URWPalladioL-Italic", "URWPalladioL-Italic" +@map font 54 to "URWPalladioL-Roman", "URWPalladioL-Roman" +@map font 55 to "Utopia-Bold", "Utopia-Bold" +@map font 56 to "Utopia-BoldItalic", "Utopia-BoldItalic" +@map font 57 to "Utopia-Italic", "Utopia-Italic" +@map font 58 to "Utopia-Regular", "Utopia-Regular" +@map font 13 to "ZapfDingbats", "ZapfDingbats" +@map color 0 to (255, 255, 255), "white" +@map color 1 to (0, 0, 0), "black" +@map color 2 to (255, 0, 0), "red" +@map color 3 to (0, 0, 255), "blue" +@map color 4 to (0, 255, 0), "green" +@map color 5 to (114, 33, 188), "indigo" +@map color 6 to (255, 0, 255), "magenta" +@map color 7 to (255, 165, 0), "orange" +@map color 8 to (0, 139, 0), "green4" +@map color 9 to (103, 7, 72), "maroon" +@map color 10 to (176, 23, 31), "indianred" +@map color 11 to (220, 20, 60), "crimson" +@map color 12 to (135, 38, 87), "raspberry" +@map color 13 to (139, 102, 139), "plum" +@map color 14 to (100, 149, 237), "blue2" +@map color 15 to (16, 78, 139), "blue3" +@map color 16 to (46, 139, 87), "seagreen" +@map color 17 to (238, 201, 0), "gold" +@map color 18 to (139, 105, 20), "goldenrod" +@map color 19 to (238, 118, 0), "darkorange" +@map color 20 to (139, 69, 19), "chocolate" +@map color 21 to (250, 128, 114), "salmon" +@map color 22 to (120, 120, 120), "darkgrey" +@map color 23 to (127, 127, 127), "grey" +@map color 24 to (255, 127, 127), "lightred" +@map color 25 to (127, 127, 255), "lightblue" +@map color 26 to (127, 255, 127), "lightgreen" +@map color 27 to (204, 149, 255), "lightindigo" +@map color 28 to (255, 127, 255), "lightmagenta" +@map color 29 to (255, 210, 127), "lightorange" +@map color 30 to (127, 255, 127), "lightgreen4" +@map color 31 to (206, 110, 174), "lightmaroon" +@map color 32 to (255, 144, 149), "lightindianred" +@map color 33 to (255, 139, 162), "lightcrimson" +@map color 34 to (255, 163, 209), "lightraspberry" +@map color 35 to (255, 221, 255), "lightplum" +@map color 36 to (181, 207, 255), "lightblue2" +@map color 37 to (142, 199, 255), "lightblue3" +@map color 38 to (169, 255, 207), "lightseagreen" +@map color 39 to (255, 235, 127), "lightgold" +@map color 40 to (255, 223, 145), "lightgoldenrod" +@map color 41 to (255, 190, 127), "lightdarkorange" +@map color 42 to (255, 190, 144), "lightchocolate" +@map color 43 to (255, 192, 185), "lightsalmon" +@map color 44 to (240, 240, 240), "lightgrey" +@map color 45 to (200, 200, 200), "lightdarkgrey" +@reference date 0 +@date wrap off +@date wrap year 1950 +@default linewidth 1.0 +@default linestyle 1 +@default color 1 +@default pattern 1 +@default font 0 +@default char size 1.000000 +@default symbol size 1.000000 +@default sformat "%.8g" +@background color 0 +@page background fill on +@timestamp off +@timestamp 0.03, 0.03 +@timestamp color 1 +@timestamp rot 0 +@timestamp font 0 +@timestamp char size 1.000000 +@timestamp def "Fri Feb 19 11:06:55 2021" +@with string +@ string on +@ string loctype view +@ string 0.497549019608, 0.803921568627 +@ string color 1 +@ string rot 0 +@ string font 4 +@ string just 0 +@ string char size 1.000000 +@ string def "120 K" +@with string +@ string on +@ string loctype view +@ string 1.02450980392, 0.79044117647 +@ string color 1 +@ string rot 0 +@ string font 4 +@ string just 0 +@ string char size 1.000000 +@ string def "100 K" +@with string +@ string on +@ string loctype view +@ string 0.490196078432, 0.411764705882 +@ string color 1 +@ string rot 0 +@ string font 4 +@ string just 0 +@ string char size 1.000000 +@ string def "080 K" +@with string +@ string on +@ string loctype view +@ string 1.02450980392, 0.405637254902 +@ string color 1 +@ string rot 0 +@ string font 4 +@ string just 0 +@ string char size 1.000000 +@ string def "060 K" +@r0 off +@link r0 to g0 +@r0 type above +@r0 linestyle 1 +@r0 linewidth 1.0 +@r0 color 1 +@r0 line 0, 0, 0, 0 +@r1 off +@link r1 to g0 +@r1 type above +@r1 linestyle 1 +@r1 linewidth 1.0 +@r1 color 1 +@r1 line 0, 0, 0, 0 +@r2 off +@link r2 to g0 +@r2 type above +@r2 linestyle 1 +@r2 linewidth 1.0 +@r2 color 1 +@r2 line 0, 0, 0, 0 +@r3 off +@link r3 to g0 +@r3 type above +@r3 linestyle 1 +@r3 linewidth 1.0 +@r3 color 1 +@r3 line 0, 0, 0, 0 +@r4 off +@link r4 to g0 +@r4 type above +@r4 linestyle 1 +@r4 linewidth 1.0 +@r4 color 1 +@r4 line 0, 0, 0, 0 +@g0 on +@g0 hidden false +@g0 type XY +@g0 stacked false +@g0 bar hgap 0.000000 +@g0 fixedpoint off +@g0 fixedpoint type 0 +@g0 fixedpoint xy 0.000000, 0.000000 +@g0 fixedpoint format general general +@g0 fixedpoint prec 6, 6 +@with g0 +@ world 1.5, 0, 3.5, 0.2 +@ stack world 0, 0, 0, 0 +@ znorm 1 +@ view 0.150000, 0.531818, 0.601872, 0.850000 +@ title "" +@ title font 0 +@ title size 1.500000 +@ title color 1 +@ subtitle "" +@ subtitle font 0 +@ subtitle size 1.000000 +@ subtitle color 1 +@ xaxes scale Normal +@ yaxes scale Normal +@ xaxes invert off +@ yaxes invert off +@ xaxis on +@ xaxis type zero false +@ xaxis offset 0.000000 , 0.000000 +@ xaxis bar on +@ xaxis bar color 1 +@ xaxis bar linestyle 1 +@ xaxis bar linewidth 2.0 +@ xaxis label "" +@ xaxis label layout para +@ xaxis label place auto +@ xaxis label char size 1.350000 +@ xaxis label font 4 +@ xaxis label color 1 +@ xaxis label place normal +@ xaxis tick on +@ xaxis tick major 0.5 +@ xaxis tick minor ticks 1 +@ xaxis tick default 6 +@ xaxis tick place rounded true +@ xaxis tick in +@ xaxis tick major size 0.500000 +@ xaxis tick major color 1 +@ xaxis tick major linewidth 1.5 +@ xaxis tick major linestyle 1 +@ xaxis tick major grid off +@ xaxis tick minor color 1 +@ xaxis tick minor linewidth 1.5 +@ xaxis tick minor linestyle 1 +@ xaxis tick minor grid off +@ xaxis tick minor size 0.500000 +@ xaxis ticklabel on +@ xaxis ticklabel format general +@ xaxis ticklabel prec 5 +@ xaxis ticklabel formula "" +@ xaxis ticklabel append "" +@ xaxis ticklabel prepend "" +@ xaxis ticklabel angle 0 +@ xaxis ticklabel skip 0 +@ xaxis ticklabel stagger 0 +@ xaxis ticklabel place normal +@ xaxis ticklabel offset auto +@ xaxis ticklabel offset 0.000000 , 0.010000 +@ xaxis ticklabel start type auto +@ xaxis ticklabel start 0.000000 +@ xaxis ticklabel stop type auto +@ xaxis ticklabel stop 0.000000 +@ xaxis ticklabel char size 1.000000 +@ xaxis ticklabel font 4 +@ xaxis ticklabel color 1 +@ xaxis tick place normal +@ xaxis tick spec type none +@ yaxis on +@ yaxis type zero false +@ yaxis offset 0.000000 , 0.000000 +@ yaxis bar on +@ yaxis bar color 1 +@ yaxis bar linestyle 1 +@ yaxis bar linewidth 2.0 +@ yaxis label "Energy(eV)" +@ yaxis label layout para +@ yaxis label place auto +@ yaxis label char size 1.250000 +@ yaxis label font 4 +@ yaxis label color 1 +@ yaxis label place normal +@ yaxis tick on +@ yaxis tick major 0.05 +@ yaxis tick minor ticks 1 +@ yaxis tick default 6 +@ yaxis tick place rounded true +@ yaxis tick in +@ yaxis tick major size 1.000000 +@ yaxis tick major color 1 +@ yaxis tick major linewidth 1.5 +@ yaxis tick major linestyle 1 +@ yaxis tick major grid off +@ yaxis tick minor color 1 +@ yaxis tick minor linewidth 1.5 +@ yaxis tick minor linestyle 1 +@ yaxis tick minor grid off +@ yaxis tick minor size 0.500000 +@ yaxis ticklabel on +@ yaxis ticklabel format general +@ yaxis ticklabel prec 5 +@ yaxis ticklabel formula "" +@ yaxis ticklabel append "" +@ yaxis ticklabel prepend "" +@ yaxis ticklabel angle 0 +@ yaxis ticklabel skip 0 +@ yaxis ticklabel stagger 0 +@ yaxis ticklabel place normal +@ yaxis ticklabel offset auto +@ yaxis ticklabel offset 0.000000 , 0.010000 +@ yaxis ticklabel start type auto +@ yaxis ticklabel start 0.000000 +@ yaxis ticklabel stop type auto +@ yaxis ticklabel stop 0.000000 +@ yaxis ticklabel char size 1.000000 +@ yaxis ticklabel font 4 +@ yaxis ticklabel color 1 +@ yaxis tick place normal +@ yaxis tick spec type none +@ altxaxis off +@ altyaxis off +@ legend on +@ legend loctype view +@ legend 0.85, 0.95 +@ legend box color 1 +@ legend box pattern 1 +@ legend box linewidth 2.0 +@ legend box linestyle 1 +@ legend box fill color 0 +@ legend box fill pattern 1 +@ legend font 0 +@ legend char size 1.000000 +@ legend color 1 +@ legend length 4 +@ legend vgap 1 +@ legend hgap 1 +@ legend invert false +@ frame type 0 +@ frame linestyle 1 +@ frame linewidth 2.0 +@ frame color 1 +@ frame pattern 1 +@ frame background color 0 +@ frame background pattern 0 +@ s0 hidden false +@ s0 type xy +@ s0 symbol 0 +@ s0 symbol size 1.000000 +@ s0 symbol color 1 +@ s0 symbol pattern 1 +@ s0 symbol fill color 1 +@ s0 symbol fill pattern 0 +@ s0 symbol linewidth 1.0 +@ s0 symbol linestyle 1 +@ s0 symbol char 65 +@ s0 symbol char font 0 +@ s0 symbol skip 0 +@ s0 line type 1 +@ s0 line linestyle 1 +@ s0 line linewidth 2.0 +@ s0 line color 1 +@ s0 line pattern 1 +@ s0 baseline type 0 +@ s0 baseline off +@ s0 dropline off +@ s0 fill type 0 +@ s0 fill rule 0 +@ s0 fill color 1 +@ s0 fill pattern 1 +@ s0 avalue off +@ s0 avalue type 2 +@ s0 avalue char size 1.000000 +@ s0 avalue font 0 +@ s0 avalue color 1 +@ s0 avalue rot 0 +@ s0 avalue format general +@ s0 avalue prec 3 +@ s0 avalue prepend "" +@ s0 avalue append "" +@ s0 avalue offset 0.000000 , 0.000000 +@ s0 errorbar on +@ s0 errorbar place both +@ s0 errorbar color 1 +@ s0 errorbar pattern 1 +@ s0 errorbar size 1.000000 +@ s0 errorbar linewidth 1.0 +@ s0 errorbar linestyle 1 +@ s0 errorbar riser linewidth 1.0 +@ s0 errorbar riser linestyle 1 +@ s0 errorbar riser clip off +@ s0 errorbar riser clip length 0.100000 +@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/120K/inst1D.dat" +@ s0 legend "Ohne Friction" +@ s1 hidden false +@ s1 type xy +@ s1 symbol 0 +@ s1 symbol size 1.000000 +@ s1 symbol color 2 +@ s1 symbol pattern 1 +@ s1 symbol fill color 2 +@ s1 symbol fill pattern 0 +@ s1 symbol linewidth 1.0 +@ s1 symbol linestyle 1 +@ s1 symbol char 65 +@ s1 symbol char font 0 +@ s1 symbol skip 0 +@ s1 line type 1 +@ s1 line linestyle 1 +@ s1 line linewidth 2.0 +@ s1 line color 2 +@ s1 line pattern 1 +@ s1 baseline type 0 +@ s1 baseline off +@ s1 dropline off +@ s1 fill type 0 +@ s1 fill rule 0 +@ s1 fill color 1 +@ s1 fill pattern 1 +@ s1 avalue off +@ s1 avalue type 2 +@ s1 avalue char size 1.000000 +@ s1 avalue font 0 +@ s1 avalue color 1 +@ s1 avalue rot 0 +@ s1 avalue format general +@ s1 avalue prec 3 +@ s1 avalue prepend "" +@ s1 avalue append "" +@ s1 avalue offset 0.000000 , 0.000000 +@ s1 errorbar on +@ s1 errorbar place both +@ s1 errorbar color 2 +@ s1 errorbar pattern 1 +@ s1 errorbar size 1.000000 +@ s1 errorbar linewidth 1.0 +@ s1 errorbar linestyle 1 +@ s1 errorbar riser linewidth 1.0 +@ s1 errorbar riser linestyle 1 +@ s1 errorbar riser clip off +@ s1 errorbar riser clip length 0.100000 +@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/120K/inst1D.dat" +@ s1 legend "Friction" +@g1 on +@g1 hidden false +@g1 type XY +@g1 stacked false +@g1 bar hgap 0.000000 +@g1 fixedpoint off +@g1 fixedpoint type 0 +@g1 fixedpoint xy 0.000000, 0.000000 +@g1 fixedpoint format general general +@g1 fixedpoint prec 6, 6 +@with g1 +@ world 1.5, 0, 3.5, 0.2 +@ stack world 0, 0, 0, 0 +@ znorm 1 +@ view 0.692246, 0.531818, 1.144118, 0.850000 +@ title "" +@ title font 0 +@ title size 1.500000 +@ title color 1 +@ subtitle "" +@ subtitle font 0 +@ subtitle size 1.000000 +@ subtitle color 1 +@ xaxes scale Normal +@ yaxes scale Normal +@ xaxes invert off +@ yaxes invert off +@ xaxis on +@ xaxis type zero false +@ xaxis offset 0.000000 , 0.000000 +@ xaxis bar on +@ xaxis bar color 1 +@ xaxis bar linestyle 1 +@ xaxis bar linewidth 1.0 +@ xaxis label "" +@ xaxis label layout para +@ xaxis label place auto +@ xaxis label char size 1.000000 +@ xaxis label font 4 +@ xaxis label color 1 +@ xaxis label place normal +@ xaxis tick on +@ xaxis tick major 0.5 +@ xaxis tick minor ticks 1 +@ xaxis tick default 6 +@ xaxis tick place rounded true +@ xaxis tick in +@ xaxis tick major size 1.000000 +@ xaxis tick major color 1 +@ xaxis tick major linewidth 1.0 +@ xaxis tick major linestyle 1 +@ xaxis tick major grid off +@ xaxis tick minor color 1 +@ xaxis tick minor linewidth 1.0 +@ xaxis tick minor linestyle 1 +@ xaxis tick minor grid off +@ xaxis tick minor size 0.500000 +@ xaxis ticklabel on +@ xaxis ticklabel format general +@ xaxis ticklabel prec 5 +@ xaxis ticklabel formula "" +@ xaxis ticklabel append "" +@ xaxis ticklabel prepend "" +@ xaxis ticklabel angle 0 +@ xaxis ticklabel skip 0 +@ xaxis ticklabel stagger 0 +@ xaxis ticklabel place normal +@ xaxis ticklabel offset auto +@ xaxis ticklabel offset 0.000000 , 0.010000 +@ xaxis ticklabel start type auto +@ xaxis ticklabel start 0.000000 +@ xaxis ticklabel stop type auto +@ xaxis ticklabel stop 0.000000 +@ xaxis ticklabel char size 1.000000 +@ xaxis ticklabel font 4 +@ xaxis ticklabel color 1 +@ xaxis tick place both +@ xaxis tick spec type none +@ yaxis on +@ yaxis type zero false +@ yaxis offset 0.000000 , 0.000000 +@ yaxis bar on +@ yaxis bar color 1 +@ yaxis bar linestyle 1 +@ yaxis bar linewidth 1.0 +@ yaxis label "" +@ yaxis label layout para +@ yaxis label place auto +@ yaxis label char size 1.000000 +@ yaxis label font 0 +@ yaxis label color 1 +@ yaxis label place normal +@ yaxis tick on +@ yaxis tick major 0.02 +@ yaxis tick minor ticks 1 +@ yaxis tick default 6 +@ yaxis tick place rounded true +@ yaxis tick in +@ yaxis tick major size 1.000000 +@ yaxis tick major color 1 +@ yaxis tick major linewidth 1.0 +@ yaxis tick major linestyle 1 +@ yaxis tick major grid off +@ yaxis tick minor color 1 +@ yaxis tick minor linewidth 1.0 +@ yaxis tick minor linestyle 1 +@ yaxis tick minor grid off +@ yaxis tick minor size 0.500000 +@ yaxis ticklabel off +@ yaxis ticklabel format general +@ yaxis ticklabel prec 5 +@ yaxis ticklabel formula "" +@ yaxis ticklabel append "" +@ yaxis ticklabel prepend "" +@ yaxis ticklabel angle 0 +@ yaxis ticklabel skip 0 +@ yaxis ticklabel stagger 0 +@ yaxis ticklabel place normal +@ yaxis ticklabel offset auto +@ yaxis ticklabel offset 0.000000 , 0.010000 +@ yaxis ticklabel start type auto +@ yaxis ticklabel start 0.000000 +@ yaxis ticklabel stop type auto +@ yaxis ticklabel stop 0.000000 +@ yaxis ticklabel char size 1.000000 +@ yaxis ticklabel font 0 +@ yaxis ticklabel color 1 +@ yaxis tick place both +@ yaxis tick spec type none +@ altxaxis off +@ altyaxis off +@ legend on +@ legend loctype view +@ legend 0.5, 0.8 +@ legend box color 1 +@ legend box pattern 1 +@ legend box linewidth 1.0 +@ legend box linestyle 1 +@ legend box fill color 0 +@ legend box fill pattern 1 +@ legend font 0 +@ legend char size 1.000000 +@ legend color 1 +@ legend length 4 +@ legend vgap 1 +@ legend hgap 1 +@ legend invert false +@ frame type 0 +@ frame linestyle 1 +@ frame linewidth 2.0 +@ frame color 1 +@ frame pattern 1 +@ frame background color 0 +@ frame background pattern 0 +@ s0 hidden false +@ s0 type xy +@ s0 symbol 0 +@ s0 symbol size 1.000000 +@ s0 symbol color 1 +@ s0 symbol pattern 1 +@ s0 symbol fill color 1 +@ s0 symbol fill pattern 0 +@ s0 symbol linewidth 1.0 +@ s0 symbol linestyle 1 +@ s0 symbol char 65 +@ s0 symbol char font 0 +@ s0 symbol skip 0 +@ s0 line type 1 +@ s0 line linestyle 1 +@ s0 line linewidth 2.0 +@ s0 line color 1 +@ s0 line pattern 1 +@ s0 baseline type 0 +@ s0 baseline off +@ s0 dropline off +@ s0 fill type 0 +@ s0 fill rule 0 +@ s0 fill color 1 +@ s0 fill pattern 1 +@ s0 avalue off +@ s0 avalue type 2 +@ s0 avalue char size 1.000000 +@ s0 avalue font 0 +@ s0 avalue color 1 +@ s0 avalue rot 0 +@ s0 avalue format general +@ s0 avalue prec 3 +@ s0 avalue prepend "" +@ s0 avalue append "" +@ s0 avalue offset 0.000000 , 0.000000 +@ s0 errorbar on +@ s0 errorbar place both +@ s0 errorbar color 1 +@ s0 errorbar pattern 1 +@ s0 errorbar size 1.000000 +@ s0 errorbar linewidth 1.0 +@ s0 errorbar linestyle 1 +@ s0 errorbar riser linewidth 1.0 +@ s0 errorbar riser linestyle 1 +@ s0 errorbar riser clip off +@ s0 errorbar riser clip length 0.100000 +@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/100K/inst1D.dat" +@ s0 legend "" +@ s1 hidden false +@ s1 type xy +@ s1 symbol 0 +@ s1 symbol size 1.000000 +@ s1 symbol color 2 +@ s1 symbol pattern 1 +@ s1 symbol fill color 2 +@ s1 symbol fill pattern 0 +@ s1 symbol linewidth 1.0 +@ s1 symbol linestyle 1 +@ s1 symbol char 65 +@ s1 symbol char font 0 +@ s1 symbol skip 0 +@ s1 line type 1 +@ s1 line linestyle 1 +@ s1 line linewidth 2.0 +@ s1 line color 2 +@ s1 line pattern 1 +@ s1 baseline type 0 +@ s1 baseline off +@ s1 dropline off +@ s1 fill type 0 +@ s1 fill rule 0 +@ s1 fill color 1 +@ s1 fill pattern 1 +@ s1 avalue off +@ s1 avalue type 2 +@ s1 avalue char size 1.000000 +@ s1 avalue font 0 +@ s1 avalue color 1 +@ s1 avalue rot 0 +@ s1 avalue format general +@ s1 avalue prec 3 +@ s1 avalue prepend "" +@ s1 avalue append "" +@ s1 avalue offset 0.000000 , 0.000000 +@ s1 errorbar on +@ s1 errorbar place both +@ s1 errorbar color 2 +@ s1 errorbar pattern 1 +@ s1 errorbar size 1.000000 +@ s1 errorbar linewidth 1.0 +@ s1 errorbar linestyle 1 +@ s1 errorbar riser linewidth 1.0 +@ s1 errorbar riser linestyle 1 +@ s1 errorbar riser clip off +@ s1 errorbar riser clip length 0.100000 +@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/100K/inst1D.dat" +@ s1 legend "" +@g2 on +@g2 hidden false +@g2 type XY +@g2 stacked false +@g2 bar hgap 0.000000 +@g2 fixedpoint off +@g2 fixedpoint type 0 +@g2 fixedpoint xy 0.000000, 0.000000 +@g2 fixedpoint format general general +@g2 fixedpoint prec 6, 6 +@with g2 +@ world 1.5, 0, 3.5, 0.2 +@ stack world 0, 0, 0, 0 +@ znorm 1 +@ view 0.150000, 0.150000, 0.601872, 0.468182 +@ title "" +@ title font 0 +@ title size 1.500000 +@ title color 1 +@ subtitle "" +@ subtitle font 0 +@ subtitle size 1.000000 +@ subtitle color 1 +@ xaxes scale Normal +@ yaxes scale Normal +@ xaxes invert off +@ yaxes invert off +@ xaxis on +@ xaxis type zero false +@ xaxis offset 0.000000 , 0.000000 +@ xaxis bar on +@ xaxis bar color 1 +@ xaxis bar linestyle 1 +@ xaxis bar linewidth 1.0 +@ xaxis label "" +@ xaxis label layout para +@ xaxis label place auto +@ xaxis label char size 1.000000 +@ xaxis label font 4 +@ xaxis label color 1 +@ xaxis label place normal +@ xaxis tick on +@ xaxis tick major 0.5 +@ xaxis tick minor ticks 1 +@ xaxis tick default 6 +@ xaxis tick place rounded true +@ xaxis tick in +@ xaxis tick major size 1.000000 +@ xaxis tick major color 1 +@ xaxis tick major linewidth 1.0 +@ xaxis tick major linestyle 1 +@ xaxis tick major grid off +@ xaxis tick minor color 1 +@ xaxis tick minor linewidth 1.0 +@ xaxis tick minor linestyle 1 +@ xaxis tick minor grid off +@ xaxis tick minor size 0.500000 +@ xaxis ticklabel on +@ xaxis ticklabel format general +@ xaxis ticklabel prec 5 +@ xaxis ticklabel formula "" +@ xaxis ticklabel append "" +@ xaxis ticklabel prepend "" +@ xaxis ticklabel angle 0 +@ xaxis ticklabel skip 0 +@ xaxis ticklabel stagger 0 +@ xaxis ticklabel place normal +@ xaxis ticklabel offset auto +@ xaxis ticklabel offset 0.000000 , 0.010000 +@ xaxis ticklabel start type auto +@ xaxis ticklabel start 0.000000 +@ xaxis ticklabel stop type auto +@ xaxis ticklabel stop 0.000000 +@ xaxis ticklabel char size 1.000000 +@ xaxis ticklabel font 4 +@ xaxis ticklabel color 1 +@ xaxis tick place both +@ xaxis tick spec type none +@ yaxis on +@ yaxis type zero false +@ yaxis offset 0.000000 , 0.000000 +@ yaxis bar on +@ yaxis bar color 1 +@ yaxis bar linestyle 1 +@ yaxis bar linewidth 1.0 +@ yaxis label "Energy (eV)" +@ yaxis label layout para +@ yaxis label place auto +@ yaxis label char size 1.250000 +@ yaxis label font 4 +@ yaxis label color 1 +@ yaxis label place normal +@ yaxis tick on +@ yaxis tick major 0.05 +@ yaxis tick minor ticks 1 +@ yaxis tick default 6 +@ yaxis tick place rounded true +@ yaxis tick in +@ yaxis tick major size 1.000000 +@ yaxis tick major color 1 +@ yaxis tick major linewidth 1.0 +@ yaxis tick major linestyle 1 +@ yaxis tick major grid off +@ yaxis tick minor color 1 +@ yaxis tick minor linewidth 1.0 +@ yaxis tick minor linestyle 1 +@ yaxis tick minor grid off +@ yaxis tick minor size 0.500000 +@ yaxis ticklabel on +@ yaxis ticklabel format general +@ yaxis ticklabel prec 5 +@ yaxis ticklabel formula "" +@ yaxis ticklabel append "" +@ yaxis ticklabel prepend "" +@ yaxis ticklabel angle 0 +@ yaxis ticklabel skip 0 +@ yaxis ticklabel stagger 0 +@ yaxis ticklabel place normal +@ yaxis ticklabel offset auto +@ yaxis ticklabel offset 0.000000 , 0.010000 +@ yaxis ticklabel start type auto +@ yaxis ticklabel start 0.000000 +@ yaxis ticklabel stop type auto +@ yaxis ticklabel stop 0.000000 +@ yaxis ticklabel char size 1.000000 +@ yaxis ticklabel font 4 +@ yaxis ticklabel color 1 +@ yaxis tick place both +@ yaxis tick spec type none +@ altxaxis off +@ altyaxis off +@ legend on +@ legend loctype view +@ legend 0.5, 0.8 +@ legend box color 1 +@ legend box pattern 1 +@ legend box linewidth 1.0 +@ legend box linestyle 1 +@ legend box fill color 0 +@ legend box fill pattern 1 +@ legend font 0 +@ legend char size 1.000000 +@ legend color 1 +@ legend length 4 +@ legend vgap 1 +@ legend hgap 1 +@ legend invert false +@ frame type 0 +@ frame linestyle 1 +@ frame linewidth 2.0 +@ frame color 1 +@ frame pattern 1 +@ frame background color 0 +@ frame background pattern 0 +@ s0 hidden false +@ s0 type xy +@ s0 symbol 0 +@ s0 symbol size 1.000000 +@ s0 symbol color 1 +@ s0 symbol pattern 1 +@ s0 symbol fill color 1 +@ s0 symbol fill pattern 0 +@ s0 symbol linewidth 1.0 +@ s0 symbol linestyle 1 +@ s0 symbol char 65 +@ s0 symbol char font 0 +@ s0 symbol skip 0 +@ s0 line type 1 +@ s0 line linestyle 1 +@ s0 line linewidth 2.0 +@ s0 line color 1 +@ s0 line pattern 1 +@ s0 baseline type 0 +@ s0 baseline off +@ s0 dropline off +@ s0 fill type 0 +@ s0 fill rule 0 +@ s0 fill color 1 +@ s0 fill pattern 1 +@ s0 avalue off +@ s0 avalue type 2 +@ s0 avalue char size 1.000000 +@ s0 avalue font 0 +@ s0 avalue color 1 +@ s0 avalue rot 0 +@ s0 avalue format general +@ s0 avalue prec 3 +@ s0 avalue prepend "" +@ s0 avalue append "" +@ s0 avalue offset 0.000000 , 0.000000 +@ s0 errorbar on +@ s0 errorbar place both +@ s0 errorbar color 1 +@ s0 errorbar pattern 1 +@ s0 errorbar size 1.000000 +@ s0 errorbar linewidth 1.0 +@ s0 errorbar linestyle 1 +@ s0 errorbar riser linewidth 1.0 +@ s0 errorbar riser linestyle 1 +@ s0 errorbar riser clip off +@ s0 errorbar riser clip length 0.100000 +@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/080K/inst1D.dat" +@ s0 legend "" +@ s1 hidden false +@ s1 type xy +@ s1 symbol 0 +@ s1 symbol size 1.000000 +@ s1 symbol color 2 +@ s1 symbol pattern 1 +@ s1 symbol fill color 2 +@ s1 symbol fill pattern 0 +@ s1 symbol linewidth 1.0 +@ s1 symbol linestyle 1 +@ s1 symbol char 65 +@ s1 symbol char font 0 +@ s1 symbol skip 0 +@ s1 line type 1 +@ s1 line linestyle 1 +@ s1 line linewidth 2.0 +@ s1 line color 2 +@ s1 line pattern 1 +@ s1 baseline type 0 +@ s1 baseline off +@ s1 dropline off +@ s1 fill type 0 +@ s1 fill rule 0 +@ s1 fill color 1 +@ s1 fill pattern 1 +@ s1 avalue off +@ s1 avalue type 2 +@ s1 avalue char size 1.000000 +@ s1 avalue font 0 +@ s1 avalue color 1 +@ s1 avalue rot 0 +@ s1 avalue format general +@ s1 avalue prec 3 +@ s1 avalue prepend "" +@ s1 avalue append "" +@ s1 avalue offset 0.000000 , 0.000000 +@ s1 errorbar on +@ s1 errorbar place both +@ s1 errorbar color 2 +@ s1 errorbar pattern 1 +@ s1 errorbar size 1.000000 +@ s1 errorbar linewidth 1.0 +@ s1 errorbar linestyle 1 +@ s1 errorbar riser linewidth 1.0 +@ s1 errorbar riser linestyle 1 +@ s1 errorbar riser clip off +@ s1 errorbar riser clip length 0.100000 +@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/080K/inst1D.dat" +@ s1 legend "" +@g3 on +@g3 hidden false +@g3 type XY +@g3 stacked false +@g3 bar hgap 0.000000 +@g3 fixedpoint off +@g3 fixedpoint type 0 +@g3 fixedpoint xy 0.000000, 0.000000 +@g3 fixedpoint format general general +@g3 fixedpoint prec 6, 6 +@with g3 +@ world 1.5, 0, 3.5, 0.2 +@ stack world 0, 0, 0, 0 +@ znorm 1 +@ view 0.692246, 0.150000, 1.144118, 0.468182 +@ title "" +@ title font 0 +@ title size 1.500000 +@ title color 1 +@ subtitle "" +@ subtitle font 0 +@ subtitle size 1.000000 +@ subtitle color 1 +@ xaxes scale Normal +@ yaxes scale Normal +@ xaxes invert off +@ yaxes invert off +@ xaxis on +@ xaxis type zero false +@ xaxis offset 0.000000 , 0.000000 +@ xaxis bar on +@ xaxis bar color 1 +@ xaxis bar linestyle 1 +@ xaxis bar linewidth 1.0 +@ xaxis label "" +@ xaxis label layout para +@ xaxis label place auto +@ xaxis label char size 1.000000 +@ xaxis label font 4 +@ xaxis label color 1 +@ xaxis label place normal +@ xaxis tick on +@ xaxis tick major 0.5 +@ xaxis tick minor ticks 1 +@ xaxis tick default 6 +@ xaxis tick place rounded true +@ xaxis tick in +@ xaxis tick major size 1.000000 +@ xaxis tick major color 1 +@ xaxis tick major linewidth 1.0 +@ xaxis tick major linestyle 1 +@ xaxis tick major grid off +@ xaxis tick minor color 1 +@ xaxis tick minor linewidth 1.0 +@ xaxis tick minor linestyle 1 +@ xaxis tick minor grid off +@ xaxis tick minor size 0.500000 +@ xaxis ticklabel on +@ xaxis ticklabel format general +@ xaxis ticklabel prec 5 +@ xaxis ticklabel formula "" +@ xaxis ticklabel append "" +@ xaxis ticklabel prepend "" +@ xaxis ticklabel angle 0 +@ xaxis ticklabel skip 0 +@ xaxis ticklabel stagger 0 +@ xaxis ticklabel place normal +@ xaxis ticklabel offset auto +@ xaxis ticklabel offset 0.000000 , 0.010000 +@ xaxis ticklabel start type auto +@ xaxis ticklabel start 0.000000 +@ xaxis ticklabel stop type auto +@ xaxis ticklabel stop 0.000000 +@ xaxis ticklabel char size 1.000000 +@ xaxis ticklabel font 4 +@ xaxis ticklabel color 1 +@ xaxis tick place both +@ xaxis tick spec type none +@ yaxis on +@ yaxis type zero false +@ yaxis offset 0.000000 , 0.000000 +@ yaxis bar on +@ yaxis bar color 1 +@ yaxis bar linestyle 1 +@ yaxis bar linewidth 1.0 +@ yaxis label "" +@ yaxis label layout para +@ yaxis label place auto +@ yaxis label char size 1.000000 +@ yaxis label font 0 +@ yaxis label color 1 +@ yaxis label place normal +@ yaxis tick on +@ yaxis tick major 0.05 +@ yaxis tick minor ticks 1 +@ yaxis tick default 6 +@ yaxis tick place rounded true +@ yaxis tick in +@ yaxis tick major size 1.000000 +@ yaxis tick major color 1 +@ yaxis tick major linewidth 1.0 +@ yaxis tick major linestyle 1 +@ yaxis tick major grid off +@ yaxis tick minor color 1 +@ yaxis tick minor linewidth 1.0 +@ yaxis tick minor linestyle 1 +@ yaxis tick minor grid off +@ yaxis tick minor size 0.500000 +@ yaxis ticklabel off +@ yaxis ticklabel format general +@ yaxis ticklabel prec 5 +@ yaxis ticklabel formula "" +@ yaxis ticklabel append "" +@ yaxis ticklabel prepend "" +@ yaxis ticklabel angle 0 +@ yaxis ticklabel skip 0 +@ yaxis ticklabel stagger 0 +@ yaxis ticklabel place normal +@ yaxis ticklabel offset auto +@ yaxis ticklabel offset 0.000000 , 0.010000 +@ yaxis ticklabel start type auto +@ yaxis ticklabel start 0.000000 +@ yaxis ticklabel stop type auto +@ yaxis ticklabel stop 0.000000 +@ yaxis ticklabel char size 1.000000 +@ yaxis ticklabel font 0 +@ yaxis ticklabel color 1 +@ yaxis tick place both +@ yaxis tick spec type none +@ altxaxis off +@ altyaxis off +@ legend on +@ legend loctype view +@ legend 0.5, 0.8 +@ legend box color 1 +@ legend box pattern 1 +@ legend box linewidth 1.0 +@ legend box linestyle 1 +@ legend box fill color 0 +@ legend box fill pattern 1 +@ legend font 0 +@ legend char size 1.000000 +@ legend color 1 +@ legend length 4 +@ legend vgap 1 +@ legend hgap 1 +@ legend invert false +@ frame type 0 +@ frame linestyle 1 +@ frame linewidth 2.0 +@ frame color 1 +@ frame pattern 1 +@ frame background color 0 +@ frame background pattern 0 +@ s0 hidden false +@ s0 type xy +@ s0 symbol 0 +@ s0 symbol size 1.000000 +@ s0 symbol color 1 +@ s0 symbol pattern 1 +@ s0 symbol fill color 1 +@ s0 symbol fill pattern 0 +@ s0 symbol linewidth 1.0 +@ s0 symbol linestyle 1 +@ s0 symbol char 65 +@ s0 symbol char font 0 +@ s0 symbol skip 0 +@ s0 line type 1 +@ s0 line linestyle 1 +@ s0 line linewidth 2.0 +@ s0 line color 1 +@ s0 line pattern 1 +@ s0 baseline type 0 +@ s0 baseline off +@ s0 dropline off +@ s0 fill type 0 +@ s0 fill rule 0 +@ s0 fill color 1 +@ s0 fill pattern 1 +@ s0 avalue off +@ s0 avalue type 2 +@ s0 avalue char size 1.000000 +@ s0 avalue font 0 +@ s0 avalue color 1 +@ s0 avalue rot 0 +@ s0 avalue format general +@ s0 avalue prec 3 +@ s0 avalue prepend "" +@ s0 avalue append "" +@ s0 avalue offset 0.000000 , 0.000000 +@ s0 errorbar on +@ s0 errorbar place both +@ s0 errorbar color 1 +@ s0 errorbar pattern 1 +@ s0 errorbar size 1.000000 +@ s0 errorbar linewidth 1.0 +@ s0 errorbar linestyle 1 +@ s0 errorbar riser linewidth 1.0 +@ s0 errorbar riser linestyle 1 +@ s0 errorbar riser clip off +@ s0 errorbar riser clip length 0.100000 +@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/060K/inst1D.dat" +@ s0 legend "" +@ s1 hidden false +@ s1 type xy +@ s1 symbol 0 +@ s1 symbol size 1.000000 +@ s1 symbol color 2 +@ s1 symbol pattern 1 +@ s1 symbol fill color 2 +@ s1 symbol fill pattern 0 +@ s1 symbol linewidth 1.0 +@ s1 symbol linestyle 1 +@ s1 symbol char 65 +@ s1 symbol char font 0 +@ s1 symbol skip 0 +@ s1 line type 1 +@ s1 line linestyle 1 +@ s1 line linewidth 2.0 +@ s1 line color 2 +@ s1 line pattern 1 +@ s1 baseline type 0 +@ s1 baseline off +@ s1 dropline off +@ s1 fill type 0 +@ s1 fill rule 0 +@ s1 fill color 1 +@ s1 fill pattern 1 +@ s1 avalue off +@ s1 avalue type 2 +@ s1 avalue char size 1.000000 +@ s1 avalue font 0 +@ s1 avalue color 1 +@ s1 avalue rot 0 +@ s1 avalue format general +@ s1 avalue prec 3 +@ s1 avalue prepend "" +@ s1 avalue append "" +@ s1 avalue offset 0.000000 , 0.000000 +@ s1 errorbar on +@ s1 errorbar place both +@ s1 errorbar color 2 +@ s1 errorbar pattern 1 +@ s1 errorbar size 1.000000 +@ s1 errorbar linewidth 1.0 +@ s1 errorbar linestyle 1 +@ s1 errorbar riser linewidth 1.0 +@ s1 errorbar riser linestyle 1 +@ s1 errorbar riser clip off +@ s1 errorbar riser clip length 0.100000 +@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/060K/inst1D.dat" +@ s1 legend "" +@target G0.S0 +@type xy +2.4125107 0.13868364 +2.4179878 0.13929953 +2.42874 0.14043325 +2.4443652 0.14190263 +2.4642667 0.14346675 +2.4876664 0.14485944 +2.5136318 0.14583115 +2.541117 0.14619083 +2.5690172 0.14584724 +2.5962289 0.14487161 +2.6217012 0.14344662 +2.6444774 0.14180062 +2.6637273 0.1401668 +2.67877 0.13875202 +2.6890878 0.13771595 +2.6943337 0.13716836 +& +@target G0.S1 +@type xy +2.5404617 0.14619035 +2.5408892 0.14619071 +2.5417277 0.14619091 +2.5429447 0.14619005 +2.544493 0.14618697 +2.546313 0.1461805 +2.5483342 0.1461697 +2.5504789 0.14615412 +2.5526643 0.14613391 +2.5548065 0.14610987 +2.5568234 0.14608347 +2.5586376 0.1460566 +2.5601798 0.14603146 +2.5613911 0.14601024 +2.5622252 0.14599487 +2.5626503 0.14598681 +& +@target G1.S0 +@type xy +2.1140352 0.076168765 +2.1292682 0.079772628 +2.1600045 0.087227829 +2.2065283 0.098705526 +2.2685997 0.11349751 +2.3448117 0.1289372 +2.4322203 0.14077881 +2.5264469 0.14608519 +2.6221167 0.1434196 +2.7138878 0.13499974 +2.7972109 0.12330028 +2.8688194 0.10989162 +2.9268984 0.0974325 +2.970644 0.087614053 +2.9998041 0.081026366 +3.0143653 0.077748183 +& +@target G1.S1 +@type xy +2.1481513 0.084329875 +2.1625478 0.087852471 +2.1914769 0.094993194 +2.234972 0.10562813 +2.2925299 0.11877371 +2.3626514 0.13188808 +2.4426064 0.14174779 +2.5285044 0.14611196 +2.6156591 0.14382628 +2.6994168 0.13662413 +2.7757577 0.1267172 +2.841669 0.11529636 +2.8953394 0.10432512 +2.9358895 0.095431447 +2.9629791 0.089344847 +2.9765244 0.086285344 +& +@target G2.S0 +@type xy +1.956477 0.046867586 +1.9572334 0.046957184 +1.9587518 0.047138935 +1.9610427 0.047417985 +1.9641224 0.047802136 +1.9680123 0.04830194 +1.972739 0.048930812 +1.9783343 0.049705143 +1.9848348 0.050644402 +1.9922821 0.051771202 +2.000722 0.053111296 +2.0102045 0.054693458 +2.0207829 0.056549205 +2.0325136 0.058712293 +2.0454546 0.061217918 +2.059665 0.064101525 +2.0752031 0.067397157 +2.0921251 0.071135228 +2.1104829 0.075339671 +2.1303212 0.080024383 +2.1516756 0.085188987 +2.174568 0.090813985 +2.1990037 0.09685188 +2.2249673 0.1032131 +2.2524204 0.10976658 +2.2813009 0.11633792 +2.3115228 0.12270836 +2.3429769 0.12861822 +2.3755333 0.13384883 +2.4090433 0.13828036 +2.4433411 0.1418128 +2.478246 0.14435723 +2.5135651 0.14582944 +2.549099 0.14616463 +2.5846475 0.14535968 +2.6200151 0.14355507 +2.655014 0.14093213 +2.689466 0.13767694 +2.7232052 0.13389365 +2.7560798 0.12959701 +2.7879557 0.12481065 +2.8187184 0.11957546 +2.8482749 0.11401288 +2.8765525 0.10829448 +2.9034961 0.10256725 +2.929066 0.096951254 +2.9532352 0.091541105 +2.9759874 0.086406625 +2.9973151 0.081587948 +3.0172176 0.077107878 +3.0357001 0.072979233 +3.0527718 0.069206719 +3.0684455 0.065788641 +3.0827356 0.062718474 +3.0956584 0.059986241 +3.1072302 0.057579723 +3.1174676 0.055485416 +3.1263864 0.053688596 +3.1340014 0.052175081 +3.1403257 0.050932623 +3.1453709 0.04995098 +3.1491464 0.04922194 +3.1516593 0.048739341 +3.1529145 0.048499069 +& +@target G2.S1 +@type xy +1.986685 0.05091937 +1.9994379 0.052903203 +2.0262721 0.057548082 +2.0697017 0.06621438 +2.1329715 0.080659415 +2.2189211 0.101742 +2.3276738 0.12584533 +2.4543702 0.14273224 +2.589553 0.14516575 +2.7216097 0.13408648 +2.8405658 0.11550857 +2.9403611 0.094431774 +3.0189906 0.076710307 +3.0766054 0.064029716 +3.1141674 0.056156934 +3.1326587 0.052440646 +& +@target G3.S0 +@type xy +1.8783333 0.04143116 +1.8785298 0.041434377 +1.8789259 0.041441038 +1.8795283 0.041451616 +1.880347 0.041466856 +1.8813956 0.041487822 +1.8826913 0.041515972 +1.8842555 0.04155324 +1.8861138 0.041602164 +1.8882966 0.041666035 +1.8908392 0.041749098 +1.8937826 0.041856794 +1.8971737 0.041996075 +1.9010661 0.042175779 +1.9055207 0.042407096 +1.9106062 0.042704131 +1.9163997 0.043084566 +1.9229876 0.04357044 +1.9304662 0.044189025 +1.9389418 0.044973801 +1.9485316 0.045965467 +1.9593638 0.047212921 +1.9715773 0.04877408 +1.9853211 0.050716343 +2.0007534 0.053116408 +2.0180395 0.056059049 +2.0373487 0.059634333 +2.05885 0.06393263 +2.0827061 0.069036704 +2.1090654 0.075010162 +2.1380517 0.081881749 +2.1697507 0.089625454 +2.2041943 0.098131184 +2.2413435 0.10715123 +2.2810793 0.11628911 +2.3232012 0.12499742 +2.367431 0.13263222 +2.4134242 0.13878817 +2.4607781 0.14321764 +2.5090414 0.14570372 +2.5577323 0.14607037 +2.6063639 0.1443606 +2.6544674 0.14097875 +2.7016038 0.1363858 +2.7473734 0.13079626 +2.7914281 0.12425051 +2.8334837 0.11685568 +2.873327 0.10896346 +2.9108089 0.10097612 +2.9458331 0.093205118 +2.9783456 0.085873647 +3.0083249 0.079106341 +3.0357747 0.072962653 +3.0607167 0.067468044 +3.0831858 0.06262255 +3.103225 0.058408112 +3.1208816 0.054794562 +3.1362039 0.051740885 +3.1492389 0.04920413 +3.1600298 0.04714707 +3.1686146 0.045538633 +3.1750246 0.044353979 +3.1792843 0.043574515 +3.18141 0.043187871 +& +@target G3.S1 +@type xy +1.8946271 0.041889967 +1.8948991 0.041900864 +1.8954468 0.041923123 +1.8962777 0.041957701 +1.8974032 0.042006086 +1.898839 0.042070378 +1.9006049 0.042153388 +1.9027257 0.042258777 +1.9052311 0.042391233 +1.9081565 0.042556696 +1.9115431 0.04276264 +1.915439 0.043018423 +1.9198995 0.043335705 +1.9249875 0.043728954 +1.9307747 0.044216051 +1.9373418 0.044818972 +1.9447791 0.045564569 +1.9531874 0.046485417 +1.9626779 0.047620672 +1.9733726 0.04901689 +1.9854041 0.05072866 +1.998915 0.05281888 +2.0140564 0.055358408 +2.0309865 0.05842472 +2.0498671 0.062099107 +2.0708593 0.066461841 +2.0941181 0.071584671 +2.1197841 0.077520041 +2.1479738 0.084286621 +2.1787667 0.091851139 +2.2121906 0.10009594 +2.2482068 0.10877698 +2.2867032 0.11751916 +2.3274929 0.12581136 +2.3703181 0.13307221 +2.4148594 0.13895093 +2.4607429 0.14321508 +2.5075487 0.14565816 +2.554827 0.14610963 +2.6021217 0.14458378 +2.648992 0.14143639 +2.6950236 0.13709531 +2.7398381 0.13179811 +2.7831028 0.12558053 +2.824544 0.11851734 +2.8639535 0.11088444 +2.9011862 0.10306702 +2.936149 0.095373505 +2.9687911 0.088032683 +2.9990946 0.081186502 +3.027067 0.074902943 +3.052735 0.069214895 +3.0761391 0.064129837 +3.0973288 0.05963651 +3.1163591 0.055710643 +3.1332873 0.052316292 +3.1481702 0.049410068 +3.1610622 0.046952418 +3.1720132 0.04490887 +3.1810679 0.043250076 +3.1882644 0.04195178 +3.1936341 0.040994736 +3.1972005 0.040364616 +3.1989797 0.040051921 +& diff --git a/drivers/py/pes/friction/test-ohne80/RESTART b/drivers/py/pes/friction/test-ohne80/RESTART new file mode 100644 index 000000000..df3ffa6a3 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/RESTART @@ -0,0 +1,117 @@ + + + [ step, potential{electronvolt} ] + + 9 + 30 + + + + + + + + + 2.53345216e-04 + [ 1.00000000e+00 ] + + + + + 1.00000000e-03 + 2.00000000e-04 + + 1.00000000e-01 + + [ 1.72723599e-03, 1.78383969e-03, 1.92188540e-03, 2.19375838e-03, 2.67508700e-03, + 3.42744998e-03, 4.37771723e-03, 5.14525767e-03, 5.36208621e-03, 4.99086344e-03, + 4.28675855e-03, 3.45354589e-03, 2.74792678e-03, 2.24637181e-03, 1.93846815e-03, + 1.79407991e-03 ] + + + [ -1.47659842e-03, -1.01710041e-19, 6.14390492e-20, -1.64007837e-03, -1.64201483e-19, + -8.12405107e-20, -1.95624952e-03, -2.46552617e-19, -8.15163089e-20, -2.38446595e-03, + -1.79715622e-19, 1.08511958e-19, -2.81025400e-03, -5.82622524e-20, -6.43310029e-20, + -2.97330106e-03, 1.47020953e-19, -7.19317832e-20, -2.50439628e-03, 3.77448738e-19, + -1.07375903e-19, -1.36423595e-03, 1.96370431e-19, -4.81220028e-20, 1.58525091e-04, + -3.42880551e-19, 8.34061212e-20, 1.53298828e-03, -4.23026760e-19, 9.21223603e-20, + 2.41157879e-03, 3.89313928e-19, -8.09693606e-20, 2.72736124e-03, 4.35468830e-19, + -8.00203360e-20, 2.73600998e-03, -8.50959899e-19, 1.44884979e-19, 2.62525620e-03, + 6.38415013e-19, -9.73003224e-20, 2.50468515e-03, -2.87741941e-19, 3.91395380e-20, + 2.43269161e-03, 7.03282316e-20, -8.43639446e-21 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00 ] + + + [ 1.37205221e-02, 0.00000000e+00, 0.00000000e+00, 1.30098510e-02, 0.00000000e+00, + 0.00000000e+00, 1.14766409e-02, 0.00000000e+00, 0.00000000e+00, 8.88476534e-03, + 0.00000000e+00, 0.00000000e+00, 4.85797340e-03, 0.00000000e+00, 0.00000000e+00, + -1.07975035e-03, 0.00000000e+00, 0.00000000e+00, -6.90526383e-03, 0.00000000e+00, + 0.00000000e+00, -1.01681686e-02, 0.00000000e+00, 0.00000000e+00, -1.06348704e-02, + 0.00000000e+00, 0.00000000e+00, -8.68319027e-03, 0.00000000e+00, 0.00000000e+00, + -4.71302762e-03, 0.00000000e+00, 0.00000000e+00, -1.26413120e-03, 0.00000000e+00, + 0.00000000e+00, 1.01183208e-03, 0.00000000e+00, 0.00000000e+00, 2.50136313e-03, + 0.00000000e+00, 0.00000000e+00, 3.38117402e-03, 0.00000000e+00, 0.00000000e+00, + 3.76313059e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, + 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, + 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, + -4.81482486e-32, 5.51152161e-01, 0.00000000e+00, 1.20370622e-32, 5.51152161e-01, + 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, + 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, + 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 4.81482486e-32, 5.51152161e-01, + 0.00000000e+00, 4.81482486e-32, 5.51152161e-01, 0.00000000e+00, -4.81482486e-32, + 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] + + True + + + + + [ 1.95759707e+00, 1.84540764e-19, -1.11473842e-19, 1.96982806e+00, 2.97924049e-19, + 1.47401238e-19, 1.99564425e+00, 4.47340381e-19, 1.47901641e-19, 2.03766475e+00, + 3.26072607e-19, -1.96882033e-19, 2.09943703e+00, 1.05709923e-19, 1.16720948e-19, + 2.18448906e+00, -2.66752020e-19, 1.30511660e-19, 2.29417353e+00, -6.84835813e-19, + 1.94820796e-19, 2.42460987e+00, -3.56290776e-19, 8.73116468e-20, 2.56635830e+00, + 6.22115951e-19, -1.51330480e-19, 2.70680953e+00, 7.67531708e-19, -1.67145059e-19, + 2.83458135e+00, -7.06363788e-19, 1.46909268e-19, 2.94239697e+00, -7.90106363e-19, + 1.45187376e-19, 3.02764003e+00, 1.54396546e-18, -2.62876550e-19, 3.09023755e+00, + -1.15832806e-18, 1.76539855e-19, 3.13110554e+00, 5.22073507e-19, -7.10140334e-20, + 3.15124164e+00, -1.27602206e-19, 1.53068337e-20 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03 ] + [ H ] +
+ + [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, + 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] + +
+
diff --git a/drivers/py/pes/friction/test-ohne80/control.in b/drivers/py/pes/friction/test-ohne80/control.in new file mode 100644 index 000000000..687e6ee90 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/control.in @@ -0,0 +1,181 @@ +# Physical settings +xc pbe +spin none +relativistic atomic_zora scalar +charge 0.0 +#vdw_correction_hirshfeld + +# k-grid settings (to be adjusted) +k_grid 12 12 12 + +# accuracy requirements +sc_iter_limit 200 +sc_init_iter 200 + +#Mixing settings + mixer pulay + n_max_pulay 10 + charge_mix_param 0.05 + + +# occupation gaussian broadening +occupation_type gaussian 0.1 + +final_forces_cleaned .true. +compute_forces .true. + + +# IPI + output_level MD_light +# use_pimd_wrapper localhost 41000 + use_pimd_wrapper drag092 41111 + +#=============================================================================== + +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for Pd atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species Pd +# global species definitions + nucleus 46 + mass 106.42 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 62 5.0 + radial_multiplier 2 + angular_grids specified + division 0.5211 50 + division 0.9161 110 + division 1.2296 194 + division 1.5678 302 +# division 1.9785 434 +# division 2.0474 590 +# division 2.1195 770 +# division 2.1568 974 +# division 2.7392 1202 +# outer_grid 974 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 5 s 1. + valence 4 p 6. + valence 4 d 9. +# ion occupancy + ion_occ 5 s 0. + ion_occ 4 p 6. + ion_occ 4 d 8. +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A +# +################################################################################ +# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV + ionic 5 p auto + hydro 4 f 8 +# hydro 5 g 10 + hydro 3 s 2.6 + hydro 3 d 2.5 +# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV +# hydro 5 f 17.2 +# hydro 6 h 14 +# hydro 4 d 4 +# hydro 5 f 7.6 +# hydro 3 p 3.3 +# hydro 4 s 9.4 +# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV +# hydro 4 f 20 +# hydro 5 g 12.8 +# hydro 5 d 9.8 +# hydro 6 h 15.2 +# hydro 5 s 10 +# hydro 6 p 9.8 +# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV +# hydro 5 f 9.2 +# hydro 2 s 5.6 +# hydro 5 f 43.2 +# hydro 5 d 13.2 +# hydro 5 g 14 +# hydro 4 p 4.7 +################################################################################ +# +# FHI-aims code project +# VB, Fritz-Haber Institut, 2009 +# +# Suggested "light" defaults for H atom (to be pasted into control.in file) +# Be sure to double-check any results obtained with these settings for post-processing, +# e.g., with the "tight" defaults and larger basis sets. +# +################################################################################ + species H +# global species definitions + nucleus 1 + mass 1.00794 +# + l_hartree 4 +# + cut_pot 3.5 1.5 1.0 + basis_dep_cutoff 1e-4 +# + radial_base 24 5.0 + radial_multiplier 2 + angular_grids specified + division 0.2421 50 + division 0.3822 110 + division 0.4799 194 + division 0.5341 302 +# division 0.5626 434 +# division 0.5922 590 +# division 0.6542 770 +# division 0.6868 1202 +# outer_grid 770 + outer_grid 302 +################################################################################ +# +# Definition of "minimal" basis +# +################################################################################ +# valence basis states + valence 1 s 1. +# ion occupancy + ion_occ 1 s 0.5 +################################################################################ +# +# Suggested additional basis functions. For production calculations, +# uncomment them one after another (the most important basis functions are +# listed first). +# +# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A +# +################################################################################ +# "First tier" - improvements: -1014.90 meV to -62.69 meV + hydro 2 s 2.1 + hydro 2 p 3.5 +# "Second tier" - improvements: -12.89 meV to -1.83 meV +# hydro 1 s 0.85 +# hydro 2 p 3.7 +# hydro 2 s 1.2 +# hydro 3 d 7 +# "Third tier" - improvements: -0.25 meV to -0.12 meV +# hydro 4 f 11.2 +# hydro 3 p 4.8 +# hydro 4 d 9 +# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/test-ohne80/geometry.in b/drivers/py/pes/friction/test-ohne80/geometry.in new file mode 100644 index 000000000..cd6ad1f1f --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/geometry.in @@ -0,0 +1,11 @@ +#=======================================# +# iterations/iteration0105/aims-chain-node-0.56500/geometry.in +#=======================================# +lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 +lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 +lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 +atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd +atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd +atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd +atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd +atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/test-ohne80/get1D.sh b/drivers/py/pes/friction/test-ohne80/get1D.sh new file mode 100755 index 000000000..5cd175503 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/get1D.sh @@ -0,0 +1,6 @@ +n=${1} +tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 +grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 +paste aux2 aux1 >inst1D.dat +rm aux1 aux2 +xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/test-ohne80/hessian.dat b/drivers/py/pes/friction/test-ohne80/hessian.dat new file mode 100644 index 000000000..536cf2c98 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/hessian.dat @@ -0,0 +1 @@ +0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 diff --git a/drivers/py/pes/friction/test-ohne80/init.xyz b/drivers/py/pes/friction/test-ohne80/init.xyz new file mode 100644 index 000000000..223399063 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 0.0 0.0 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/test-ohne80/input.xml b/drivers/py/pes/friction/test-ohne80/input.xml new file mode 100644 index 000000000..afcec152d --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/input.xml @@ -0,0 +1,37 @@ + + + [ step, potential{electronvolt}] + + 30 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + + + 80 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + true + 0.1 + + + +
diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 new file mode 100644 index 000000000..f2f2eab70 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 @@ -0,0 +1 @@ +3.734818280233287088e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.845782312592117815e-03 0.000000000000000000e+00 4.597851281863155766e-35 7.664769565135540023e-04 -5.641672198402295020e-34 -5.099816676521848316e-35 -2.421625395738981248e-03 -4.924659551023193814e-33 -6.175121694072970245e-35 -5.934054372920137717e-03 -1.745698724309905664e-34 0.000000000000000000e+00 -8.687218023080303317e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.054397414683942019e-02 -1.845462876222226530e-33 6.748072532624786352e-38 -1.075144957901948313e-02 0.000000000000000000e+00 5.269410684734435833e-39 -9.558332897562037828e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.476186931212857809e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.524595410098533436e-03 -1.848189503563817759e-37 0.000000000000000000e+00 -2.170742788691551548e-03 1.254472657255384445e-37 6.272363286276922225e-38 -5.363218365243636442e-04 -9.877504856835469417e-38 0.000000000000000000e+00 5.550899951789409204e-04 -8.497088663121496587e-38 0.000000000000000000e+00 1.211414114240429900e-03 0.000000000000000000e+00 -3.096516590406364803e-35 1.489980234621267417e-03 0.000000000000000000e+00 9.183549615799117241e-39 0.000000000000000000e+00 5.511521610893899137e-01 -8.224399241397367023e-38 0.000000000000000000e+00 5.511521610893899137e-01 -5.897911703110076037e-35 -5.641672198402295020e-34 5.511521610893899137e-01 -1.595782179766953557e-36 -4.924659551023193814e-33 5.511521610893899137e-01 -2.736468729736113066e-35 -1.745698724309905664e-34 5.511521610893899137e-01 3.230513701848005415e-34 0.000000000000000000e+00 5.511521610893899137e-01 -3.746640196012831775e-37 -1.845462876222226530e-33 5.511521610893899137e-01 -8.251348517995317136e-39 0.000000000000000000e+00 5.511521610893899137e-01 -6.305912822656329130e-40 0.000000000000000000e+00 5.511521610893899137e-01 5.212108934203943390e-40 0.000000000000000000e+00 5.511521610893899137e-01 4.104049214484437078e-42 -1.848189503563817759e-37 5.511521610893899137e-01 -3.614198904941168172e-40 1.254472657255384445e-37 5.511521610893899137e-01 -2.142468746332492301e-40 -9.877504856835469417e-38 5.511521610893899137e-01 -2.117846475705540036e-40 -8.497088663121496587e-38 5.511521610893899137e-01 -8.278898936108957144e-41 0.000000000000000000e+00 5.511521610893899137e-01 1.728296928676643158e-41 0.000000000000000000e+00 5.511521610893899137e-01 2.824111339950594965e-42 0.000000000000000000e+00 -6.634335062466123784e-33 5.511521610893899137e-01 4.597851281863155766e-35 -6.693231935504809852e-33 5.511521610893899137e-01 -5.099816676521848316e-35 -6.635848600653475924e-33 5.511521610893899137e-01 -6.175121694072970245e-35 -6.661617505771071078e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.311201448288908775e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634627482493310683e-33 5.511521610893899137e-01 6.748072532624786352e-38 -6.634261069822228090e-33 5.511521610893899137e-01 5.269410684734435833e-39 -6.634253449064992168e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252297262816241e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252814369660801e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253179893600258e-33 5.511521610893899137e-01 6.272363286276922225e-38 -6.634253032720584159e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253030258357700e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252901262699273e-33 5.511521610893899137e-01 -3.096516590406364803e-35 -6.634252801190740225e-33 5.511521610893899137e-01 9.183549615799117241e-39 -6.634252815649597786e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 new file mode 100644 index 000000000..25072c3fb --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 @@ -0,0 +1 @@ +9.892913615669208030e-03 0.000000000000000000e+00 0.000000000000000000e+00 8.967960163997572981e-03 1.614951759475882236e-32 8.246251695649536416e-33 6.858333381143919688e-03 2.136792064844772747e-34 -7.260501194090478013e-35 3.294098717232307478e-03 3.733952422943596913e-33 -1.700656174663918155e-32 -1.883111251835540081e-03 4.662873566019753647e-32 1.868795087220818113e-32 -6.909399291245864327e-03 0.000000000000000000e+00 -1.415159042963247631e-33 -9.947480542244835702e-03 2.181281584841297074e-33 -5.737206219768610313e-37 -1.083839149683370195e-02 3.428520116758796274e-32 2.142830342384932400e-33 -9.348424149405528891e-03 1.653711061776393223e-31 6.459808835064036028e-34 -6.265511515632433970e-03 5.174352847145581049e-35 8.084926323664970389e-37 -2.617943301605032795e-03 -1.489092802103321111e-32 -2.205382583246868412e-36 -1.034614635909382116e-04 2.245169974936651202e-32 -9.960300609146510793e-36 1.614442208560950198e-03 -5.724717697437056580e-35 2.371658679920791783e-33 2.741523544600115922e-03 2.303101426121082228e-35 0.000000000000000000e+00 3.387531636094563356e-03 -5.066406213847528809e-36 -3.096516590406364803e-35 3.660104868431911414e-03 5.877471754111438375e-37 -1.505183782029476225e-35 0.000000000000000000e+00 5.511521610893899137e-01 -4.455683826064147910e-35 1.614951759475882236e-32 5.511521610893899137e-01 -1.488126295331421371e-34 2.136792064844772747e-34 5.511521610893899137e-01 -1.282562250654161197e-36 3.733952422943596913e-33 5.511521610893899137e-01 -1.506062012919669114e-34 4.662873566019753647e-32 5.511521610893899137e-01 3.498214094918402662e-34 0.000000000000000000e+00 5.511521610893899137e-01 2.830290147970561428e-36 2.181281584841297074e-33 5.511521610893899137e-01 1.119598608131650601e-37 3.428520116758796274e-32 5.511521610893899137e-01 -1.260610132146908431e-36 1.653711061776393223e-31 5.511521610893899137e-01 2.670266514641765167e-36 5.174352847145581049e-35 5.511521610893899137e-01 -2.292532857939595301e-36 -1.489092802103321111e-32 5.511521610893899137e-01 -3.524462513891821374e-36 2.245169974936651202e-32 5.511521610893899137e-01 -1.746952636438934422e-35 -5.724717697437056580e-35 5.511521610893899137e-01 -8.500574790556673181e-36 2.303101426121082228e-35 5.511521610893899137e-01 -1.280196201750088239e-36 -5.066406213847528809e-36 5.511521610893899137e-01 -6.521311212262208397e-38 5.877471754111438375e-37 5.511521610893899137e-01 -9.243186767302303250e-40 0.000000000000000000e+00 -6.678809656734351228e-33 5.511521610893899137e-01 8.246251695649536416e-33 -6.783065448006851496e-33 5.511521610893899137e-01 -7.260501194090478013e-35 -6.635535380724362458e-33 5.511521610893899137e-01 -1.700656174663918155e-32 -6.784859019765677040e-33 5.511521610893899137e-01 1.868795087220818113e-32 -6.284431408981868494e-33 5.511521610893899137e-01 -1.415159042963247631e-33 -6.631422528325739353e-33 5.511521610893899137e-01 -5.737206219768610313e-37 -6.634140858612896258e-33 5.511521610893899137e-01 2.142830342384932400e-33 -6.635513428605857417e-33 5.511521610893899137e-01 6.459808835064036028e-34 -6.631582551959068371e-33 5.511521610893899137e-01 8.084926323664970389e-37 -6.636545351331649433e-33 5.511521610893899137e-01 -2.205382583246868412e-36 -6.637777280987601198e-33 5.511521610893899137e-01 -9.960300609146510793e-36 -6.651722344838098642e-33 5.511521610893899137e-01 2.371658679920791783e-33 -6.642753393264267358e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.635533014675460649e-33 5.511521610893899137e-01 -3.096516590406364803e-35 -6.634318031585831746e-33 5.511521610893899137e-01 -1.505183782029476225e-35 -6.634253742792385306e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 new file mode 100644 index 000000000..09a85d0b5 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 @@ -0,0 +1 @@ +1.297717861181817839e-02 0.000000000000000000e+00 -1.587057591239417484e-33 1.212179150376219844e-02 -4.044133410817390068e-31 8.246251695649536416e-33 1.023495068474918057e-02 1.374874082278548983e-34 -3.773722049673942213e-34 7.019420557719971074e-03 3.733952422943596913e-33 1.621044803035586025e-33 2.021911683957246242e-03 -5.045942251219761709e-32 -2.948271222101864843e-32 -4.439556615543967244e-03 0.000000000000000000e+00 3.073542592520248260e-33 -8.914059996526576754e-03 2.805409072116473415e-34 8.586475414792535202e-36 -1.091285399369415834e-02 -8.997482023453314094e-33 -5.071637379789344971e-33 -9.687061940582898309e-03 1.418825435015178791e-32 6.459808835064036028e-34 -6.517554089700547393e-03 5.174352847145581049e-35 -1.709872188738425000e-32 -2.397908563780358580e-03 5.537434216832573317e-33 -2.205382583246868412e-36 4.017945734196125968e-04 2.245169974936651202e-32 5.045201353242628595e-32 2.291926566506841557e-03 -9.716694092551321802e-35 2.371658679920791783e-33 3.500670581460030295e-03 5.489651641268065512e-35 3.186550215146982750e-35 4.141755059447818632e-03 1.080596682216596700e-36 -6.377154319807145998e-36 4.407491885433248782e-03 1.668367199494600138e-36 -1.505183782029476225e-35 0.000000000000000000e+00 5.511521610893899137e-01 -2.977087589350948246e-32 -4.044133410817390068e-31 5.511521610893899137e-01 -5.159600047764989871e-32 1.374874082278548983e-34 5.511521610893899137e-01 -4.107018409596793783e-34 3.733952422943596913e-33 5.511521610893899137e-01 6.112425622025477091e-34 -5.045942251219761709e-32 5.511521610893899137e-01 3.397576558955371873e-33 0.000000000000000000e+00 5.511521610893899137e-01 1.928754867416306195e-35 2.805409072116473415e-34 5.511521610893899137e-01 -6.942168761099936106e-37 -8.997482023453314094e-33 5.511521610893899137e-01 -5.527639458564507626e-37 1.418825435015178791e-32 5.511521610893899137e-01 5.772437820439283762e-37 5.174352847145581049e-35 5.511521610893899137e-01 4.769986070774829629e-36 5.537434216832573317e-33 5.511521610893899137e-01 -1.341596888461318830e-36 2.245169974936651202e-32 5.511521610893899137e-01 -1.105795406506512485e-34 -9.716694092551321802e-35 5.511521610893899137e-01 -1.656595602864174550e-34 5.489651641268065512e-35 5.511521610893899137e-01 -6.247933186764104648e-35 1.080596682216596700e-36 5.511521610893899137e-01 -8.168673189436548443e-36 1.668367199494600138e-36 5.511521610893899137e-01 -3.076868209282457878e-37 -1.587057591239417484e-33 -3.640512871198318930e-32 5.511521610893899137e-01 8.246251695649536416e-33 -5.823025329612360554e-32 5.511521610893899137e-01 -3.773722049673942213e-34 -7.044954659433387925e-33 5.511521610893899137e-01 1.621044803035586025e-33 -6.023010256271162377e-33 5.511521610893899137e-01 -2.948271222101864843e-32 -3.236676259518337016e-33 5.511521610893899137e-01 3.073542592520248260e-33 -6.614965269799547059e-33 5.511521610893899137e-01 8.586475414792535202e-36 -6.634947035349819908e-33 5.511521610893899137e-01 -5.071637379789344971e-33 -6.634805582419566918e-33 5.511521610893899137e-01 6.459808835064036028e-34 -6.633675574691665839e-33 5.511521610893899137e-01 -1.709872188738425000e-32 -6.629482832402935437e-33 5.511521610893899137e-01 -2.205382583246868412e-36 -6.635594415362170712e-33 5.511521610893899137e-01 5.045201353242628595e-32 -6.744832359124360864e-33 5.511521610893899137e-01 2.371658679920791783e-33 -6.799912378760128033e-33 5.511521610893899137e-01 3.186550215146982750e-35 -6.696732150341351817e-33 5.511521610893899137e-01 -6.377154319807145998e-36 -6.642421491663145735e-33 5.511521610893899137e-01 -1.505183782029476225e-35 -6.634560505294636607e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 new file mode 100644 index 000000000..ac0c928b3 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 @@ -0,0 +1 @@ +1.326697938691712500e-02 -3.436519449523465765e-31 -1.587057591239417484e-33 1.249014660394636746e-02 -2.603507112345384461e-32 8.246251695649536416e-33 1.081221990719443207e-02 1.374874082278548983e-34 -3.773722049673942213e-34 7.969590343063824231e-03 -8.525426525301300832e-32 1.621044803035586025e-33 3.543078470445989309e-03 1.343866176434485623e-32 -2.948271222101864843e-32 -2.753180329516431105e-03 1.428692175075599036e-33 2.315757838267004947e-34 -7.983070269410200842e-03 2.685972510287069034e-34 3.247378778067339144e-35 -1.069905429420435136e-02 -1.713928353924731256e-33 -5.067434521353379181e-33 -1.020509664259706441e-02 -1.053401809279171042e-33 6.459808835064036028e-34 -7.667299694980426322e-03 5.174352847145581049e-35 2.403274999540800712e-32 -3.417865289183932842e-03 1.687104178334103572e-35 -1.079101738114614049e-35 -3.165902434181564569e-04 -1.846981759237531628e-33 -4.672192218626060397e-32 1.756568002332469739e-03 -9.083643985619460307e-35 2.371658679920791783e-33 3.105885213102797630e-03 4.923643007017172544e-33 -1.945063685778190305e-32 3.856753230101362534e-03 1.080596682216596700e-36 -6.377154319807145998e-36 4.174254122014324497e-03 3.361789095746924865e-34 -1.618625254645058275e-35 -3.436519449523465765e-31 5.511521610893899137e-01 -2.868431779549579768e-32 -2.603507112345384461e-32 5.511521610893899137e-01 -5.041893450685493515e-32 1.374874082278548983e-34 5.511521610893899137e-01 3.481182583062192475e-34 -8.525426525301300832e-32 5.511521610893899137e-01 1.728675260320496180e-33 1.343866176434485623e-32 5.511521610893899137e-01 3.770304158716389006e-33 1.428692175075599036e-33 5.511521610893899137e-01 1.857284814810217619e-35 2.685972510287069034e-34 5.511521610893899137e-01 6.594467567311686729e-36 -1.713928353924731256e-33 5.511521610893899137e-01 4.412910800665558469e-37 -1.053401809279171042e-33 5.511521610893899137e-01 -2.175537723334330594e-37 5.174352847145581049e-35 5.511521610893899137e-01 -6.808445727137127657e-36 1.687104178334103572e-35 5.511521610893899137e-01 -2.488040964095655123e-36 -1.846981759237531628e-33 5.511521610893899137e-01 -1.226032696205281228e-34 -9.083643985619460307e-35 5.511521610893899137e-01 -1.811470434051900345e-34 4.923643007017172544e-33 5.511521610893899137e-01 -6.704322957372316328e-35 1.080596682216596700e-36 5.511521610893899137e-01 -8.565583050657174589e-36 3.361789095746924865e-34 5.511521610893899137e-01 -3.309997228519980292e-37 -1.587057591239417484e-33 -3.531857061396950452e-32 5.511521610893899137e-01 8.246251695649536416e-33 -5.705318732532864198e-32 5.511521610893899137e-01 -3.773722049673942213e-34 -6.286134560167488700e-33 5.511521610893899137e-01 1.621044803035586025e-33 -4.905577558153213393e-33 5.511521610893899137e-01 -2.948271222101864843e-32 -2.863948659757319882e-33 5.511521610893899137e-01 2.315757838267004947e-34 -6.615679970325608463e-33 5.511521610893899137e-01 3.247378778067339144e-35 -6.627658350906397590e-33 5.511521610893899137e-01 -5.067434521353379181e-33 -6.633811527393643560e-33 5.511521610893899137e-01 6.459808835064036028e-34 -6.634470372246043809e-33 5.511521610893899137e-01 2.403274999540800712e-32 -6.641061264200847041e-33 5.511521610893899137e-01 -1.079101738114614049e-35 -6.636740859437805120e-33 5.511521610893899137e-01 -4.672192218626060397e-32 -6.756856088094237696e-33 5.511521610893899137e-01 2.371658679920791783e-33 -6.815399861878900035e-33 5.511521610893899137e-01 -1.945063685778190305e-32 -6.701296048047434094e-33 5.511521610893899137e-01 -6.377154319807145998e-36 -6.642818401524365864e-33 5.511521610893899137e-01 -1.618625254645058275e-35 -6.634583818196560018e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 new file mode 100644 index 000000000..090642728 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 @@ -0,0 +1 @@ +1.348105139917538976e-02 -7.668023353324523642e-32 -1.609114077642185327e-33 1.273577563624147223e-02 -2.600004614777261509e-32 -1.106985657178011861e-31 1.112760490112172512e-02 1.374874082278548983e-34 -3.773722049673942213e-34 8.408668957458507662e-03 -1.019357468449447682e-32 1.509264176723570327e-33 4.185844418960517517e-03 -4.367502943423001401e-32 -8.087280827715933084e-33 -1.944617064427021924e-03 1.428692175075599036e-33 2.315757838267004947e-34 -7.476395676433939506e-03 1.363370024116781492e-33 5.806172785937895930e-34 -1.046348102422013822e-02 4.248529999262566016e-35 8.466121371840540561e-35 -1.043918224155719783e-02 -7.285884269289415537e-35 -7.764585254068245071e-36 -8.223274073844119222e-03 -3.131656052681589212e-36 4.469322681809003052e-36 -4.068932357432573921e-03 2.065607638125683916e-36 -6.994165944030183254e-35 -7.958502629903999297e-04 1.167302409597223206e-35 1.037807328735401565e-35 1.376699260233349735e-03 -9.072132492384225864e-35 -3.896311846960215919e-35 2.796265930116329911e-03 -2.620185217536552828e-35 -3.278804338353152372e-35 3.615787880010486437e-03 -9.184370456139274847e-35 1.685939485426929459e-35 3.965528479983848956e-03 -5.760036400186170059e-36 8.146564404981491779e-35 -7.668023353324523642e-32 5.511521610893899137e-01 -2.889399000560562656e-32 -2.600004614777261509e-32 5.511521610893899137e-01 -5.011971054253917440e-32 1.374874082278548983e-34 5.511521610893899137e-01 1.587566408653974462e-33 -1.019357468449447682e-32 5.511521610893899137e-01 1.282009624467491290e-33 -4.367502943423001401e-32 5.511521610893899137e-01 3.759655391411658788e-33 1.428692175075599036e-33 5.511521610893899137e-01 1.414718507821078149e-35 1.363370024116781492e-33 5.511521610893899137e-01 6.543457904602231167e-36 4.248529999262566016e-35 5.511521610893899137e-01 4.405066880151662215e-37 -7.285884269289415537e-35 5.511521610893899137e-01 -2.176732055564081971e-37 -3.131656052681589212e-36 5.511521610893899137e-01 -6.808317154894128754e-36 2.065607638125683916e-36 5.511521610893899137e-01 -2.487960018241296235e-36 1.167302409597223206e-35 5.511521610893899137e-01 -1.226040309290718825e-34 -9.072132492384225864e-35 5.511521610893899137e-01 -1.811451563154299911e-34 -2.620185217536552828e-35 5.511521610893899137e-01 -6.704326603291460263e-35 -9.184370456139274847e-35 5.511521610893899137e-01 -8.565634144754383328e-36 -5.760036400186170059e-36 5.511521610893899137e-01 -3.311424048846644951e-37 -1.609114077642185327e-33 -3.552824282407933339e-32 5.511521610893899137e-01 -1.106985657178011861e-31 -5.675396336101288124e-32 5.511521610893899137e-01 -3.773722049673942213e-34 -5.046686409819733058e-33 5.511521610893899137e-01 1.509264176723570327e-33 -5.352243194006218625e-33 5.511521610893899137e-01 -8.087280827715933084e-33 -2.874597427062050443e-33 5.511521610893899137e-01 2.315757838267004947e-34 -6.620105633395500416e-33 5.511521610893899137e-01 5.806172785937895930e-34 -6.627709360569107342e-33 5.511521610893899137e-01 8.466121371840540561e-35 -6.633812311785695350e-33 5.511521610893899137e-01 -7.764585254068245071e-36 -6.634470491679266148e-33 5.511521610893899137e-01 4.469322681809003052e-36 -6.641061135628603809e-33 5.511521610893899137e-01 -6.994165944030183254e-35 -6.636740778491951227e-33 5.511521610893899137e-01 1.037807328735401565e-35 -6.756856849402781990e-33 5.511521610893899137e-01 -3.896311846960215919e-35 -6.815397974789140056e-33 5.511521610893899137e-01 -3.278804338353152372e-35 -6.701296084506625544e-33 5.511521610893899137e-01 1.685939485426929459e-35 -6.642818452618462574e-33 5.511521610893899137e-01 8.146564404981491779e-35 -6.634583960878592438e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 new file mode 100644 index 000000000..370c0d527 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 @@ -0,0 +1 @@ +1.360375687276000473e-02 -7.657979022920952359e-32 -1.609114077642185327e-33 1.287598181939019967e-02 9.961203632580170862e-32 1.487446434399835321e-32 1.130571931044606175e-02 -3.012150813830570144e-33 -2.018536311680979037e-31 8.651096302266212540e-03 -1.017898391336952743e-32 1.567627261223366707e-33 4.527806611753107044e-03 7.154088979381308404e-32 -6.571167637885988801e-32 -1.511366485664991394e-03 -9.735002489462927825e-34 1.120893236429363067e-32 -7.194792770197902185e-03 1.363370024116781492e-33 1.813767879151036843e-32 -1.031822635219253187e-02 4.023388603664965418e-35 1.516463189084567755e-32 -1.054303883615845608e-02 -7.285884269289415537e-35 7.007136270331468784e-33 -8.468719134442789787e-03 -7.047632079618085285e-33 4.469322681809003052e-36 -4.397682515011993101e-03 9.414002177613127567e-37 7.462248057000984626e-33 -1.034336174624523024e-03 -8.337491946789278611e-33 -1.171697129322223296e-35 1.190752488224667291e-03 9.260946725418910840e-33 -3.896311846960215919e-35 2.646391717116255808e-03 -2.620464666280672182e-33 4.146688848322069556e-32 3.497952884983801004e-03 -9.184370456139274847e-35 1.125322248437168041e-32 3.864119454702644955e-03 -5.802615748856883069e-36 8.146564404981491779e-35 -7.657979022920952359e-32 5.511521610893899137e-01 -2.870661510083477607e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.996742580915486787e-32 -3.012150813830570144e-33 5.511521610893899137e-01 1.602454791917423650e-33 -1.017898391336952743e-32 5.511521610893899137e-01 1.068118438990721255e-33 7.154088979381308404e-32 5.511521610893899137e-01 3.730573311342456885e-33 -9.735002489462927825e-34 5.511521610893899137e-01 1.408377631237783680e-35 1.363370024116781492e-33 5.511521610893899137e-01 1.334699197107296041e-35 4.023388603664965418e-35 5.511521610893899137e-01 3.913978032308525530e-36 -7.285884269289415537e-35 5.511521610893899137e-01 -3.893514546687561292e-37 -7.047632079618085285e-33 5.511521610893899137e-01 -1.466466518516152849e-35 9.414002177613127567e-37 5.511521610893899137e-01 -2.829366413850706120e-36 -8.337491946789278611e-33 5.511521610893899137e-01 -1.323969003624028343e-34 9.260946725418910840e-33 5.511521610893899137e-01 -1.900937608591865503e-34 -2.620464666280672182e-33 5.511521610893899137e-01 -6.883210420820293459e-35 -9.184370456139274847e-35 5.511521610893899137e-01 -8.640760521213921962e-36 -5.802615748856883069e-36 5.511521610893899137e-01 -3.384771269619072764e-37 -1.609114077642185327e-33 -3.534086791930848291e-32 5.511521610893899137e-01 1.487446434399835321e-32 -5.660167862762857471e-32 5.511521610893899137e-01 -2.018536311680979037e-31 -5.031798026556283870e-33 5.511521610893899137e-01 1.567627261223366707e-33 -5.566134379482988489e-33 5.511521610893899137e-01 -6.571167637885988801e-32 -2.903679507131252346e-33 5.511521610893899137e-01 1.120893236429363067e-32 -6.620169042161333375e-33 5.511521610893899137e-01 1.813767879151036843e-32 -6.620905826502636302e-33 5.511521610893899137e-01 1.516463189084567755e-32 -6.630338840441402481e-33 5.511521610893899137e-01 7.007136270331468784e-33 -6.634642169928378633e-33 5.511521610893899137e-01 4.469322681809003052e-36 -6.648917483658871743e-33 5.511521610893899137e-01 7.462248057000984626e-33 -6.637082184887560367e-33 5.511521610893899137e-01 -1.171697129322223296e-35 -6.766649718836112300e-33 5.511521610893899137e-01 -3.896311846960215919e-35 -6.824346579332895952e-33 5.511521610893899137e-01 4.146688848322069556e-32 -6.703084922681913929e-33 5.511521610893899137e-01 1.125322248437168041e-32 -6.642893578994921871e-33 5.511521610893899137e-01 8.146564404981491779e-35 -6.634591295600670189e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 new file mode 100644 index 000000000..4fe6289ca --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 @@ -0,0 +1 @@ +1.366465157692338568e-02 -7.657979022920952359e-32 -1.609114077642185327e-33 1.294589312243548014e-02 9.961203632580170862e-32 1.485861783160527517e-32 1.139517976401576912e-02 -1.485914064781893706e-34 -6.440148024901372194e-32 8.773710783513129913e-03 -1.016667612948965393e-32 1.579935045103240198e-33 4.701522253474878753e-03 -3.531460210140193439e-32 -1.229806849580585810e-32 -1.285427269787913808e-03 -9.735002489462927825e-34 -3.627872011334522073e-34 -7.044040333093151696e-03 1.368834827201453768e-33 -1.509925356946595944e-32 -1.023984552103838520e-02 4.023388603664965418e-35 -4.251438650362712214e-32 -1.059269568676834104e-02 3.316781942255381255e-33 -6.551426869461634226e-33 -8.585246694615597182e-03 6.704038665259261726e-33 4.469322681809003052e-36 -4.565780607357744145e-03 9.414002177613127567e-37 -2.220447320094047286e-32 -1.157007561320025010e-03 8.230988922638532594e-33 -3.346395192577719490e-35 1.094942590077343332e-03 9.262675794400551567e-33 -3.896311846960215919e-35 2.568628275175905817e-03 2.598082218247164722e-33 4.147552042265545903e-32 3.435543887882049237e-03 -8.019293383041284214e-34 1.125577933598412232e-32 3.810143648551499174e-03 -2.903608437706601180e-35 6.029146023327594799e-33 -7.657979022920952359e-32 5.511521610893899137e-01 -2.881259161470650433e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.986782753913350173e-32 -1.485914064781893706e-34 5.511521610893899137e-01 1.602192257140373909e-33 -1.016667612948965393e-32 5.511521610893899137e-01 1.095866609511388656e-33 -3.531460210140193439e-32 5.511521610893899137e-01 3.608111524840095247e-33 -9.735002489462927825e-34 5.511521610893899137e-01 1.377237119795542082e-35 1.368834827201453768e-33 5.511521610893899137e-01 2.811192404646573690e-35 4.023388603664965418e-35 5.511521610893899137e-01 1.093604204382866207e-35 3.316781942255381255e-33 5.511521610893899137e-01 -6.957235078644786856e-37 6.704038665259261726e-33 5.511521610893899137e-01 -2.893621720240826099e-35 9.414002177613127567e-37 5.511521610893899137e-01 -3.487242871257896993e-36 8.230988922638532594e-33 5.511521610893899137e-01 -1.524456900591711166e-34 9.262675794400551567e-33 5.511521610893899137e-01 -2.085498743775719342e-34 2.598082218247164722e-33 5.511521610893899137e-01 -7.254184999924371844e-35 -8.019293383041284214e-34 5.511521610893899137e-01 -8.869622913848486991e-36 -2.903608437706601180e-35 5.511521610893899137e-01 -3.386538384238352919e-37 -1.609114077642185327e-33 -3.544684443318021117e-32 5.511521610893899137e-01 1.485861783160527517e-32 -5.650208035760720857e-32 5.511521610893899137e-01 -6.440148024901372194e-32 -5.032060561333333269e-33 5.511521610893899137e-01 1.579935045103240198e-33 -5.538386208962321430e-33 5.511521610893899137e-01 -1.229806849580585810e-32 -3.026141293633613641e-33 5.511521610893899137e-01 -3.627872011334522073e-34 -6.620480447275756079e-33 5.511521610893899137e-01 -1.509925356946595944e-32 -6.606140894427243601e-33 5.511521610893899137e-01 -4.251438650362712214e-32 -6.623316776429881721e-33 5.511521610893899137e-01 -6.551426869461634226e-33 -6.634948541981574370e-33 5.511521610893899137e-01 4.469322681809003052e-36 -6.663189035676118989e-33 5.511521610893899137e-01 -2.220447320094047286e-32 -6.637740061344967514e-33 5.511521610893899137e-01 -3.346395192577719490e-35 -6.786698508532880732e-33 5.511521610893899137e-01 -3.896311846960215919e-35 -6.842802692851281849e-33 5.511521610893899137e-01 4.147552042265545903e-32 -6.706794668472955034e-33 5.511521610893899137e-01 1.125577933598412232e-32 -6.643122441387555831e-33 5.511521610893899137e-01 6.029146023327594799e-33 -6.634591472312131472e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 new file mode 100644 index 000000000..88d10bdb9 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 @@ -0,0 +1 @@ +1.369758266412592074e-02 4.825185487074058229e-32 -1.604290971039142556e-33 1.298357942468922506e-02 9.961203632580170862e-32 1.485483871072945402e-32 1.144315861247862005e-02 -4.475605252991051122e-32 2.481344199785092107e-32 8.839095082846614923e-03 1.549119830347482346e-32 1.868759936676362329e-32 4.793616472341798163e-03 -3.531460210140193439e-32 6.307924018424626325e-34 -1.164774845174188162e-03 3.996215470964709319e-33 -3.627872011334522073e-34 -6.962895567908617030e-03 1.162020186535016265e-34 -5.681401035523279279e-34 -1.019791857588655051e-02 1.306153937362450189e-35 3.119876382022624995e-34 -1.061770515280208160e-02 4.728193374929779168e-35 -1.242519830963587598e-35 -8.643387785283668592e-03 -2.720568866158413905e-35 4.496511554422271141e-36 -4.652389889329083296e-03 -1.105898490725019044e-34 -2.525686824038393369e-35 -1.219989260686054440e-03 -3.116791056096124471e-35 2.149307491690853733e-34 1.046068524069051434e-03 4.262624617086682794e-35 -3.898785726354743826e-35 2.529092011222609359e-03 -4.648788402235605810e-35 9.587842473898067174e-35 3.403660923273767527e-03 -4.204567699734799393e-35 1.108159579225518693e-34 3.782587691776719691e-03 5.922165653919295338e-35 2.757273743400747263e-35 4.825185487074058229e-32 5.511521610893899137e-01 -2.878266593887413063e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.976202111790506191e-32 -4.475605252991051122e-32 5.511521610893899137e-01 1.577893771636058623e-33 1.549119830347482346e-32 5.511521610893899137e-01 1.094784704348111891e-33 -3.531460210140193439e-32 5.511521610893899137e-01 3.606005983904457369e-33 3.996215470964709319e-33 5.511521610893899137e-01 1.363706487769884367e-35 1.162020186535016265e-34 5.511521610893899137e-01 2.810997366000843055e-35 1.306153937362450189e-35 5.511521610893899137e-01 1.093607731081430692e-35 4.728193374929779168e-35 5.511521610893899137e-01 -6.957448491854272665e-37 -2.720568866158413905e-35 5.511521610893899137e-01 -2.893645886900312774e-35 -1.105898490725019044e-34 5.511521610893899137e-01 -3.487268435354157757e-36 -3.116791056096124471e-35 5.511521610893899137e-01 -1.524459086742857623e-34 4.262624617086682794e-35 5.511521610893899137e-01 -2.085495411105424993e-34 -4.648788402235605810e-35 5.511521610893899137e-01 -7.254206021856046591e-35 -4.204567699734799393e-35 5.511521610893899137e-01 -8.869677000963140768e-36 5.922165653919295338e-35 5.511521610893899137e-01 -3.386385280977337131e-37 -1.604290971039142556e-33 -3.541691875734783746e-32 5.511521610893899137e-01 1.485483871072945402e-32 -5.639627393637876875e-32 5.511521610893899137e-01 2.481344199785092107e-32 -5.056359046837648555e-33 5.511521610893899137e-01 1.868759936676362329e-32 -5.539468114125598366e-33 5.511521610893899137e-01 6.307924018424626325e-34 -3.028246834569251861e-33 5.511521610893899137e-01 -3.627872011334522073e-34 -6.620615753596012515e-33 5.511521610893899137e-01 -5.681401035523279279e-34 -6.606142844813700373e-33 5.511521610893899137e-01 3.119876382022624995e-34 -6.623316741162895572e-33 5.511521610893899137e-01 -1.242519830963587598e-35 -6.634948563322895654e-33 5.511521610893899137e-01 4.496511554422271141e-36 -6.663189277342713796e-33 5.511521610893899137e-01 -2.525686824038393369e-35 -6.637740086909063404e-33 5.511521610893899137e-01 2.149307491690853733e-34 -6.786698727147995378e-33 5.511521610893899137e-01 -3.898785726354743826e-35 -6.842802359584251858e-33 5.511521610893899137e-01 9.587842473898067174e-35 -6.706794878692272038e-33 5.511521610893899137e-01 1.108159579225518693e-34 -6.643122495474670057e-33 5.511521610893899137e-01 2.757273743400747263e-35 -6.634591457001805825e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 new file mode 100644 index 000000000..01a1b9aac --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 @@ -0,0 +1 @@ +1.371462307946609040e-02 4.825399148373140098e-32 1.159008770720961249e-31 1.300309815256473628e-02 9.961203632580170862e-32 1.486155206499155570e-32 1.146804094136671774e-02 -4.476483847801318358e-32 -1.731078618042207662e-32 8.873044980785255165e-03 1.549119830347482346e-32 1.868759936676362329e-32 4.841472570197069558e-03 1.373343108816398238e-32 6.307924018424626325e-34 -1.101621874151874911e-03 -3.378613067619615589e-32 -3.592528376023801112e-34 -6.920118425194711313e-03 1.069572785787056687e-34 -5.658289185336289224e-34 -1.017582381339245286e-02 2.658694324792213893e-32 3.124247661419346537e-34 -1.063051470790147592e-02 4.728193374929779168e-35 -1.281334564643944056e-35 -8.673110154630736535e-03 -2.400031823969091892e-35 1.272500903083766671e-32 -4.697548986309914125e-03 -1.031208111894393683e-34 -2.525686824038393369e-35 -1.252871607725007923e-03 -3.116791056096124471e-35 2.160943939651569028e-34 1.020551431061371894e-03 3.080945368840777810e-35 -4.046495632385481682e-35 2.508419661346137589e-03 -4.648788402235605810e-35 9.587842473898067174e-35 3.386907159852666025e-03 -8.382068632558372584e-32 1.102728576979402544e-34 3.768091454515344954e-03 5.981605770802224096e-35 -5.450502734642837584e-33 4.825399148373140098e-32 5.511521610893899137e-01 -2.875759932920306299e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.983058881884260848e-32 -4.476483847801318358e-32 5.511521610893899137e-01 1.545800228738392917e-33 1.549119830347482346e-32 5.511521610893899137e-01 1.182984821847473832e-33 1.373343108816398238e-32 5.511521610893899137e-01 3.603044902570189134e-33 -3.378613067619615589e-32 5.511521610893899137e-01 1.759073494943684232e-35 1.069572785787056687e-34 5.511521610893899137e-01 3.713963678364259903e-35 2.658694324792213893e-32 5.511521610893899137e-01 1.177534796676072218e-35 4.728193374929779168e-35 5.511521610893899137e-01 -2.003657854201122279e-36 -2.400031823969091892e-35 5.511521610893899137e-01 -3.317441395374082417e-35 -1.031208111894393683e-34 5.511521610893899137e-01 -9.602379224875355249e-36 -3.116791056096124471e-35 5.511521610893899137e-01 -1.585921050007451623e-34 3.080945368840777810e-35 5.511521610893899137e-01 -2.298543943609470604e-34 -4.648788402235605810e-35 5.511521610893899137e-01 -8.332415973520049580e-35 -8.382068632558372584e-32 5.511521610893899137e-01 -1.076209880849181303e-35 5.981605770802224096e-35 5.511521610893899137e-01 -4.335414906141147984e-37 1.159008770720961249e-31 -3.539185214767676982e-32 5.511521610893899137e-01 1.486155206499155570e-32 -5.646484163731631532e-32 5.511521610893899137e-01 -1.731078618042207662e-32 -5.088452589735314261e-33 5.511521610893899137e-01 1.868759936676362329e-32 -5.451267996626236083e-33 5.511521610893899137e-01 6.307924018424626325e-34 -3.031207915903520096e-33 5.511521610893899137e-01 -3.592528376023801112e-34 -6.616662083524274019e-33 5.511521610893899137e-01 -5.658289185336289224e-34 -6.597113181690066076e-33 5.511521610893899137e-01 3.124247661419346537e-34 -6.622477470506948792e-33 5.511521610893899137e-01 -1.281334564643944056e-35 -6.636256476327910788e-33 5.511521610893899137e-01 1.272500903083766671e-32 -6.667427232427450830e-33 5.511521610893899137e-01 -2.525686824038393369e-35 -6.643855197698585217e-33 5.511521610893899137e-01 2.160943939651569028e-34 -6.792844923474455056e-33 5.511521610893899137e-01 -4.046495632385481682e-35 -6.864107212834655821e-33 5.511521610893899137e-01 9.587842473898067174e-35 -6.717576978208911972e-33 5.511521610893899137e-01 1.102728576979402544e-34 -6.645014917282198824e-33 5.511521610893899137e-01 -5.450502734642837584e-33 -6.634686359964322724e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener new file mode 100644 index 000000000..d3a8fe1a0 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.06609749183902248 +1 0.06917958687928251 +2 0.07651636325411229 +3 0.08895589010071343 +4 0.10654574807957333 +5 0.12626279217180666 +6 0.14119662586930817 +7 0.14613925312163503 +8 0.13976616621533475 +9 0.1265881070980252 +10 0.109287250786556 +11 0.09214845045953049 +12 0.07826181720228342 +13 0.06835240828788859 +14 0.06223621123522454 +15 0.05955516525759201 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz new file mode 100644 index 000000000..88ba37b02 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 2.0691538559413805 -4.2868688864203186e-19 -5.138942451019324e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 2.0833536824672327 -1.636309764493738e-17 -9.282345172384641e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.1155186852509167 4.946417445169928e-19 8.024088785907777e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.167033215236072 -4.077755212220506e-18 -1.7809342412626963e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.238804326863034 3.948381363608722e-17 -2.6247191849036978e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.3299088281683242 2.4265296708308084e-18 6.230582052024254e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.4365769433400213 3.8315878303015453e-19 9.30785729539914e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.552129813940306 2.7069444044935072e-20 -8.249062057539133e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6681134225744096 4.8519803421942683e-20 -3.416982927206734e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7766029399681456 7.553456352036286e-21 -1.7554601333758717e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.871758937004375 6.107170284695514e-20 2.0957043455293886e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9505359604533554 4.063355158901011e-20 2.577492161510732e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.012079453709823 3.741574729491395e-20 3.476434351595815e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.056668826777411 3.6694052049529836e-20 1.5957571228168472e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.0850014875038165 3.755109185292569e-21 -3.5434321439519996e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.09771729893857 -4.362068518178427e-21 5.2044260034031155e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener new file mode 100644 index 000000000..94b04377e --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.04898068445015675 +1 0.05119741959945367 +2 0.05680842959524242 +3 0.0678179688713372 +4 0.08638481797601462 +5 0.11189406234581419 +6 0.13570629787935032 +7 0.14612527912448361 +8 0.13932984992953926 +9 0.12168522800329801 +10 0.09821116521257958 +11 0.07670181968081968 +12 0.060500459691730915 +13 0.049660862830592574 +14 0.043200961486597814 +15 0.04027358936215093 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz new file mode 100644 index 000000000..c564fa6fa --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9731065225143827 -3.985014930050983e-18 -1.9248061644795873e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9885338600363707 -2.737417786433003e-17 -2.1263558139668283e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0222202017852005 2.2892173629593923e-19 9.708408917705893e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.077141928812368 6.1864317459886246e-18 -8.348653355671235e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.156566039173988 3.610216131589014e-17 -1.3030826742946108e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.2615844314806313 -5.282518839530046e-18 1.7147126262879487e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.3887064319962747 1.7917091088420308e-18 -2.347923771840515e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.529658863708937 1.0507374674367432e-17 -7.064866459527254e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.6727715170618134 7.064710970042742e-18 -7.350259329970387e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.8067477289810148 -1.0861847316478021e-17 -1.6006515714906315e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.9233831334955056 -9.708332657947795e-18 -4.83257565699322e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 3.0190281229640163 2.035738589766852e-17 1.9769834836040175e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0932097789661555 -1.4148446507339516e-17 -1.7990501488726383e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.1468703893864154 5.537065329784149e-18 8.820181721652334e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.181337854649266 -1.3521108721628223e-18 -2.406126221680295e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1977172989385703 2.1308558230822185e-19 2.4851922836926145e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener new file mode 100644 index 000000000..5eda4ce9d --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.04825645474156761 +1 0.05011521281190444 +2 0.054624235348314294 +3 0.06342044555206088 +4 0.07871442411019267 +5 0.10170489616039473 +6 0.12774657424813082 +7 0.1442415299315078 +8 0.14343918260365737 +9 0.12879765847746547 +10 0.1063865812260448 +11 0.08358316189393798 +12 0.06568119212236621 +13 0.053433377899566765 +14 0.04604882916038747 +15 0.042596090568175496 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz new file mode 100644 index 000000000..731b4e383 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9676634524402903 1.2691883678552141e-17 -2.1257651817839068e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9812082224492942 -3.678369833467928e-18 1.5680322509625736e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0097992132398375 -1.7762527882450108e-18 3.7916192174971166e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0563660312204806 -1.3908043834327753e-17 3.5579999355101055e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.1248273632289782 -2.91764374380476e-18 7.117964611917471e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.218769138145316 7.226491048441428e-19 -3.1933393924204427e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.338045533615313 1.214689630085618e-18 -3.704624554881775e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4762644125316084 9.433038636320541e-19 -3.540166435251642e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.621815763577319 -5.970135692395523e-19 2.0210846034916955e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7617072721938243 -1.367898422424243e-18 5.8274193351755465e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.885652565274277 4.0275193425279097e-19 -1.880026924669266e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.98848006340828 1.3302424088005805e-18 -7.06114572836146e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.068941929703719 -1.5088660892039283e-18 9.009560284472286e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.127663816007621 8.256944461237921e-19 -5.430052798721378e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1658769973828838 -2.3020057008746675e-19 2.0485649726740926e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1846801153652597 5.933096706093729e-20 -4.288766435340115e-19 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener new file mode 100644 index 000000000..a0ed90892 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.04768356085140438 +1 0.04939461365412743 +2 0.05355048513773009 +3 0.06167311746295977 +4 0.07586808144503333 +5 0.09755620906576387 +6 0.12357123059665635 +7 0.14236588438419132 +8 0.1450010725927133 +9 0.1325996741109535 +10 0.11178658068515497 +11 0.08895596564707188 +12 0.07038959870944665 +13 0.05744359155335994 +14 0.04957909050081842 +15 0.04589793710632664 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz new file mode 100644 index 000000000..22c5e8858 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.963180596264626 -5.758479667304717e-19 3.553162555337343e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9761180768527646 6.556621873230681e-19 -3.422714236851307e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 2.0034024579983583 3.9818096772923815e-18 -8.962056298561226e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.047742240346857 -2.0094899479834505e-18 -3.792593633909826e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.112749142893046 2.0318540336091786e-18 -1.0406858769630795e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.201860121775764 1.0462147427369784e-18 5.515923843836488e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.315862209285933 1.7813948607820626e-19 1.2158399685867374e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.449821584750394 2.734748231954091e-20 9.146855579724638e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.593385896152681 1.3171791433828178e-20 -1.120480541939179e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7336220613414843 -3.991640723165517e-21 3.455463331628317e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8594882683093066 -3.7309199558855136e-21 1.2957481904435053e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.964701822060645 -6.380874001868044e-21 1.8841479057808342e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0473961986581792 -2.0827849495408548e-20 -1.5382725592391947e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.107890686659913 -5.283858850810538e-21 9.159154621637666e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1472937293941343 5.192662682707128e-21 5.442277951767934e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1666852187356698 -1.421488700463162e-20 1.1209794419264826e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener new file mode 100644 index 000000000..d183d19c5 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.047326260866351076 +1 0.04894986765132139 +2 0.052902171650412215 +3 0.060657866260543356 +4 0.07430107173527616 +5 0.09538501517105737 +6 0.12135412977459256 +7 0.14123367696811998 +8 0.1455399452109994 +9 0.13429049423312447 +10 0.1143049536886203 +11 0.09151109415922248 +12 0.07259935096992415 +13 0.05928338595076988 +14 0.051153140720327596 +15 0.0473445083172125 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz new file mode 100644 index 000000000..75040010c --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.960294890009016 -3.692070348819142e-18 9.35842813872747e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9728795584981598 -2.5557826932313724e-18 5.556901801076555e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.999431606720305 -6.166669894915221e-20 6.362915042525495e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.042614842600379 1.6111425915301633e-18 3.594095503667428e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.106003898381913 9.926070084731194e-19 -8.2937761054037185e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.1930627416011648 1.4715679825093765e-19 -4.160169976303156e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.304848656419043 3.1123617886362306e-20 -7.09058206976107e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4369717379796625 4.7915582680618834e-21 -1.5228022266993677e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5795756680368913 1.6047458795096228e-21 -2.7922155991346283e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.719908440306673 4.572677807267683e-21 8.533594544676464e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8467812918182096 -5.5038453206985205e-21 1.6344460637231293e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.953368530718814 2.074293314075208e-21 -5.289747818873409e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.037410131934603 -1.0960412960415687e-21 9.723477701699874e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.099018407154604 -4.329901017776546e-21 -5.5757871134169095e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1391983289374874 -5.3281537856874535e-21 6.763097117399336e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.158985112277123 -8.664145208306943e-21 3.907893837353662e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener new file mode 100644 index 000000000..0793d605c --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.04716196301854047 +1 0.04874305405774195 +2 0.05259525136155942 +3 0.06016778552483738 +4 0.07353106531182262 +5 0.0943013453205325 +6 0.12021725056134766 +7 0.14061774433201396 +8 0.1457503361134273 +9 0.13509418710270654 +10 0.11554222394137909 +11 0.09280787692836757 +12 0.07374463359257678 +13 0.06025497749370654 +14 0.05199519333324893 +15 0.04812384900505698 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz new file mode 100644 index 000000000..238b4d772 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9589426312876965 2.054505958206617e-18 4.499305129565119e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.971346067050039 -9.72764293060044e-19 -1.0577986177837286e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9975205929365543 -4.0926635108043654e-21 1.0607962544935101e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0401060418793335 2.529544907393278e-19 -4.945898734221825e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.1026610009577045 1.4688312529387233e-18 1.1662613420205774e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.1886781271122118 1.5269089438716387e-19 9.240727829194017e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.2993615957057223 7.27037118209472e-19 -1.1161594898810347e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.430585021880612 6.903858631522325e-19 -1.437955213242034e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5727115389384214 -1.897338228842745e-19 4.042594743482909e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7130730362936046 -6.937044861115863e-19 2.150274622305578e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8403903175826954 9.475846370913777e-20 -4.2142569923854494e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9476021562676125 5.084513468459578e-19 -2.7016561048868935e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0322599444499696 -3.9723618191244144e-19 3.2320081062666723e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0943777019345684 1.3071571643328668e-19 -1.903964347582647e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.134912903508376 -2.2000265324888932e-20 7.090513949940993e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1548802291493576 -4.038353022886922e-22 -1.4363296461449258e-19 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener new file mode 100644 index 000000000..5ad0cb46c --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.04707110851815223 +1 0.048629325243244335 +2 0.05242790114762217 +3 0.05990286681175513 +4 0.07311785306411694 +5 0.09372267510917924 +6 0.11960845253011342 +7 0.14028170303204948 +8 0.14584369758232013 +9 0.13549596412035578 +10 0.11616264040153498 +11 0.09346028517031822 +12 0.0743189125241669 +13 0.06074011940717821 +14 0.052413780127769254 +15 0.04851015984559665 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz new file mode 100644 index 000000000..8af17b809 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9581876347857052 3.790886544373569e-19 -1.421721123096947e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9704949418533713 -1.9346301894498622e-18 1.514466808342032e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9964697216550698 -1.0397749321528743e-20 5.467954591357833e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0387402473718303 -3.872630304905376e-19 1.6479010778832037e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.100858832806455 -4.889655452317044e-19 -3.1967749050189758e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.186337516299244 -1.7524365574094355e-20 4.804702212162522e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.29646289729918 -3.9278060605536936e-21 9.680413869961679e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4272460911354603 -2.010691165908609e-21 4.541538990254332e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5691604697372648 2.3619822982963e-21 -7.548331775167822e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7095719344028035 2.1645046808533926e-21 -7.095040966578605e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.837144430629525 -3.1240442793450615e-21 -1.7246111293594936e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.9446959876927328 -1.6191438933680932e-21 4.521473485650961e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.029683302133993 -2.255627179391739e-21 -5.884414731537842e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0920712941337753 -2.278361135323538e-21 4.168337366472404e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1327940177953644 1.108746928938257e-21 -3.409304243020153e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1528564683764557 -4.975813467134529e-22 -6.017002628866389e-22 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener new file mode 100644 index 000000000..6e40c34fa --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.04702493896116645 +1 0.048571397421526434 +2 0.05234234949380354 +3 0.059766893903191225 +4 0.07290492312524598 +5 0.09342319302388279 +6 0.1192909504569416 +7 0.1401037681900495 +8 0.1458878705963857 +9 0.1357017751645486 +10 0.1164828056934044 +11 0.09379976928707788 +12 0.07461930400013642 +13 0.060995018830304386 +14 0.05263440467212523 +15 0.04871410326084989 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz new file mode 100644 index 000000000..b8cc2e678 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.9578019461229983 -1.0898886132137001e-20 2.044537092349526e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.970059224444842 -1.3946418441665392e-19 -2.8177140404755867e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9959300174823171 -2.819041421490817e-19 3.4689725326655616e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.0380365383551955 -3.4090007299074405e-19 3.4152846698069692e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.0999278390155665 -1.1883555855063766e-19 5.0342269847588187e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.185126233659367 -5.886615886446936e-20 8.246964195114006e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.294961477410879 -9.921100397683706e-21 6.39779889003223e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4255157756092616 -1.5165232943180077e-21 -5.547168728425464e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.567319658702937 -7.644645063033909e-22 1.7004440326256178e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7077557509686394 -2.1901332478402847e-23 -8.242538790171847e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8354579764093533 -2.821222072579752e-22 -4.678559860486276e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.943182188059441 -9.297411963106498e-23 -6.904706704061733e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0283369735992 -7.180581034985084e-23 -2.2464360683834053e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.090862269093421 3.916511461260653e-23 8.146473170651664e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1316802216474313 5.73133327426157e-22 5.198125911465029e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.15179096682048 7.285984434432587e-22 -8.727419392668278e-23 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener new file mode 100644 index 000000000..477b4789a --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.047000480881081705 +1 0.048540745805408125 +2 0.05229716062457533 +3 0.05969520026890455 +4 0.0727928178949055 +5 0.0932656555395706 +6 0.11912374210959654 +7 0.14000957921110332 +8 0.1459097837493836 +9 0.13580829857132964 +10 0.11664863044981832 +11 0.09397576134328887 +12 0.07477488908450806 +13 0.061126884492198046 +14 0.05274840016111142 +15 0.048819396349009836 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz new file mode 100644 index 000000000..7187d7843 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.957597069513815 1.8454076374258458e-19 -1.1147384246216175e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9698280629346974 2.9792404869356036e-19 1.4740123764355072e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9956442544887898 4.473403805096716e-19 1.479016406775356e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.037664750295609 3.260726072789764e-19 -1.9688203320099592e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.0994370329353953 1.0570992286908351e-19 1.167209482268265e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.184489057243468 -2.667520203750863e-19 1.3051165961264418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.294173528708773 -6.848358127452143e-19 1.9482079588247094e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4246098740175857 -3.56290775542309e-19 8.731164675236389e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5663582965951695 6.221159505979333e-19 -1.5133048028005144e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7068095330095456 7.675317081630339e-19 -1.671450587034784e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8345813531977164 -7.063637883494281e-19 1.4690926815560342e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.942396970346781 -7.901063633389286e-19 1.451873759134359e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0276400334362035 1.5439654592257134e-18 -2.628765503513539e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0902375519586887 -1.1583280586923087e-18 1.7653985468521653e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1311055360453413 5.22073506681833e-19 -7.101403336840961e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1512416404087644 -1.2760220601906393e-19 1.5306833674839856e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 new file mode 100644 index 000000000..a27b38170 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 @@ -0,0 +1 @@ +1.372052205055116804e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.300985096933852947e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.147664087203107211e-02 0.000000000000000000e+00 0.000000000000000000e+00 8.884765340518626514e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.857973401520016693e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.079750346441631439e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.905263832824703324e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.016816863896711706e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.063487038369620788e-02 0.000000000000000000e+00 0.000000000000000000e+00 -8.683190272443522956e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.713027617988564677e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.264131200286481779e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.011832077725278306e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.501363126292512409e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.381174021117178130e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.763130593976765290e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener new file mode 100644 index 000000000..477b4789a --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener @@ -0,0 +1,17 @@ +#Bead Energy (eV) +0 0.047000480881081705 +1 0.048540745805408125 +2 0.05229716062457533 +3 0.05969520026890455 +4 0.0727928178949055 +5 0.0932656555395706 +6 0.11912374210959654 +7 0.14000957921110332 +8 0.1459097837493836 +9 0.13580829857132964 +10 0.11664863044981832 +11 0.09397576134328887 +12 0.07477488908450806 +13 0.061126884492198046 +14 0.05274840016111142 +15 0.048819396349009836 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz new file mode 100644 index 000000000..7187d7843 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H 1.957597069513815 1.8454076374258458e-19 -1.1147384246216175e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H 1.9698280629346974 2.9792404869356036e-19 1.4740123764355072e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H 1.9956442544887898 4.473403805096716e-19 1.479016406775356e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H 2.037664750295609 3.260726072789764e-19 -1.9688203320099592e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H 2.0994370329353953 1.0570992286908351e-19 1.167209482268265e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 2.184489057243468 -2.667520203750863e-19 1.3051165961264418e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 2.294173528708773 -6.848358127452143e-19 1.9482079588247094e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 2.4246098740175857 -3.56290775542309e-19 8.731164675236389e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 2.5663582965951695 6.221159505979333e-19 -1.5133048028005144e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 2.7068095330095456 7.675317081630339e-19 -1.671450587034784e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 2.8345813531977164 -7.063637883494281e-19 1.4690926815560342e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 2.942396970346781 -7.901063633389286e-19 1.451873759134359e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 3.0276400334362035 1.5439654592257134e-18 -2.628765503513539e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 3.0902375519586887 -1.1583280586923087e-18 1.7653985468521653e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 3.1311055360453413 5.22073506681833e-19 -7.101403336840961e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 3.1512416404087644 -1.2760220601906393e-19 1.5306833674839856e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz new file mode 100644 index 000000000..2744e7b43 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001476598416876829 -1.0171004074581202e-19 6.143904917795865e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001640078365219887 -1.6420148327795642e-19 -8.124051067449371e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0019562495162948708 -2.465526174604555e-19 -8.151630888809017e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0023844659486092624 -1.7971562217385978e-19 1.085119580784019e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0028102540002227804 -5.82622524378881e-20 -6.433100285961822e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029733010561764648 1.4702095250468979e-19 -7.193178324287169e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002504396281231223 3.774487381859336e-19 -1.0737590267577877e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0013642359479591707 1.9637043091635838e-19 -4.812200279583877e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00015852509147107251 -3.4288055062023107e-19 8.340612124504565e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0015329882820110424 -4.230267596586871e-19 9.212236031983506e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002411578791966826 3.8931392846407573e-19 -8.096936062802152e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027273612402308233 4.354688296447292e-19 -8.002033599758783e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027360099752299473 -8.509598994996242e-19 1.4488497882587251e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026252562040650204 6.384150127987437e-19 -9.730032242816395e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002504685150634024 -2.8774194145520833e-19 3.9139537958673e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002432691609055136 7.032823160718064e-20 -8.436394459323836e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz new file mode 100644 index 000000000..a673dd854 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.002632603767693688 2.362717051057425e-19 2.8323392375933067e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.00272346708611596 9.018556629123943e-18 5.1159846017374606e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0028796323283429436 -2.726228664555665e-19 -4.42249387512621e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002981460159024136 2.247463597608855e-18 9.81565755830028e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002821039559668824 -2.1761589213580196e-17 1.446619651012455e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002235730249099677 -1.337387072025926e-18 -3.4339987628179334e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.001241374556023047 -2.1117879130745037e-19 -5.13004566347088e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 6.319864928009974e-06 -1.491938258485428e-20 4.546488379973182e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0011826369593138807 -2.6741794511636085e-20 1.883277524735541e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.002077627536058465 -4.163103792119179e-21 9.675256462163803e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0025629234018341627 -3.3659801005508374e-20 -1.155051979042948e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027367058833866497 -2.2395269771020137e-20 -1.4205903750076026e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002748702226711721 -2.062176998036632e-20 -1.9160443057674253e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026962574858969933 -2.0224006086224927e-20 -8.795049868142923e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0026380430962335945 -2.069636542600618e-21 1.952970283812755e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0026059177089612275 2.4041634906140326e-21 -2.8684306390054437e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz new file mode 100644 index 000000000..9a667ca2e --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0016824157950850215 2.1963495906710832e-18 1.0608610772311043e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001873126695798665 1.508733728797084e-17 1.1719456021128061e-17 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002239760224779918 -1.2617070967984234e-19 -5.350810555733108e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0026853493877254503 -3.4096652262336386e-18 4.601378339164389e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002975903404547755 -1.9897784229250622e-17 7.181968320156164e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002707810787148424 2.9114716744024008e-18 -9.450675696258665e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0017175655361622774 -9.875043473818302e-19 1.2940632609230514e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.00023722909098543375 -5.7911622591535344e-18 3.8938164169763927e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0012261828023101397 -3.8937307186109784e-18 4.05111131428063e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.002266500058754907 5.986530621899852e-18 8.822025727781897e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0026980726212388604 5.350768525002628e-18 2.6634845169797917e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002743792182764511 -1.1220017231630674e-17 -1.0896187194263847e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002617722005223619 7.797946868577806e-18 9.915503774593433e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0024489677782446873 -3.051765522603669e-18 -4.861262217089819e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002311700604821963 7.452188292249994e-19 1.326141666932943e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0022399072221180364 -1.1744257918616755e-19 -1.3697190978798605e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz new file mode 100644 index 000000000..0a6bd4d58 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0016117801025368815 -6.995159117729168e-18 1.17162007390878e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0017843268443360006 2.027341483001868e-18 -8.64224363775883e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0021126320195622938 9.789855628822922e-19 -2.0897591257515973e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0025395146250638714 7.665448415815707e-18 -1.9609993536123045e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002911730604821207 1.6080656546869316e-18 -3.923081578416115e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.002897891705921677 -3.982896158441624e-19 1.7600159072244064e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0021691598238081054 -6.694788146745599e-19 2.0418118294479095e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0008199149407570549 -5.199039630047778e-19 1.951170381405064e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0007325712620767708 3.2904531888606936e-19 -1.1139251469589407e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0019729464454195725 7.539201716698888e-19 -3.2117947601560988e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002607598168584877 -2.2197759894635766e-19 1.0361809024377055e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002756066227322505 -7.331659783831956e-19 3.891765727953534e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.00267334213366018 8.316148058592413e-19 -4.965638621252039e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.002516203664642486 -4.550832783806349e-19 2.9927853348447778e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002375735688628403 1.2687554168771687e-19 -1.1290710118213531e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0022973685029263067 -3.2700390715158996e-20 2.3637628892453435e-19 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz new file mode 100644 index 000000000..ec2e8b547 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.00155230614205983 3.173798513224306e-19 -1.9583332210760757e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0017207501795999155 -3.6136963148770534e-19 1.8864363484320202e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.002043468895198924 -2.1945830086863424e-18 4.939456696756798e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00247078654459684 1.1075347275184844e-18 2.090296177463263e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0028689365223876625 -1.1198607416418926e-18 5.735762701034082e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029444452771817996 -5.766235164230658e-19 -3.040113346934975e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002346250860738663 -9.818196272735668e-20 -6.701128262254362e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0011028281908805621 -1.5072623980768854e-20 -5.041309219937779e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0004424417174721176 -7.259661314173113e-21 6.175552721483892e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0017576087168179643 2.2000014108650898e-21 -1.9044860827920903e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0025181721261724036 2.056304596537832e-21 -7.141544153906043e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027485382681062018 3.516832495768676e-21 -1.038452190083155e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027111886754016368 1.1479314260238982e-20 8.478222453691886e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0025776167347003006 2.9122102245155283e-21 -5.048087863467473e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002447406767469851 -2.8619472593822625e-21 -2.9995232543660357e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0023724837743575944 7.834565692244203e-21 -6.1783024195455915e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz new file mode 100644 index 000000000..65553ed96 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0015134037877050283 2.034892551645728e-18 -5.157917893059402e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0016795051364418179 1.4086251546493321e-18 -3.062698436624866e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001999282831055633 3.398773439307406e-20 -3.506934376516114e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.002427671954333487 -8.879847211450097e-19 -1.9808935040079624e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002840701978296214 -5.470774978324343e-19 4.571132624084803e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029615528127915776 -8.110578737499964e-20 2.2928866729386803e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0024285925397748587 -1.7153849258988975e-20 3.9079896311304934e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0012372823187302472 -2.6408776944280414e-21 8.392957381570916e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00029827422937391256 -8.844591594910222e-22 1.538935661690556e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.001644837852503877 -2.5202412554410763e-21 -4.703309075159062e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0024664682983626444 3.0334562428047158e-21 -9.008284802050493e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027395186652112587 -1.1432512427858236e-21 2.915455941989966e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027249364860726247 6.040855289565263e-22 -5.35911574859638e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026024259876034662 2.3864343032506924e-21 3.073107117334101e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002476678018324827 2.936623473598254e-21 -3.7274955919120674e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002403018765817869 4.775262355550654e-21 -2.1538441337653794e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz new file mode 100644 index 000000000..8a846889e --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014950079888311277 -1.1323453988366049e-18 -2.479801745560393e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001659759928435622 5.361411423506359e-19 5.830079941888716e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.001977677445618153 2.2556803385915162e-21 -5.846601481396285e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0024059680776925244 -1.3941641422824659e-19 2.725942775895637e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.002825565985236469 -8.095495193328136e-19 -6.427874590496533e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029681795721827426 -8.415591642015716e-20 -5.093047113099149e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0024680708045246944 -4.0070807889335273e-19 6.1517371496836335e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0013031819010874387 -3.805076604619167e-19 7.925321233281016e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00022590544971233848 1.0457220651441943e-19 -2.228084829279213e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0015869507357467554 3.8233672667780545e-19 -1.185128505019391e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002438362822713231 -5.2226332054801806e-20 2.3226968487393133e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027335542955199505 -2.802340586229606e-19 1.4890236007287548e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027310690846347758 2.1893758012394014e-19 -1.781328252427303e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026147071114593465 -7.204424960055383e-20 1.0493740648073261e-18 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.00249166823456797 1.2125493778352504e-20 -3.9079520867444443e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002418880524571148 2.225746995805998e-22 7.916361885095345e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz new file mode 100644 index 000000000..bbf44a355 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0014846912246896204 -2.089355311376182e-19 7.835846694613169e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0016487413526057515 1.0662756098240674e-18 -8.34701654315862e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0019657025784567956 5.730742009026305e-21 -3.013674989765522e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0023939849916939804 2.1344085616488608e-19 -9.082442403368628e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0028170930515688665 2.6949441695270574e-19 1.7619093974175377e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029711882571496913 9.658591957882611e-21 -2.6481220076243463e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0024884893530138508 2.1648187986141714e-21 -5.335381024669084e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0013373720361232412 1.1081967813738748e-21 -2.503079029150401e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.0001882900543018318 -1.3018116481608897e-21 4.160279370503456e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0015568929123112414 -1.1929714325404475e-21 3.9104471617475525e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.00242354281500877 1.7218237558999765e-21 9.505231509852985e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.002730191836504344 8.923946559445133e-22 -2.492019882924904e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002733890360045934 1.243193794533722e-21 3.243207896033324e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026206314157505503 1.2557236634756439e-21 -2.2973881476809218e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002498947759428428 -6.110882659855446e-22 1.879045401351784e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002426591343826207 2.7424303455888857e-22 3.3162840021802503e-22 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz new file mode 100644 index 000000000..68efcfeea --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001479408222349577 6.006944645194491e-21 -1.126851036875859e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0016430841810253921 7.686598663580803e-20 1.5529891827400363e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0019595266580041707 1.5537207716551695e-19 -1.9119317081383585e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00238776484078529 1.8788781194437935e-19 -1.8823415264995745e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0028126302243972156 6.549647490944867e-20 -2.7746250820643463e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029725991286990165 3.2444210673183645e-20 -4.545332138563906e-21 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002498943582899671 5.46803592456818e-21 -3.5261606844565635e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0013550176529700067 8.358350910057709e-22 3.0573340325991775e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00016874486549731484 4.2133626472524747e-22 -9.372034033931663e-23 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.001541194934600551 1.2070966726208973e-23 4.542893067066339e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.0024156967724460266 1.5549226422154178e-22 2.5785983778930856e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027283450172088976 5.124288696004493e-23 3.805544021632023e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.002735298711949237 3.9575927553095173e-23 1.2381280938386664e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026236891513214786 -2.1585937558051732e-23 -4.4899462932614e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.0025027387438536415 -3.1588367200327935e-22 -2.8649583297187054e-22 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.0024306216968974096 -4.0156860667011765e-22 4.810136059002572e-23 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz new file mode 100644 index 000000000..2744e7b43 --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.001476598416876829 -1.0171004074581202e-19 6.143904917795865e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.001640078365219887 -1.6420148327795642e-19 -8.124051067449371e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.0019562495162948708 -2.465526174604555e-19 -8.151630888809017e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.0023844659486092624 -1.7971562217385978e-19 1.085119580784019e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0028102540002227804 -5.82622524378881e-20 -6.433100285961822e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.0029733010561764648 1.4702095250468979e-19 -7.193178324287169e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.002504396281231223 3.774487381859336e-19 -1.0737590267577877e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.0013642359479591707 1.9637043091635838e-19 -4.812200279583877e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.00015852509147107251 -3.4288055062023107e-19 8.340612124504565e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0015329882820110424 -4.230267596586871e-19 9.212236031983506e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H 0.002411578791966826 3.8931392846407573e-19 -8.096936062802152e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H 0.0027273612402308233 4.354688296447292e-19 -8.002033599758783e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H 0.0027360099752299473 -8.509598994996242e-19 1.4488497882587251e-19 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H 0.0026252562040650204 6.384150127987437e-19 -9.730032242816395e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H 0.002504685150634024 -2.8774194145520833e-19 3.9139537958673e-20 +1 +CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H 0.002432691609055136 7.032823160718064e-20 -8.436394459323836e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst1D.dat b/drivers/py/pes/friction/test-ohne80/inst1D.dat new file mode 100644 index 000000000..a1f44d19f --- /dev/null +++ b/drivers/py/pes/friction/test-ohne80/inst1D.dat @@ -0,0 +1,16 @@ +1.957597069513815 0.047000480881081705 +1.9698280629346974 0.048540745805408125 +1.9956442544887898 0.05229716062457533 +2.037664750295609 0.05969520026890455 +2.0994370329353953 0.0727928178949055 +2.184489057243468 0.0932656555395706 +2.294173528708773 0.11912374210959654 +2.4246098740175857 0.14000957921110332 +2.5663582965951695 0.1459097837493836 +2.7068095330095456 0.13580829857132964 +2.8345813531977164 0.11664863044981832 +2.942396970346781 0.09397576134328887 +3.0276400334362035 0.07477488908450806 +3.0902375519586887 0.061126884492198046 +3.1311055360453413 0.05274840016111142 +3.1512416404087644 0.048819396349009836 diff --git a/drivers/py/pes/friction/test2/clean.sh b/drivers/py/pes/friction/test2/clean.sh new file mode 100755 index 000000000..21687e485 --- /dev/null +++ b/drivers/py/pes/friction/test2/clean.sh @@ -0,0 +1,4 @@ +rm inst* +rm \#inst* +rm *tmp +rm *RES* diff --git a/drivers/py/pes/friction/test2/init.xyz b/drivers/py/pes/friction/test2/init.xyz new file mode 100644 index 000000000..e308c01de --- /dev/null +++ b/drivers/py/pes/friction/test2/init.xyz @@ -0,0 +1,48 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1441466 1.1441364 1.1471352 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1503273 1.1503173 1.1503182 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1649317 1.1649216 1.1649205 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.1880459 1.1880352 1.1880343 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2194632 1.2194523 1.2194517 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.2583844 1.2583735 1.2583731 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3031849 1.3031754 1.3031744 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3513008 1.3512929 1.3512915 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.3996751 1.3996689 1.3996679 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4454179 1.4454138 1.4454129 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.4863054 1.4863029 1.4863018 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5208596 1.5208578 1.5208567 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5482857 1.5482846 1.5482833 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5683137 1.5683131 1.5683116 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5809606 1.5809607 1.5809623 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 1.5863237 1.5863240 1.5850224 diff --git a/drivers/py/pes/friction/test2/input.xml b/drivers/py/pes/friction/test2/input.xml new file mode 100644 index 000000000..33b8aff93 --- /dev/null +++ b/drivers/py/pes/friction/test2/input.xml @@ -0,0 +1,45 @@ + + + [ step, potential{electronvolt}] + extras + extras + + 100 + +
localhost
+
+ + + init.xyz + [3.9408969800000002,3.9408969800000002,3.9408969800000002] + + + + ['friction'] + + + + 118 + + + + + 1e-3 + 2e-4 + 1e-3 + + nichols + 0.1 + 1 + powell + true + + z_friction.dat + true + true + crystal + 0.1 + + + +
diff --git a/drivers/py/pes/friction/test2/z_friction.dat b/drivers/py/pes/friction/test2/z_friction.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/drivers/py/pes/friction/test2/z_friction.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index 8b977b209..7cfcc088e 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -12,7 +12,7 @@ def __init__(self, args=None): super(Harmonic_driver, self).__init__(args) def check_arguments(self): - """ Function that checks the arguments required to run the driver """ + """Function that checks the arguments required to run the driver""" try: k = list(map(float, self.args.split(","))) except ValueError: @@ -28,7 +28,7 @@ def check_arguments(self): sys.exit(self.error_msg) def __call__(self, cell, pos): - """ Silly harmonic potential""" + """Silly harmonic potential""" if self.type == "isotropic": pot = 0.5 * self.k * (pos ** 2).sum() force = -self.k * pos # makes a zero force with same shape as pos diff --git a/drivers/py/pes/spline.py b/drivers/py/pes/spline.py index 4a0b24a2d..f5ed5408e 100644 --- a/drivers/py/pes/spline.py +++ b/drivers/py/pes/spline.py @@ -25,7 +25,7 @@ def __init__(self, args=None): self.k = 1836 * (3800.0 / 219323.0) ** 2 def check_arguments(self): - """ Function that checks the arguments required to run the driver """ + """Function that checks the arguments required to run the driver""" try: data = np.loadtxt(self.args[0]).reshape(-1, 5) @@ -34,7 +34,7 @@ def check_arguments(self): self.data = data def get_spline(self): - """Function that creates the 1D spline and its derivative """ + """Function that creates the 1D spline and its derivative""" self.spline_f = [] for i in range(3): @@ -47,7 +47,7 @@ def get_spline(self): ) def get_spline_fric(self): - """Function that creates the 1D spline for the friction """ + """Function that creates the 1D spline for the friction""" data = np.loadtxt(self.args[1]).reshape(-1, 10) self.spline_fric = [] for i in range(9): @@ -98,11 +98,11 @@ def full2oneD(self, pos): return factor_coord * pos[0, 0] def check_dimensions(self, pos): - """ Functions that checks dimensions of the received position """ + """Functions that checks dimensions of the received position""" assert pos.shape == (1, 3) def __call__(self, cell, pos): - """ Evaluate energy, forces and friction""" + """Evaluate energy, forces and friction""" self.check_dimensions(pos) vir = cell * 0.0 # makes a zero virial with same shape as cell diff --git a/drivers/py/pes/test.dat b/drivers/py/pes/test.dat new file mode 100644 index 000000000..0cea4ac1d --- /dev/null +++ b/drivers/py/pes/test.dat @@ -0,0 +1,200 @@ +6.851845134703705043e+00 +6.516274392034565821e+00 +6.192021198888439493e+00 +5.878845035438853728e+00 +5.576507823685005860e+00 +5.284773927451720255e+00 +5.003410152389479393e+00 +4.732185745974415880e+00 +4.470872397508305340e+00 +4.219244238118584178e+00 +3.977077840758333149e+00 +3.744152220206278248e+00 +3.520248833066796035e+00 +3.305151577769913640e+00 +3.098646794571314533e+00 +2.900523265552320318e+00 +2.710572214619908937e+00 +2.528587307506704018e+00 +2.354364651770979311e+00 +2.187702796796663574e+00 +2.028402733793328583e+00 +1.876267895796196461e+00 +1.731104157666138121e+00 +1.592719836089679264e+00 +1.460925689578987496e+00 +1.335534918471885879e+00 +1.216363164931844043e+00 +1.103228512947980189e+00 +9.959514883350644165e-01 +8.943550587335138413e-01 +7.982646336093978112e-01 +7.075080642544325782e-01 +6.219156437859827413e-01 +5.413201071470671311e-01 +4.655566311063493168e-01 +3.944628342581446567e-01 +3.278787770224170228e-01 +2.656469616447789672e-01 +2.076123321964949142e-01 +1.536222745744760254e-01 +1.035266165012851403e-01 +5.717762752513215474e-02 +1.443001901987814480e-02 +-2.485905581496745606e-02 +-6.083000195424459466e-02 +-9.362078254714506498e-02 +-1.233669189172105912e-01 +-1.502014905623338947e-01 +-1.742551351547576288e-01 +-1.956560485410760442e-01 +-2.145299847422328376e-01 +-2.310002559535231093e-01 +-2.451877325445926126e-01 +-2.572108430594370887e-01 +-2.671855742164032099e-01 +-2.752254709081883299e-01 +-2.814416362018403728e-01 +-2.859427313387575831e-01 +-2.888349757346890812e-01 +-2.902221469797346964e-01 +-2.902055808383444124e-01 +-2.888841712493191438e-01 +-2.863543703258105144e-01 +-2.827101883553204131e-01 +-2.780431937997014380e-01 +-2.724425132951567297e-01 +-2.659948316522403600e-01 +-2.587843918558564438e-01 +-2.508929950652603602e-01 +-2.424000006140573926e-01 +-2.333823260102039221e-01 +-2.239144469360066503e-01 +-2.140683972481230990e-01 +-2.039137689775612217e-01 +-1.935177123296795976e-01 +-1.829449356841873486e-01 +-1.722577055951443614e-01 +-1.615158467909609541e-01 +-1.507767421743982095e-01 +-1.400953328225675587e-01 +-1.295241179869313086e-01 +-1.191131550933021283e-01 +-1.089100597418434513e-01 +-9.896000570706919852e-02 +-8.930572493784399990e-02 +-7.998750755738293083e-02 +-7.104320186325177588e-02 +-6.250821432736687611e-02 +-5.441550959599519149e-02 +-4.679561048975428711e-02 +-3.967659800361224287e-02 +-3.308411130688783397e-02 +-2.704134774325038515e-02 +-2.156906283071982969e-02 +-1.668557026166668858e-02 +-1.240674190281208615e-02 +-8.746007795227741383e-03 +-5.714356154335966179e-03 +-3.320333369909676639e-03 +-1.570044006072379402e-03 +-4.671508012981798793e-04 +-1.287466841177984082e-05 +-2.059946945884777512e-04 +-1.042848141354168036e-03 +-2.517330444585342848e-03 +-4.620895214509090042e-03 +-7.342554235703092728e-03 +-1.066887746709563323e-02 +-1.458399304196559415e-02 +-1.906958726794243802e-02 +-2.410490462700624198e-02 +-2.966674777548768474e-02 +-3.572947754406800847e-02 +-4.226501293777909507e-02 +-4.924283113600335521e-02 +-5.662996749247391215e-02 +-6.439101553527439015e-02 +-7.248812696683903933e-02 +-8.088101166395267327e-02 +-8.952693767775070366e-02 +-9.838073123371929296e-02 +-1.073947767316949520e-01 +-1.165190167458649978e-01 +-1.257009520247671097e-01 +-1.348856414912899260e-01 +-1.440157022426723499e-01 +-1.530313095505039522e-01 +-1.618701968607250408e-01 +-1.704676557936262993e-01 +-1.787565361438492595e-01 +-1.866672458803859125e-01 +-1.941277511465787919e-01 +-2.010635762601211129e-01 +-2.073978037130566332e-01 +-2.130510741717799306e-01 +-2.179415864770356814e-01 +-2.219850976439197709e-01 +-2.250949228618781550e-01 +-2.271819354947076652e-01 +-2.281545670805558701e-01 +-2.279188073319203534e-01 +-2.263782041356500463e-01 +-2.234338635529438677e-01 +-2.189844498193516953e-01 +-2.129261853447737829e-01 +-2.051528507134613433e-01 +-1.955557846840156599e-01 +-1.840238841893888089e-01 +-1.704436043368837417e-01 +-1.546989584081536750e-01 +-1.366715178592028124e-01 +-1.162404123203854417e-01 +-9.328232959640633815e-02 +-6.767151566632190196e-02 +-3.927977468353820167e-02 +-7.976468975811900480e-03 +2.637148095474896661e-02 +6.389959643168688364e-02 +1.047458406041928830e-01 +1.490506184471076800e-01 +1.969567767609210762e-01 +2.486096041717725524e-01 +3.041568311314521988e-01 +3.637486299173966486e-01 +4.275376146326954618e-01 +4.956788412060836868e-01 +5.683298073919489379e-01 +6.456504527703275098e-01 +7.278031587469034891e-01 +8.149527485530140281e-01 +9.072664872456399632e-01 +1.004914081707416695e+00 +1.108067680646627862e+00 +1.216901874597203781e+00 +1.331593695918728670e+00 +1.452322618796431097e+00 +1.579270559241192862e+00 +1.712621875089545664e+00 +1.852563366003664891e+00 +1.999284273471383599e+00 +2.152976280806176312e+00 +2.313833513147172116e+00 +2.482052537459147779e+00 +2.657832362532533743e+00 +2.841374438983398143e+00 +3.032882659253470337e+00 +3.232563357610124921e+00 +3.440625310146385285e+00 +3.657279734780927605e+00 +3.882740291258070187e+00 +4.117223081147786345e+00 +4.360946647845698187e+00 +4.614131976573078830e+00 +4.877002494376850628e+00 +5.149784070129575397e+00 +5.432705014529476628e+00 +5.725996080100421715e+00 +6.029890461191930839e+00 +6.344623793979176973e+00 +6.670434156462962783e+00 diff --git a/ipi/engine/forcefields.py b/ipi/engine/forcefields.py index 12e321e53..be77d7f6b 100644 --- a/ipi/engine/forcefields.py +++ b/ipi/engine/forcefields.py @@ -32,7 +32,7 @@ class NumpyEncoder(json.JSONEncoder): - """ Special json encoder for numpy types """ + """Special json encoder for numpy types""" def default(self, obj): if isinstance(obj, np.integer): @@ -292,7 +292,7 @@ def start(self): softexit.register_function(self.softexit) def softexit(self): - """ Takes care of cleaning up upon softexit """ + """Takes care of cleaning up upon softexit""" self.stop() @@ -558,7 +558,7 @@ def evaluate(self, r): r["status"] = "Done" def dmd_update(self): - """ Updates time step when a full step is done. Can only be called after implementation goes into smotion mode...""" + """Updates time step when a full step is done. Can only be called after implementation goes into smotion mode...""" self.dmdstep += 1 @@ -628,7 +628,7 @@ def poll(self): self.evaluate(r) def evaluate(self, r): - """ A simple evaluator for a harmonic Debye crystal potential. """ + """A simple evaluator for a harmonic Debye crystal potential.""" q = r["pos"] n3 = len(q) @@ -800,7 +800,7 @@ def mtd_update(self, pos, cell): class FFYaff(ForceField): - """ Use Yaff as a library to construct a force field """ + """Use Yaff as a library to construct a force field""" def __init__( self, @@ -896,7 +896,7 @@ def poll(self): self.evaluate(r) def evaluate(self, r): - """ Evaluate the energy and forces with the Yaff force field. """ + """Evaluate the energy and forces with the Yaff force field.""" q = r["pos"] nat = len(q) / 3 @@ -1015,7 +1015,7 @@ def poll(self): self.evaluate(r) def evaluate(self, r): - """ Evaluate the energy and forces. """ + """Evaluate the energy and forces.""" E, F = self.predictor.predict(r["pos"] * self.bohr_to_ang) @@ -1125,7 +1125,7 @@ def check_finish(self, r): return True def gather(self, r): - """ Collects results from all sub-requests, and assemble the committee of models. """ + """Collects results from all sub-requests, and assemble the committee of models.""" r["result"] = [0.0, np.zeros(len(r["pos"]), float), np.zeros((3, 3), float), ""] diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index 85e299a59..d0eb6dff6 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -1039,7 +1039,7 @@ def pots_component(self, index, weighted=True): return self.mrpc[index].b2tob1(self.mforces[index].pots) def forces_component(self, index, weighted=True): - """ Fetches the index^th component of the total force.""" + """Fetches the index^th component of the total force.""" if weighted: if self.mforces[index].weight != 0: return self.mforces[index].weight * self.mrpc[index].b2tob1( @@ -1051,7 +1051,7 @@ def forces_component(self, index, weighted=True): return self.mrpc[index].b2tob1(dstrip(self.mforces[index].f)) def extras_component(self, index): - """ Fetches extras that are computed for one specific force component.""" + """Fetches extras that are computed for one specific force component.""" if self.nbeads != self.mforces[index].nbeads: raise ValueError( @@ -1077,7 +1077,7 @@ def queue_mts(self, level): ff.queue() def forces_mts(self, level): - """ Fetches ONLY the forces associated with a given MTS level.""" + """Fetches ONLY the forces associated with a given MTS level.""" self.queue_mts(level) fk = np.zeros((self.nbeads, 3 * self.natoms)) @@ -1096,7 +1096,7 @@ def forces_mts(self, level): return fk def forcesvirs_4th_order(self, index): - """ Fetches the 4th order |f^2| correction to the force vector and the virial associated with a given component.""" + """Fetches the 4th order |f^2| correction to the force vector and the virial associated with a given component.""" # gives an error is number of beads is not even. if self.nbeads % 2 != 0: @@ -1281,11 +1281,11 @@ def forcesvirs_4th_order(self, index): return [f_4th_order, v_4th_order] def vir_mts(self, level): - """ Fetches ONLY the total virial associated with a given MTS level.""" + """Fetches ONLY the total virial associated with a given MTS level.""" return np.sum(self.virs_mts(level), axis=0) def virs_mts(self, level): - """ Fetches ONLY the total virial associated with a given MTS level.""" + """Fetches ONLY the total virial associated with a given MTS level.""" self.queue_mts(level) rp = np.zeros((self.beads.nbeads, 3, 3), float) @@ -1305,7 +1305,7 @@ def virs_mts(self, level): return rp def get_nmtslevels(self): - """ Returns the total number of mts levels.""" + """Returns the total number of mts levels.""" nm = len(self.mforces[0].mts_weights) if all(len(x.mts_weights) == nm for x in self.mforces): diff --git a/ipi/engine/motion/constrained_dynamics.py b/ipi/engine/motion/constrained_dynamics.py index 9f8fb7f0b..ceb1b0cd1 100644 --- a/ipi/engine/motion/constrained_dynamics.py +++ b/ipi/engine/motion/constrained_dynamics.py @@ -353,7 +353,7 @@ def get_tdt(self): return super(ConstrainedIntegrator, self).get_tdt() / self.nsteps_o def bind(self, motion): - """ Creates local references to all the variables for simpler access.""" + """Creates local references to all the variables for simpler access.""" super(ConstrainedIntegrator, self).bind(motion) diff --git a/ipi/engine/motion/dynamics.py b/ipi/engine/motion/dynamics.py index 21d3afaf4..db4977b63 100644 --- a/ipi/engine/motion/dynamics.py +++ b/ipi/engine/motion/dynamics.py @@ -241,14 +241,14 @@ def get_ntemp(self): return self.ensemble.temp * self.beads.nbeads def step(self, step=None): - """ Advances the dynamics by one time step """ + """Advances the dynamics by one time step""" self.integrator.step(step) self.ensemble.time += self.dt # increments internal time class DummyIntegrator(dobject): - """ No-op integrator for (PI)MD """ + """No-op integrator for (PI)MD""" def __init__(self): pass @@ -274,7 +274,7 @@ def get_tdt(self): ) def bind(self, motion): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" self.beads = motion.beads self.bias = motion.ensemble.bias @@ -428,7 +428,7 @@ def qcstep(self): # take the BAB MTS, and insert the O in the very middle. This might imply breaking a A step in two, e.g. one could have # Bbabb(a/2) O (a/2)bbabB def mtsprop_ba(self, index): - """ Recursive MTS step """ + """Recursive MTS step""" mk = int(self.nmts[index] / 2) @@ -461,7 +461,7 @@ def mtsprop_ba(self, index): self.mtsprop_ba(index + 1) def mtsprop_ab(self, index): - """ Recursive MTS step """ + """Recursive MTS step""" if self.nmts[index] % 2 == 1: if index == self.nmtslevels - 1: diff --git a/ipi/engine/motion/geop.py b/ipi/engine/motion/geop.py index c34ba46f4..9040518c1 100755 --- a/ipi/engine/motion/geop.py +++ b/ipi/engine/motion/geop.py @@ -267,10 +267,10 @@ def __call__(self, x): class DummyOptimizer(dobject): - """ Dummy class for all optimization classes """ + """Dummy class for all optimization classes""" def __init__(self): - """initialises object for LineMapper (1-d function) and for GradientMapper (multi-dimensional function) """ + """initialises object for LineMapper (1-d function) and for GradientMapper (multi-dimensional function)""" self.lm = LineMapper() self.gm = GradientMapper() @@ -348,7 +348,7 @@ def bind(self, geop): self.d = geop.d def exitstep(self, fx, u0, x): - """ Exits the simulation step. Computes time, checks for convergence. """ + """Exits the simulation step. Computes time, checks for convergence.""" info(" @GEOP: Updating bead positions", verbosity.debug) self.qtime += time.time() @@ -401,7 +401,7 @@ def exitstep(self, fx, u0, x): class BFGSOptimizer(DummyOptimizer): - """ BFGS Minimization """ + """BFGS Minimization""" def bind(self, geop): # call bind function from DummyOptimizer @@ -508,7 +508,7 @@ def step(self, step=None): class BFGSTRMOptimizer(DummyOptimizer): - """ BFGSTRM Minimization with Trust Radius Method. """ + """BFGSTRM Minimization with Trust Radius Method.""" def bind(self, geop): # call bind function from DummyOptimizer diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 48db8c40c..cd3fe6133 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -311,15 +311,15 @@ def bind(self, mapper): self.spline = False def initialize(self, q, forces): - """ Initialize potential and forces """ + """Initialize potential and forces""" self.save(forces.pots, -forces.f) def set_pos(self, x): - """Set the positions """ + """Set the positions""" self.dbeads.q = x def save(self, e, g): - """ Stores potential and forces in this class for convenience """ + """Stores potential and forces in this class for convenience""" self.pot = e self.f = -g @@ -383,7 +383,7 @@ def interpolation(self, full_q, full_mspath, get_all_info=False): return full_pot, full_forces def __call__(self, x, new_disc=True): - """ Computes energy and gradient for optimization step""" + """Computes energy and gradient for optimization step""" self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) @@ -434,7 +434,7 @@ def bind(self, mapper): self.interp1d = interp1d def save(self, e, g, eta=None): - """ Stores potential and forces in this class for convenience """ + """Stores potential and forces in this class for convenience""" super(FrictionMapper, self).save(e, g) # ALBERTO: CLEAN THE MASS UNSCALING self.eta = eta * test_factor @@ -449,7 +449,7 @@ def save(self, e, g, eta=None): # print(self.eta[0]) def initialize(self, q, forces): - """ Initialize potential, forces and friction """ + """Initialize potential, forces and friction""" if self.frictionSD: eta = np.array(forces.extras["friction"]).reshape( @@ -482,7 +482,7 @@ def check_eta(self, eta): softexit.trigger("The provided friction is not positive definite") def set_z_friction(self, z_friction): - """Sets the scaling factors corresponding to frequency dependence of the friction """ + """Sets the scaling factors corresponding to frequency dependence of the friction""" # from scipy.interpolate import interp1d @@ -546,7 +546,7 @@ def get_fric_rp_hessian(self, fric_hessian, eta, SD): return h_fric def obtain_g(self, s): - """ Computes g from s """ + """Computes g from s""" if debug: return self.dbeads.q.copy() @@ -579,7 +579,7 @@ def obtain_g(self, s): return gq def compute_friction_terms(self): - """ Computes friction component of the energy and gradient """ + """Computes friction component of the energy and gradient""" s = self.eta @@ -609,7 +609,7 @@ def compute_friction_terms(self): return e, g def get_full_extras(self, reduced_forces, full_mspath, indexes): - """ Get the full extra strings """ + """Get the full extra strings""" diction = {} for key in reduced_forces.extras.keys(): if str(key) != "raw": @@ -628,7 +628,7 @@ def get_full_extras(self, reduced_forces, full_mspath, indexes): return diction def __call__(self, x, new_disc=True): - """ Computes energy and gradient for optimization step""" + """Computes energy and gradient for optimization step""" self.fcount += 1 full_q = x.copy() full_mspath = ms_pathway(full_q, self.dbeads.m3) @@ -721,7 +721,7 @@ def bind(self, mapper): ) def save(self, e, g): - """ Stores potential and forces in this class for convenience """ + """Stores potential and forces in this class for convenience""" self.pot = e self.f = -g @@ -912,7 +912,7 @@ def bind(self, dumop): self.sm.bind(self) def set_coef(self, coef): - """ Sets coeficients for non-uniform instanton calculation """ + """Sets coeficients for non-uniform instanton calculation""" self.coef[:] = coef.reshape(-1, 1) def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): @@ -948,7 +948,7 @@ def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): class DummyOptimizer(dobject): - """ Dummy class for all optimization classes """ + """Dummy class for all optimization classes""" def __init__(self): """Initializes object for PesMapper (physical potential, forces and hessian) @@ -1053,7 +1053,7 @@ def bind(self, geop): self.mapper.bind(self) def initial_geo(self): - """ Generates the initial instanton geometry by stretching the transitions-state geometry along the mode with imaginary frequency """ + """Generates the initial instanton geometry by stretching the transitions-state geometry along the mode with imaginary frequency""" info( " @GEOP: We stretch the initial geometry with an 'amplitude' of {:4.2f}".format( @@ -1079,7 +1079,7 @@ def initial_geo(self): ) def exitstep(self, d_x_max, step): - """ Exits the simulation step. Computes time, checks for convergence. """ + """Exits the simulation step. Computes time, checks for convergence.""" self.qtime += time.time() tolerances = self.options["tolerances"] @@ -1183,7 +1183,7 @@ def exitstep(self, d_x_max, step): return False def update_pos_for(self): - """ Update positions and forces """ + """Update positions and forces""" self.beads.q[:] = self.mapper.gm.dbeads.q[:] @@ -1191,14 +1191,14 @@ def update_pos_for(self): self.forces.transfer_forces(self.mapper.gm.dforces) def update_old_pos_for(self): - """ Update 'old' positions and forces arrays """ + """Update 'old' positions and forces arrays""" self.optarrays["old_x"][:] = self.beads.q self.optarrays["old_u"][:] = self.forces.pots self.optarrays["old_f"][:] = self.forces.f def print_geo(self, step): - """ Small interface to call the function that prints thet instanton geometry """ + """Small interface to call the function that prints thet instanton geometry""" if ( self.options["save"] > 0 and np.mod(step, self.options["save"]) == 0 @@ -1218,7 +1218,7 @@ def print_geo(self, step): ) def pre_step(self, step=None, adaptative=False): - """ General tasks that have to be performed before actual step""" + """General tasks that have to be performed before actual step""" if self.exit: softexit.trigger("Geometry optimization converged. Exiting simulation") @@ -1260,7 +1260,7 @@ def func(x): class HessianOptimizer(DummyOptimizer): - """ Instaton Rate calculation""" + """Instaton Rate calculation""" def bind(self, geop): # call bind function from DummyOptimizer @@ -1401,7 +1401,7 @@ def initialize(self, step): self.init = True def update_hessian(self, update, active_hessian, new_x, d_x, d_g): - """ Update hessian """ + """Update hessian""" if update == "powell": @@ -1450,7 +1450,7 @@ def print_hess(self, step): ) def post_step(self, step, new_x, d_x, activearrays): - """ General tasks that have to be performed after finding the new step""" + """General tasks that have to be performed after finding the new step""" d_x_max = np.amax(np.absolute(d_x)) info("Current step norm = {}".format(d_x_max), verbosity.medium) @@ -1478,10 +1478,10 @@ def post_step(self, step, new_x, d_x, activearrays): class NicholsOptimizer(HessianOptimizer): - """ Class that implements a nichols optimization. It can find first order saddle points or minimum""" + """Class that implements a nichols optimization. It can find first order saddle points or minimum""" def step(self, step=None): - """ Does one simulation step.""" + """Does one simulation step.""" activearrays = self.pre_step(step) @@ -1585,10 +1585,10 @@ def step(self, step=None): class NROptimizer(HessianOptimizer): - """ Class that implements a Newton-Raphson optsmization. It can find first order saddle points or minimum""" + """Class that implements a Newton-Raphson optsmization. It can find first order saddle points or minimum""" def step(self, step=None): - """ Does one simulaion step.""" + """Does one simulaion step.""" activearrays = self.pre_step(step) dyn_mat = get_dynmat( @@ -1627,7 +1627,7 @@ class LanczosOptimizer(HessianOptimizer): the full (3*natoms*nbeads)^2 matrix""" def step(self, step=None): - """ Does one simulation step.""" + """Does one simulation step.""" activearrays = self.pre_step(step) @@ -1856,7 +1856,7 @@ def initialize(self, step): def post_step(self, step, activearrays): - """ General tasks that have to be performed after the actual step""" + """General tasks that have to be performed after the actual step""" # Update self.optarrays["qlist"][:] = self.fix.get_full_vector( @@ -1879,7 +1879,7 @@ def post_step(self, step, activearrays): self.update_old_pos_for() def step(self, step=None): - """ Does one simulation step.""" + """Does one simulation step.""" activearrays = self.pre_step(step) diff --git a/ipi/engine/motion/phonons.py b/ipi/engine/motion/phonons.py index acbc1c880..92236b82c 100644 --- a/ipi/engine/motion/phonons.py +++ b/ipi/engine/motion/phonons.py @@ -105,7 +105,7 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): self.dforces = self.forces.copy(self.dbeads, self.dcell) def step(self, step=None): - """Executes one step of phonon computation. """ + """Executes one step of phonon computation.""" if step < 3 * self.beads.natoms: self.phcalc.step(step) else: @@ -115,7 +115,7 @@ def step(self, step=None): softexit.trigger("Dynamic matrix is calculated. Exiting simulation") def printall(self, prefix, dmatx, deltaw=0.0, fixdof=np.array([])): - """ Prints out diagnostics for a given dynamical matrix. """ + """Prints out diagnostics for a given dynamical matrix.""" dmatx = dmatx + np.eye(len(dmatx)) * deltaw if deltaw != 0.0: @@ -284,13 +284,13 @@ def apply_asr(self, dm): class DummyPhononCalculator(dobject): - """ No-op PhononCalculator """ + """No-op PhononCalculator""" def __init__(self): pass def bind(self, dm): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" self.dm = dm def step(self, step=None): @@ -307,7 +307,7 @@ class FDPhononCalculator(DummyPhononCalculator): """Finite difference phonon evaluator.""" def bind(self, dm): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" super(FDPhononCalculator, self).bind(dm) # Initialises a 3*number of atoms X 3*number of atoms dynamic matrix. @@ -374,7 +374,7 @@ class NMFDPhononCalculator(FDPhononCalculator): """Normal mode finite difference phonon evaluator.""" def bind(self, dm): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" super(NMFDPhononCalculator, self).bind(dm) if np.array_equal( diff --git a/ipi/engine/motion/planetary.py b/ipi/engine/motion/planetary.py index a63624a8e..63fa636c9 100644 --- a/ipi/engine/motion/planetary.py +++ b/ipi/engine/motion/planetary.py @@ -205,7 +205,7 @@ def matrix_screen(self): return sij def save_matrix(self, matrix): - """ Writes the compressed, sparse frequency matrix to a netstring encoded file """ + """Writes the compressed, sparse frequency matrix to a netstring encoded file""" sparse.save_npz( self.fomega2, matrix, saver=netstring_encoded_savez, compressed=True diff --git a/ipi/engine/motion/scphonons.py b/ipi/engine/motion/scphonons.py index 2d6205cc0..0b786df28 100644 --- a/ipi/engine/motion/scphonons.py +++ b/ipi/engine/motion/scphonons.py @@ -201,13 +201,13 @@ def step(self, step=None): class DummyPhononator(dobject): - """ No-op phononator """ + """No-op phononator""" def __init__(self): pass def bind(self, dm): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" self.dm = dm def reset(self): diff --git a/ipi/engine/motion/vscf.py b/ipi/engine/motion/vscf.py index 7acb66181..1354d9d1c 100644 --- a/ipi/engine/motion/vscf.py +++ b/ipi/engine/motion/vscf.py @@ -146,18 +146,18 @@ def bind(self, ens, beads, nm, cell, bforce, prng, omaker): self.dforces = self.forces.copy(self.dbeads, self.dcell) def step(self, step=None): - """Executes one step of phonon computation. """ + """Executes one step of phonon computation.""" self.calc.step(step) class DummyCalculator(dobject): - """ No-op Calculator """ + """No-op Calculator""" def __init__(self): pass def bind(self, imm): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" self.imm = imm def step(self, step=None): @@ -169,7 +169,7 @@ class IMF(DummyCalculator): """Temperature scaled normal mode Born-Oppenheimer surface evaluator.""" def bind(self, imm): - """ Reference all the variables for simpler access.""" + """Reference all the variables for simpler access.""" if scipy is None: info(" @NM: scipy import failed", verbosity.low) @@ -758,7 +758,7 @@ def terminate(self): class VSCF(IMF): - """""" + """ """ def bind(self, imm): """ diff --git a/ipi/engine/outputs.py b/ipi/engine/outputs.py index be2e4720e..7fd021af1 100644 --- a/ipi/engine/outputs.py +++ b/ipi/engine/outputs.py @@ -44,7 +44,7 @@ def __init__(self, prefix, olist): class OutputMaker(dobject): - """ Class to create floating outputs with an appropriate prefix """ + """Class to create floating outputs with an appropriate prefix""" def __init__(self, prefix="", f_start=False): self.prefix = prefix @@ -69,7 +69,7 @@ def get_output(self, filename="out", mode=None): class BaseOutput(object): - """Base class for outputs. Deals with flushing upon close and little more """ + """Base class for outputs. Deals with flushing upon close and little more""" def __init__(self, filename="out"): """Initializes the class""" @@ -116,7 +116,7 @@ def remove(self): os.remove(self.filename) def write(self, data): - """ Writes data to file """ + """Writes data to file""" if self.out is not None: return self.out.write(data) @@ -323,7 +323,7 @@ def bind(self, system, mode="w"): super(TrajectoryOutput, self).bind(mode) def print_header(self): - """ No headers for trajectory files """ + """No headers for trajectory files""" pass def open_stream(self, mode): diff --git a/ipi/inputs/forcefields.py b/ipi/inputs/forcefields.py index 509426970..c91eb3175 100644 --- a/ipi/inputs/forcefields.py +++ b/ipi/inputs/forcefields.py @@ -768,7 +768,7 @@ class InputFFCommittee(InputForceField): ) def store(self, ff): - """ Store all the sub-forcefields """ + """Store all the sub-forcefields""" super(InputFFCommittee, self).store(ff) _fflist = ff.fflist @@ -815,7 +815,7 @@ def store(self, ff): self.extra[_ii][1].store(_obj) def fetch(self): - """ Fetches all of the FF objects """ + """Fetches all of the FF objects""" super(InputFFCommittee, self).fetch() diff --git a/ipi/inputs/motion/motion.py b/ipi/inputs/motion/motion.py index 128097aaf..f2dc9f874 100755 --- a/ipi/inputs/motion/motion.py +++ b/ipi/inputs/motion/motion.py @@ -396,7 +396,7 @@ def fetch(self): class InputMotion(InputMotionBase): - """ Extends InputMotionBase to allow the definition of a multimotion """ + """Extends InputMotionBase to allow the definition of a multimotion""" attribs = copy(InputMotionBase.attribs) diff --git a/ipi/inputs/normalmodes.py b/ipi/inputs/normalmodes.py index e95a8ae9c..d7ded046d 100644 --- a/ipi/inputs/normalmodes.py +++ b/ipi/inputs/normalmodes.py @@ -19,7 +19,7 @@ class InputNMFrequencies(InputArray): - """ Storage class for NormalModes engine. """ + """Storage class for NormalModes engine.""" attribs = copy(InputArray.attribs) attribs["style"] = ( diff --git a/ipi/inputs/smotion/smotion.py b/ipi/inputs/smotion/smotion.py index ca5c17371..eb2709b42 100644 --- a/ipi/inputs/smotion/smotion.py +++ b/ipi/inputs/smotion/smotion.py @@ -115,7 +115,7 @@ def fetch(self): class InputSmotion(InputSmotionBase): - """ Extends InputSmotionBase to allow the definition of a multismotion """ + """Extends InputSmotionBase to allow the definition of a multismotion""" attribs = copy(InputSmotionBase.attribs) diff --git a/ipi/inputs/thermostats.py b/ipi/inputs/thermostats.py index 0f797f422..7584b09d1 100644 --- a/ipi/inputs/thermostats.py +++ b/ipi/inputs/thermostats.py @@ -325,7 +325,7 @@ def check(self): class InputThermo(InputThermoBase): - """ Extends InputThermoBase to allow the definition of a multithermo """ + """Extends InputThermoBase to allow the definition of a multithermo""" attribs = copy(InputThermoBase.attribs) diff --git a/ipi/utils/constrtools.py b/ipi/utils/constrtools.py index 4d3f0aea1..d8e023428 100644 --- a/ipi/utils/constrtools.py +++ b/ipi/utils/constrtools.py @@ -124,7 +124,7 @@ def bind(self, beads): ) def gfunc(self): - """ Calculates the value of the constraint(s) """ + """Calculates the value of the constraint(s)""" raise NotImplementedError() def Dgfunc(self): @@ -159,7 +159,7 @@ def GCfunc(self): class ValueConstraintBase(ConstraintBase): - """ Base class for a constraint that contains target values. """ + """Base class for a constraint that contains target values.""" def __init__(self, constrained_indices, constraint_values, ncons): """Initialize the constraint. diff --git a/ipi/utils/depend.py b/ipi/utils/depend.py index d216ac955..ecdff85de 100644 --- a/ipi/utils/depend.py +++ b/ipi/utils/depend.py @@ -180,7 +180,7 @@ def __init__( self.taint(taintme=tainted) def __deepcopy__(self, memo): - """ Overrides deepcopy behavior, to avoid copying the (uncopiable) RLOCK """ + """Overrides deepcopy behavior, to avoid copying the (uncopiable) RLOCK""" newone = type(self)(None) @@ -192,11 +192,11 @@ def __deepcopy__(self, memo): return newone def hold(self): - """ Sets depend object as on hold. """ + """Sets depend object as on hold.""" self._active[:] = False def resume(self): - """ Sets depend object as active again. """ + """Sets depend object as active again.""" self._active[:] = True if self._func is None: self.taint(taintme=False) @@ -204,7 +204,7 @@ def resume(self): self.taint(taintme=True) def add_synchro(self, synchro=None): - """ Links depend object to a synchronizer. """ + """Links depend object to a synchronizer.""" assert ( self._synchro is None @@ -909,7 +909,7 @@ class ddirect(object): depend_base members.""" def __init__(self, dobj): - """ Just stores a reference to the dobject we want to access """ + """Just stores a reference to the dobject we want to access""" object.__setattr__(self, "dobj", dobj) diff --git a/ipi/utils/inputvalue.py b/ipi/utils/inputvalue.py index e01732719..648fa35ec 100644 --- a/ipi/utils/inputvalue.py +++ b/ipi/utils/inputvalue.py @@ -770,7 +770,7 @@ class InputDictionary(Input): def __init__( self, help=None, default=None, dtype=str, options=None, dimension=None ): - """Allows one to introduce additional (homogeneous) fields during initialization """ + """Allows one to introduce additional (homogeneous) fields during initialization""" if hasattr(options, "__len__"): self.instancefields = {} diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index d7ff92f6f..1029c472c 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -220,7 +220,7 @@ def get_imvector(h, m3): def print_instanton_geo( prefix, step, nbeads, natoms, names, q, f, pots, cell, shift, output_maker ): - """ Alternative (but very useful) output of the instanton geometry and potential energy """ + """Alternative (but very useful) output of the instanton geometry and potential energy""" outfile = output_maker.get_output(prefix + "_" + str(step) + ".ener", "w") print("#Bead Energy (eV)", file=outfile) @@ -286,14 +286,14 @@ def print_instanton_geo( def print_instanton_hess(prefix, step, hessian, output_maker): - """ Print physical part of the instanton hessian """ + """Print physical part of the instanton hessian""" outfile = output_maker.get_output(prefix + ".hess_" + str(step), "w") np.savetxt(outfile, hessian.reshape(1, hessian.size)) outfile.close_stream() def ms_pathway(pos, m3): - """ Compute mass scaled pathway """ + """Compute mass scaled pathway""" dx = list() path = np.zeros(pos.shape[0]) for i in range(1, pos.shape[0]): diff --git a/ipi/utils/io/io_units.py b/ipi/utils/io/io_units.py index 6874c6cdb..1c31f334d 100755 --- a/ipi/utils/io/io_units.py +++ b/ipi/utils/io/io_units.py @@ -29,7 +29,7 @@ def auto_units( cell_units="automatic", mode="xyz", ): - """ Processes comment line and requested units to determine how to interpret the I/O conversion. """ + """Processes comment line and requested units to determine how to interpret the I/O conversion.""" # heuristics to detect units if mode == "pdb": # these are the default units auto_cell = "angstrom" diff --git a/ipi/utils/mathtools.py b/ipi/utils/mathtools.py index 9acbeaf7a..e89a0227d 100644 --- a/ipi/utils/mathtools.py +++ b/ipi/utils/mathtools.py @@ -411,7 +411,7 @@ def root_herm(A): def _sinch(x): - """ Computes sinh(x)/x in a way that is stable for x->0 """ + """Computes sinh(x)/x in a way that is stable for x->0""" x2 = x * x if x2 < 1e-12: diff --git a/ipi/utils/nmtransform.py b/ipi/utils/nmtransform.py index 252ef67b7..6e08bece5 100644 --- a/ipi/utils/nmtransform.py +++ b/ipi/utils/nmtransform.py @@ -141,10 +141,10 @@ def mk_o_rs_matrix(nb1, nb2): class nm_noop(object): - """ A no-op NM transformation for classical trajectories """ + """A no-op NM transformation for classical trajectories""" def __init__(self, nbeads, open_paths=None): - """Initializes nm_noop. """ + """Initializes nm_noop.""" if nbeads > 1: raise ValueError( "Shouldn't use a noop transformation for ring-polymer systems " diff --git a/ipi/utils/softexit.py b/ipi/utils/softexit.py index e0e96a38f..7e0eb4749 100644 --- a/ipi/utils/softexit.py +++ b/ipi/utils/softexit.py @@ -158,7 +158,7 @@ def _kill_handler(self, signal, frame): self._kill[signal](signal, frame) def _softexit_monitor(self): - """Keeps checking for soft exit conditions. """ + """Keeps checking for soft exit conditions.""" while self._doloop[0]: time.sleep(SOFTEXITLATENCY) diff --git a/ipi_tests/examples/exampletools.py b/ipi_tests/examples/exampletools.py index 989f12688..98b349ed8 100644 --- a/ipi_tests/examples/exampletools.py +++ b/ipi_tests/examples/exampletools.py @@ -36,7 +36,7 @@ class Runner_examples(Runner): """ def __init__(self, parent, call_ipi="i-pi new.xml"): - """ Store parent directory and commands to call i-pi """ + """Store parent directory and commands to call i-pi""" self.parent = parent self.call_ipi = call_ipi diff --git a/ipi_tests/test_tools.py b/ipi_tests/test_tools.py index 975c43631..eb7b8736d 100644 --- a/ipi_tests/test_tools.py +++ b/ipi_tests/test_tools.py @@ -155,7 +155,7 @@ def modify_xml_4_dummy_test( driver_info, test_settings, ): - """ Modify xml to run dummy tests """ + """Modify xml to run dummy tests""" try: tree = ET.parse(input_name) except: From 113cbc93824044c9eb9786b374c9a6b37da20464 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 28 Apr 2021 16:14:47 +0200 Subject: [PATCH 070/120] add harmonic_bath --- drivers/f90/Makefile | 4 +- drivers/f90/pes/harmonic_bath.f90 | 125 ++++++++++++++++++++++++++++++ 2 files changed, 127 insertions(+), 2 deletions(-) create mode 100644 drivers/f90/pes/harmonic_bath.f90 diff --git a/drivers/f90/Makefile b/drivers/f90/Makefile index 4f2eb1e15..c4e308eb2 100644 --- a/drivers/f90/Makefile +++ b/drivers/f90/Makefile @@ -27,8 +27,8 @@ CFLAGS=$(FLAGS) FFLAGS=$(FLAGS) -ffree-line-length-none -ffixed-line-length-none -Wno-maybe-uninitialized #FFLAGS=-g -O0 -fcheck=all -Wall -pedantic -ffree-line-length-none -MODULES=distance.f90 LJ.f90 SG.f90 pes/pswater.f90 pes/LEPS.f90 LJPolymer.f90 pes/efield.f90 pes/eckart.f90 pes/doublewell.f90 pes/doublewell_1D.f90 pes/MB.f90 -PES=pes/zundel.f pes/morse.f pes/qtip4pf.f pes/utility.f pes/ch52008.f pes/harmonic_bath.f90 +MODULES=distance.f90 LJ.f90 SG.f90 pes/pswater.f90 pes/LEPS.f90 LJPolymer.f90 pes/efield.f90 pes/eckart.f90 pes/doublewell.f90 pes/doublewell_1D.f90 pes/MB.f90 pes/harmonic_bath.f90 +PES=pes/zundel.f pes/morse.f pes/qtip4pf.f pes/utility.f pes/ch52008.f OBJECTS=$(MODULES:%.f90=%.o) $(PES:%.f=%.o) FC=gfortran CC=gcc diff --git a/drivers/f90/pes/harmonic_bath.f90 b/drivers/f90/pes/harmonic_bath.f90 new file mode 100644 index 000000000..5edb0a24c --- /dev/null +++ b/drivers/f90/pes/harmonic_bath.f90 @@ -0,0 +1,125 @@ +!Harmonic bath + +! V(q,x1,..,xn) = sum_1^(nat-1) [ 0.5 m omega_i^2(q - (c_i s(q))/(m omega_i)^2)^2 ] +! s(q) = q *sd(q) +! sd(q) = [1+eps exp( (q-0)^2 / (2deltaQ^2) ) ] + delta tanh(q/deltaQ) +! If eps=delta=0 then sd(q) =1 and s(q) = q + + + SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,eps,delta,deltaQ,q,pot,force) + IMPLICIT NONE + integer :: nat, i + real(kind=8),PARAMETER :: pi= 3.141592653589793D0 + real(kind=8) :: bath_type,friction,omega_c,mass + real(kind=8) :: eps,delta,deltaQ,S,dSD_dq + real(kind=8) :: A,B + real(kind=8) :: q(nat*3),pot,force(nat*3),x(nat*3-1) + real(kind=8) :: c(nat*3-1),omega(nat*3-1), omega2(nat*3-1),aux + mass = 1837.36223469 + pot = 0.0 + A = -0.00476705894242374 + B = 0.0005980249683218661 + + DO i = 1, 3*nat -1 + x(i) = q(i+1) + ENDDO + + !Get omega and c_i + IF (IDINT(bath_type) .EQ. 1 ) THEN !Ohmic + DO i = 1, 3*nat -1 + omega(i) = - omega_c * LOG( (i - 0.5 ) / (3*nat-1) ) + omega2(i) = omega(i)**2 + c(i) = omega(i) * ( ( 2 * friction * mass *omega_c) / ( (3*nat-1) * pi ) )**0.5 + ENDDO + END IF + + !SYSTEM + pot = A * (q(1) ** 2) + B * (q(1) ** 4) + force(1) = - ( 2 * A * (q(1)) + 4 * B * (q(1) ** 3) ) + + !BATH + DO i = 1,3*nat-1 + aux = x(i) - ( c(i)*S(q(1),eps,delta,deltaQ) / ( mass*omega2(i) ) ) + + pot = pot + 0.5 * mass * omega2(i) * aux **2 + + force(1) = force(1) + aux * c(i)*dSD_dq(q(1),eps,delta,deltaQ) + force(i+1) = -mass * omega2(i) * aux + + + ENDDO + + return + end + + REAL*8 FUNCTION SD(q,eps,delta,deltaQ) + IMPLICIT NONE + real(kind=8), intent(in) :: q,eps,delta,deltaQ ! q system position + real(kind=8) :: dx + + dx = q / deltaQ + SD = 1.0 + eps*DEXP(-0.5 * (dx**2) ) + delta*DTANH(dx) + END FUNCTION SD + + REAL*8 FUNCTION S(q,eps,delta,deltaQ) + IMPLICIT NONE + real(kind=8), intent(in) :: q,eps,delta,deltaQ + real(kind=8) :: SD + S = q* SD(q,eps,delta,deltaQ) + END FUNCTION S + + REAL*8 FUNCTION dSD_dq(q,eps,delta,deltaQ) + IMPLICIT NONE + real(kind=8), intent(in) :: q,eps,delta,deltaQ + real(kind=8) :: dx,dsddq1,dsddq2,SD + dx = q / deltaQ + dsddq1 = eps*DEXP(-0.5 * (dx**2))*(-dx/deltaQ) + dsddq2 = delta* (1- DTANH(DX)**2) / deltaQ + dSD_dq = q *(dsddq1 + dsddq2) + SD(q,eps,delta,deltaQ) + + END FUNCTION dSD_dq + + SUBROUTINE get_meanfield_harmonic_bath(nat,eta,eps,delta,deltaQ,q,pot,force,friction) + IMPLICIT NONE + integer :: nat, i + real(kind=8) :: A,B,k,eta + real(kind=8) :: eps,delta,deltaQ,dSD_dq + real(kind=8) :: x,y,z,fx,fy,fz + real(kind=8) :: q(nat,3),pot,force(nat,3) + real(kind=8) :: friction(3*nat,3*nat) + + k = 1836*(3800.0d0/219323d0)**2 + + A = -0.00476705894242374 + B = 0.0005980249683218661 + + DO i = 1,nat + x = q(i,1) + y = q(i,2) + z = q(i,3) + + pot = 0.0 + + pot = pot+ 0.5*k*y**2 + fy = -k*y + pot = pot+ 0.5*k*z**2 + fz = -k*z + + pot = pot + A * (x ** 2) + B * (x ** 4) + + + fx = - ( 2 * A * (x) + 4 * B * (x ** 3) ) + + force(i,1) = fx + force(i,2) = fy + force(i,3) = fz + + friction(nat*3*(i-1)+1,nat*3*(i-1)+1) = eta * (dSD_dq(x,eps,delta,deltaQ) )**2 + friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = eta * (dSD_dq(y,eps,delta,deltaQ) )**2 + friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = eta * (dSD_dq(z,eps,delta,deltaQ) )**2 + + ENDDO + + return + end + From 14492346e76d67c839bdf502834b0ac411f183fc Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 5 May 2021 14:00:48 +0200 Subject: [PATCH 071/120] update driver.py --- drivers/py/driver.py | 1 + drivers/py/pes/.doublewell.py.swp | Bin 12288 -> 0 bytes drivers/py/pes/__init__.py | 7 ++- drivers/py/pes/doublewell.py | 97 ++++++++++++++++++++++++++++-- drivers/py/pes/harmonic.py | 2 +- 5 files changed, 99 insertions(+), 8 deletions(-) delete mode 100644 drivers/py/pes/.doublewell.py.swp diff --git a/drivers/py/driver.py b/drivers/py/driver.py index 6b615628f..660fa675c 100755 --- a/drivers/py/driver.py +++ b/drivers/py/driver.py @@ -3,6 +3,7 @@ import argparse import numpy as np + try: from pes import * except ImportError: diff --git a/drivers/py/pes/.doublewell.py.swp b/drivers/py/pes/.doublewell.py.swp deleted file mode 100644 index e73b77d4c2c14e9ba0aa23477a320011ad46795d..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 12288 zcmeHN&2Jk;6rWb5d=^kS!r@^bx=!uQ`Xgx?$%mu~q9wGINE1-gx*L03ud-k4>?Sq` z;DjjR!U6t-UJwV=3kA{MLE_E@5CS23284u=_|2?$H)+!#ax0pVe%_sVZ{EE3oA+jI zdDpF#(=XGEX)&~?8N0!+U77vrV|M5YW3Cf>wm-6^Xs;%0H{MI0$==KiPM!*STueH( z(3yN?ZvOOKdfSVfO&*EKa5Nc0+zXO*mv3>`HN#P6Ltixmnt}Z?aD+7*bye!+()0Ap z(F^-Eq~~b{Gy|Fe&46Y=GoTsJ3}^;40}mhrad?2e1-}oDeLpk49=Pi|?&^zXKr^5j z&Gy|Fe&46Y=GoTsJ3}^;40}mhrc8{?;hZr*t!+HGwpZ)&-`6f-SNydHyZUCPG2`~lxeT1>UfZM<=;7i~mKmZYN0J!}GYys~A4)82+=W)iq z0p0;#1x^4Z;4tv#V~qU*+yLGO)`642bHE>uGWH{I6Zj1H09XSq0yDr-;2`kBBaD3k zd=7j9yaqf3{Q59s-vi$PUjrWk9iRz33>*e-fuHNZ+rSEN0g#;40NpeLngPwg|DORG zw}{6{2B@x+T6BE>^m?H6v z?WF8E3(M{{t4uH2kr((*w}`8-Nod)!mNL-Hy(}Vv1kpFZ;T1%toaW}Rr z=(P&fd8wM)97nEV-rIKLnl^_m^_Mt zsN;#Ng+Zyuhg}}Vvur#kzo^C3UP_Ma$o4Kai{#DJyj)ZED?PP|0A@bwq4HeMDQM+ifrfVF+rQQo8Txj&X{y+z&(@B53t!(Z#1f8&9v&)G>$9FnkvF{`bG4T zv{I>vQN_2B1|pNrXwF#j$eg4`{baMzG%b~ujoc|&2rndlH+BM_;(;Agcfh+F0{5K2 zZ{nda1V#My#EIZ`98i=y;!~|7&W((PgCi-qgaxVM@CV2ozzCUofWgwaeOC6 zy{V1OeGEtO0N$m#cwLxk-uB|H1tjTLn6+gKU1|8uKPuUMG3VhpQD>nctxP=)hf9a7!|#x6G|jA1Q(FkF@gI$Gf) z4KKI$v91TJ(l+Ma74yQm3-e2hw7R&oMCZ>fFP>dKJ-1Y>x62)VaE{L=xSk-JgegBe zae&;4dF0!!QR>Td=6-ins!|F1crTrIJ#^}*56L?oHiE~UFv6T5l(m89PQ<&8z-_zU zLc%5?283uYM+vXS1NrSIaC_}zzU?2Yx{lAcoL)R=*DXt$>_>q|PUx6P?6`s)FAQ+_ sDgW5G<0l?c8(&)dFjY5uG9fbE?b(q{!D9hGqEW%wcY Date: Wed, 12 May 2021 14:22:26 +0200 Subject: [PATCH 072/120] small bugfix and remove debug flags here and there --- drivers/f90/pes/harmonic_bath.f90 | 8 ++-- ipi/engine/motion/instanton.py | 64 +++++++++++-------------------- ipi/utils/hesstools.py | 13 ++++--- 3 files changed, 35 insertions(+), 50 deletions(-) diff --git a/drivers/f90/pes/harmonic_bath.f90 b/drivers/f90/pes/harmonic_bath.f90 index 5edb0a24c..1b5ee2d60 100644 --- a/drivers/f90/pes/harmonic_bath.f90 +++ b/drivers/f90/pes/harmonic_bath.f90 @@ -42,7 +42,6 @@ SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,eps,delta,deltaQ,q,p aux = x(i) - ( c(i)*S(q(1),eps,delta,deltaQ) / ( mass*omega2(i) ) ) pot = pot + 0.5 * mass * omega2(i) * aux **2 - force(1) = force(1) + aux * c(i)*dSD_dq(q(1),eps,delta,deltaQ) force(i+1) = -mass * omega2(i) * aux @@ -58,7 +57,8 @@ REAL*8 FUNCTION SD(q,eps,delta,deltaQ) real(kind=8) :: dx dx = q / deltaQ - SD = 1.0 + eps*DEXP(-0.5 * (dx**2) ) + delta*DTANH(dx) + SD = 1.0 + eps*DEXP(-0.5 * (dx**2) ) + delta*DTANH(dx) + !write(6,*) 'ALBERTO', 1,eps, dx, DEXP(-0.5 * (dx**2) ), eps*DEXP(-0.5 * (dx**2) ) END FUNCTION SD REAL*8 FUNCTION S(q,eps,delta,deltaQ) @@ -115,8 +115,8 @@ SUBROUTINE get_meanfield_harmonic_bath(nat,eta,eps,delta,deltaQ,q,pot,force,fric force(i,3) = fz friction(nat*3*(i-1)+1,nat*3*(i-1)+1) = eta * (dSD_dq(x,eps,delta,deltaQ) )**2 - friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = eta * (dSD_dq(y,eps,delta,deltaQ) )**2 - friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = eta * (dSD_dq(z,eps,delta,deltaQ) )**2 + friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = 0 !eta * (dSD_dq(y,eps,delta,deltaQ) )**2 + friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = 0 !eta * (dSD_dq(z,eps,delta,deltaQ) )**2 ENDDO diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index cd3fe6133..8fbfbf736 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -3,9 +3,6 @@ Algorithms implemented by Yair Litman and Mariana Rossi, 2017 """ -debug = True -debug = False -test_factor = 1 # This file is part of i-PI. # i-PI Copyright (C) 2014-2015 i-PI developers # See the "licenses" directory for full license information. @@ -436,17 +433,7 @@ def bind(self, mapper): def save(self, e, g, eta=None): """Stores potential and forces in this class for convenience""" super(FrictionMapper, self).save(e, g) - # ALBERTO: CLEAN THE MASS UNSCALING - self.eta = eta * test_factor - if debug: - for i in range(self.dbeads.nbeads): - self.eta[i] = np.eye(self.dbeads.natoms * 3) - # print('mass scaling ALBERTO') - # for e in self.eta: - # m=self.dbeads.m3[0][:,np.newaxis] - # e[:] =(e/m**-0.5)/m.T**-0.5 #Mass unscale - # ALBERTO - # print(self.eta[0]) + self.eta = eta def initialize(self, q, forces): """Initialize potential, forces and friction""" @@ -492,10 +479,7 @@ def set_z_friction(self, z_friction): ) z_friction = spline(self.omegak) - # z_friction = z_friction /1.6743276# / z_friction[1] # UPDATE HERE WHEN AIMS IMPLEMENTATION IS READY - if debug: - z_friction = self.dbeads.m3[0, 0] * self.omegak - self.z_k = np.multiply(self.omegak, z_friction)[:, np.newaxis] / test_factor + self.z_k = np.multiply(self.omegak, z_friction)[:, np.newaxis] info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) @@ -548,9 +532,6 @@ def get_fric_rp_hessian(self, fric_hessian, eta, SD): def obtain_g(self, s): """Computes g from s""" - if debug: - return self.dbeads.q.copy() - nphys = self.dbeads.natoms * 3 ss = np.zeros(s.shape) @@ -872,9 +853,6 @@ def initialize(self, q, forces): e2, g2 = self.sm(q) g = self.fix.get_active_vector(g1 + g2, 1) e = np.sum(e1 + e2) - if debug: - g = self.fix.get_active_vector(g1, 1) - e = np.sum(e1) self.save(e, g) @@ -923,9 +901,6 @@ def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): e2, g2 = self.gm(x, new_disc) e = e1 + e2 g = np.add(g1, g2) - if debug: - e = e2 - g = g2 elif mode == "physical": e, g = self.gm(x, new_disc) @@ -1153,8 +1128,10 @@ def exitstep(self, d_x_max, step): if self.options["friction"] and self.options["frictionSD"]: friction_hessian = current_hessian[1] - # self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) - self.optarrays["fric_hessian"][:] = friction_hessian + print('alberto2') + print(np.amax(friction_hessian),np.amin(friction_hessian)) + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) + #self.optarrays["fric_hessian"][:] = friction_hessian #ALBERTO print_instanton_hess( self.options["prefix"] + "fric_FINAL", step, @@ -1167,8 +1144,8 @@ def exitstep(self, d_x_max, step): else: phys_hessian = current_hessian - # self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) - self.optarrays["hessian"][:] = phys_hessian + self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + #self.optarrays["hessian"][:] = phys_hessian #ALBERTO print_instanton_hess( self.options["prefix"] + "_FINAL", @@ -1387,14 +1364,13 @@ def initialize(self, step): ) if self.options["friction"] and self.options["frictionSD"]: phys_hessian = active_hessian[0] - friction_hessian = active_hessian[1] - self.optarrays["fric_hessian"][:] = friction_hessian[:] + friction_hessian = active_hessian[1] #ALBERTO + self.optarrays["fric_hessian"][:] = friction_hessian[:] #ALBERTO else: phys_hessian = active_hessian - print("Check phys_hessian") - # self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) - self.optarrays["hessian"][:] = phys_hessian + self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + #self.optarrays["hessian"][:] = phys_hessian self.update_old_pos_for() @@ -1411,9 +1387,10 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): dg = d_g[j, :] dx = d_x[j, :] Powell(dx, dg, aux) + phys_hessian = active_hessian if self.options["friction"]: info( - "powell update for friction hessian is not implemented", + "Powell update for friction hessian is not implemented. We move on without updating it. In all tested cases this is not a problem", verbosity.medium, ) @@ -1436,7 +1413,7 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): else: phys_hessian = active_hessian - self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) + self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) def print_hess(self, step): if ( @@ -1448,6 +1425,14 @@ def print_hess(self, step): self.optarrays["hessian"], self.output_maker, ) + if self.options["friction"]: + print_instanton_hess( + self.options["prefix"]+'_fric', + step, + self.optarrays["fric_hessian"], + self.output_maker, + ) + def post_step(self, step, new_x, d_x, activearrays): """General tasks that have to be performed after finding the new step""" @@ -1496,9 +1481,6 @@ def step(self, step=None): # Add spring terms to the physical hessian h = np.add(self.mapper.sm.h, h0) - if debug: - h = h0 - # Add friction terms to the hessian if self.options["friction"]: print("ALBERTO clean here gm call") diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 785d7d826..4c0d59812 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -260,24 +260,27 @@ def get_hessian( ) x = x0.copy() + #PLUS x[:, j] = x0[:, j] + d e, f1 = gm(x, new_disc) if friction: eta1 = gm.eta + + #Minus x[:, j] = x0[:, j] - d + e, f2 = gm(x, new_disc) if friction: eta2 = gm.eta - e, f2 = gm(x, new_disc) - g = (f1 - f2) / (2 * d) - if friction: - eta_h[:, :, :, j] = (eta1 - eta2) / (2 * d) + #COMBINE + g = (f1 - f2) / (2 * d) h[j, :] = g.flatten() - f = open("hessian_" + str(j) + ".tmp", "w") np.savetxt(f, h) f.close() + if friction: + eta_h[:, :, :, j] = (eta1 - eta2) / (2 * d) f = open("hessianEta_" + str(j) + ".tmp", "w") np.savetxt(f, eta_h.flatten()) f.close() From e22c7b89bde96eea53862a590e5672d81c7fe988 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 12 May 2021 14:23:35 +0200 Subject: [PATCH 073/120] black --- drivers/py/pes/doublewell.py | 27 ++++++++++++--------------- drivers/py/pes/harmonic.py | 2 +- ipi/engine/motion/instanton.py | 29 +++++++++++++++-------------- ipi/utils/hesstools.py | 6 +++--- 4 files changed, 31 insertions(+), 33 deletions(-) diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 0d0fb5bb0..38f6a28de 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -39,12 +39,12 @@ def check_arguments(self): else: try: arglist = self.args.split(",") - param = list(map(float, arglist )) + param = list(map(float, arglist)) assert len(param) == 4 w_b = param[0] * invcm2au v0 = param[1] * invcm2au m = param[2] - self.delta = param[3]*A2au + self.delta = param[3] * A2au except: sys.exit(self.error_msg) @@ -77,17 +77,14 @@ def __call__(self, cell, pos): return pot, force, vir, extras - - - class DoubleWell_with_friction_driver(DoubleWell_driver): - """ Adds to the double well potential the calculation of the friction tensor. + """Adds to the double well potential the calculation of the friction tensor. - friction(q) = eta0 [\partial sd(q) \partial q ]^2 - with - q = position, and - sd(q) = [1+eps1 exp( (q-0)^2 / (2deltaQ^2) ) ] + eps2 tanh(q/deltaQ) - """ + friction(q) = eta0 [\partial sd(q) \partial q ]^2 + with + q = position, and + sd(q) = [1+eps1 exp( (q-0)^2 / (2deltaQ^2) ) ] + eps2 tanh(q/deltaQ) + """ def __init__(self, args=None): @@ -108,7 +105,7 @@ def check_arguments(self): w_b = param[0] * invcm2au v0 = param[1] * invcm2au m = param[2] - self.delta = param[3]*A2au + self.delta = param[3] * A2au self.eta0 = param[4] self.eps1 = param[5] self.eps2 = param[6] @@ -123,13 +120,13 @@ def check_dimensions(self, pos): """Functions that checks dimensions of the received position""" assert pos.shape == (1, 3) - def SD(self,q): + def SD(self, q): """Auxiliary function to compute friction tensor""" dx = q / self.deltaQ SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx ** 2)) + self.eps2 * np.tanh(dx) return SD - def dSD_dq(self,q): + def dSD_dq(self, q): """Auxiliary function to compute friction tensor""" dx = q / self.deltaQ dsddq1 = self.eps1 * np.exp(-0.5 * (dx ** 2)) * (-dx / self.deltaQ) @@ -138,7 +135,7 @@ def dSD_dq(self,q): return dSD_dq - def get_friction_tensor(self,pos): + def get_friction_tensor(self, pos): """Function that computes spatially dependent friction tensor""" self.check_dimensions(pos) diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index 21fabee54..65e58c2c4 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -31,7 +31,7 @@ def __call__(self, cell, pos): """Silly harmonic potential""" if self.type == "isotropic": pot = 0.5 * self.k * (pos ** 2).sum() - force = -self.k * pos + force = -self.k * pos vir = cell * 0.0 # makes a zero virial with same shape as cell extras = "nada" else: diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 8fbfbf736..87f774ca8 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -433,7 +433,7 @@ def bind(self, mapper): def save(self, e, g, eta=None): """Stores potential and forces in this class for convenience""" super(FrictionMapper, self).save(e, g) - self.eta = eta + self.eta = eta def initialize(self, q, forces): """Initialize potential, forces and friction""" @@ -1128,10 +1128,12 @@ def exitstep(self, d_x_max, step): if self.options["friction"] and self.options["frictionSD"]: friction_hessian = current_hessian[1] - print('alberto2') - print(np.amax(friction_hessian),np.amin(friction_hessian)) - self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) - #self.optarrays["fric_hessian"][:] = friction_hessian #ALBERTO + print("alberto2") + print(np.amax(friction_hessian), np.amin(friction_hessian)) + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( + friction_hessian, 4 + ) + # self.optarrays["fric_hessian"][:] = friction_hessian #ALBERTO print_instanton_hess( self.options["prefix"] + "fric_FINAL", step, @@ -1145,7 +1147,7 @@ def exitstep(self, d_x_max, step): phys_hessian = current_hessian self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) - #self.optarrays["hessian"][:] = phys_hessian #ALBERTO + # self.optarrays["hessian"][:] = phys_hessian #ALBERTO print_instanton_hess( self.options["prefix"] + "_FINAL", @@ -1364,13 +1366,13 @@ def initialize(self, step): ) if self.options["friction"] and self.options["frictionSD"]: phys_hessian = active_hessian[0] - friction_hessian = active_hessian[1] #ALBERTO - self.optarrays["fric_hessian"][:] = friction_hessian[:] #ALBERTO + friction_hessian = active_hessian[1] # ALBERTO + self.optarrays["fric_hessian"][:] = friction_hessian[:] # ALBERTO else: phys_hessian = active_hessian self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) - #self.optarrays["hessian"][:] = phys_hessian + # self.optarrays["hessian"][:] = phys_hessian self.update_old_pos_for() @@ -1427,12 +1429,11 @@ def print_hess(self, step): ) if self.options["friction"]: print_instanton_hess( - self.options["prefix"]+'_fric', - step, - self.optarrays["fric_hessian"], - self.output_maker, + self.options["prefix"] + "_fric", + step, + self.optarrays["fric_hessian"], + self.output_maker, ) - def post_step(self, step, new_x, d_x, activearrays): """General tasks that have to be performed after finding the new step""" diff --git a/ipi/utils/hesstools.py b/ipi/utils/hesstools.py index 4c0d59812..8a617936f 100644 --- a/ipi/utils/hesstools.py +++ b/ipi/utils/hesstools.py @@ -260,19 +260,19 @@ def get_hessian( ) x = x0.copy() - #PLUS + # PLUS x[:, j] = x0[:, j] + d e, f1 = gm(x, new_disc) if friction: eta1 = gm.eta - #Minus + # Minus x[:, j] = x0[:, j] - d e, f2 = gm(x, new_disc) if friction: eta2 = gm.eta - #COMBINE + # COMBINE g = (f1 - f2) / (2 * d) h[j, :] = g.flatten() f = open("hessian_" + str(j) + ".tmp", "w") From 280a431170d6ca8395445976177e7121f220a0aa Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 13 May 2021 14:10:09 +0200 Subject: [PATCH 074/120] Change input for frequency dependence from LT to Jw/w --- ipi/engine/motion/instanton.py | 73 ++++++++++++++++++++++------------ ipi/inputs/motion/instanton.py | 16 ++++++-- ipi/utils/mathtools.py | 33 ++++++++++++++- 3 files changed, 93 insertions(+), 29 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 29ed06cce..dcf2e0583 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -37,7 +37,6 @@ from ipi.utils.instools import print_instanton_hess, diag_banded, ms_pathway from ipi.utils.hesstools import get_hessian, clean_hessian, get_dynmat - __all__ = ["InstantonMotion"] @@ -113,7 +112,8 @@ def __init__( friction=False, frictionSD=True, eta=np.eye(0, 0, 0, float), - z_friction=np.zeros(0, float), + fric_spec_dens=np.zeros(0, float), + fric_spec_dens_ener=0.0, ): """Initialises InstantonMotion.""" @@ -142,7 +142,8 @@ def __init__( else: self.options["frictionSD"] = frictionSD - self.options["z_friction"] = z_friction + self.options["fric_spec_dens"] = fric_spec_dens + self.options["fric_spec_dens_ener"] = fric_spec_dens_ener self.optarrays = {} # Optimization arrays self.optarrays["big_step"] = biggest_step @@ -458,24 +459,44 @@ def check_eta(self, eta): warnings.filterwarnings("error") try: self.sqrtm( - eta[i] + np.eye(self.dbeads.natoms * 3) * 0.0001 + eta[i] + np.eye(self.dbeads.natoms * 3) * 0.000000000001 ) # dgdq = s ** 0.5 -> won't work for multiD except Warning: print(eta[i]) softexit.trigger("The provided friction is not positive definite") - def set_z_friction(self, z_friction): - """Sets the scaling factors corresponding to frequency dependence of the friction""" + def set_fric_spec_dens(self, fric_spec_dens_data, fric_spec_dens_ener): + """Computes and sets the laplace transform of the friction tensor""" + from ipi.utils.mathtools import LT_friction # from scipy.interpolate import interp1d + if len(fric_spec_dens_data) == 0: + LT_fric_spec_dens = np.ones((1000, 2)) + LT_fric_spec_dens[:, 0] = np.arange(1000) + else: + invcm2au = units.unit_to_internal("frequency", "inversecm", 1) + + # We perform the spline in inversecm for numerical reasons + freq = fric_spec_dens_data[:, 0] / invcm2au + spline = self.interp1d( + freq, + fric_spec_dens_data[:, 1], + kind="cubic", + fill_value=0.0, + bounds_error=False, + ) + fric_spec_dens = spline(self.omegak / invcm2au) - freq = units.unit_to_internal("frequency", "inversecm", z_friction[:, 0]) - spline = self.interp1d( - freq, z_friction[:, 1], kind="cubic", fill_value=0.0, bounds_error=False - ) + if fric_spec_dens_ener == 0 or fric_spec_dens_ener < freq[0]: + norm = 1.0 # spline(freq[0])*freq[0]*invcm2au + elif fric_spec_dens_ener > freq[-1]: + norm = 1.0 # spline(freq[-1])*freq[-10]*invcm2au + else: + norm = spline(fric_spec_dens_ener / invcm2au) * fric_spec_dens_ener + + LT_fric_spec_dens = LT_friction(self.omegak / invcm2au, spline) / norm - z_friction = spline(self.omegak) - self.z_k = np.multiply(self.omegak, z_friction)[:, np.newaxis] + self.fric_LTwk = np.multiply(self.omegak, LT_fric_spec_dens)[:, np.newaxis] info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) @@ -491,7 +512,7 @@ def get_fric_rp_hessian(self, fric_hessian, eta, SD): dgdq = np.zeros(s.shape) for i in range(nbeads): - dgdq[i] = self.sqrtm(s[i] + np.eye(nphys) * 0.0001) + dgdq[i] = self.sqrtm(s[i] + np.eye(nphys) * 0.000000000001) h_fric = np.zeros((ndof, ndof)) @@ -499,7 +520,7 @@ def get_fric_rp_hessian(self, fric_hessian, eta, SD): if SD: gq = self.obtain_g(s) gq_k = np.dot(self.C, gq) - prefactor = np.dot(self.C.T, self.z_k * gq_k) + prefactor = np.dot(self.C.T, self.fric_LTwk * gq_k) for n in range(self.dbeads.nbeads): for j in range(nphys): for k in range(nphys): @@ -518,7 +539,9 @@ def get_fric_rp_hessian(self, fric_hessian, eta, SD): for ne in range(nbeads): prefactor = 0 for alpha in range(nbeads): - prefactor += self.C[alpha, nl] * self.C[alpha, ne] * self.z_k[alpha] + prefactor += ( + self.C[alpha, nl] * self.C[alpha, ne] * self.fric_LTwk[alpha] + ) for j in range(nphys): for k in range(nphys): suma = np.sum(dgdq[nl, :, j] * dgdq[ne, :, k]) @@ -534,7 +557,7 @@ def obtain_g(self, s): for i in range(self.dbeads.nbeads): ss[i] = self.sqrtm( - s[i] + np.eye(nphys) * 0.0001 + s[i] + np.eye(nphys) * 0.000000001 ) # ss = s ** 0.5 -> won't work for multiD q = self.dbeads.q.copy() @@ -568,7 +591,7 @@ def compute_friction_terms(self): warnings.filterwarnings("error") try: dgdq[i] = self.sqrtm( - s[i] + np.eye(nphys) * 0.0001 + s[i] + np.eye(nphys) * 0.00000001 ) # dgdq = s ** 0.5 -> won't work for multiD except Warning: print(s[i]) @@ -576,9 +599,9 @@ def compute_friction_terms(self): gq = self.obtain_g(s) gq_k = np.dot(self.C, gq) - e = 0.5 * np.sum(self.z_k * gq_k ** 2) + e = 0.5 * np.sum(self.fric_LTwk * gq_k ** 2) - f = np.dot(self.C.T, self.z_k * gq_k) + f = np.dot(self.C.T, self.fric_LTwk * gq_k) g = np.zeros(f.shape) for i in range(self.dbeads.nbeads): g[i, :] = np.dot(dgdq[i], f[i]) @@ -879,7 +902,9 @@ def bind(self, dumop): self.frictionSD = self.options["frictionSD"] self.gm = FrictionMapper(self.frictionSD, self.options["eta0"]) self.gm.bind(self) - self.gm.set_z_friction(dumop.options["z_friction"]) + self.gm.set_fric_spec_dens( + dumop.options["fric_spec_dens"], dumop.options["fric_spec_dens_ener"] + ) else: self.gm.bind(self) @@ -1001,10 +1026,8 @@ def bind(self, geop): self.options["frictionSD"] = geop.options["frictionSD"] if self.options["friction"]: self.options["eta0"] = geop.options["eta0"] - if len(geop.options["z_friction"]) == 0: - geop.options["z_friction"] = np.ones((1000, 2)) - geop.options["z_friction"][:, 0] = np.arange(1000) - self.options["z_friction"] = geop.options["z_friction"] + self.options["fric_spec_dens"] = geop.options["fric_spec_dens"] + self.options["fric_spec_dens_ener"] = geop.options["fric_spec_dens_ener"] self.options["tolerances"] = geop.options["tolerances"] self.optarrays["big_step"] = geop.optarrays["big_step"] self.optarrays["old_x"] = geop.optarrays["old_x"] @@ -1624,7 +1647,7 @@ def step(self, step=None): ) h_up_band = banded_hessian( - dyn_mat, self.mapper.sm, masses=False, shift=0.000000001 + dyn_mat, self.mapper.sm, masses=False, shift=0.0000001 ) # create upper band matrix f = np.multiply(f, self.fix.fixbeads.m3.reshape(f.shape) ** -0.5) # CARTESIAN diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index bbc1e3a5f..167b57255 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -139,12 +139,21 @@ class InputInst(InputDictionary): InputValue, {"dtype": bool, "default": True, "help": "Activates SD Friction."}, ), - "z_friction": ( + "fric_spec_dens": ( InputArray, { "dtype": float, "default": input_default(factory=np.ones, args=(0,)), - "help": "Normalized frequency dependence of the friction tensor (z). A two column data is expected. First column: omega (cm^-1). Second column: z(omega). ", + "help": "Spectral density of the friction tensor over frequency (J(w)/w). A two column data is expected. First column: w (a.u.). Second column: J(w)/w (a.u.)", + }, + ), + "fric_spec_dens_ener": ( + InputValue, + { + "dtype": float, + "default": 0.0, + "help": "Energy at which the friction tensor is evaluated in the client code", + "dimension": "energy", }, ), "eta": ( @@ -337,7 +346,8 @@ def store(self, geop): self.friction.store(options["friction"]) self.frictionSD.store(options["frictionSD"]) if options["friction"]: - self.z_friction.store(options["z_friction"]) + self.fric_spec_dens.store(options["fric_spec_dens"]) + self.fric_spec_dens_ener.store(options["fric_spec_dens_ener"]) self.alt_out.store(options["save"]) self.prefix.store(options["prefix"]) self.delta.store(optarrays["delta"]) diff --git a/ipi/utils/mathtools.py b/ipi/utils/mathtools.py index e89a0227d..3890e5de8 100644 --- a/ipi/utils/mathtools.py +++ b/ipi/utils/mathtools.py @@ -10,7 +10,7 @@ import numpy as np from ipi.utils.messages import verbosity, warning - +from ipi.utils import units __all__ = [ "matrix_exp", @@ -492,3 +492,34 @@ def gaussian_inv(x): z = x k = np.log(-np.log(z)) return np.sign(y) * np.polyval([c8, c7, c6, c5, c4, c3, c2, c1, c0], k) + + +def LT_friction(freqs, spectral_density_over_w, forceit=False): + """Computes laplace transform of an harmonic bath spectral density. + spectral_density_over_w ( J(w)/w ) is a provided as a function (spline) + For numerical reasons the spline expects frequencies in invcm""" + import scipy.integrate as integrate + from scipy.interpolate import interp1d + + if freqs[1] < 1e-4 or np.amax(freqs) > 1e4: # assumes invcm units + if not forceit: + raise ValueError( + "Problem computing laplace transform. freq outside tested region {} {}".format( + freqs[1], np.amax(freqs) + ) + ) + + integral = np.zeros(freqs.size) + for n, wk in enumerate(freqs): + if wk != 0: + + def f(w): + return spectral_density_over_w(w) * (wk / (wk ** 2 + w ** 2)) + + # if np.mod(n,100)==0: + # print('{} over {}'.format(n,freqs.size)) + integral[n] = integrate.quad( + f, 0, np.inf, limit=100000, epsrel=1e-4, epsabs=1e-7 + )[0] + + return 2 * integral / np.pi From 8609396cfe989e9ad29237fa9c2a10f1dfb0510b Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 13 May 2021 14:47:21 +0200 Subject: [PATCH 075/120] fix local call of test_run.py and small bug in harmonic python driver --- drivers/py/pes/harmonic.py | 3 +-- ipi/utils/mathtools.py | 2 -- ipi_tests/regression_tests/runstools.py | 12 ++++++++---- ipi_tests/regression_tests/test_run.py | 9 +++++++-- ipi_tests/test_tools.py | 2 +- 5 files changed, 17 insertions(+), 11 deletions(-) diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index 65e58c2c4..7b6fdfc4d 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -45,6 +45,5 @@ def __call__(self, cell, pos): ) # makes a zero force with same shape as pos vir = cell * 0.0 # makes a zero virial with same shape as cell extras = "nada" - pos = pos3.reshape(pos.shape) - force = force3.reshape(pos.shape) + force = force3.reshape(pos.shape) return pot, force, vir, extras diff --git a/ipi/utils/mathtools.py b/ipi/utils/mathtools.py index 3890e5de8..e318fe4ad 100644 --- a/ipi/utils/mathtools.py +++ b/ipi/utils/mathtools.py @@ -10,7 +10,6 @@ import numpy as np from ipi.utils.messages import verbosity, warning -from ipi.utils import units __all__ = [ "matrix_exp", @@ -499,7 +498,6 @@ def LT_friction(freqs, spectral_density_over_w, forceit=False): spectral_density_over_w ( J(w)/w ) is a provided as a function (spline) For numerical reasons the spline expects frequencies in invcm""" import scipy.integrate as integrate - from scipy.interpolate import interp1d if freqs[1] < 1e-4 or np.amax(freqs) > 1e4: # assumes invcm units if not forceit: diff --git a/ipi_tests/regression_tests/runstools.py b/ipi_tests/regression_tests/runstools.py index 65298a5ef..18097aa98 100644 --- a/ipi_tests/regression_tests/runstools.py +++ b/ipi_tests/regression_tests/runstools.py @@ -1,9 +1,13 @@ import numpy as np from pathlib import Path -from ..test_tools import ( - Runner, - modify_xml_4_dummy_test, -) + +try: + from ..test_tools import ( + Runner, + modify_xml_4_dummy_test, + ) +except ImportError: + from ipi_tests.test_tools import Runner, modify_xml_4_dummy_test class Runner_regression(Runner): diff --git a/ipi_tests/regression_tests/test_run.py b/ipi_tests/regression_tests/test_run.py index 349300664..56dc2b2db 100644 --- a/ipi_tests/regression_tests/test_run.py +++ b/ipi_tests/regression_tests/test_run.py @@ -3,8 +3,13 @@ import argparse from argparse import RawTextHelpFormatter import time -from .runstools import Runner_regression -from ..test_tools import get_test_list + +try: + from .runstools import Runner_regression + from ..test_tools import get_test_list +except ImportError: + from runstools import Runner_regression + from ipi_tests.test_tools import get_test_list """ Run regression test """ diff --git a/ipi_tests/test_tools.py b/ipi_tests/test_tools.py index eb7b8736d..11a8e50e3 100644 --- a/ipi_tests/test_tools.py +++ b/ipi_tests/test_tools.py @@ -28,7 +28,7 @@ "gas", ] -# YL should do this automatically but for now I do it explicitly +# We should do this automatically but for now I we do it explicitly here python_driver_models = ["dummy", "harmonic"] From 39489551b12d5b52015e4a66abdf750449654007 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 13 May 2021 14:51:49 +0200 Subject: [PATCH 076/120] black again --- ipi/engine/motion/instanton.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index dcf2e0583..8fbae90e1 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -485,7 +485,7 @@ def set_fric_spec_dens(self, fric_spec_dens_data, fric_spec_dens_ener): fill_value=0.0, bounds_error=False, ) - fric_spec_dens = spline(self.omegak / invcm2au) + # fric_spec_dens = spline(self.omegak / invcm2au) if fric_spec_dens_ener == 0 or fric_spec_dens_ener < freq[0]: norm = 1.0 # spline(freq[0])*freq[0]*invcm2au From 8642525dabfd69a74b54e8535bf71b2604156d32 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 13 May 2021 20:19:15 +0200 Subject: [PATCH 077/120] change back Jw/w to LT --- ipi/engine/motion/instanton.py | 16 +++++++++------- 1 file changed, 9 insertions(+), 7 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 8fbae90e1..0efc9003c 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -467,12 +467,12 @@ def check_eta(self, eta): def set_fric_spec_dens(self, fric_spec_dens_data, fric_spec_dens_ener): """Computes and sets the laplace transform of the friction tensor""" - from ipi.utils.mathtools import LT_friction + # from ipi.utils.mathtools import LT_friction # from scipy.interpolate import interp1d if len(fric_spec_dens_data) == 0: LT_fric_spec_dens = np.ones((1000, 2)) - LT_fric_spec_dens[:, 0] = np.arange(1000) + LT_fric_spec_dens[:, 0] = np.arange(self.omegak.shape) else: invcm2au = units.unit_to_internal("frequency", "inversecm", 1) @@ -485,16 +485,18 @@ def set_fric_spec_dens(self, fric_spec_dens_data, fric_spec_dens_ener): fill_value=0.0, bounds_error=False, ) - # fric_spec_dens = spline(self.omegak / invcm2au) - if fric_spec_dens_ener == 0 or fric_spec_dens_ener < freq[0]: + if fric_spec_dens_ener == 0 or fric_spec_dens_ener / invcm2au < freq[0]: norm = 1.0 # spline(freq[0])*freq[0]*invcm2au - elif fric_spec_dens_ener > freq[-1]: + elif fric_spec_dens_ener / invcm2au > freq[-1]: norm = 1.0 # spline(freq[-1])*freq[-10]*invcm2au else: - norm = spline(fric_spec_dens_ener / invcm2au) * fric_spec_dens_ener + # norm = spline(fric_spec_dens_ener / invcm2au) * fric_spec_dens_ener + norm = spline(fric_spec_dens_ener / invcm2au) - LT_fric_spec_dens = LT_friction(self.omegak / invcm2au, spline) / norm + fric_spec_dens = spline(self.omegak / invcm2au) + LT_fric_spec_dens = fric_spec_dens / norm + # LT_fric_spec_dens = LT_friction(self.omegak / invcm2au, spline) / norm self.fric_LTwk = np.multiply(self.omegak, LT_fric_spec_dens)[:, np.newaxis] From e8723f5f4489f52fc44511e478369b50da757970 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Thu, 13 May 2021 23:08:53 +0200 Subject: [PATCH 078/120] correct some docstings --- ipi/inputs/motion/instanton.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 167b57255..1b7420cdd 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -144,7 +144,7 @@ class InputInst(InputDictionary): { "dtype": float, "default": input_default(factory=np.ones, args=(0,)), - "help": "Spectral density of the friction tensor over frequency (J(w)/w). A two column data is expected. First column: w (a.u.). Second column: J(w)/w (a.u.)", + "help": "LT of friction. A two column data is expected. First column: w (a.u.). Second column: LT(eta)(w)", }, ), "fric_spec_dens_ener": ( @@ -152,7 +152,7 @@ class InputInst(InputDictionary): { "dtype": float, "default": 0.0, - "help": "Energy at which the friction tensor is evaluated in the client code", + "help": "Energy at which the LT of the friction tensor is evaluated in the client code", "dimension": "energy", }, ), From 4d3c71d37b1b2402ce2d11161ed2f7c36ea60a84 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 14 May 2021 09:10:34 +0200 Subject: [PATCH 079/120] delete some old comments --- ipi/engine/motion/instanton.py | 9 ++++----- 1 file changed, 4 insertions(+), 5 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 0efc9003c..3c7aad93e 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1149,8 +1149,6 @@ def exitstep(self, d_x_max, step): if self.options["friction"] and self.options["frictionSD"]: friction_hessian = current_hessian[1] - print("alberto2") - print(np.amax(friction_hessian), np.amin(friction_hessian)) self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( friction_hessian, 4 ) @@ -1387,8 +1385,9 @@ def initialize(self, step): ) if self.options["friction"] and self.options["frictionSD"]: phys_hessian = active_hessian[0] - friction_hessian = active_hessian[1] # ALBERTO - self.optarrays["fric_hessian"][:] = friction_hessian[:] # ALBERTO + friction_hessian = active_hessian[1] + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) + #self.optarrays["fric_hessian"][:] = friction_hessian[:] # ALBERTO else: phys_hessian = active_hessian @@ -1505,7 +1504,7 @@ def step(self, step=None): # Add friction terms to the hessian if self.options["friction"]: - print("ALBERTO clean here gm call") + eta_active = self.fix.get_active_vector(self.mapper.gm.eta, 5) if self.options["frictionSD"]: h_fric = self.mapper.gm.get_fric_rp_hessian( From 978d4df13adc642eb81f9f595e7ab1137659c262 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 14 May 2021 09:15:26 +0200 Subject: [PATCH 080/120] black --- ipi/engine/motion/instanton.py | 10 ++++++---- 1 file changed, 6 insertions(+), 4 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 3c7aad93e..0819b2356 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1385,9 +1385,11 @@ def initialize(self, step): ) if self.options["friction"] and self.options["frictionSD"]: phys_hessian = active_hessian[0] - friction_hessian = active_hessian[1] - self.optarrays["fric_hessian"][:] = self.fix.get_full_vector(friction_hessian, 4 ) - #self.optarrays["fric_hessian"][:] = friction_hessian[:] # ALBERTO + friction_hessian = active_hessian[1] + self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( + friction_hessian, 4 + ) + # self.optarrays["fric_hessian"][:] = friction_hessian[:] # ALBERTO else: phys_hessian = active_hessian @@ -1504,7 +1506,7 @@ def step(self, step=None): # Add friction terms to the hessian if self.options["friction"]: - + eta_active = self.fix.get_active_vector(self.mapper.gm.eta, 5) if self.options["frictionSD"]: h_fric = self.mapper.gm.get_fric_rp_hessian( From 5dacec61fbc94236e38f81eec973d7c88c031c85 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 7 Jul 2021 15:23:38 +0200 Subject: [PATCH 081/120] add explicit bath into py-driver --- drivers/f90/pes/.harmonic_bath.f90.swp | Bin 0 -> 16384 bytes drivers/py/driver.py | 5 +- drivers/py/pes/__init__.py | 7 +- drivers/py/pes/doublewell.py | 99 ++++++++++++++++++++++++- ipi/engine/motion/instanton.py | 6 +- ipi/engine/motion/vscf.py | 29 +++----- ipi/inputs/simulation.py | 5 +- ipi_tests/test_tools.py | 13 +--- setup.py | 5 +- 9 files changed, 118 insertions(+), 51 deletions(-) create mode 100644 drivers/f90/pes/.harmonic_bath.f90.swp diff --git a/drivers/f90/pes/.harmonic_bath.f90.swp b/drivers/f90/pes/.harmonic_bath.f90.swp new file mode 100644 index 0000000000000000000000000000000000000000..d7958d1032cf4f3c6c6f41afafc5ea1567052a5b GIT binary patch literal 16384 zcmeHNON=8&87`99JlP}=4m_pbAhO*(?MHWeJf4UVc-G#m(XMBA?A;_pJC4`g-f8XF z<3}%P&jAz!0zp7R9CF|Q2^>I3Iph#2ha7^C5O4`6IDwSpfDl5UxHZJi&V~;4Cw*J?)&}gPyXzW+LIq}7~6NferGW4@S@|= zurr?QJJaK;h_Wxt1m@2k*v=&HW`}ORS=p*rf}i%-{k$`tB zJKkOnxhHCn6(j?af#nRGW|nD)Y4nMYXXwHAUs+yNmPiI91CjyBfMh^2AQ_MhNCqSW z|91>{!`s*w(W~3Sp7q1;_Z<1YJ$%L$fk=b!dsZ)elwXno$$(@)G9Vd{3`hnf1CjyB zfMh^2AQ_Mh{1-CNu>+%C;|F;h?q}!!zuwQ-Ux4odUk1v+9l$AI1^D58jC~6j04DIx zX~upI`~(;PXMlTvKfRZ+UjaV`egr%Nct8(ufX@OS1m3xqu@`}7fE@5q;52YM@YX$y zy$XB@cp8`hj{|oDcLA^6&Dd9f7SIHCfGwZ`n7~88CxN%`V(fRow}CEj9XJQ906(~s zv2Orh2R;W>fqQ{B?qKX?;CbLVU>~>&d<=N=6#5K&6L=JOAMgP1_6lqUo&}x;I>4ua z`++~;BIPCEYrt25UEmt$qMB;cJB-`o*Cu6eYKJV5$HgU*kiSZW+?s}p znr0^J_NIxNp|EMP!g0c;T-dRdp%w446Dkg2??`cVOHJlZ!(20!>xa2UoLk){7rBN$ z=y8PMamRBjRm(~kw<&C0QG_CbwEaN8cyivAF znqrj;sA?DTrmn)qb+=Wsvqh-U++!zUhL?j)tuo(x1D{j6MSCQ?Pj%YkCuw9=v(?t z-SIk64R_!D-mZ*;akKL1Bj?dthgf#a%}u(iD4Q+am*$ zNBj`eh?-SpG^baMd&Q;jW+sFP{xA!TELB^T#(Aas827zO`Jm`>N_U`alh7%xT6^r0 zf)TdHXRYn?MyjS{Z9gw$UXBL@*XM^8&xuVr6*Z#-ci6rj^e^}_^=38hMY18B22Tz= z#T|$NI^TVY8!mDx(N3*$K`Y19&zN3BC1W!yQ{HMu*(h#;+>v&oFOt2O2^HVy{(rQ$ z&3Dt$YO<%9r^c@5C?#D}=}hIqR&A%XeMZNM#fLukA<=@dLMrl?j3Y`9R`7s@Dp$ZL zU)}&SfG-7FFp6#e=Xj~#E~@-_3_kHf{& zIUa+~z)l$G-5L+#GK^1bAe7#MgEiP)HB|7L?RO>kKJ>YTSyBSE7_1Xj2tiSJsGoo7t+g&d2=4-33#SX@VUQwQ#*WW+@^=#4S97M>1AY zPuShKNjlb@>3$VJSUftfD13 z{t(l9lr5;cCZFnN5TETL$W!SW4;}f&NnU5Lr;MWDEz}+f*MwBA;wmBq-_Ub8-AA;w zNt0Xswz12H1V$V^A?9{Joc8Xnsf_r_i5W*+mYP?hGT6gSx`wWv5C5y4IA4sP|9^vX zx`i`5KmX%Tq`%>e|4ZN(zze{403Ub?_z3U{>bHSi;1aM6dQ;-vzFuj+0bvi2&dV79aBEP>)-J$xa3smtQSlphnzXL6nH%kBj literal 0 HcmV?d00001 diff --git a/drivers/py/driver.py b/drivers/py/driver.py index 660fa675c..899ed0b57 100755 --- a/drivers/py/driver.py +++ b/drivers/py/driver.py @@ -189,8 +189,5 @@ def run_driver(unix=False, address="", port=12345, driver=Dummy_driver()): raise ValueError("Unsupported driver mode ", args.mode) run_driver( - unix=args.unix, - address=args.address, - port=args.port, - driver=d_f, + unix=args.unix, address=args.address, port=args.port, driver=d_f, ) diff --git a/drivers/py/pes/__init__.py b/drivers/py/pes/__init__.py index a3fa1eba0..cea49d2f0 100644 --- a/drivers/py/pes/__init__.py +++ b/drivers/py/pes/__init__.py @@ -3,7 +3,11 @@ from .dummy import Dummy_driver from .harmonic import Harmonic_driver from .spline import Spline_driver -from .doublewell import DoubleWell_driver, DoubleWell_with_friction_driver +from .doublewell import ( + DoubleWell_driver, + DoubleWell_with_friction_driver, + DoubleWell_with_explicit_bath_driver, +) from .rascal import Rascal_driver __all__ = [ @@ -23,5 +27,6 @@ "rascal": Rascal_driver, "DoubleWell": DoubleWell_driver, "DW_friction": DoubleWell_with_friction_driver, + "DW_explicit": DoubleWell_with_explicit_bath_driver, "spline": Spline_driver, } diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 38f6a28de..8d141e47f 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -70,7 +70,7 @@ def __call__(self, cell, pos): force3[:, 2] = -self.k * pos3[:, 2] vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "nada" + extras = "empty" pos = pos3.reshape(pos.shape) force = force3.reshape(pos.shape) @@ -88,8 +88,8 @@ class DoubleWell_with_friction_driver(DoubleWell_driver): def __init__(self, args=None): - self.error_msg = """\nDW+fric driver excepts 8 arguments.\n - Example: python driver.py -m DoubleWell_with_fric -o omega_c (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ \n + self.error_msg = """\nDW+fric driver expects 8 arguments.\n + Example: python driver.py -m DoubleWell_with_fric -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ \n python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1\n""" self.args = args self.check_arguments() @@ -154,5 +154,98 @@ def __call__(self, cell, pos): friction_tensor = self.get_friction_tensor(pos) extras = json.dumps({"friction": friction_tensor.tolist()}) + return pot, force, vir, extras + + +class DoubleWell_with_explicit_bath_driver(DoubleWell_with_friction_driver): + """Adds to the double well potential the an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization + +! V(q,x1,..,xn) = DW(q) + +! sum_2^(3*N) [ 0.5 m w_i^2(q - (c_i s(q))/(m w_i)^2)^2 ] +! s(q) = q *sd(q) +! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) +! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independenth bath + +""" + + def __init__(self, args=None): + + self.error_msg = """\nDW+explicit_bath driver expects 8 arguments.\n + Example: python driver.py -m DoubleWell_with_explicit_bath -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n + python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1,500\n""" + self.args = args + self.check_arguments() + self.init = False + + def check_arguments(self): + """Function that checks the arguments required to run the driver""" + + try: + arglist = self.args.split(",") + param = list(map(float, arglist)) + assert len(param) == 9 + w_b = param[0] * invcm2au + v0 = param[1] * invcm2au + self.m = param[2] + self.delta = param[3] * A2au + self.eta0 = param[4] + self.eps1 = param[5] + self.eps2 = param[6] + self.deltaQ = param[7] + self.w_c = param[8] * invcm2au + except: + sys.exit(self.error_msg) + + self.A = -0.5 * self.m * (w_b) ** 2 + self.B = ((self.m ** 2) * (w_b) ** 4) / (16 * v0) + + def set_ci_and_wi(self): + """ Computes the the parameters to represent the harmonic bath """ + + self.omega = np.zeros(self.nbath) + self.omega2 = np.zeros(self.nbath) + self.coef = np.zeros(self.nbath) + + for i in range(self.nbath): + self.omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) + self.omega2[i] = self.omega[i] ** 2 + self.coef[i] = ( + self.omega[i] + * ((2 * self.eta0 * self.m * self.w_c) / (self.nbath * np.pi)) ** 0.5 + ) + self.init = True + + def S(self, q): + """ S coupling function """ + return q * self.SD(q) + + def __call__(self, cell, pos): + """DoubleWell potential""" + pot = 0 + q = pos.reshape(-1, 1)[0] + x = pos.reshape(-1, 1)[1:] + fq = np.zeros(q.shape) + fx = np.zeros(x.shape) + + if not self.init: + self.nbath = np.size(x) + self.set_ci_and_wi() + + # DW + pot += self.A * (q - self.delta) ** 2 + self.B * (q ** 4) + fq = -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q ** 3) + + # Harmonic bath + + for i in range(self.nbath): + aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) + pot += 0.5 * self.m * self.omega2[i] * aux ** 2 + fq += aux * self.coef[i] * self.dSD_dq(q) + fx[i] -= self.m * self.omega2[i] * aux + + pos = np.concatenate((q, x.flatten())).reshape(pos.shape) + force = np.concatenate((fq, fx.flatten())).reshape(pos.shape) + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "empty" return pot, force, vir, extras diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 0819b2356..996ecab8d 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1558,11 +1558,7 @@ def step(self, step=None): if self.options["mode"] == "rate": d_x = nichols( - self.mapper.f, - d, - w, - self.fix.fixbeads.m3, - activearrays["big_step"], + self.mapper.f, d, w, self.fix.fixbeads.m3, activearrays["big_step"], ) elif self.options["mode"] == "splitting": d_x = nichols( diff --git a/ipi/engine/motion/vscf.py b/ipi/engine/motion/vscf.py index 1354d9d1c..706433a7a 100644 --- a/ipi/engine/motion/vscf.py +++ b/ipi/engine/motion/vscf.py @@ -481,14 +481,10 @@ def step(self, step=None): - 0.50 * self.imm.w2[step] * (nmd * counter) ** 2 - v0 ) - df = ( - np.dot( - dstrip(self.imm.dforces.f).copy()[0], - np.real(self.imm.V.T[step]), - ) - / self.nprim - + self.imm.w2[step] * (nmd * counter) - ) + df = np.dot( + dstrip(self.imm.dforces.f).copy()[0], + np.real(self.imm.V.T[step]), + ) / self.nprim + self.imm.w2[step] * (nmd * counter) # Adds to the list. # Also stores the total energetics i.e. including @@ -527,14 +523,10 @@ def step(self, step=None): - 0.50 * self.imm.w2[step] * (nmd * counter) ** 2 - v0 ) - df = ( - np.dot( - dstrip(self.imm.dforces.f).copy()[0], - np.real(self.imm.V.T[step]), - ) - / self.nprim - + self.imm.w2[step] * (nmd * counter) - ) + df = np.dot( + dstrip(self.imm.dforces.f).copy()[0], + np.real(self.imm.V.T[step]), + ) / self.nprim + self.imm.w2[step] * (nmd * counter) # Adds to the list. # Also stores the total energetics i.e. including @@ -805,10 +797,7 @@ def bind(self, imm): if self.imm.w[inm] < 9.1126705e-06: info( " @NM: Ignoring normal mode no. %8d with frequency %15.8f cm^-1." - % ( - inm, - self.imm.w[inm] * 219474, - ), + % (inm, self.imm.w[inm] * 219474,), verbosity.medium, ) continue diff --git a/ipi/inputs/simulation.py b/ipi/inputs/simulation.py index 865de87e5..7a1facf3f 100644 --- a/ipi/inputs/simulation.py +++ b/ipi/inputs/simulation.py @@ -204,10 +204,7 @@ def store(self, simul): if len(self.extra) != len(_fflist) + len(simul.syslist): self.extra = [0] * (len(_fflist) + len(simul.syslist)) - for ( - _ii, - _obj, - ) in enumerate(_fflist + simul.syslist): + for (_ii, _obj,) in enumerate(_fflist + simul.syslist): if self.extra[_ii] == 0: if isinstance(_obj, eforcefields.FFSocket): _iobj = iforcefields.InputFFSocket() diff --git a/ipi_tests/test_tools.py b/ipi_tests/test_tools.py index 11a8e50e3..ba0ff55e1 100644 --- a/ipi_tests/test_tools.py +++ b/ipi_tests/test_tools.py @@ -54,8 +54,7 @@ def clean_tmp_dir(): def get_test_settings( - example_folder, - settings_file="test_settings.dat", + example_folder, settings_file="test_settings.dat", ): """This function looks for the existence of test_settings.dat file. This file can contain instructions like number of steps or driver name. @@ -149,11 +148,7 @@ def get_test_settings( def modify_xml_4_dummy_test( - input_name, - output_name, - nid, - driver_info, - test_settings, + input_name, output_name, nid, driver_info, test_settings, ): """Modify xml to run dummy tests""" try: @@ -214,9 +209,7 @@ class Runner(object): """ def __init__( - self, - parent, - call_ipi="i-pi input.xml", + self, parent, call_ipi="i-pi input.xml", ): """Store parent directory and commands to call i-pi and driver call_ipi: command to call i-pi diff --git a/setup.py b/setup.py index 69e020cf3..4ffdb0625 100644 --- a/setup.py +++ b/setup.py @@ -11,10 +11,7 @@ "ipi.tests", "ipi.tests.regression_tests", ], - package_dir={ - "ipi._driver": "drivers/py", - "ipi.tests": "ipi_tests", - }, + package_dir={"ipi._driver": "drivers/py", "ipi.tests": "ipi_tests",}, package_data={"ipi.tests.regression_tests": ["tests/NVE/NVE_1/harmonic_python/*"]}, scripts=[str(p) for p in Path("bin").iterdir()], ) From 9ac1aa65da878ff03c0f17014c0b1690997ba770 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 7 Jul 2021 15:24:08 +0200 Subject: [PATCH 082/120] remove tmp file --- drivers/f90/pes/.harmonic_bath.f90.swp | Bin 16384 -> 0 bytes 1 file changed, 0 insertions(+), 0 deletions(-) delete mode 100644 drivers/f90/pes/.harmonic_bath.f90.swp diff --git a/drivers/f90/pes/.harmonic_bath.f90.swp b/drivers/f90/pes/.harmonic_bath.f90.swp deleted file mode 100644 index d7958d1032cf4f3c6c6f41afafc5ea1567052a5b..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 16384 zcmeHNON=8&87`99JlP}=4m_pbAhO*(?MHWeJf4UVc-G#m(XMBA?A;_pJC4`g-f8XF z<3}%P&jAz!0zp7R9CF|Q2^>I3Iph#2ha7^C5O4`6IDwSpfDl5UxHZJi&V~;4Cw*J?)&}gPyXzW+LIq}7~6NferGW4@S@|= zurr?QJJaK;h_Wxt1m@2k*v=&HW`}ORS=p*rf}i%-{k$`tB zJKkOnxhHCn6(j?af#nRGW|nD)Y4nMYXXwHAUs+yNmPiI91CjyBfMh^2AQ_MhNCqSW z|91>{!`s*w(W~3Sp7q1;_Z<1YJ$%L$fk=b!dsZ)elwXno$$(@)G9Vd{3`hnf1CjyB zfMh^2AQ_Mh{1-CNu>+%C;|F;h?q}!!zuwQ-Ux4odUk1v+9l$AI1^D58jC~6j04DIx zX~upI`~(;PXMlTvKfRZ+UjaV`egr%Nct8(ufX@OS1m3xqu@`}7fE@5q;52YM@YX$y zy$XB@cp8`hj{|oDcLA^6&Dd9f7SIHCfGwZ`n7~88CxN%`V(fRow}CEj9XJQ906(~s zv2Orh2R;W>fqQ{B?qKX?;CbLVU>~>&d<=N=6#5K&6L=JOAMgP1_6lqUo&}x;I>4ua z`++~;BIPCEYrt25UEmt$qMB;cJB-`o*Cu6eYKJV5$HgU*kiSZW+?s}p znr0^J_NIxNp|EMP!g0c;T-dRdp%w446Dkg2??`cVOHJlZ!(20!>xa2UoLk){7rBN$ z=y8PMamRBjRm(~kw<&C0QG_CbwEaN8cyivAF znqrj;sA?DTrmn)qb+=Wsvqh-U++!zUhL?j)tuo(x1D{j6MSCQ?Pj%YkCuw9=v(?t z-SIk64R_!D-mZ*;akKL1Bj?dthgf#a%}u(iD4Q+am*$ zNBj`eh?-SpG^baMd&Q;jW+sFP{xA!TELB^T#(Aas827zO`Jm`>N_U`alh7%xT6^r0 zf)TdHXRYn?MyjS{Z9gw$UXBL@*XM^8&xuVr6*Z#-ci6rj^e^}_^=38hMY18B22Tz= z#T|$NI^TVY8!mDx(N3*$K`Y19&zN3BC1W!yQ{HMu*(h#;+>v&oFOt2O2^HVy{(rQ$ z&3Dt$YO<%9r^c@5C?#D}=}hIqR&A%XeMZNM#fLukA<=@dLMrl?j3Y`9R`7s@Dp$ZL zU)}&SfG-7FFp6#e=Xj~#E~@-_3_kHf{& zIUa+~z)l$G-5L+#GK^1bAe7#MgEiP)HB|7L?RO>kKJ>YTSyBSE7_1Xj2tiSJsGoo7t+g&d2=4-33#SX@VUQwQ#*WW+@^=#4S97M>1AY zPuShKNjlb@>3$VJSUftfD13 z{t(l9lr5;cCZFnN5TETL$W!SW4;}f&NnU5Lr;MWDEz}+f*MwBA;wmBq-_Ub8-AA;w zNt0Xswz12H1V$V^A?9{Joc8Xnsf_r_i5W*+mYP?hGT6gSx`wWv5C5y4IA4sP|9^vX zx`i`5KmX%Tq`%>e|4ZN(zze{403Ub?_z3U{>bHSi;1aM6dQ;-vzFuj+0bvi2&dV79aBEP>)-J$xa3smtQSlphnzXL6nH%kBj From bdc14482b93a22e0ebf600a3cc8d97215eef8494 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 7 Jul 2021 19:30:06 +0200 Subject: [PATCH 083/120] extend DW python driver --- drivers/py/pes/doublewell.py | 17 +++++++++-------- 1 file changed, 9 insertions(+), 8 deletions(-) diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 8d141e47f..88bdf0148 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -202,19 +202,20 @@ def check_arguments(self): def set_ci_and_wi(self): """ Computes the the parameters to represent the harmonic bath """ - self.omega = np.zeros(self.nbath) + omega = np.zeros(self.nbath) self.omega2 = np.zeros(self.nbath) self.coef = np.zeros(self.nbath) - for i in range(self.nbath): - self.omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) - self.omega2[i] = self.omega[i] ** 2 + if self.w_c>0: + for i in range(self.nbath): + omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) + self.omega2[i] = omega[i] ** 2 self.coef[i] = ( - self.omega[i] + omega[i] * ((2 * self.eta0 * self.m * self.w_c) / (self.nbath * np.pi)) ** 0.5 ) self.init = True - + def S(self, q): """ S coupling function """ return q * self.SD(q) @@ -234,10 +235,10 @@ def __call__(self, cell, pos): # DW pot += self.A * (q - self.delta) ** 2 + self.B * (q ** 4) fq = -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q ** 3) - # Harmonic bath - for i in range(self.nbath): + if self.w_c >0: + for i in range(self.nbath): aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) pot += 0.5 * self.m * self.omega2[i] * aux ** 2 fq += aux * self.coef[i] * self.dSD_dq(q) From b5bb6c8b40d11062d722fa239f521476ca9d6af6 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 27 Jul 2021 00:11:42 +0200 Subject: [PATCH 084/120] add DDW --- drivers/py/pes/__init__.py | 2 + drivers/py/pes/doublewell.py | 242 +++++++++++++++++++++++++++++------ drivers/py/pes/test.dat | 200 ----------------------------- 3 files changed, 204 insertions(+), 240 deletions(-) delete mode 100644 drivers/py/pes/test.dat diff --git a/drivers/py/pes/__init__.py b/drivers/py/pes/__init__.py index cea49d2f0..920803e1a 100644 --- a/drivers/py/pes/__init__.py +++ b/drivers/py/pes/__init__.py @@ -7,6 +7,7 @@ DoubleWell_driver, DoubleWell_with_friction_driver, DoubleWell_with_explicit_bath_driver, + DDW_with_explicit_bath_driver, ) from .rascal import Rascal_driver @@ -28,5 +29,6 @@ "DoubleWell": DoubleWell_driver, "DW_friction": DoubleWell_with_friction_driver, "DW_explicit": DoubleWell_with_explicit_bath_driver, + "DDW_explicit": DDW_with_explicit_bath_driver, "spline": Spline_driver, } diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 88bdf0148..90c68c214 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -157,20 +157,90 @@ def __call__(self, cell, pos): return pot, force, vir, extras -class DoubleWell_with_explicit_bath_driver(DoubleWell_with_friction_driver): - """Adds to the double well potential the an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization +class Harmonic_Bath_explicit(object): + """ Explicit description of an Harmonic bath """ + + def __init__(self, nbath, parameters): + + self.nbath = nbath + self.m = parameters["m"] + # self.delta = parameters["delta"] + self.eta0 = parameters["eta0"] + self.eps1 = parameters["eps1"] + self.eps2 = parameters["eps2"] + self.deltaQ = parameters["deltaQ"] + self.w_c = parameters["w_c"] + + self.set_ci_and_wi() + + def set_ci_and_wi(self): + """ Computes the the parameters to represent the harmonic bath """ + + omega = np.zeros(self.nbath) + self.omega2 = np.zeros(self.nbath) + self.coef = np.zeros(self.nbath) + + if self.w_c > 0: + for i in range(self.nbath): + omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) + self.omega2[i] = omega[i] ** 2 + self.coef[i] = ( + omega[i] + * ((2 * self.eta0 * self.m * self.w_c) / (self.nbath * np.pi)) + ** 0.5 + ) + self.init = True + + def S(self, q): + """ S coupling function """ + return q * self.SD(q) + + def SD(self, q): + """Auxiliary function to compute friction tensor""" + dx = q / self.deltaQ + SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx ** 2)) + self.eps2 * np.tanh(dx) + return SD + + def dSD_dq(self, q): + """Auxiliary function to compute friction tensor""" + dx = q / self.deltaQ + dsddq1 = self.eps1 * np.exp(-0.5 * (dx ** 2)) * (-dx / self.deltaQ) + dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ + dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) + + return dSD_dq + + def __call__(self, q, x): + + pot_bath = 0 + fq_bath = np.zeros(q.shape) + fx = np.zeros(x.shape) + assert x.size == self.nbath, "x.size {} , nbath {}".format(x.size, self.nbath) + + if self.w_c > 0: + for i in range(self.nbath): + aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) + pot_bath += 0.5 * self.m * self.omega2[i] * aux ** 2 + fq_bath += aux * self.coef[i] * self.dSD_dq(q) + fx[i] -= (self.m * self.omega2[i] * aux).flatten() + + return pot_bath, fq_bath, fx + + +class DoubleWell_with_explicit_bath_driver(Dummy_driver): + """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization ! V(q,x1,..,xn) = DW(q) + ! sum_2^(3*N) [ 0.5 m w_i^2(q - (c_i s(q))/(m w_i)^2)^2 ] ! s(q) = q *sd(q) ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) -! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independenth bath +! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath """ def __init__(self, args=None): - self.error_msg = """\nDW+explicit_bath driver expects 8 arguments.\n + self.error_msg = """\nDW+explicit_bath driver expects 9 arguments.\n Example: python driver.py -m DoubleWell_with_explicit_bath -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1,500\n""" self.args = args @@ -188,38 +258,22 @@ def check_arguments(self): v0 = param[1] * invcm2au self.m = param[2] self.delta = param[3] * A2au - self.eta0 = param[4] - self.eps1 = param[5] - self.eps2 = param[6] - self.deltaQ = param[7] - self.w_c = param[8] * invcm2au + + self.bath_parameters = {} + self.bath_parameters["m"] = param[2] + # self.bath_parameters["delta"] = param[3] * A2au + self.bath_parameters["eta0"] = param[4] + self.bath_parameters["eps1"] = param[5] + self.bath_parameters["eps2"] = param[6] + self.bath_parameters["deltaQ"] = param[7] + self.bath_parameters["w_c"] = param[8] * invcm2au + except: sys.exit(self.error_msg) self.A = -0.5 * self.m * (w_b) ** 2 self.B = ((self.m ** 2) * (w_b) ** 4) / (16 * v0) - def set_ci_and_wi(self): - """ Computes the the parameters to represent the harmonic bath """ - - omega = np.zeros(self.nbath) - self.omega2 = np.zeros(self.nbath) - self.coef = np.zeros(self.nbath) - - if self.w_c>0: - for i in range(self.nbath): - omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) - self.omega2[i] = omega[i] ** 2 - self.coef[i] = ( - omega[i] - * ((2 * self.eta0 * self.m * self.w_c) / (self.nbath * np.pi)) ** 0.5 - ) - self.init = True - - def S(self, q): - """ S coupling function """ - return q * self.SD(q) - def __call__(self, cell, pos): """DoubleWell potential""" pot = 0 @@ -230,22 +284,130 @@ def __call__(self, cell, pos): if not self.init: self.nbath = np.size(x) - self.set_ci_and_wi() + self.bath = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) + + # Harmonic bath + pot, fq, fx = self.bath(q, x) # DW pot += self.A * (q - self.delta) ** 2 + self.B * (q ** 4) - fq = -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q ** 3) + fq += -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q ** 3) + + force = np.concatenate((fq, fx.flatten())).reshape(pos.shape) + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "empty" + + return pot, force, vir, extras + + +class DDW_with_explicit_bath_driver(Dummy_driver): + + """Adds to a double-double well (DDW) potential coupled to two (explicit) harmonic baths. + pos[0:2] = DDW + pos[2:n//2+1] = bath1 + pos[n//2+1:] = bath2 + where n = 3*natoms = # dofs + +! V(q1,q2,x1,..,xm,y1,...,ym) = +! DDW(q1,q2) + +! sum_i^(m) [ 0.5 m w_i^2(xi - (c_i s(q1))/(m w_i)^2)^2 ] + +! sum_i^(m) [ 0.5 m w_i^2(yi - (c_i s(q2))/(m w_i)^2)^2 ] + +! +! with +! s(q) = q *sd(q) +! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) +! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath +! +! and +! +! DDW(q1,q2) = DW(q1) + DW(q2) + C(q1q2)^2 + +""" + + def __init__(self, args=None): + + self.error_msg = """\nDW+explicit_bath driver expects 11 arguments.\n + Example: python driver.py -m DoubleWell_with_explicit_bath -o wb1 (cm^-1) V1 (cm^-1) wb2 (cm^-1) V2 (cm^-1) coupling(au) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n + python driver.py -m DoubleWell -o 500,2085,500,2085,0.1,1837,0.00,1,0,0,1,500\n""" + self.args = args + self.check_arguments() + self.init = False + + def check_arguments(self): + """Function that checks the arguments required to run the driver""" + + try: + arglist = self.args.split(",") + param = list(map(float, arglist)) + assert len(param) == 12 + wb1 = param[0] * invcm2au + v1 = param[1] * invcm2au + wb2 = param[2] * invcm2au + v2 = param[3] * invcm2au + self.C = param[4] + self.m = param[5] + self.delta = param[6] * A2au + + self.bath_parameters = {} + self.bath_parameters["m"] = self.m + self.bath_parameters["delta"] = self.delta + self.bath_parameters["eta0"] = param[7] + self.bath_parameters["eps1"] = param[8] + self.bath_parameters["eps2"] = param[9] + self.bath_parameters["deltaQ"] = param[10] + self.bath_parameters["w_c"] = param[11] * invcm2au + + except: + print("Received arguments:") + sys.exit(self.error_msg) + + self.A1 = -0.5 * self.m * (wb1) ** 2 + self.B1 = ((self.m ** 2) * (wb1) ** 4) / (16 * v1) + + self.A2 = -0.5 * self.m * (wb2) ** 2 + self.B2 = ((self.m ** 2) * (wb2) ** 4) / (16 * v2) + + def __call__(self, cell, pos): + """DoubleWell potential""" + if not self.init: + self.ndof = np.size(pos) + assert self.ndof % 2 == 0, "Sorry we need an even number of ndof" + self.nbath = (self.ndof - 2) // 2 + self.bath1 = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) + self.bath2 = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) + self.init = True + + pot = 0 + q1 = pos.reshape(-1, 1)[0:1] + q2 = pos.reshape(-1, 1)[1:2] + x = pos.reshape(-1, 1)[2 : self.ndof // 2 + 1] + y = pos.reshape(-1, 1)[self.ndof // 2 + 1 :] + assert self.ndof == q1.size + q2.size + x.size + y.size + + # fq1 = np.zeros(q1.shape) + # fq2 = np.zeros(q2.shape) + fx = np.zeros(x.shape) + fy = np.zeros(x.shape) + # Harmonic bath + pot_x, fq1, fx = self.bath1(q1, x) + pot_y, fq2, fy = self.bath2(q2, y) - if self.w_c >0: - for i in range(self.nbath): - aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) - pot += 0.5 * self.m * self.omega2[i] * aux ** 2 - fq += aux * self.coef[i] * self.dSD_dq(q) - fx[i] -= self.m * self.omega2[i] * aux + pot = pot_x + pot_y - pos = np.concatenate((q, x.flatten())).reshape(pos.shape) - force = np.concatenate((fq, fx.flatten())).reshape(pos.shape) + # DW + pot += self.A1 * (q1 - self.delta) ** 2 + self.B1 * (q1 ** 4) + fq1 += -2.0 * self.A1 * (q1 - self.delta) - 4.0 * self.B1 * (q1 ** 3) + + pot += self.A2 * (q2 - self.delta) ** 2 + self.B2 * (q2 ** 4) + fq2 += -2.0 * self.A2 * (q2 - self.delta) - 4.0 * self.B2 * (q2 ** 3) + + # Coupling + pot += self.C * q1 * q2 + fq1 += -self.C * q2 + fq2 += -self.C * q1 + + force = np.concatenate((fq1, fq2, fx, fy), axis=None).reshape(pos.shape) vir = cell * 0.0 # makes a zero virial with same shape as cell extras = "empty" diff --git a/drivers/py/pes/test.dat b/drivers/py/pes/test.dat deleted file mode 100644 index 0cea4ac1d..000000000 --- a/drivers/py/pes/test.dat +++ /dev/null @@ -1,200 +0,0 @@ -6.851845134703705043e+00 -6.516274392034565821e+00 -6.192021198888439493e+00 -5.878845035438853728e+00 -5.576507823685005860e+00 -5.284773927451720255e+00 -5.003410152389479393e+00 -4.732185745974415880e+00 -4.470872397508305340e+00 -4.219244238118584178e+00 -3.977077840758333149e+00 -3.744152220206278248e+00 -3.520248833066796035e+00 -3.305151577769913640e+00 -3.098646794571314533e+00 -2.900523265552320318e+00 -2.710572214619908937e+00 -2.528587307506704018e+00 -2.354364651770979311e+00 -2.187702796796663574e+00 -2.028402733793328583e+00 -1.876267895796196461e+00 -1.731104157666138121e+00 -1.592719836089679264e+00 -1.460925689578987496e+00 -1.335534918471885879e+00 -1.216363164931844043e+00 -1.103228512947980189e+00 -9.959514883350644165e-01 -8.943550587335138413e-01 -7.982646336093978112e-01 -7.075080642544325782e-01 -6.219156437859827413e-01 -5.413201071470671311e-01 -4.655566311063493168e-01 -3.944628342581446567e-01 -3.278787770224170228e-01 -2.656469616447789672e-01 -2.076123321964949142e-01 -1.536222745744760254e-01 -1.035266165012851403e-01 -5.717762752513215474e-02 -1.443001901987814480e-02 --2.485905581496745606e-02 --6.083000195424459466e-02 --9.362078254714506498e-02 --1.233669189172105912e-01 --1.502014905623338947e-01 --1.742551351547576288e-01 --1.956560485410760442e-01 --2.145299847422328376e-01 --2.310002559535231093e-01 --2.451877325445926126e-01 --2.572108430594370887e-01 --2.671855742164032099e-01 --2.752254709081883299e-01 --2.814416362018403728e-01 --2.859427313387575831e-01 --2.888349757346890812e-01 --2.902221469797346964e-01 --2.902055808383444124e-01 --2.888841712493191438e-01 --2.863543703258105144e-01 --2.827101883553204131e-01 --2.780431937997014380e-01 --2.724425132951567297e-01 --2.659948316522403600e-01 --2.587843918558564438e-01 --2.508929950652603602e-01 --2.424000006140573926e-01 --2.333823260102039221e-01 --2.239144469360066503e-01 --2.140683972481230990e-01 --2.039137689775612217e-01 --1.935177123296795976e-01 --1.829449356841873486e-01 --1.722577055951443614e-01 --1.615158467909609541e-01 --1.507767421743982095e-01 --1.400953328225675587e-01 --1.295241179869313086e-01 --1.191131550933021283e-01 --1.089100597418434513e-01 --9.896000570706919852e-02 --8.930572493784399990e-02 --7.998750755738293083e-02 --7.104320186325177588e-02 --6.250821432736687611e-02 --5.441550959599519149e-02 --4.679561048975428711e-02 --3.967659800361224287e-02 --3.308411130688783397e-02 --2.704134774325038515e-02 --2.156906283071982969e-02 --1.668557026166668858e-02 --1.240674190281208615e-02 --8.746007795227741383e-03 --5.714356154335966179e-03 --3.320333369909676639e-03 --1.570044006072379402e-03 --4.671508012981798793e-04 --1.287466841177984082e-05 --2.059946945884777512e-04 --1.042848141354168036e-03 --2.517330444585342848e-03 --4.620895214509090042e-03 --7.342554235703092728e-03 --1.066887746709563323e-02 --1.458399304196559415e-02 --1.906958726794243802e-02 --2.410490462700624198e-02 --2.966674777548768474e-02 --3.572947754406800847e-02 --4.226501293777909507e-02 --4.924283113600335521e-02 --5.662996749247391215e-02 --6.439101553527439015e-02 --7.248812696683903933e-02 --8.088101166395267327e-02 --8.952693767775070366e-02 --9.838073123371929296e-02 --1.073947767316949520e-01 --1.165190167458649978e-01 --1.257009520247671097e-01 --1.348856414912899260e-01 --1.440157022426723499e-01 --1.530313095505039522e-01 --1.618701968607250408e-01 --1.704676557936262993e-01 --1.787565361438492595e-01 --1.866672458803859125e-01 --1.941277511465787919e-01 --2.010635762601211129e-01 --2.073978037130566332e-01 --2.130510741717799306e-01 --2.179415864770356814e-01 --2.219850976439197709e-01 --2.250949228618781550e-01 --2.271819354947076652e-01 --2.281545670805558701e-01 --2.279188073319203534e-01 --2.263782041356500463e-01 --2.234338635529438677e-01 --2.189844498193516953e-01 --2.129261853447737829e-01 --2.051528507134613433e-01 --1.955557846840156599e-01 --1.840238841893888089e-01 --1.704436043368837417e-01 --1.546989584081536750e-01 --1.366715178592028124e-01 --1.162404123203854417e-01 --9.328232959640633815e-02 --6.767151566632190196e-02 --3.927977468353820167e-02 --7.976468975811900480e-03 -2.637148095474896661e-02 -6.389959643168688364e-02 -1.047458406041928830e-01 -1.490506184471076800e-01 -1.969567767609210762e-01 -2.486096041717725524e-01 -3.041568311314521988e-01 -3.637486299173966486e-01 -4.275376146326954618e-01 -4.956788412060836868e-01 -5.683298073919489379e-01 -6.456504527703275098e-01 -7.278031587469034891e-01 -8.149527485530140281e-01 -9.072664872456399632e-01 -1.004914081707416695e+00 -1.108067680646627862e+00 -1.216901874597203781e+00 -1.331593695918728670e+00 -1.452322618796431097e+00 -1.579270559241192862e+00 -1.712621875089545664e+00 -1.852563366003664891e+00 -1.999284273471383599e+00 -2.152976280806176312e+00 -2.313833513147172116e+00 -2.482052537459147779e+00 -2.657832362532533743e+00 -2.841374438983398143e+00 -3.032882659253470337e+00 -3.232563357610124921e+00 -3.440625310146385285e+00 -3.657279734780927605e+00 -3.882740291258070187e+00 -4.117223081147786345e+00 -4.360946647845698187e+00 -4.614131976573078830e+00 -4.877002494376850628e+00 -5.149784070129575397e+00 -5.432705014529476628e+00 -5.725996080100421715e+00 -6.029890461191930839e+00 -6.344623793979176973e+00 -6.670434156462962783e+00 From 8e677f0be9f6f315d5c9e0103bf53c69e3eee6f6 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 30 Aug 2023 12:42:25 +0200 Subject: [PATCH 085/120] black --- drivers/drivers/doublewell.py | 2 +- drivers/py/driver.py | 5 +- drivers/py/pes/doublewell.py | 94 +++++++++++++++++----------------- drivers/py/pes/harmonic.py | 2 +- ipi/engine/motion/instanton.py | 21 +++++--- ipi/engine/motion/vscf.py | 5 +- ipi/inputs/simulation.py | 5 +- ipi/utils/instools.py | 6 +-- ipi/utils/mathtools.py | 2 +- ipi_tests/test_tools.py | 13 +++-- setup.py | 5 +- 11 files changed, 91 insertions(+), 69 deletions(-) diff --git a/drivers/drivers/doublewell.py b/drivers/drivers/doublewell.py index 0b7547016..f2c2dd61e 100644 --- a/drivers/drivers/doublewell.py +++ b/drivers/drivers/doublewell.py @@ -46,7 +46,7 @@ def check_arguments(self): sys.exit(self.error_msg) self.A = -0.5 * m * (w_b) ** 2 - self.B = ((m ** 2) * (w_b) ** 4) / (16 * v0) + self.B = ((m**2) * (w_b) ** 4) / (16 * v0) def __call__(self, cell, pos): """DoubleWell potential l""" diff --git a/drivers/py/driver.py b/drivers/py/driver.py index afe1e77a9..a9790c782 100755 --- a/drivers/py/driver.py +++ b/drivers/py/driver.py @@ -212,5 +212,8 @@ def run_driver(unix=False, address="", port=12345, driver=Dummy_driver()): raise ValueError("Unsupported driver mode ", args.mode) run_driver( - unix=args.unix, address=args.address, port=args.port, driver=d_f, + unix=args.unix, + address=args.address, + port=args.port, + driver=d_f, ) diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 90c68c214..59e111e00 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -49,7 +49,7 @@ def check_arguments(self): sys.exit(self.error_msg) self.A = -0.5 * m * (w_b) ** 2 - self.B = ((m ** 2) * (w_b) ** 4) / (16 * v0) + self.B = ((m**2) * (w_b) ** 4) / (16 * v0) def __call__(self, cell, pos): """DoubleWell potential l""" @@ -114,7 +114,7 @@ def check_arguments(self): sys.exit(self.error_msg) self.A = -0.5 * m * (w_b) ** 2 - self.B = ((m ** 2) * (w_b) ** 4) / (16 * v0) + self.B = ((m**2) * (w_b) ** 4) / (16 * v0) def check_dimensions(self, pos): """Functions that checks dimensions of the received position""" @@ -123,13 +123,13 @@ def check_dimensions(self, pos): def SD(self, q): """Auxiliary function to compute friction tensor""" dx = q / self.deltaQ - SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx ** 2)) + self.eps2 * np.tanh(dx) + SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx**2)) + self.eps2 * np.tanh(dx) return SD def dSD_dq(self, q): """Auxiliary function to compute friction tensor""" dx = q / self.deltaQ - dsddq1 = self.eps1 * np.exp(-0.5 * (dx ** 2)) * (-dx / self.deltaQ) + dsddq1 = self.eps1 * np.exp(-0.5 * (dx**2)) * (-dx / self.deltaQ) dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) @@ -158,7 +158,7 @@ def __call__(self, cell, pos): class Harmonic_Bath_explicit(object): - """ Explicit description of an Harmonic bath """ + """Explicit description of an Harmonic bath""" def __init__(self, nbath, parameters): @@ -174,7 +174,7 @@ def __init__(self, nbath, parameters): self.set_ci_and_wi() def set_ci_and_wi(self): - """ Computes the the parameters to represent the harmonic bath """ + """Computes the the parameters to represent the harmonic bath""" omega = np.zeros(self.nbath) self.omega2 = np.zeros(self.nbath) @@ -192,19 +192,19 @@ def set_ci_and_wi(self): self.init = True def S(self, q): - """ S coupling function """ + """S coupling function""" return q * self.SD(q) def SD(self, q): """Auxiliary function to compute friction tensor""" dx = q / self.deltaQ - SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx ** 2)) + self.eps2 * np.tanh(dx) + SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx**2)) + self.eps2 * np.tanh(dx) return SD def dSD_dq(self, q): """Auxiliary function to compute friction tensor""" dx = q / self.deltaQ - dsddq1 = self.eps1 * np.exp(-0.5 * (dx ** 2)) * (-dx / self.deltaQ) + dsddq1 = self.eps1 * np.exp(-0.5 * (dx**2)) * (-dx / self.deltaQ) dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) @@ -220,7 +220,7 @@ def __call__(self, q, x): if self.w_c > 0: for i in range(self.nbath): aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) - pot_bath += 0.5 * self.m * self.omega2[i] * aux ** 2 + pot_bath += 0.5 * self.m * self.omega2[i] * aux**2 fq_bath += aux * self.coef[i] * self.dSD_dq(q) fx[i] -= (self.m * self.omega2[i] * aux).flatten() @@ -228,15 +228,14 @@ def __call__(self, q, x): class DoubleWell_with_explicit_bath_driver(Dummy_driver): - """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization + """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization -! V(q,x1,..,xn) = DW(q) + -! sum_2^(3*N) [ 0.5 m w_i^2(q - (c_i s(q))/(m w_i)^2)^2 ] -! s(q) = q *sd(q) -! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) -! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath - -""" + ! V(q,x1,..,xn) = DW(q) + + ! sum_2^(3*N) [ 0.5 m w_i^2(q - (c_i s(q))/(m w_i)^2)^2 ] + ! s(q) = q *sd(q) + ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) + ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath + """ def __init__(self, args=None): @@ -272,7 +271,7 @@ def check_arguments(self): sys.exit(self.error_msg) self.A = -0.5 * self.m * (w_b) ** 2 - self.B = ((self.m ** 2) * (w_b) ** 4) / (16 * v0) + self.B = ((self.m**2) * (w_b) ** 4) / (16 * v0) def __call__(self, cell, pos): """DoubleWell potential""" @@ -290,8 +289,8 @@ def __call__(self, cell, pos): pot, fq, fx = self.bath(q, x) # DW - pot += self.A * (q - self.delta) ** 2 + self.B * (q ** 4) - fq += -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q ** 3) + pot += self.A * (q - self.delta) ** 2 + self.B * (q**4) + fq += -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q**3) force = np.concatenate((fq, fx.flatten())).reshape(pos.shape) vir = cell * 0.0 # makes a zero virial with same shape as cell @@ -302,27 +301,26 @@ def __call__(self, cell, pos): class DDW_with_explicit_bath_driver(Dummy_driver): - """Adds to a double-double well (DDW) potential coupled to two (explicit) harmonic baths. - pos[0:2] = DDW - pos[2:n//2+1] = bath1 - pos[n//2+1:] = bath2 - where n = 3*natoms = # dofs - -! V(q1,q2,x1,..,xm,y1,...,ym) = -! DDW(q1,q2) + -! sum_i^(m) [ 0.5 m w_i^2(xi - (c_i s(q1))/(m w_i)^2)^2 ] + -! sum_i^(m) [ 0.5 m w_i^2(yi - (c_i s(q2))/(m w_i)^2)^2 ] + -! -! with -! s(q) = q *sd(q) -! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) -! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath -! -! and -! -! DDW(q1,q2) = DW(q1) + DW(q2) + C(q1q2)^2 - -""" + """Adds to a double-double well (DDW) potential coupled to two (explicit) harmonic baths. + pos[0:2] = DDW + pos[2:n//2+1] = bath1 + pos[n//2+1:] = bath2 + where n = 3*natoms = # dofs + + ! V(q1,q2,x1,..,xm,y1,...,ym) = + ! DDW(q1,q2) + + ! sum_i^(m) [ 0.5 m w_i^2(xi - (c_i s(q1))/(m w_i)^2)^2 ] + + ! sum_i^(m) [ 0.5 m w_i^2(yi - (c_i s(q2))/(m w_i)^2)^2 ] + + ! + ! with + ! s(q) = q *sd(q) + ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) + ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath + ! + ! and + ! + ! DDW(q1,q2) = DW(q1) + DW(q2) + C(q1q2)^2 + """ def __init__(self, args=None): @@ -362,10 +360,10 @@ def check_arguments(self): sys.exit(self.error_msg) self.A1 = -0.5 * self.m * (wb1) ** 2 - self.B1 = ((self.m ** 2) * (wb1) ** 4) / (16 * v1) + self.B1 = ((self.m**2) * (wb1) ** 4) / (16 * v1) self.A2 = -0.5 * self.m * (wb2) ** 2 - self.B2 = ((self.m ** 2) * (wb2) ** 4) / (16 * v2) + self.B2 = ((self.m**2) * (wb2) ** 4) / (16 * v2) def __call__(self, cell, pos): """DoubleWell potential""" @@ -396,11 +394,11 @@ def __call__(self, cell, pos): pot = pot_x + pot_y # DW - pot += self.A1 * (q1 - self.delta) ** 2 + self.B1 * (q1 ** 4) - fq1 += -2.0 * self.A1 * (q1 - self.delta) - 4.0 * self.B1 * (q1 ** 3) + pot += self.A1 * (q1 - self.delta) ** 2 + self.B1 * (q1**4) + fq1 += -2.0 * self.A1 * (q1 - self.delta) - 4.0 * self.B1 * (q1**3) - pot += self.A2 * (q2 - self.delta) ** 2 + self.B2 * (q2 ** 4) - fq2 += -2.0 * self.A2 * (q2 - self.delta) - 4.0 * self.B2 * (q2 ** 3) + pot += self.A2 * (q2 - self.delta) ** 2 + self.B2 * (q2**4) + fq2 += -2.0 * self.A2 * (q2 - self.delta) - 4.0 * self.B2 * (q2**3) # Coupling pot += self.C * q1 * q2 diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index 7b6fdfc4d..5ff48ff83 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -30,7 +30,7 @@ def check_arguments(self): def __call__(self, cell, pos): """Silly harmonic potential""" if self.type == "isotropic": - pot = 0.5 * self.k * (pos ** 2).sum() + pot = 0.5 * self.k * (pos**2).sum() force = -self.k * pos vir = cell * 0.0 # makes a zero virial with same shape as cell extras = "nada" diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 43dc9c623..a01d9478c 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -606,7 +606,7 @@ def compute_friction_terms(self): gq = self.obtain_g(s) gq_k = np.dot(self.C, gq) - e = 0.5 * np.sum(self.fric_LTwk * gq_k ** 2) + e = 0.5 * np.sum(self.fric_LTwk * gq_k**2) f = np.dot(self.C.T, self.fric_LTwk * gq_k) g = np.zeros(f.shape) @@ -769,7 +769,7 @@ def __call__(self, x, ret=True, new_disc=True): # g[i, :] += self.dbeads.m3[i, :] * self.omega2 * (self.dbeads.q[i, :] - self.dbeads.q[i - 1, :]) gq_k = np.dot(self.C, self.dbeads.q) g = self.dbeads.m3[0] * np.dot( - self.C.T, gq_k * (self.omegak ** 2)[:, np.newaxis] + self.C.T, gq_k * (self.omegak**2)[:, np.newaxis] ) # With new discretization #This can be expressed as matrix multp @@ -867,6 +867,7 @@ def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): def __call__(self, x, ret=True, new_disc=True): """Computes spring energy and gradient for instanton optimization step""" + class Mapper(object): """Creation of the multi-dimensional function that is the proxy between all the energy and force components and the optimization algorithm. It also handles fixatoms""" @@ -1089,7 +1090,7 @@ def exitstep(self, d_x_max, step): tolerances = self.options["tolerances"] d_u = self.forces.pot - self.optarrays["old_u"].sum() - # active_force = self.fix.get_active_vector(self.forces.f, 1) + self.im.f + # active_force = self.fix.get_active_vector(self.forces.f, 1) + self.im.f active_force = self.mapper.f @@ -1268,7 +1269,7 @@ def func(x): # c0 = 2*self.sm.dbeads.nbeads - 2*np.sum(coef) # coef = np.insert(coef,0,c0) - #self.im.set_coef(coef) + # self.im.set_coef(coef) fphys = self.gm.dforces.f * ((coef[1:] + coef[:-1]) / 2).reshape(-1, 1) e, gspring = self.sm(self.sm.dbeads.q) @@ -1417,7 +1418,7 @@ def initialize(self, step): self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) # self.optarrays["hessian"][:] = phys_hessian - # self.gm.save(self.forces.pots, self.forces.f) + # self.gm.save(self.forces.pots, self.forces.f) self.update_old_pos_for() self.init = True @@ -1592,7 +1593,11 @@ def step(self, step=None): if self.options["mode"] == "rate": d_x = nichols( - self.mapper.f, d, w, self.fix.fixbeads.m3, activearrays["big_step"], + self.mapper.f, + d, + w, + self.fix.fixbeads.m3, + activearrays["big_step"], ) elif self.options["mode"] == "splitting": d_x = nichols( @@ -1648,7 +1653,7 @@ def step(self, step=None): f = np.multiply(f, self.sm.dbeads.m3.reshape(f.shape) ** -0.5) d_x = invmul_banded(h_up_band, f).reshape(self.sm.dbeads.q.shape) - d_x = np.multiply(d_x, self.sm.dbeads.m3 ** -0.5) + d_x = np.multiply(d_x, self.sm.dbeads.m3**-0.5) # Rescale step if necessary if np.amax(np.absolute(d_x)) > activearrays["big_step"]: @@ -1784,7 +1789,7 @@ def step(self, step=None): d_x.shape = self.fix.fixbeads.q.shape # MASS-scaled - d_x = np.multiply(d_x, self.fix.fixbeads.m3 ** -0.5) + d_x = np.multiply(d_x, self.fix.fixbeads.m3**-0.5) # Rescale step if necessary if np.amax(np.absolute(d_x)) > activearrays["big_step"]: diff --git a/ipi/engine/motion/vscf.py b/ipi/engine/motion/vscf.py index b22f7737e..1d876f2c7 100644 --- a/ipi/engine/motion/vscf.py +++ b/ipi/engine/motion/vscf.py @@ -793,7 +793,10 @@ def bind(self, imm): if self.imm.w[inm] < 9.1126705e-06: info( " @NM: Ignoring normal mode no. %8d with frequency %15.8f cm^-1." - % (inm, self.imm.w[inm] * 219474,), + % ( + inm, + self.imm.w[inm] * 219474, + ), verbosity.medium, ) continue diff --git a/ipi/inputs/simulation.py b/ipi/inputs/simulation.py index bd9cd6a31..a6881ab54 100644 --- a/ipi/inputs/simulation.py +++ b/ipi/inputs/simulation.py @@ -218,7 +218,10 @@ def store(self, simul): if len(self.extra) != len(_fflist) + len(simul.syslist): self.extra = [0] * (len(_fflist) + len(simul.syslist)) - for (_ii, _obj,) in enumerate(_fflist + simul.syslist): + for ( + _ii, + _obj, + ) in enumerate(_fflist + simul.syslist): if self.extra[_ii] == 0: if isinstance(_obj, eforcefields.FFSocket): _iobj = iforcefields.InputFFSocket() diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index 1029c472c..a1e021a39 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -15,7 +15,7 @@ def banded_hessian(h, sm, masses=True, shift=0.001): natoms = sm.fix.fixbeads.natoms coef = sm.coef # new_disc m3 = sm.fix.fixbeads.m3 - omega2 = sm.omegan ** 2 + omega2 = sm.omegan**2 ii = natoms * 3 * nbeads ndiag = natoms * 3 + 1 # only upper diagonal form @@ -176,11 +176,11 @@ def get_imvector(h, m3): OUT imv = eigenvector corresponding to the imaginary mode """ info("@get_imvector", verbosity.high) - if h.size != m3.size ** 2: + if h.size != m3.size**2: raise ValueError( "@Get_imvector. Initial hessian size does not match system size." ) - m = 1.0 / (m3 ** 0.5) + m = 1.0 / (m3**0.5) mm = np.outer(m, m) hm = np.multiply(h, mm) diff --git a/ipi/utils/mathtools.py b/ipi/utils/mathtools.py index 0b85e36af..000043233 100644 --- a/ipi/utils/mathtools.py +++ b/ipi/utils/mathtools.py @@ -512,7 +512,7 @@ def LT_friction(freqs, spectral_density_over_w, forceit=False): if wk != 0: def f(w): - return spectral_density_over_w(w) * (wk / (wk ** 2 + w ** 2)) + return spectral_density_over_w(w) * (wk / (wk**2 + w**2)) # if np.mod(n,100)==0: # print('{} over {}'.format(n,freqs.size)) diff --git a/ipi_tests/test_tools.py b/ipi_tests/test_tools.py index d0a7a4322..ea4274c2a 100644 --- a/ipi_tests/test_tools.py +++ b/ipi_tests/test_tools.py @@ -54,7 +54,8 @@ def clean_tmp_dir(): def get_test_settings( - example_folder, settings_file="test_settings.dat", + example_folder, + settings_file="test_settings.dat", ): """This function looks for the existence of test_settings.dat file. This file can contain instructions like number of steps or driver name. @@ -148,7 +149,11 @@ def get_test_settings( def modify_xml_4_dummy_test( - input_name, output_name, nid, driver_info, test_settings, + input_name, + output_name, + nid, + driver_info, + test_settings, ): """Modify xml to run dummy tests""" try: @@ -225,7 +230,9 @@ class Runner(object): """ def __init__( - self, parent, call_ipi="i-pi input.xml", + self, + parent, + call_ipi="i-pi input.xml", ): """Store parent directory and commands to call i-pi and driver call_ipi: command to call i-pi diff --git a/setup.py b/setup.py index 4ffdb0625..69e020cf3 100644 --- a/setup.py +++ b/setup.py @@ -11,7 +11,10 @@ "ipi.tests", "ipi.tests.regression_tests", ], - package_dir={"ipi._driver": "drivers/py", "ipi.tests": "ipi_tests",}, + package_dir={ + "ipi._driver": "drivers/py", + "ipi.tests": "ipi_tests", + }, package_data={"ipi.tests.regression_tests": ["tests/NVE/NVE_1/harmonic_python/*"]}, scripts=[str(p) for p in Path("bin").iterdir()], ) From 84e336908a4a00fa4d7c0cac16199c5c18bbb67c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 30 Aug 2023 12:51:14 +0200 Subject: [PATCH 086/120] merge related bugfix --- ipi/engine/motion/instanton.py | 7 +++---- 1 file changed, 3 insertions(+), 4 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index a01d9478c..a08b50e51 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1291,7 +1291,9 @@ def bind(self, geop): self.options["hessian_asr"] = "none" # self.output_maker = geop.output_maker self.options["hessian_init"] = geop.options["hessian_init"] + print("ALBERTO", self.options["hessian_init"]) self.optarrays["initial_hessian"] = None + print(geop.optarrays["hessian"].size) if geop.optarrays["hessian"].size != ( self.beads.natoms * 3 * self.beads.q.size @@ -1302,10 +1304,7 @@ def bind(self, geop): (self.beads.natoms * 3, self.beads.q.size), float ) - elif ( - geop.optarrays["hessian"].size == 0 - and geop.options["hessian_init"] == "true" - ): + elif geop.optarrays["hessian"].size == 0 and geop.options["hessian_init"]: info( " Initial hessian is not provided. We are going to compute it.", verbosity.low, From 1ffdd28d6e98c26dd86a14783450f98558b8066c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 30 Aug 2023 12:53:55 +0200 Subject: [PATCH 087/120] merge related bugfix --- ipi/engine/motion/instanton.py | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index a08b50e51..38d0123d1 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -864,8 +864,8 @@ def spring_hessian(natoms, nbeads, m3, omega2, mode="half", coef=None): return h - def __call__(self, x, ret=True, new_disc=True): - """Computes spring energy and gradient for instanton optimization step""" + # def __call__(self, x, ret=True, new_disc=True): + # """Computes spring energy and gradient for instanton optimization step""" class Mapper(object): From f7b1c85dccc87dda7b4537de43b61bec012a9367 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Wed, 30 Aug 2023 14:12:31 +0200 Subject: [PATCH 088/120] black with stable version --- drivers/drivers/doublewell.py | 1 - drivers/drivers/spline.py | 2 -- drivers/py/pes/doublewell.py | 6 ------ drivers/py/pes/harmonic.py | 1 - drivers/py/pes/spline.py | 2 -- ipi/engine/motion/instanton.py | 26 -------------------------- ipi/utils/instools.py | 11 ++--------- ipi_tests/regression_tests/test_run.py | 1 - 8 files changed, 2 insertions(+), 48 deletions(-) diff --git a/drivers/drivers/doublewell.py b/drivers/drivers/doublewell.py index f2c2dd61e..23120ae72 100644 --- a/drivers/drivers/doublewell.py +++ b/drivers/drivers/doublewell.py @@ -20,7 +20,6 @@ class DoubleWell_driver(Dummy_driver): def __init__(self, args=None): - self.error_msg = """\nDW driver excepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -u \n python driver.py -m DoubleWell -o 500 2085 1837 0.00\n""" super(DoubleWell_driver, self).__init__(args) diff --git a/drivers/drivers/spline.py b/drivers/drivers/spline.py index f5ed5408e..e674f7bac 100644 --- a/drivers/drivers/spline.py +++ b/drivers/drivers/spline.py @@ -16,7 +16,6 @@ class Spline_driver(Dummy_driver): def __init__(self, args=None): - self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" super(Spline_driver, self).__init__(args) self.get_spline() @@ -76,7 +75,6 @@ def get_forces(self, pos): return force def get_friction(self, pos): - x = self.full2oneD(pos) friction_tensor = np.zeros(9) diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 59e111e00..45c9ad798 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -22,7 +22,6 @@ class DoubleWell_driver(Dummy_driver): def __init__(self, args=None): - self.error_msg = """\nDW driver accepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -o omega_b (cm^-1) V0 (cm^-1) mass(a.u) delta(angs) \n python driver.py -m DoubleWell -o 500,2085,1837,0.00 \n""" super(DoubleWell_driver, self).__init__(args) @@ -87,7 +86,6 @@ class DoubleWell_with_friction_driver(DoubleWell_driver): """ def __init__(self, args=None): - self.error_msg = """\nDW+fric driver expects 8 arguments.\n Example: python driver.py -m DoubleWell_with_fric -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ \n python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1\n""" @@ -161,7 +159,6 @@ class Harmonic_Bath_explicit(object): """Explicit description of an Harmonic bath""" def __init__(self, nbath, parameters): - self.nbath = nbath self.m = parameters["m"] # self.delta = parameters["delta"] @@ -211,7 +208,6 @@ def dSD_dq(self, q): return dSD_dq def __call__(self, q, x): - pot_bath = 0 fq_bath = np.zeros(q.shape) fx = np.zeros(x.shape) @@ -238,7 +234,6 @@ class DoubleWell_with_explicit_bath_driver(Dummy_driver): """ def __init__(self, args=None): - self.error_msg = """\nDW+explicit_bath driver expects 9 arguments.\n Example: python driver.py -m DoubleWell_with_explicit_bath -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1,500\n""" @@ -323,7 +318,6 @@ class DDW_with_explicit_bath_driver(Dummy_driver): """ def __init__(self, args=None): - self.error_msg = """\nDW+explicit_bath driver expects 11 arguments.\n Example: python driver.py -m DoubleWell_with_explicit_bath -o wb1 (cm^-1) V1 (cm^-1) wb2 (cm^-1) V2 (cm^-1) coupling(au) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n python driver.py -m DoubleWell -o 500,2085,500,2085,0.1,1837,0.00,1,0,0,1,500\n""" diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index 5ff48ff83..9a9710a65 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -7,7 +7,6 @@ class Harmonic_driver(Dummy_driver): def __init__(self, args=None): - self.error_msg = """\nHarmonic driver requires specification of force constant.\nExample: python driver.py -m harmonic -u -o 1.3\n""" super(Harmonic_driver, self).__init__(args) diff --git a/drivers/py/pes/spline.py b/drivers/py/pes/spline.py index f5ed5408e..e674f7bac 100644 --- a/drivers/py/pes/spline.py +++ b/drivers/py/pes/spline.py @@ -16,7 +16,6 @@ class Spline_driver(Dummy_driver): def __init__(self, args=None): - self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" super(Spline_driver, self).__init__(args) self.get_spline() @@ -76,7 +75,6 @@ def get_forces(self, pos): return force def get_friction(self, pos): - x = self.full2oneD(pos) friction_tensor = np.zeros(9) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 38d0123d1..6746ede0f 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -170,7 +170,6 @@ def __init__( or self.options["opt"] == "NR" or self.options["opt"] == "lanczos" ): - if self.options["friction"]: # and not self.options["frictionSD"]: self.options["eta0"] = eta @@ -219,7 +218,6 @@ def __init__( ) if self.options["friction"]: - found = util.find_spec("scipy") if found is None: softexit.trigger( @@ -271,7 +269,6 @@ def __init__(self): pass def bind(self, mapper): - self.dbeads = mapper.beads.copy() self.dcell = mapper.cell.copy() self.dforces = mapper.forces.copy(self.dbeads, self.dcell) @@ -416,13 +413,11 @@ class FrictionMapper(PesMapper): as well as the friction terms""" def __init__(self, frictionSD, eta0): - super(FrictionMapper, self).__init__() self.frictionSD = frictionSD self.eta0 = eta0 def bind(self, mapper): - super(FrictionMapper, self).bind(mapper) from scipy.interpolate import interp1d from scipy.linalg import sqrtm @@ -454,7 +449,6 @@ def initialize(self, q, forces): self.save(forces.pots, -forces.f, eta) def check_eta(self, eta): - for i in range(self.dbeads.nbeads): assert ( eta[i] - eta[i].T @@ -622,7 +616,6 @@ def get_full_extras(self, reduced_forces, full_mspath, indexes): if str(key) != "raw": red_data = np.array(reduced_forces.extras[key]) if self.spline: - red_mspath = full_mspath[indexes] spline = self.interp1d(red_mspath, red_data.T, kind="cubic") full_data = spline(full_mspath).T @@ -693,13 +686,11 @@ class SpringMapper(object): """ def __init__(self): - self.pot = None self.f = None pass def bind(self, mapper): - self.temp = mapper.temp self.fix = mapper.fix self.coef = mapper.coef @@ -873,13 +864,11 @@ class Mapper(object): It also handles fixatoms""" def __init__(self, esum=False): - self.sm = SpringMapper() self.gm = PesMapper() self.esum = esum def initialize(self, q, forces): - self.gm.initialize(q, forces) e1, g1 = self.gm.evaluate() @@ -894,7 +883,6 @@ def save(self, e, g): self.f = -g def bind(self, dumop): - self.temp = dumop.temp self.beads = dumop.beads self.forces = dumop.forces @@ -929,9 +917,7 @@ def set_coef(self, coef): self.coef[:] = coef.reshape(-1, 1) def __call__(self, x, mode="all", apply_fix=True, new_disc=True, ret=True): - if mode == "all": - e1, g1 = self.sm(x, new_disc) e2, g2 = self.gm(x, new_disc) e = e1 + e2 @@ -1126,7 +1112,6 @@ def exitstep(self, d_x_max, step): ) and (d_x_max <= tolerances["position"]) ): - print_instanton_geo( self.options["prefix"] + "_FINAL", step, @@ -1328,7 +1313,6 @@ def bind(self, geop): self.optarrays["hessian"] = geop.optarrays["hessian"] if self.options["friction"]: - if geop.options["eta0"].shape == (0, 0): geop.options["eta0"] = np.zeros( (self.beads.natoms * 3, self.beads.natoms * 3) @@ -1364,24 +1348,19 @@ def bind(self, geop): self.optarrays["fric_hessian"] = geop.optarrays["fric_hessian"] def initialize(self, step): - if step == 0: - info(" @GEOP: Initializing INSTANTON", verbosity.low) if self.beads.nbeads == 1: - info(" @GEOP: Classical TS search", verbosity.low) else: # If the coordinates in all the imaginary time slices are the same if ((self.beads.q - self.beads.q[0]) == 0).all(): - self.initial_geo() self.options["hessian_init"] = True else: - info( " @GEOP: Starting from the provided geometry in the extended phase space", verbosity.low, @@ -1426,7 +1405,6 @@ def update_hessian(self, update, active_hessian, new_x, d_x, d_g): """Update hessian""" if update == "powell": - i = self.fix.fixbeads.natoms * 3 for j in range(self.fix.fixbeads.nbeads): aux = active_hessian[:, j * i : (j + 1) * i] @@ -1537,7 +1515,6 @@ def step(self, step=None): # Add friction terms to the hessian if self.options["friction"]: - eta_active = self.fix.get_active_vector(self.mapper.gm.eta, 5) if self.options["frictionSD"]: h_fric = self.mapper.gm.get_fric_rp_hessian( @@ -1590,7 +1567,6 @@ def step(self, step=None): # Find new movement direction if self.options["mode"] == "rate": - d_x = nichols( self.mapper.f, d, @@ -1869,7 +1845,6 @@ def bind(self, geop): self.mapper.esum = True def initialize(self, step): - if step == 0: info(" @GEOP: Initializing instanton", verbosity.low) @@ -1910,7 +1885,6 @@ def initialize(self, step): self.init = True def post_step(self, step, activearrays): - """General tasks that have to be performed after the actual step""" # Update diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index a1e021a39..dac1d29cb 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -10,7 +10,8 @@ def banded_hessian(h, sm, masses=True, shift=0.001): """Given Hessian in the reduced format (h), construct the upper band hessian including the RP terms. If masses is True returns hessian otherwise it returns dynmat - shift is value that is added to the diagonal to avoid numerical problems with close to 0 frequencies""" + shift is value that is added to the diagonal to avoid numerical problems with close to 0 frequencies + """ nbeads = sm.fix.fixbeads.nbeads natoms = sm.fix.fixbeads.natoms coef = sm.coef # new_disc @@ -307,7 +308,6 @@ class Fix(object): """Class that applies a fixatoms type constrain""" def __init__(self, fixatoms, beads, nbeads=None): - self.natoms = beads.natoms if nbeads is None: self.nbeads = beads.nbeads @@ -339,7 +339,6 @@ def __init__(self, fixatoms, beads, nbeads=None): self.mask3 = np.arange(9 * self.natoms * self.nbeads)[mask3b] def get_mask(self, m): - if m == 0: return self.mask0 elif m == 1: @@ -357,7 +356,6 @@ def get_active_array(self, arrays): activearrays = {} for key in arrays: - if ( key == "old_u" or key == "big_step" @@ -403,14 +401,12 @@ def get_full_vector(self, vector, t): return vector if t == 1: - full_vector = np.zeros((self.nbeads, 3 * self.natoms)) full_vector[:, self.get_mask(1)] = vector return full_vector elif t == 2: - full_vector = np.zeros((3 * self.natoms, 3 * self.natoms * self.nbeads)) ii = 0 @@ -421,13 +417,11 @@ def get_full_vector(self, vector, t): return full_vector elif t == 3: - full_vector = np.zeros((vector.shape[0], 3 * self.natoms * self.nbeads)) full_vector[:, self.fix.get_mask(2)] = vector return full_vector elif t == 4: - full_vector = np.zeros( (self.nbeads, 3 * self.natoms, 3 * self.natoms, 3 * self.natoms) ) @@ -459,7 +453,6 @@ def get_full_vector(self, vector, t): return full_vector else: - raise ValueError("@apply_fix_atoms: type number is not valid") def get_active_vector(self, vector, t): diff --git a/ipi_tests/regression_tests/test_run.py b/ipi_tests/regression_tests/test_run.py index f6a9b05c1..aea4daac7 100644 --- a/ipi_tests/regression_tests/test_run.py +++ b/ipi_tests/regression_tests/test_run.py @@ -36,7 +36,6 @@ def test_regtest(regtest): if __name__ == "__main__": - parser = argparse.ArgumentParser( formatter_class=RawTextHelpFormatter, description="" From 48672e16380b6fa7212c9f0eb84d64e934f43fb4 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Fri, 1 Sep 2023 17:18:11 +0100 Subject: [PATCH 089/120] Nice bug catch of a corner case done by the automatic tests. Related to vectores shapes and fix dofs --- ipi/engine/motion/instanton.py | 21 +++++++++------------ ipi/utils/instools.py | 8 ++++---- 2 files changed, 13 insertions(+), 16 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 6746ede0f..a759e8970 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1161,8 +1161,8 @@ def exitstep(self, d_x_max, step): else: phys_hessian = current_hessian - self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) - # self.optarrays["hessian"][:] = phys_hessian #ALBERTO + #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) #ALBERTO + self.optarrays["hessian"][:] = phys_hessian #ALBERTO print_instanton_hess( self.options["prefix"] + "_FINAL", @@ -1276,7 +1276,6 @@ def bind(self, geop): self.options["hessian_asr"] = "none" # self.output_maker = geop.output_maker self.options["hessian_init"] = geop.options["hessian_init"] - print("ALBERTO", self.options["hessian_init"]) self.optarrays["initial_hessian"] = None print(geop.optarrays["hessian"].size) @@ -1375,7 +1374,7 @@ def initialize(self, step): self.mapper.initialize(self.beads.q, self.forces) if self.options["hessian_init"]: - active_hessian = get_hessian( + full_hessian = get_hessian( gm=self.mapper.gm, x0=self.beads.q.copy(), natoms=self.beads.natoms, @@ -1384,17 +1383,15 @@ def initialize(self, step): friction=self.options["frictionSD"], ) if self.options["friction"] and self.options["frictionSD"]: - phys_hessian = active_hessian[0] + full_hessian = active_hessian[0] friction_hessian = active_hessian[1] - self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( - friction_hessian, 4 - ) - # self.optarrays["fric_hessian"][:] = friction_hessian[:] # ALBERTO + #self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( friction_hessian, 4 ) #ALBERTO + self.optarrays["fric_hessian"][:] = friction_hessian[:] else: - phys_hessian = active_hessian + phys_hessian = full_hessian - self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) - # self.optarrays["hessian"][:] = phys_hessian + #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) #ALBERTO + self.optarrays["hessian"][:] = phys_hessian # self.gm.save(self.forces.pots, self.forces.f) self.update_old_pos_for() diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index dac1d29cb..e071df6d7 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -382,10 +382,10 @@ def get_active_array(self, arrays): return activearrays def get_full_vector(self, vector, t): - """Set 0 the degrees of freedom (dof) corresponding to the fix atoms + """From an active vector (i.e the subarray corresponding to the active degrees-of-freedom ) return + the full dimensional array. All the entries a corresponding to fix degrees-of-freedom are 0 IN: - fixatoms indexes of the fixed atoms - vector vector to be reduced + vector active vector t type of array: type=-1 : do nothing type=0 : names (natoms ) @@ -395,7 +395,7 @@ def get_full_vector(self, vector, t): type=4 : fric_hessian(nbeads,dof,dof,dof) type=5 : eta(nbeads,dof,dof) OUT: - clean_vector reduced vector + full_vector full dimensional vector """ if len(self.fixatoms) == 0 or t == -1: return vector From ecc816cec1adc172787d5da9c730721f3249a777 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Sep 2023 10:20:24 +0100 Subject: [PATCH 090/120] lint --- ipi/engine/motion/instanton.py | 10 +++++----- ipi/utils/instools.py | 2 +- 2 files changed, 6 insertions(+), 6 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index a759e8970..6f0b3bd37 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1161,8 +1161,8 @@ def exitstep(self, d_x_max, step): else: phys_hessian = current_hessian - #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) #ALBERTO - self.optarrays["hessian"][:] = phys_hessian #ALBERTO + # self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) #ALBERTO + self.optarrays["hessian"][:] = phys_hessian # ALBERTO print_instanton_hess( self.options["prefix"] + "_FINAL", @@ -1385,12 +1385,12 @@ def initialize(self, step): if self.options["friction"] and self.options["frictionSD"]: full_hessian = active_hessian[0] friction_hessian = active_hessian[1] - #self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( friction_hessian, 4 ) #ALBERTO - self.optarrays["fric_hessian"][:] = friction_hessian[:] + # self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( friction_hessian, 4 ) #ALBERTO + self.optarrays["fric_hessian"][:] = friction_hessian[:] else: phys_hessian = full_hessian - #self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) #ALBERTO + # self.optarrays["hessian"][:] = self.fix.get_full_vector(phys_hessian, 2) #ALBERTO self.optarrays["hessian"][:] = phys_hessian # self.gm.save(self.forces.pots, self.forces.f) diff --git a/ipi/utils/instools.py b/ipi/utils/instools.py index e071df6d7..a7db3e532 100644 --- a/ipi/utils/instools.py +++ b/ipi/utils/instools.py @@ -383,7 +383,7 @@ def get_active_array(self, arrays): def get_full_vector(self, vector, t): """From an active vector (i.e the subarray corresponding to the active degrees-of-freedom ) return - the full dimensional array. All the entries a corresponding to fix degrees-of-freedom are 0 + the full dimensional array. All the entries a corresponding to fix degrees-of-freedom are 0 IN: vector active vector t type of array: From 443130a477711759c9a4ba05f157d267b373ddd3 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Sep 2023 10:32:08 +0100 Subject: [PATCH 091/120] Solve some leftover inconsistencies after merge --- ipi/engine/motion/instanton.py | 4 ++-- ipi/inputs/motion/instanton.py | 2 +- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index 6f0b3bd37..d442d2526 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -1383,8 +1383,8 @@ def initialize(self, step): friction=self.options["frictionSD"], ) if self.options["friction"] and self.options["frictionSD"]: - full_hessian = active_hessian[0] - friction_hessian = active_hessian[1] + phys_hessian = full_hessian[0] + friction_hessian = full_hessian[1] # self.optarrays["fric_hessian"][:] = self.fix.get_full_vector( friction_hessian, 4 ) #ALBERTO self.optarrays["fric_hessian"][:] = friction_hessian[:] else: diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 7f2d8f06e..1d7d69cb2 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -144,7 +144,7 @@ class InputInst(InputDictionary): { "dtype": float, "default": input_default(factory=np.ones, args=(0,)), - "help": "LT of friction. A two column data is expected. First column: w (a.u.). Second column: LT(eta)(w)", + "help": "Laplace Transform (LT) of friction. A two column data is expected. First column: w (a.u.). Second column: LT(eta)(w)", }, ), "fric_spec_dens_ener": ( From d97c985c674754d385bcf44845268691726b359b Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Sep 2023 11:00:39 +0100 Subject: [PATCH 092/120] add some examples --- drivers/py/pes/doublewell.py | 4 +- .../explicit_harmonic_bath1/README.md | 3 + .../explicit_harmonic_bath1/init.xyz | 60 +++++++++++++++++++ .../explicit_harmonic_bath1/input.xml | 38 ++++++++++++ .../explicit_harmonic_bath1/run.sh | 8 +++ .../explicit_harmonic_bath2/README.md | 3 + .../explicit_harmonic_bath2/init.xyz | 60 +++++++++++++++++++ .../explicit_harmonic_bath2/input.xml | 38 ++++++++++++ .../explicit_harmonic_bath2/run.sh | 23 +++++++ 9 files changed, 236 insertions(+), 1 deletion(-) create mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/README.md create mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/init.xyz create mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/input.xml create mode 100755 examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh create mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/README.md create mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz create mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml create mode 100755 examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 45c9ad798..017d85014 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -116,7 +116,9 @@ def check_arguments(self): def check_dimensions(self, pos): """Functions that checks dimensions of the received position""" - assert pos.shape == (1, 3) + assert pos.shape == (1, 3), "We expect pos.shape (1,3), but we have {}".format( + pos.shape + ) def SD(self, q): """Auxiliary function to compute friction tensor""" diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/README.md b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/README.md new file mode 100644 index 000000000..b8e55864d --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/README.md @@ -0,0 +1,3 @@ +Ring Polymer Instanton calculation in a double well potential coupled to an (explicit) harmonic bath + + diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/init.xyz b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/init.xyz new file mode 100644 index 000000000..322a4c670 --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/init.xyz @@ -0,0 +1,60 @@ +4 + +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +4 + +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +4 + +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +4 + +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +4 + +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +4 + +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +4 + +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +4 + +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +4 + +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +4 + +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/input.xml b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/input.xml new file mode 100644 index 000000000..8cca98ffb --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/input.xml @@ -0,0 +1,38 @@ + + + [ step, potential{electronvolt}] + + 100 + +
localhost
+
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + powell + none + true + true + 0.05 + + + +
diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh new file mode 100755 index 000000000..989b41566 --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh @@ -0,0 +1,8 @@ + +#Launch i-pi and wait + i-pi input.xml & + sleep 2 +#Laun Driver + #i-pi-driver -u -m harmonic_bath -o 1,1.674,500 + i-pi-driver -u -m harmonic_bath -o 1,0.5,500 + diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/README.md b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/README.md new file mode 100644 index 000000000..b8e55864d --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/README.md @@ -0,0 +1,3 @@ +Ring Polymer Instanton calculation in a double well potential coupled to an (explicit) harmonic bath + + diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz new file mode 100644 index 000000000..322a4c670 --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz @@ -0,0 +1,60 @@ +4 + +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +4 + +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +4 + +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +4 + +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +4 + +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +4 + +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +4 + +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +4 + +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +4 + +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +4 + +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml new file mode 100644 index 000000000..8cca98ffb --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml @@ -0,0 +1,38 @@ + + + [ step, potential{electronvolt}] + + 100 + +
localhost
+
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + powell + none + true + true + 0.05 + + + +
diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh new file mode 100755 index 000000000..3d35d5d0e --- /dev/null +++ b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh @@ -0,0 +1,23 @@ +#Define model parameters + eta=1.674 + eta=0.5 + + wb=500 + wc=500 + V0=2085 + mass=1837.36223469 + x0=0 + epsilon=0 + delta=0 + deltaQ=1 + + address=localhost + model='DW_explicit' + + +#Launch i-pi and wait + i-pi input.xml & + sleep 3 + +#Launch driver + python3 /home/yl899/codes/other_i-pi/sabia/i-pi/drivers/py/driver.py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} From 5d54cb7ac0f88be94b952cf60d1cc35a29c15525 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 13:42:06 +0000 Subject: [PATCH 093/120] rename and reorganize instanton friction examples. Add symbolic link i-pi-driver-py --- bin/i-pi-driver-py | 1 + drivers/drivers/doublewell.py | 73 --- drivers/drivers/spline.py | 116 ----- .../double_well/explicit_harmonic_bath/README | 6 - .../explicit_harmonic_bath2/init.xyz | 60 --- .../explicit_harmonic_bath2/input.xml | 38 -- .../README.md | 0 .../clean.sh | 2 + .../init.xyz | 0 .../input.xml | 0 .../run.sh | 2 +- .../README.md | 0 .../RESTART | 417 ++++++++++++++++++ .../clean.sh | 2 + .../init.xyz | 0 .../input.xml | 0 .../run.sh | 2 +- .../simulation.instanton_FINAL.hess_22 | 1 + .../simulation.instanton_FINAL_22.ener | 11 + .../simulation.instanton_FINAL_22.xyz | 60 +++ .../simulation.instanton_FINAL_forces_22.xyz | 60 +++ .../meanfield_bath_pos_dependent}/README | 0 .../meanfield_bath_pos_dependent}/init.xyz | 0 .../meanfield_bath_pos_dependent}/input.xml | 0 .../z_friction.dat | 0 25 files changed, 556 insertions(+), 295 deletions(-) create mode 120000 bin/i-pi-driver-py delete mode 100644 drivers/drivers/doublewell.py delete mode 100644 drivers/drivers/spline.py delete mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath/README delete mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz delete mode 100644 examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath1 => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent}/README.md (100%) create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/clean.sh rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent}/init.xyz (100%) rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent}/input.xml (100%) rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath2 => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent}/run.sh (59%) rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath2 => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent}/README.md (100%) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/clean.sh rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath1 => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent}/init.xyz (100%) rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath1 => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent}/input.xml (100%) rename examples/features/{instanton/Rates/double_well/explicit_harmonic_bath1 => ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent}/run.sh (91%) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz rename examples/features/{instanton/Rates/double_well/meanfield_bath => ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent}/README (100%) rename examples/features/{instanton/Rates/double_well/meanfield_bath => ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent}/init.xyz (100%) rename examples/features/{instanton/Rates/double_well/meanfield_bath => ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent}/input.xml (100%) rename examples/features/{instanton/Rates/double_well/meanfield_bath => ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent}/z_friction.dat (100%) diff --git a/bin/i-pi-driver-py b/bin/i-pi-driver-py new file mode 120000 index 000000000..50876d765 --- /dev/null +++ b/bin/i-pi-driver-py @@ -0,0 +1 @@ +../drivers/py/driver.py \ No newline at end of file diff --git a/drivers/drivers/doublewell.py b/drivers/drivers/doublewell.py deleted file mode 100644 index 23120ae72..000000000 --- a/drivers/drivers/doublewell.py +++ /dev/null @@ -1,73 +0,0 @@ -""" Harmonic potential """ - -import sys -from .dummy import Dummy_driver -import numpy as np -from ipi.utils import units - -# np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) - -invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) - -# ------------DOUBLE WELL POTENTIAL----------------------------- -# -# m^2*w_b^4 -# V(x,w_b,v0) = - 0.5 *m*w_b^2*(x-delta)^2 + ---------- x^4 -# 16V0 -# -# --------------------------------------------------------- - - -class DoubleWell_driver(Dummy_driver): - def __init__(self, args=None): - self.error_msg = """\nDW driver excepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -u \n - python driver.py -m DoubleWell -o 500 2085 1837 0.00\n""" - super(DoubleWell_driver, self).__init__(args) - - def check_arguments(self): - """Function that checks the arguments required to run the driver""" - self.k = 1836 * (3800.0 / 219323.0) ** 2 - if self.args == "": - # We used Craig's values (J. Chem. Phys. 122, 084106, 2005) - w_b = 500 * invcm2au # Tc = 115K - v0 = 2085 * invcm2au - m = 1837 - self.delta = 00 - else: - try: - param = list(map(float, self.args)) - assert len(param) == 4 - w_b = param[0] * invcm2au - v0 = param[1] * invcm2au - m = param[2] - self.delta = param[3] - except: - sys.exit(self.error_msg) - - self.A = -0.5 * m * (w_b) ** 2 - self.B = ((m**2) * (w_b) ** 4) / (16 * v0) - - def __call__(self, cell, pos): - """DoubleWell potential l""" - pot = 0 - pos3 = pos.reshape(-1, 3) - force3 = np.zeros(pos.shape) - - # DW - pot += self.A * (pos3[:, 0] - self.delta) ** 2 + self.B * (pos3[:, 0] ** 4) - force3[:, 0] = -2.0 * self.A * (pos3[:, 0] - self.delta) - 4.0 * self.B * ( - pos3[:, 0] ** 3 - ) - - # Harmonic - pot += 0.5 * self.k * (pos3[:, 1] ** 2).sum() - pot += 0.5 * self.k * (pos3[:, 2] ** 2).sum() - force3[:, 1] = -self.k * pos3[:, 1] - force3[:, 2] = -self.k * pos3[:, 2] - - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "nada" - pos = pos3.reshape(pos.shape) - force = force3.reshape(pos.shape) - - return pot, force, vir, extras diff --git a/drivers/drivers/spline.py b/drivers/drivers/spline.py deleted file mode 100644 index e674f7bac..000000000 --- a/drivers/drivers/spline.py +++ /dev/null @@ -1,116 +0,0 @@ -""" spline potential """ - -import numpy as np -import sys -from .dummy import Dummy_driver -from scipy import interpolate -import json - -"""Spline driver. This is not a serious interpolation, use it if you know what you are doing. """ -factor_coord = 5 -mass = 1836 -friction = False -SI = True -fric_value = 0.165 - - -class Spline_driver(Dummy_driver): - def __init__(self, args=None): - self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" - super(Spline_driver, self).__init__(args) - self.get_spline() - if friction and not SI: - self.get_spline_fric() - self.k = 1836 * (3800.0 / 219323.0) ** 2 - - def check_arguments(self): - """Function that checks the arguments required to run the driver""" - - try: - data = np.loadtxt(self.args[0]).reshape(-1, 5) - except ValueError: - sys.exit(self.error_msg) - self.data = data - - def get_spline(self): - """Function that creates the 1D spline and its derivative""" - - self.spline_f = [] - for i in range(3): - self.spline_f.append( - interpolate.interp1d(self.data[:, 0], self.data[:, i + 1], kind="cubic") - ) - - self.spline_e = interpolate.interp1d( - factor_coord * self.data[:, 0], self.data[:, 4], kind="cubic" - ) - - def get_spline_fric(self): - """Function that creates the 1D spline for the friction""" - data = np.loadtxt(self.args[1]).reshape(-1, 10) - self.spline_fric = [] - for i in range(9): - self.spline_fric.append( - interpolate.interp1d( - factor_coord * data[:, 0], mass * data[:, i + 1], kind="cubic" - ) - ) - - def get_energy(self, pos): - x = self.full2oneD(pos) - - pot = self.spline_e(x) - pot += 0.5 * self.k * (pos[0, 1] ** 2 + pos[0, 2] ** 2) - return pot - - def get_forces(self, pos): - x = self.full2oneD(pos) - force = np.zeros(pos.shape) - d = 0.001 - force[0, 0] = -(self.spline_e(x + d) - self.spline_e(x - d)) / (2 * d) - # force[0, 0] = self.spline_f[0](x) #+ self.spline_f[1](x) + self.spline_f[2](x) - force[0, 1] = -self.k * pos[0, 1] - force[0, 2] = -self.k * pos[0, 2] - - return force - - def get_friction(self, pos): - x = self.full2oneD(pos) - - friction_tensor = np.zeros(9) - - if SI: - friction_tensor = np.eye(3) * fric_value - else: - for i in range(9): - friction_tensor[i] = self.spline_fric[i](x) - friction_tensor = friction_tensor.reshape((3, 3)) - - w = np.linalg.eigvals(friction_tensor) - assert (w >= 0).all() - assert (friction_tensor - friction_tensor.T == np.zeros((3, 3))).all() - return friction_tensor - - def full2oneD(self, pos): - """Function that gets the 1D coordinates from the pos vector""" - return factor_coord * pos[0, 0] - - def check_dimensions(self, pos): - """Functions that checks dimensions of the received position""" - assert pos.shape == (1, 3) - - def __call__(self, cell, pos): - """Evaluate energy, forces and friction""" - self.check_dimensions(pos) - vir = cell * 0.0 # makes a zero virial with same shape as cell - - pot = self.get_energy(pos) - force = self.get_forces(pos) - - if friction: - friction_tensor = self.get_friction(pos) - extras = json.dumps({"friction": friction_tensor.tolist()}) - else: - extras = "" - - return pot, force, vir, extras diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath/README b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath/README deleted file mode 100644 index de867b8e3..000000000 --- a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath/README +++ /dev/null @@ -1,6 +0,0 @@ -Commands: - [i-pi] - i-pi input.xml - [driver] - i-pi-driver -u -m harmonic_bath -o 1,1.674,500 - diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz deleted file mode 100644 index 322a4c670..000000000 --- a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/init.xyz +++ /dev/null @@ -1,60 +0,0 @@ -4 - -H -1.00 0.0 0.0 -H -1.00 0.0 0.0 -H -1.00 0.0 0.0 -H -1.00 0.0 0.0 -4 - -H -0.50 0.0 0.0 -H -0.50 0.0 0.0 -H -0.50 0.0 0.0 -H -0.50 0.0 0.0 -4 - -H -0.20 0.0 0.0 -H -0.20 0.0 0.0 -H -0.20 0.0 0.0 -H -0.20 0.0 0.0 -4 - -H -0.10 0.0 0.0 -H -0.10 0.0 0.0 -H -0.10 0.0 0.0 -H -0.10 0.0 0.0 -4 - -H -0.05 0.0 0.0 -H -0.05 0.0 0.0 -H -0.05 0.0 0.0 -H -0.05 0.0 0.0 -4 - -H 0.05 0.0 0.0 -H 0.05 0.0 0.0 -H 0.05 0.0 0.0 -H 0.05 0.0 0.0 -4 - -H 0.10 0.0 0.0 -H 0.10 0.0 0.0 -H 0.10 0.0 0.0 -H 0.10 0.0 0.0 -4 - -H 0.20 0.0 0.0 -H 0.20 0.0 0.0 -H 0.20 0.0 0.0 -H 0.20 0.0 0.0 -4 - -H 0.50 0.0 0.0 -H 0.50 0.0 0.0 -H 0.50 0.0 0.0 -H 0.50 0.0 0.0 -4 - -H 1.00 0.0 0.0 -H 1.00 0.0 0.0 -H 1.00 0.0 0.0 -H 1.00 0.0 0.0 diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml b/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml deleted file mode 100644 index 8cca98ffb..000000000 --- a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/input.xml +++ /dev/null @@ -1,38 +0,0 @@ - - - [ step, potential{electronvolt}] - - 100 - -
localhost
-
- - - init.xyz - [300.0, 300.0, 300.0 ] - - - - - - 100 - - - - -1 - - 5e-6 - 5e-6 - 1e-3 - - 0.1 - nichols - powell - none - true - true - 0.05 - - - -
diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/README.md similarity index 100% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/README.md rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/clean.sh new file mode 100755 index 000000000..4276dd3bf --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/clean.sh @@ -0,0 +1,2 @@ +#Remove simulation output files + rm -f *simulation* *RESTART* diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/init.xyz similarity index 100% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/init.xyz diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/input.xml similarity index 100% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/input.xml diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/run.sh similarity index 59% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/run.sh index 3d35d5d0e..f13d6e938 100755 --- a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/run.sh @@ -20,4 +20,4 @@ sleep 3 #Launch driver - python3 /home/yl899/codes/other_i-pi/sabia/i-pi/drivers/py/driver.py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/README.md similarity index 100% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath2/README.md rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART new file mode 100644 index 000000000..a97e77ead --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART @@ -0,0 +1,417 @@ + + + [ step, potential{electronvolt} ] + + 23 + 100 + + + + + + + + + 3.16681520e-04 + [ 1.00000000e+00 ] + + + + + 5.00000000e-06 + 5.00000000e-06 + + 5.00000000e-02 + + [ -4.08280679e-03, -3.46602968e-03, -2.33923783e-03, -1.03434556e-03, -1.28319037e-04, + -1.28319037e-04, -1.03434556e-03, -2.33923783e-03, -3.46602968e-03, -4.08280679e-03 ] + + + [ -6.74123475e-03, -3.31368158e-04, -2.56641258e-04, -1.73434050e-04, -3.45431088e-04, + -1.89782615e-04, -2.48082411e-04, -3.37915236e-04, -1.14210849e-04, -2.98352945e-04, + -3.07700533e-04, -3.71729651e-05, -6.51794608e-03, -3.04545678e-04, -2.33738518e-04, + -1.63672373e-04, -3.16318443e-04, -1.72718160e-04, -2.31014647e-04, -3.08655221e-04, + -1.03897424e-04, -2.75647312e-04, -2.80568315e-04, -3.38099648e-05, -5.76830191e-03, + -2.49099689e-04, -1.88418165e-04, -1.39532241e-04, -2.57230257e-04, -1.39061693e-04, + -1.92910729e-04, -2.49980840e-04, -8.35939892e-05, -2.27353814e-04, -2.26595684e-04, + -2.71947501e-05, -4.11584127e-03, -1.64858547e-04, -1.22908686e-04, -9.60811869e-05, + -1.69267439e-04, -9.06029088e-05, -1.30258416e-04, -1.63834838e-04, -5.44262891e-05, + -1.51698370e-04, -1.48092618e-04, -1.77005997e-05, -1.51160289e-03, -5.78861074e-05, + -4.27748591e-05, -3.45463100e-05, -5.92265764e-05, -3.15081132e-05, -4.62933337e-05, + -5.71837634e-05, -1.89191699e-05, -5.35291166e-05, -5.15998287e-05, -6.15176974e-06, + 1.51160289e-03, 5.78861074e-05, 4.27748591e-05, 3.45463100e-05, 5.92265764e-05, + 3.15081132e-05, 4.62933337e-05, 5.71837634e-05, 1.89191699e-05, 5.35291166e-05, + 5.15998287e-05, 6.15176974e-06, 4.11584127e-03, 1.64858547e-04, 1.22908686e-04, + 9.60811869e-05, 1.69267439e-04, 9.06029088e-05, 1.30258416e-04, 1.63834838e-04, + 5.44262891e-05, 1.51698370e-04, 1.48092618e-04, 1.77005997e-05, 5.76830191e-03, + 2.49099689e-04, 1.88418165e-04, 1.39532241e-04, 2.57230257e-04, 1.39061693e-04, + 1.92910729e-04, 2.49980840e-04, 8.35939892e-05, 2.27353814e-04, 2.26595684e-04, + 2.71947501e-05, 6.51794608e-03, 3.04545678e-04, 2.33738518e-04, 1.63672373e-04, + 3.16318443e-04, 1.72718160e-04, 2.31014647e-04, 3.08655221e-04, 1.03897424e-04, + 2.75647312e-04, 2.80568315e-04, 3.38099648e-05, 6.74123475e-03, 3.31368158e-04, + 2.56641258e-04, 1.73434050e-04, 3.45431088e-04, 1.89782615e-04, 2.48082411e-04, + 3.37915236e-04, 1.14210849e-04, 2.98352945e-04, 3.07700533e-04, 3.71729651e-05 ] + + nichols + + [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, + 1.00000000e+00 ] + + False + -1 + + [ -1.47785464e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, + -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, + -4.17125977e-04, -3.68845607e-05, -2.74457677e-03, -9.07946536e-04, -3.03664938e-04, + -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, + -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -4.88577796e-03, + -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, + -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, + -3.68845607e-05, -7.14701720e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, + -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, + -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -8.60821858e-03, -9.07946536e-04, + -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, + -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, + -8.60821858e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, + -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, + -4.17125977e-04, -3.68845607e-05, -7.14701720e-03, -9.07946536e-04, -3.03664938e-04, + -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, + -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -4.88577796e-03, + -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, + -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, + -3.68845607e-05, -2.74457677e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, + -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, + -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -1.47785464e-03, -9.07946536e-04, + -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, + -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, + -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, + 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, + 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, + 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, + 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, + 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, + 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, + 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, + 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, + 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, + 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, + 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, + 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, + 0.00000000e+00, 4.06575815e-17, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 4.06575815e-17, 7.61840764e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, -4.06575815e-17, 0.00000000e+00, + 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -6.77626358e-17, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -6.77626358e-17, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, + 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, + 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, + -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, + 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, + 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, + -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, + 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 6.77626358e-18, 2.63931583e-03, 0.00000000e+00, + -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.77626358e-18, + 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, + 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, + -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, + -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05 ] + + True + + + + + [ -1.01072780e+00, -4.68874120e-02, -3.59468317e-02, -2.52838796e-02, -4.86791004e-02, + -2.65598422e-02, -3.56249983e-02, -4.74854921e-02, -1.59759557e-02, -4.24677650e-02, + -4.31552318e-02, -5.19870877e-03, -9.19269284e-01, -4.23917888e-02, -3.24651981e-02, + -2.29308911e-02, -4.39927282e-02, -2.39852603e-02, -3.22592356e-02, -4.29011410e-02, + -1.44265930e-02, -3.84199320e-02, -3.89808531e-02, -4.69442999e-03, -7.39381375e-01, + -3.37645062e-02, -2.58127098e-02, -1.83570651e-02, -3.50150253e-02, -1.90676527e-02, + -2.57589463e-02, -3.41294814e-02, -1.14678155e-02, -3.06319441e-02, -3.10002665e-02, + -3.73150660e-03, -4.81234459e-01, -2.17577394e-02, -1.66041252e-02, -1.18901097e-02, + -2.25475638e-02, -1.22635502e-02, -1.66413273e-02, -2.19664552e-02, -7.37502356e-03, + -1.97592992e-02, -1.99456146e-02, -2.39966815e-03, -1.67247515e-01, -7.51435809e-03, + -5.72813931e-03, -4.11960115e-03, -7.78369258e-03, -4.23032996e-03, -5.75646515e-03, + -7.58074855e-03, -2.54389292e-03, -6.82851412e-03, -6.88187988e-03, -8.27707300e-04, + 1.67247515e-01, 7.51435809e-03, 5.72813931e-03, 4.11960115e-03, 7.78369258e-03, + 4.23032996e-03, 5.75646515e-03, 7.58074855e-03, 2.54389292e-03, 6.82851412e-03, + 6.88187988e-03, 8.27707300e-04, 4.81234459e-01, 2.17577394e-02, 1.66041252e-02, + 1.18901097e-02, 2.25475638e-02, 1.22635502e-02, 1.66413273e-02, 2.19664552e-02, + 7.37502356e-03, 1.97592992e-02, 1.99456146e-02, 2.39966815e-03, 7.39381375e-01, + 3.37645062e-02, 2.58127098e-02, 1.83570651e-02, 3.50150253e-02, 1.90676527e-02, + 2.57589463e-02, 3.41294814e-02, 1.14678155e-02, 3.06319441e-02, 3.10002665e-02, + 3.73150660e-03, 9.19269284e-01, 4.23917888e-02, 3.24651981e-02, 2.29308911e-02, + 4.39927282e-02, 2.39852603e-02, 3.22592356e-02, 4.29011410e-02, 1.44265930e-02, + 3.84199320e-02, 3.89808531e-02, 4.69442999e-03, 1.01072780e+00, 4.68874120e-02, + 3.59468317e-02, 2.52838796e-02, 4.86791004e-02, 2.65598422e-02, 3.56249983e-02, + 4.74854921e-02, 1.59759557e-02, 4.24677650e-02, 4.31552318e-02, 5.19870877e-03 ] + +

+ [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, + 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] +

+ [ 1.83736223e+03, 1.83736223e+03, 1.83736223e+03, 1.83736223e+03 ] + [ H, H, H, H ] +
+ + [ 3.00000000e+02, 1.83697020e-14, 1.83697020e-14, 0.00000000e+00, 3.00000000e+02, + 1.83697020e-14, 0.00000000e+00, 0.00000000e+00, 3.00000000e+02 ] + +
+
diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/clean.sh new file mode 100755 index 000000000..4276dd3bf --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/clean.sh @@ -0,0 +1,2 @@ +#Remove simulation output files + rm -f *simulation* *RESTART* diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/init.xyz similarity index 100% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/init.xyz diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/input.xml similarity index 100% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/input.xml diff --git a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/run.sh similarity index 91% rename from examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/run.sh index 989b41566..f6baa79a9 100755 --- a/examples/features/instanton/Rates/double_well/explicit_harmonic_bath1/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/run.sh @@ -2,7 +2,7 @@ #Launch i-pi and wait i-pi input.xml & sleep 2 -#Laun Driver +#Launch Driver #i-pi-driver -u -m harmonic_bath -o 1,1.674,500 i-pi-driver -u -m harmonic_bath -o 1,0.5,500 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 new file mode 100644 index 000000000..134871b06 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 @@ -0,0 +1 @@ +-1.477854642297198734e-03 -9.079465359124443830e-04 -3.036649378698210149e-04 -2.450809691770789930e-03 -7.086856821782530364e-04 -2.044262173923530991e-04 -1.579747592456479761e-03 -5.495789276197622555e-04 -1.162381917757483382e-04 -1.174726919036546803e-03 -4.171259769480094304e-04 -3.688456065309916334e-05 -2.744576773996022095e-03 -9.079465359126070133e-04 -3.036649378698210149e-04 -2.450809691771115191e-03 -7.086856821783614566e-04 -2.044262173923666517e-04 -1.579747592456642391e-03 -5.495789276197622555e-04 -1.162381917757754433e-04 -1.174726919036628119e-03 -4.171259769480365354e-04 -3.688456065310593960e-05 -4.885777959485072125e-03 -9.079465359125256981e-04 -3.036649378698481200e-04 -2.450809691771115191e-03 -7.086856821783885617e-04 -2.044262173923802042e-04 -1.579747592456696602e-03 -5.495789276197622555e-04 -1.162381917757686670e-04 -1.174726919036682329e-03 -4.171259769480771930e-04 -3.688456065310763367e-05 -7.147017201396439756e-03 -9.079465359126341183e-04 -3.036649378698481200e-04 -2.450809691771033659e-03 -7.086856821783479041e-04 -2.044262173923666517e-04 -1.579747592456764256e-03 -5.495789276198029131e-04 -1.162381917757754433e-04 -1.174726919036682329e-03 -4.171259769480636405e-04 -3.688456065310932773e-05 -8.608218578287314682e-03 -9.079465359125629947e-04 -3.036649378698277912e-04 -2.450809691771030190e-03 -7.086856821783546262e-04 -2.044262173923632635e-04 -1.579747592456666027e-03 -5.495789276197927216e-04 -1.162381917757737492e-04 -1.174726919036661946e-03 -4.171259769480433117e-04 -3.688456065310509257e-05 -8.608218578287640810e-03 -9.079465359125730778e-04 -3.036649378698413437e-04 -2.450809691771070956e-03 -7.086856821783681787e-04 -2.044262173923666517e-04 -1.579747592456682941e-03 -5.495789276198096351e-04 -1.162381917757754433e-04 -1.174726919036678859e-03 -4.171259769480534490e-04 -3.688456065310678663e-05 -7.147017201396006075e-03 -9.079465359126341183e-04 -3.036649378698481200e-04 -2.450809691771108252e-03 -7.086856821783614566e-04 -2.044262173923734279e-04 -1.579747592456764256e-03 -5.495789276198300181e-04 -1.162381917757754433e-04 -1.174726919036709434e-03 -4.171259769480636405e-04 -3.688456065310932773e-05 -4.885777959485939487e-03 -9.079465359125799082e-04 -3.036649378698345675e-04 -2.450809691770952561e-03 -7.086856821783343516e-04 -2.044262173923802042e-04 -1.579747592456764256e-03 -5.495789276198435706e-04 -1.162381917757686670e-04 -1.174726919036682329e-03 -4.171259769480500880e-04 -3.688456065310593960e-05 -2.744576773996455776e-03 -9.079465359125528032e-04 -3.036649378698210149e-04 -2.450809691771115191e-03 -7.086856821783614566e-04 -2.044262173923395466e-04 -1.579747592456506866e-03 -5.495789276197351504e-04 -1.162381917757686670e-04 -1.174726919036682329e-03 -4.171259769480365354e-04 -3.688456065310593960e-05 -1.477854642296765053e-03 -9.079465359124714880e-04 -3.036649378697939099e-04 -2.450809691770640744e-03 -7.086856821782530364e-04 -2.044262173923259941e-04 -1.579747592456506866e-03 -5.495789276197351504e-04 -1.162381917757551145e-04 -1.174726919036438383e-03 -4.171259769479823253e-04 -3.688456065310255147e-05 -9.079465359126612234e-04 1.250481991216644169e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216646771e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216646771e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216645557e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359125528032e-04 1.250481991216645210e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359125528032e-04 1.250481991216644516e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216645557e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216645557e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216646771e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216644169e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256806675e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256793014e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256820119e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378698481200e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378698481200e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256793014e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256793014e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256806675e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744029912e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744029912e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744014647e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744006320e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771074425e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744010483e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771074425e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744014647e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744021585e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744029912e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744031300e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744013259e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821780090909e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821783343516e-04 0.000000000000000000e+00 0.000000000000000000e+00 4.065758146820641628e-17 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821783343516e-04 0.000000000000000000e+00 0.000000000000000000e+00 4.065758146820641628e-17 7.618407641132628541e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821780090909e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132607724e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821788764527e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132662368e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173927190174e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147201128e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173927190174e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147268349e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173923937567e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173923937567e-04 0.000000000000000000e+00 0.000000000000000000e+00 -4.065758146820641628e-17 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173927190174e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329860035e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456940547e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329845464e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456723707e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329841300e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456723707e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329843382e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329839219e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276201146212e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755678940e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -6.776263578034402713e-17 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755692818e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276197893605e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755692818e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276197893605e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755689349e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755692818e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -6.776263578034402713e-17 4.581598566755678940e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276201146212e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942447680e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942464485e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917757483382e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942464485e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942447680e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917754230776e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327382486e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036628119e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327388037e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036628119e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327388037e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327389078e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327388037e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769484431112e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769481178506e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.776263578034402713e-18 2.639315834218475265e-03 0.000000000000000000e+00 -4.171259769481178506e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.776263578034402713e-18 2.639315834218475265e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769484431112e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218464857e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345213453e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345213453e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065272308071e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345086398e-05 -3.688456065304834136e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345128750e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345213453e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885344874640e-05 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener new file mode 100644 index 000000000..7a283f79a --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener @@ -0,0 +1,11 @@ +#Bead Energy (eV) +0 -0.11109882108420299 +1 -0.0943154626112268 +2 -0.06365389758180684 +3 -0.02814597370633024 +4 -0.0034917385208372695 +5 -0.0034917385208372642 +6 -0.02814597370633021 +7 -0.06365389758180683 +8 -0.0943154626112268 +9 -0.11109882108420309 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz new file mode 100644 index 000000000..444d06b92 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz @@ -0,0 +1,60 @@ +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 0 +H -0.5348541232080581 -0.024811750232936948 -0.019022244394218887 +H -0.013379653082377777 -0.025759870905132605 -0.014054863385410017 +H -0.018851937470266734 -0.025128240616751864 -0.008454111769641903 +H -0.022472973733640152 -0.022836765494468347 -0.0027510382405951366 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 1 +H -0.4864563622053626 -0.022432768841312054 -0.01717984318004767 +H -0.012134505160844227 -0.023279949524292798 -0.012692453306145133 +H -0.017070852532265184 -0.022702306420212013 -0.007634224340828866 +H -0.02033095271196232 -0.02062777940689945 -0.002484185403369972 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 2 +H -0.3912637786536233 -0.017867407434110402 -0.013659497945798682 +H -0.009714140655624117 -0.018529153695066913 -0.010090167403116586 +H -0.013631047539681055 -0.018060544033768836 -0.006068506716267914 +H -0.01620972694699658 -0.016404634800015343 -0.0019746282819481783 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 3 +H -0.25465831218809365 -0.011513700025975392 -0.008786524762181462 +H -0.0062919751562975695 -0.011931657074548553 -0.006489591382477243 +H -0.008806211277978782 -0.011624147668387732 -0.0039026944492845054 +H -0.01045617099190619 -0.010554764816250844 -0.0012698497152878357 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 4 +H -0.08850357482186076 -0.003976427108850816 -0.0030312008212020846 +H -0.0021799990734237993 -0.0041189527838122264 -0.0022385942363618875 +H -0.0030461902126435033 -0.00401155942813208 -0.001346170176684053 +H -0.0036134941028878884 -0.003641734050405462 -0.0004380038463501842 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 5 +H 0.08850357482186069 0.003976427108850813 0.003031200821202117 +H 0.002179999073423798 0.0041189527838122264 0.0022385942363622314 +H 0.0030461902126435016 0.0040115594281320815 0.0013461701766833525 +H 0.0036134941028878875 0.003641734050405474 0.00043800384635109453 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 6 +H 0.2546583121880934 0.011513700025975387 0.008786524762181492 +H 0.006291975156297566 0.011931657074548546 0.006489591382477585 +H 0.008806211277978777 0.011624147668387728 0.0039026944492838037 +H 0.010456170991906183 0.010554764816250853 0.0012698497152887453 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 7 +H 0.3912637786536232 0.017867407434110392 0.013659497945798713 +H 0.009714140655624114 0.01852915369506691 0.010090167403116928 +H 0.013631047539681048 0.018060544033768833 0.006068506716267213 +H 0.016209726946996576 0.016404634800015354 0.001974628281949088 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 8 +H 0.4864563622053627 0.022432768841312057 0.017179843180047706 +H 0.012134505160844229 0.0232799495242928 0.012692453306145478 +H 0.017070852532265184 0.022702306420212016 0.007634224340828166 +H 0.02033095271196232 0.020627779406899468 0.002484185403370883 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 9 +H 0.5348541232080584 0.024811750232936962 0.019022244394218926 +H 0.013379653082377783 0.025759870905132615 0.014054863385410366 +H 0.01885193747026674 0.02512824061675187 0.008454111769641205 +H 0.02247297373364016 0.022836765494468374 0.0027510382405960486 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz new file mode 100644 index 000000000..89a3979ed --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz @@ -0,0 +1,60 @@ +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0067412347451789685 -0.00033136815818743664 -0.00025664125758041907 +H -0.00017343404957779576 -0.00034543108751673826 -0.00018978261482237524 +H -0.00024808241099952586 -0.00033791523568359904 -0.00011421084911364058 +H -0.0002983529445770538 -0.00030770053286353406 -3.717296506424839e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.006517946084283843 -0.00030454567775130644 -0.00023373851754084727 +H -0.0001636723729839984 -0.00031631844291162475 -0.00017271815962912723 +H -0.0002310146465327905 -0.00030865522139660083 -0.00010389742378683749 +H -0.0002756473124096979 -0.0002805683153399247 -3.3809964816010384e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.005768301914374969 -0.00024909968865260897 -0.0001884181650740105 +H -0.00013953224108501357 -0.00025723025711272 -0.00013906169307489075 +H -0.00019291072877767397 -0.0002499808396499299 -8.35939891818199e-05 +H -0.00022735381443351628 -0.00022659568382739898 -2.7194750130916368e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.00411584126599374 -0.00016485854664692395 -0.00012290868638619492 +H -9.608118694903266e-05 -0.00016926743868503452 -9.06029087883054e-05 +H -0.0001302584155754721 -0.00016383483813829698 -5.442628909834236e-05 +H -0.0001516983696533509 -0.00014809261759109952 -1.7700599695048103e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.0015116028941607616 -5.788610744197028e-05 -4.277485913568424e-05 +H -3.454631004472836e-05 -5.922657643229126e-05 -3.150811319035038e-05 +H -4.629333367848433e-05 -5.718376339139894e-05 -1.891916990945284e-05 +H -5.352911660723943e-05 -5.159982865719587e-05 -6.151769743526251e-06 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H 0.0015116028941607603 5.788610744197017e-05 4.277485913568411e-05 +H 3.4546310044728204e-05 5.9226576432291167e-05 3.150811319034994e-05 +H 4.6293333678484304e-05 5.718376339139885e-05 1.8919169909453094e-05 +H 5.352911660723932e-05 5.159982865719576e-05 6.15176974352621e-06 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H 0.0041158412659937395 0.00016485854664692378 0.00012290868638619473 +H 9.60811869490325e-05 0.00016926743868503436 9.060290878830489e-05 +H 0.00013025841557547186 0.0001638348381382968 5.4426289098342586e-05 +H 0.0001516983696533506 0.00014809261759109933 1.7700599695048045e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H 0.005768301914374969 0.0002490996886526091 0.00018841816507401035 +H 0.0001395322410850139 0.0002572302571127199 0.00013906169307489031 +H 0.00019291072877767397 0.00024998083964992984 8.359398918182017e-05 +H 0.00022735381443351633 0.00022659568382739888 2.7194750130916327e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H 0.006517946084283845 0.0003045456777513065 0.00023373851754084727 +H 0.0001636723729839984 0.0003163184429116248 0.00017271815962912685 +H 0.00023101464653279077 0.00030865522139660094 0.00010389742378683776 +H 0.0002756473124096982 0.0002805683153399246 3.380996481601036e-05 +4 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H 0.0067412347451789685 0.0003313681581874368 0.00025664125758041907 +H 0.00017343404957779609 0.00034543108751673826 0.0001897826148223749 +H 0.00024808241099952586 0.00033791523568359937 0.0001142108491136409 +H 0.00029835294457705394 0.00030770053286353406 3.717296506424837e-05 diff --git a/examples/features/instanton/Rates/double_well/meanfield_bath/README b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/README similarity index 100% rename from examples/features/instanton/Rates/double_well/meanfield_bath/README rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/README diff --git a/examples/features/instanton/Rates/double_well/meanfield_bath/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/init.xyz similarity index 100% rename from examples/features/instanton/Rates/double_well/meanfield_bath/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/init.xyz diff --git a/examples/features/instanton/Rates/double_well/meanfield_bath/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/input.xml similarity index 100% rename from examples/features/instanton/Rates/double_well/meanfield_bath/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/input.xml diff --git a/examples/features/instanton/Rates/double_well/meanfield_bath/z_friction.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/z_friction.dat similarity index 100% rename from examples/features/instanton/Rates/double_well/meanfield_bath/z_friction.dat rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/z_friction.dat From 122e345b9a305577d58ed57ab5043dd6b4780603 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 14:00:42 +0000 Subject: [PATCH 094/120] more renaming and delete mistakenly uploaded files to pes/friction --- drivers/pes/harmonic_bath.f90 | 125 -- .../frictionD/test_friction_80K_D/MEP.dat | 0 .../frictionD/test_friction_80K_D/RESTART | 1064 ------------ .../frictionD/test_friction_80K_D/clean.sh | 4 - .../frictionD/test_friction_80K_D/get1D.sh | 6 - .../frictionD/test_friction_80K_D/init.xyz | 192 --- .../frictionD/test_friction_80K_D/input.xml | 45 - .../test_friction_80K_D/inst.fric_00 | 48 - .../test_friction_80K_D/inst.fric_01 | 48 - .../test_friction_80K_D/inst.fric_02 | 48 - .../test_friction_80K_D/inst.fric_03 | 48 - .../test_friction_80K_D/inst.fric_04 | 48 - .../test_friction_80K_D/inst.fric_05 | 48 - .../test_friction_80K_D/inst.fric_06 | 48 - .../test_friction_80K_D/inst.fric_07 | 48 - .../test_friction_80K_D/inst.fric_08 | 48 - .../test_friction_80K_D/inst.fric_09 | 48 - .../test_friction_80K_D/inst.fric_10 | 48 - .../test_friction_80K_D/inst.fric_11 | 48 - .../test_friction_80K_D/inst.fric_12 | 48 - .../test_friction_80K_D/inst.fric_13 | 48 - .../test_friction_80K_D/inst.fric_14 | 48 - .../test_friction_80K_D/inst.fric_15 | 48 - .../test_friction_80K_D/inst.fric_16 | 48 - .../test_friction_80K_D/inst.fric_17 | 48 - .../test_friction_80K_D/inst.fric_18 | 48 - .../test_friction_80K_D/inst.fric_19 | 48 - .../test_friction_80K_D/inst.fric_20 | 48 - .../test_friction_80K_D/inst.fric_21 | 48 - .../test_friction_80K_D/inst.fric_22 | 48 - .../test_friction_80K_D/inst.fric_23 | 48 - .../test_friction_80K_D/inst.fric_24 | 48 - .../test_friction_80K_D/inst.fric_25 | 48 - .../test_friction_80K_D/inst.fric_26 | 48 - .../test_friction_80K_D/inst.fric_27 | 48 - .../test_friction_80K_D/inst.fric_28 | 48 - .../test_friction_80K_D/inst.fric_29 | 48 - .../test_friction_80K_D/inst.fric_30 | 48 - .../test_friction_80K_D/inst.fric_31 | 48 - .../test_friction_80K_D/inst.fric_32 | 48 - .../test_friction_80K_D/inst.fric_33 | 48 - .../test_friction_80K_D/inst.fric_34 | 48 - .../test_friction_80K_D/inst.fric_35 | 48 - .../test_friction_80K_D/inst.fric_36 | 48 - .../test_friction_80K_D/inst.fric_37 | 48 - .../test_friction_80K_D/inst.fric_38 | 48 - .../test_friction_80K_D/inst.fric_39 | 48 - .../test_friction_80K_D/inst.fric_40 | 48 - .../test_friction_80K_D/inst.fric_41 | 48 - .../test_friction_80K_D/inst.fric_42 | 48 - .../test_friction_80K_D/inst.fric_43 | 48 - .../test_friction_80K_D/inst.fric_44 | 48 - .../test_friction_80K_D/inst.fric_45 | 48 - .../test_friction_80K_D/inst.fric_46 | 48 - .../test_friction_80K_D/inst.fric_47 | 48 - .../test_friction_80K_D/inst.fric_48 | 48 - .../test_friction_80K_D/inst.fric_49 | 48 - .../test_friction_80K_D/inst.fric_50 | 48 - .../test_friction_80K_D/inst.fric_51 | 48 - .../test_friction_80K_D/inst.fric_52 | 48 - .../test_friction_80K_D/inst.fric_53 | 48 - .../test_friction_80K_D/inst.fric_54 | 48 - .../test_friction_80K_D/inst.fric_55 | 48 - .../test_friction_80K_D/inst.fric_56 | 48 - .../test_friction_80K_D/inst.fric_57 | 48 - .../test_friction_80K_D/inst.fric_58 | 48 - .../test_friction_80K_D/inst.fric_59 | 48 - .../test_friction_80K_D/inst.fric_60 | 48 - .../test_friction_80K_D/inst.fric_61 | 48 - .../test_friction_80K_D/inst.fric_62 | 48 - .../test_friction_80K_D/inst.fric_63 | 48 - .../test_friction_80K_D/inst.instanton.hess_0 | 1 - .../inst.instanton.hess_10 | 1 - .../test_friction_80K_D/inst.instanton_0.ener | 65 - .../test_friction_80K_D/inst.instanton_0.xyz | 192 --- .../inst.instanton_10.ener | 65 - .../test_friction_80K_D/inst.instanton_10.xyz | 192 --- .../inst.instanton_FINAL.hess_10 | 1 - .../inst.instanton_FINAL_10.ener | 65 - .../inst.instanton_FINAL_10.xyz | 192 --- .../inst.instanton_FINAL_forces_10.xyz | 192 --- .../inst.instanton_forces_0.xyz | 192 --- .../inst.instanton_forces_10.xyz | 192 --- .../inst.instantonfric_FINAL.hess_10 | 1 - .../frictionD/test_friction_80K_D/inst.raw_00 | 24 - .../frictionD/test_friction_80K_D/inst.raw_01 | 24 - .../frictionD/test_friction_80K_D/inst.raw_02 | 24 - .../frictionD/test_friction_80K_D/inst.raw_03 | 24 - .../frictionD/test_friction_80K_D/inst.raw_04 | 24 - .../frictionD/test_friction_80K_D/inst.raw_05 | 24 - .../frictionD/test_friction_80K_D/inst.raw_06 | 24 - .../frictionD/test_friction_80K_D/inst.raw_07 | 24 - .../frictionD/test_friction_80K_D/inst.raw_08 | 24 - .../frictionD/test_friction_80K_D/inst.raw_09 | 24 - .../frictionD/test_friction_80K_D/inst.raw_10 | 24 - .../frictionD/test_friction_80K_D/inst.raw_11 | 24 - .../frictionD/test_friction_80K_D/inst.raw_12 | 24 - .../frictionD/test_friction_80K_D/inst.raw_13 | 24 - .../frictionD/test_friction_80K_D/inst.raw_14 | 24 - .../frictionD/test_friction_80K_D/inst.raw_15 | 24 - .../frictionD/test_friction_80K_D/inst.raw_16 | 24 - .../frictionD/test_friction_80K_D/inst.raw_17 | 24 - .../frictionD/test_friction_80K_D/inst.raw_18 | 24 - .../frictionD/test_friction_80K_D/inst.raw_19 | 24 - .../frictionD/test_friction_80K_D/inst.raw_20 | 24 - .../frictionD/test_friction_80K_D/inst.raw_21 | 24 - .../frictionD/test_friction_80K_D/inst.raw_22 | 24 - .../frictionD/test_friction_80K_D/inst.raw_23 | 24 - .../frictionD/test_friction_80K_D/inst.raw_24 | 24 - .../frictionD/test_friction_80K_D/inst.raw_25 | 24 - .../frictionD/test_friction_80K_D/inst.raw_26 | 24 - .../frictionD/test_friction_80K_D/inst.raw_27 | 24 - .../frictionD/test_friction_80K_D/inst.raw_28 | 24 - .../frictionD/test_friction_80K_D/inst.raw_29 | 24 - .../frictionD/test_friction_80K_D/inst.raw_30 | 24 - .../frictionD/test_friction_80K_D/inst.raw_31 | 24 - .../frictionD/test_friction_80K_D/inst.raw_32 | 24 - .../frictionD/test_friction_80K_D/inst.raw_33 | 24 - .../frictionD/test_friction_80K_D/inst.raw_34 | 24 - .../frictionD/test_friction_80K_D/inst.raw_35 | 24 - .../frictionD/test_friction_80K_D/inst.raw_36 | 24 - .../frictionD/test_friction_80K_D/inst.raw_37 | 24 - .../frictionD/test_friction_80K_D/inst.raw_38 | 24 - .../frictionD/test_friction_80K_D/inst.raw_39 | 24 - .../frictionD/test_friction_80K_D/inst.raw_40 | 24 - .../frictionD/test_friction_80K_D/inst.raw_41 | 24 - .../frictionD/test_friction_80K_D/inst.raw_42 | 24 - .../frictionD/test_friction_80K_D/inst.raw_43 | 24 - .../frictionD/test_friction_80K_D/inst.raw_44 | 24 - .../frictionD/test_friction_80K_D/inst.raw_45 | 24 - .../frictionD/test_friction_80K_D/inst.raw_46 | 24 - .../frictionD/test_friction_80K_D/inst.raw_47 | 24 - .../frictionD/test_friction_80K_D/inst.raw_48 | 24 - .../frictionD/test_friction_80K_D/inst.raw_49 | 24 - .../frictionD/test_friction_80K_D/inst.raw_50 | 24 - .../frictionD/test_friction_80K_D/inst.raw_51 | 24 - .../frictionD/test_friction_80K_D/inst.raw_52 | 24 - .../frictionD/test_friction_80K_D/inst.raw_53 | 24 - .../frictionD/test_friction_80K_D/inst.raw_54 | 24 - .../frictionD/test_friction_80K_D/inst.raw_55 | 24 - .../frictionD/test_friction_80K_D/inst.raw_56 | 24 - .../frictionD/test_friction_80K_D/inst.raw_57 | 24 - .../frictionD/test_friction_80K_D/inst.raw_58 | 24 - .../frictionD/test_friction_80K_D/inst.raw_59 | 24 - .../frictionD/test_friction_80K_D/inst.raw_60 | 24 - .../frictionD/test_friction_80K_D/inst.raw_61 | 24 - .../frictionD/test_friction_80K_D/inst.raw_62 | 24 - .../frictionD/test_friction_80K_D/inst.raw_63 | 24 - .../frictionD/test_friction_80K_D/inst1D.dat | 64 - .../py/pes/friction/frictionH/060K/MEP.dat | 0 .../py/pes/friction/frictionH/060K/RESTART | 1063 ------------ .../py/pes/friction/frictionH/060K/clean.sh | 4 - .../py/pes/friction/frictionH/060K/get1D.sh | 6 - .../py/pes/friction/frictionH/060K/init.xyz | 192 --- .../py/pes/friction/frictionH/060K/input.xml | 45 - .../pes/friction/frictionH/060K/inst.fric_00 | 68 - .../pes/friction/frictionH/060K/inst.fric_01 | 68 - .../pes/friction/frictionH/060K/inst.fric_02 | 68 - .../pes/friction/frictionH/060K/inst.fric_03 | 68 - .../pes/friction/frictionH/060K/inst.fric_04 | 68 - .../pes/friction/frictionH/060K/inst.fric_05 | 68 - .../pes/friction/frictionH/060K/inst.fric_06 | 68 - .../pes/friction/frictionH/060K/inst.fric_07 | 68 - .../pes/friction/frictionH/060K/inst.fric_08 | 68 - .../pes/friction/frictionH/060K/inst.fric_09 | 68 - .../pes/friction/frictionH/060K/inst.fric_10 | 68 - .../pes/friction/frictionH/060K/inst.fric_11 | 68 - .../pes/friction/frictionH/060K/inst.fric_12 | 68 - .../pes/friction/frictionH/060K/inst.fric_13 | 68 - .../pes/friction/frictionH/060K/inst.fric_14 | 68 - .../pes/friction/frictionH/060K/inst.fric_15 | 68 - .../pes/friction/frictionH/060K/inst.fric_16 | 68 - .../pes/friction/frictionH/060K/inst.fric_17 | 68 - .../pes/friction/frictionH/060K/inst.fric_18 | 68 - .../pes/friction/frictionH/060K/inst.fric_19 | 68 - .../pes/friction/frictionH/060K/inst.fric_20 | 68 - .../pes/friction/frictionH/060K/inst.fric_21 | 68 - .../pes/friction/frictionH/060K/inst.fric_22 | 68 - .../pes/friction/frictionH/060K/inst.fric_23 | 68 - .../pes/friction/frictionH/060K/inst.fric_24 | 68 - .../pes/friction/frictionH/060K/inst.fric_25 | 68 - .../pes/friction/frictionH/060K/inst.fric_26 | 68 - .../pes/friction/frictionH/060K/inst.fric_27 | 68 - .../pes/friction/frictionH/060K/inst.fric_28 | 68 - .../pes/friction/frictionH/060K/inst.fric_29 | 68 - .../pes/friction/frictionH/060K/inst.fric_30 | 68 - .../pes/friction/frictionH/060K/inst.fric_31 | 68 - .../pes/friction/frictionH/060K/inst.fric_32 | 68 - .../pes/friction/frictionH/060K/inst.fric_33 | 68 - .../pes/friction/frictionH/060K/inst.fric_34 | 68 - .../pes/friction/frictionH/060K/inst.fric_35 | 68 - .../pes/friction/frictionH/060K/inst.fric_36 | 68 - .../pes/friction/frictionH/060K/inst.fric_37 | 68 - .../pes/friction/frictionH/060K/inst.fric_38 | 68 - .../pes/friction/frictionH/060K/inst.fric_39 | 68 - .../pes/friction/frictionH/060K/inst.fric_40 | 68 - .../pes/friction/frictionH/060K/inst.fric_41 | 68 - .../pes/friction/frictionH/060K/inst.fric_42 | 68 - .../pes/friction/frictionH/060K/inst.fric_43 | 68 - .../pes/friction/frictionH/060K/inst.fric_44 | 68 - .../pes/friction/frictionH/060K/inst.fric_45 | 68 - .../pes/friction/frictionH/060K/inst.fric_46 | 68 - .../pes/friction/frictionH/060K/inst.fric_47 | 68 - .../pes/friction/frictionH/060K/inst.fric_48 | 68 - .../pes/friction/frictionH/060K/inst.fric_49 | 68 - .../pes/friction/frictionH/060K/inst.fric_50 | 68 - .../pes/friction/frictionH/060K/inst.fric_51 | 68 - .../pes/friction/frictionH/060K/inst.fric_52 | 68 - .../pes/friction/frictionH/060K/inst.fric_53 | 68 - .../pes/friction/frictionH/060K/inst.fric_54 | 68 - .../pes/friction/frictionH/060K/inst.fric_55 | 68 - .../pes/friction/frictionH/060K/inst.fric_56 | 68 - .../pes/friction/frictionH/060K/inst.fric_57 | 68 - .../pes/friction/frictionH/060K/inst.fric_58 | 68 - .../pes/friction/frictionH/060K/inst.fric_59 | 68 - .../pes/friction/frictionH/060K/inst.fric_60 | 68 - .../pes/friction/frictionH/060K/inst.fric_61 | 68 - .../pes/friction/frictionH/060K/inst.fric_62 | 68 - .../pes/friction/frictionH/060K/inst.fric_63 | 68 - .../frictionH/060K/inst.instanton.hess_0 | 1 - .../frictionH/060K/inst.instanton.hess_1 | 1 - .../frictionH/060K/inst.instanton.hess_10 | 1 - .../frictionH/060K/inst.instanton.hess_11 | 1 - .../frictionH/060K/inst.instanton.hess_12 | 1 - .../frictionH/060K/inst.instanton.hess_13 | 1 - .../frictionH/060K/inst.instanton.hess_14 | 1 - .../frictionH/060K/inst.instanton.hess_15 | 1 - .../frictionH/060K/inst.instanton.hess_2 | 1 - .../frictionH/060K/inst.instanton.hess_3 | 1 - .../frictionH/060K/inst.instanton.hess_4 | 1 - .../frictionH/060K/inst.instanton.hess_5 | 1 - .../frictionH/060K/inst.instanton.hess_6 | 1 - .../frictionH/060K/inst.instanton.hess_7 | 1 - .../frictionH/060K/inst.instanton.hess_8 | 1 - .../frictionH/060K/inst.instanton.hess_9 | 1 - .../frictionH/060K/inst.instanton_0.ener | 65 - .../frictionH/060K/inst.instanton_0.xyz | 192 --- .../frictionH/060K/inst.instanton_1.ener | 65 - .../frictionH/060K/inst.instanton_1.xyz | 192 --- .../frictionH/060K/inst.instanton_10.ener | 65 - .../frictionH/060K/inst.instanton_10.xyz | 192 --- .../frictionH/060K/inst.instanton_11.ener | 65 - .../frictionH/060K/inst.instanton_11.xyz | 192 --- .../frictionH/060K/inst.instanton_12.ener | 65 - .../frictionH/060K/inst.instanton_12.xyz | 192 --- .../frictionH/060K/inst.instanton_13.ener | 65 - .../frictionH/060K/inst.instanton_13.xyz | 192 --- .../frictionH/060K/inst.instanton_14.ener | 65 - .../frictionH/060K/inst.instanton_14.xyz | 192 --- .../frictionH/060K/inst.instanton_15.ener | 65 - .../frictionH/060K/inst.instanton_15.xyz | 192 --- .../frictionH/060K/inst.instanton_2.ener | 65 - .../frictionH/060K/inst.instanton_2.xyz | 192 --- .../frictionH/060K/inst.instanton_3.ener | 65 - .../frictionH/060K/inst.instanton_3.xyz | 192 --- .../frictionH/060K/inst.instanton_4.ener | 65 - .../frictionH/060K/inst.instanton_4.xyz | 192 --- .../frictionH/060K/inst.instanton_5.ener | 65 - .../frictionH/060K/inst.instanton_5.xyz | 192 --- .../frictionH/060K/inst.instanton_6.ener | 65 - .../frictionH/060K/inst.instanton_6.xyz | 192 --- .../frictionH/060K/inst.instanton_7.ener | 65 - .../frictionH/060K/inst.instanton_7.xyz | 192 --- .../frictionH/060K/inst.instanton_8.ener | 65 - .../frictionH/060K/inst.instanton_8.xyz | 192 --- .../frictionH/060K/inst.instanton_9.ener | 65 - .../frictionH/060K/inst.instanton_9.xyz | 192 --- .../060K/inst.instanton_FINAL.hess_15 | 1 - .../060K/inst.instanton_FINAL_15.ener | 65 - .../060K/inst.instanton_FINAL_15.xyz | 192 --- .../060K/inst.instanton_FINAL_forces_15.xyz | 192 --- .../060K/inst.instanton_forces_0.xyz | 192 --- .../060K/inst.instanton_forces_1.xyz | 192 --- .../060K/inst.instanton_forces_10.xyz | 192 --- .../060K/inst.instanton_forces_11.xyz | 192 --- .../060K/inst.instanton_forces_12.xyz | 192 --- .../060K/inst.instanton_forces_13.xyz | 192 --- .../060K/inst.instanton_forces_14.xyz | 192 --- .../060K/inst.instanton_forces_15.xyz | 192 --- .../060K/inst.instanton_forces_2.xyz | 192 --- .../060K/inst.instanton_forces_3.xyz | 192 --- .../060K/inst.instanton_forces_4.xyz | 192 --- .../060K/inst.instanton_forces_5.xyz | 192 --- .../060K/inst.instanton_forces_6.xyz | 192 --- .../060K/inst.instanton_forces_7.xyz | 192 --- .../060K/inst.instanton_forces_8.xyz | 192 --- .../060K/inst.instanton_forces_9.xyz | 192 --- .../060K/inst.instantonfric_FINAL.hess_15 | 1 - .../pes/friction/frictionH/060K/inst.raw_00 | 34 - .../pes/friction/frictionH/060K/inst.raw_01 | 34 - .../pes/friction/frictionH/060K/inst.raw_02 | 34 - .../pes/friction/frictionH/060K/inst.raw_03 | 34 - .../pes/friction/frictionH/060K/inst.raw_04 | 34 - .../pes/friction/frictionH/060K/inst.raw_05 | 34 - .../pes/friction/frictionH/060K/inst.raw_06 | 34 - .../pes/friction/frictionH/060K/inst.raw_07 | 34 - .../pes/friction/frictionH/060K/inst.raw_08 | 34 - .../pes/friction/frictionH/060K/inst.raw_09 | 34 - .../pes/friction/frictionH/060K/inst.raw_10 | 34 - .../pes/friction/frictionH/060K/inst.raw_11 | 34 - .../pes/friction/frictionH/060K/inst.raw_12 | 34 - .../pes/friction/frictionH/060K/inst.raw_13 | 34 - .../pes/friction/frictionH/060K/inst.raw_14 | 34 - .../pes/friction/frictionH/060K/inst.raw_15 | 34 - .../pes/friction/frictionH/060K/inst.raw_16 | 34 - .../pes/friction/frictionH/060K/inst.raw_17 | 34 - .../pes/friction/frictionH/060K/inst.raw_18 | 34 - .../pes/friction/frictionH/060K/inst.raw_19 | 34 - .../pes/friction/frictionH/060K/inst.raw_20 | 34 - .../pes/friction/frictionH/060K/inst.raw_21 | 34 - .../pes/friction/frictionH/060K/inst.raw_22 | 34 - .../pes/friction/frictionH/060K/inst.raw_23 | 34 - .../pes/friction/frictionH/060K/inst.raw_24 | 34 - .../pes/friction/frictionH/060K/inst.raw_25 | 34 - .../pes/friction/frictionH/060K/inst.raw_26 | 34 - .../pes/friction/frictionH/060K/inst.raw_27 | 34 - .../pes/friction/frictionH/060K/inst.raw_28 | 34 - .../pes/friction/frictionH/060K/inst.raw_29 | 34 - .../pes/friction/frictionH/060K/inst.raw_30 | 34 - .../pes/friction/frictionH/060K/inst.raw_31 | 34 - .../pes/friction/frictionH/060K/inst.raw_32 | 34 - .../pes/friction/frictionH/060K/inst.raw_33 | 34 - .../pes/friction/frictionH/060K/inst.raw_34 | 34 - .../pes/friction/frictionH/060K/inst.raw_35 | 34 - .../pes/friction/frictionH/060K/inst.raw_36 | 34 - .../pes/friction/frictionH/060K/inst.raw_37 | 34 - .../pes/friction/frictionH/060K/inst.raw_38 | 34 - .../pes/friction/frictionH/060K/inst.raw_39 | 34 - .../pes/friction/frictionH/060K/inst.raw_40 | 34 - .../pes/friction/frictionH/060K/inst.raw_41 | 34 - .../pes/friction/frictionH/060K/inst.raw_42 | 34 - .../pes/friction/frictionH/060K/inst.raw_43 | 34 - .../pes/friction/frictionH/060K/inst.raw_44 | 34 - .../pes/friction/frictionH/060K/inst.raw_45 | 34 - .../pes/friction/frictionH/060K/inst.raw_46 | 34 - .../pes/friction/frictionH/060K/inst.raw_47 | 34 - .../pes/friction/frictionH/060K/inst.raw_48 | 34 - .../pes/friction/frictionH/060K/inst.raw_49 | 34 - .../pes/friction/frictionH/060K/inst.raw_50 | 34 - .../pes/friction/frictionH/060K/inst.raw_51 | 34 - .../pes/friction/frictionH/060K/inst.raw_52 | 34 - .../pes/friction/frictionH/060K/inst.raw_53 | 34 - .../pes/friction/frictionH/060K/inst.raw_54 | 34 - .../pes/friction/frictionH/060K/inst.raw_55 | 34 - .../pes/friction/frictionH/060K/inst.raw_56 | 34 - .../pes/friction/frictionH/060K/inst.raw_57 | 34 - .../pes/friction/frictionH/060K/inst.raw_58 | 34 - .../pes/friction/frictionH/060K/inst.raw_59 | 34 - .../pes/friction/frictionH/060K/inst.raw_60 | 34 - .../pes/friction/frictionH/060K/inst.raw_61 | 34 - .../pes/friction/frictionH/060K/inst.raw_62 | 34 - .../pes/friction/frictionH/060K/inst.raw_63 | 34 - .../py/pes/friction/frictionH/060K/inst1D.dat | 64 - .../friction/frictionH/060K/z_friction.dat | 1003 ----------- .../py/pes/friction/frictionH/080K/RESTART | 612 ------- .../py/pes/friction/frictionH/080K/clean.sh | 4 - .../py/pes/friction/frictionH/080K/get1D.sh | 6 - .../py/pes/friction/frictionH/080K/init.xyz | 48 - .../py/pes/friction/frictionH/080K/input.xml | 45 - .../pes/friction/frictionH/080K/inst.fric_00 | 36 - .../pes/friction/frictionH/080K/inst.fric_01 | 36 - .../pes/friction/frictionH/080K/inst.fric_02 | 36 - .../pes/friction/frictionH/080K/inst.fric_03 | 36 - .../pes/friction/frictionH/080K/inst.fric_04 | 36 - .../pes/friction/frictionH/080K/inst.fric_05 | 36 - .../pes/friction/frictionH/080K/inst.fric_06 | 36 - .../pes/friction/frictionH/080K/inst.fric_07 | 36 - .../pes/friction/frictionH/080K/inst.fric_08 | 36 - .../pes/friction/frictionH/080K/inst.fric_09 | 36 - .../pes/friction/frictionH/080K/inst.fric_10 | 36 - .../pes/friction/frictionH/080K/inst.fric_11 | 36 - .../pes/friction/frictionH/080K/inst.fric_12 | 36 - .../pes/friction/frictionH/080K/inst.fric_13 | 36 - .../pes/friction/frictionH/080K/inst.fric_14 | 36 - .../pes/friction/frictionH/080K/inst.fric_15 | 36 - .../frictionH/080K/inst.instanton.hess_0 | 1 - .../frictionH/080K/inst.instanton.hess_1 | 1 - .../frictionH/080K/inst.instanton.hess_2 | 1 - .../frictionH/080K/inst.instanton.hess_3 | 1 - .../frictionH/080K/inst.instanton.hess_4 | 1 - .../frictionH/080K/inst.instanton.hess_5 | 1 - .../frictionH/080K/inst.instanton.hess_6 | 1 - .../frictionH/080K/inst.instanton.hess_7 | 1 - .../frictionH/080K/inst.instanton_0.ener | 17 - .../frictionH/080K/inst.instanton_0.xyz | 48 - .../frictionH/080K/inst.instanton_1.ener | 17 - .../frictionH/080K/inst.instanton_1.xyz | 48 - .../frictionH/080K/inst.instanton_2.ener | 17 - .../frictionH/080K/inst.instanton_2.xyz | 48 - .../frictionH/080K/inst.instanton_3.ener | 17 - .../frictionH/080K/inst.instanton_3.xyz | 48 - .../frictionH/080K/inst.instanton_4.ener | 17 - .../frictionH/080K/inst.instanton_4.xyz | 48 - .../frictionH/080K/inst.instanton_5.ener | 17 - .../frictionH/080K/inst.instanton_5.xyz | 48 - .../frictionH/080K/inst.instanton_6.ener | 17 - .../frictionH/080K/inst.instanton_6.xyz | 48 - .../frictionH/080K/inst.instanton_7.ener | 17 - .../frictionH/080K/inst.instanton_7.xyz | 48 - .../080K/inst.instanton_FINAL.hess_7 | 1 - .../080K/inst.instanton_FINAL_7.ener | 17 - .../frictionH/080K/inst.instanton_FINAL_7.xyz | 48 - .../080K/inst.instanton_FINAL_forces_7.xyz | 48 - .../080K/inst.instanton_forces_0.xyz | 48 - .../080K/inst.instanton_forces_1.xyz | 48 - .../080K/inst.instanton_forces_2.xyz | 48 - .../080K/inst.instanton_forces_3.xyz | 48 - .../080K/inst.instanton_forces_4.xyz | 48 - .../080K/inst.instanton_forces_5.xyz | 48 - .../080K/inst.instanton_forces_6.xyz | 48 - .../080K/inst.instanton_forces_7.xyz | 48 - .../080K/inst.instantonfric_FINAL.hess_7 | 1 - .../pes/friction/frictionH/080K/inst.raw_00 | 18 - .../pes/friction/frictionH/080K/inst.raw_01 | 18 - .../pes/friction/frictionH/080K/inst.raw_02 | 18 - .../pes/friction/frictionH/080K/inst.raw_03 | 18 - .../pes/friction/frictionH/080K/inst.raw_04 | 18 - .../pes/friction/frictionH/080K/inst.raw_05 | 18 - .../pes/friction/frictionH/080K/inst.raw_06 | 18 - .../pes/friction/frictionH/080K/inst.raw_07 | 18 - .../pes/friction/frictionH/080K/inst.raw_08 | 18 - .../pes/friction/frictionH/080K/inst.raw_09 | 18 - .../pes/friction/frictionH/080K/inst.raw_10 | 18 - .../pes/friction/frictionH/080K/inst.raw_11 | 18 - .../pes/friction/frictionH/080K/inst.raw_12 | 18 - .../pes/friction/frictionH/080K/inst.raw_13 | 18 - .../pes/friction/frictionH/080K/inst.raw_14 | 18 - .../pes/friction/frictionH/080K/inst.raw_15 | 18 - .../py/pes/friction/frictionH/080K/inst1D.dat | 16 - .../friction/frictionH/080K/z_friction.dat | 1003 ----------- .../py/pes/friction/frictionH/100K/MEP.dat | 0 .../py/pes/friction/frictionH/100K/RESTART | 612 ------- .../py/pes/friction/frictionH/100K/clean.sh | 4 - .../py/pes/friction/frictionH/100K/get1D.sh | 5 - .../py/pes/friction/frictionH/100K/init.xyz | 48 - .../py/pes/friction/frictionH/100K/input.xml | 45 - .../pes/friction/frictionH/100K/inst.fric_00 | 16 - .../pes/friction/frictionH/100K/inst.fric_01 | 16 - .../pes/friction/frictionH/100K/inst.fric_02 | 16 - .../pes/friction/frictionH/100K/inst.fric_03 | 16 - .../pes/friction/frictionH/100K/inst.fric_04 | 16 - .../pes/friction/frictionH/100K/inst.fric_05 | 16 - .../pes/friction/frictionH/100K/inst.fric_06 | 16 - .../pes/friction/frictionH/100K/inst.fric_07 | 16 - .../pes/friction/frictionH/100K/inst.fric_08 | 16 - .../pes/friction/frictionH/100K/inst.fric_09 | 16 - .../pes/friction/frictionH/100K/inst.fric_10 | 16 - .../pes/friction/frictionH/100K/inst.fric_11 | 16 - .../pes/friction/frictionH/100K/inst.fric_12 | 16 - .../pes/friction/frictionH/100K/inst.fric_13 | 16 - .../pes/friction/frictionH/100K/inst.fric_14 | 16 - .../pes/friction/frictionH/100K/inst.fric_15 | 16 - .../frictionH/100K/inst.instanton.hess_0 | 1 - .../frictionH/100K/inst.instanton.hess_1 | 1 - .../frictionH/100K/inst.instanton.hess_2 | 1 - .../frictionH/100K/inst.instanton_0.ener | 17 - .../frictionH/100K/inst.instanton_0.xyz | 48 - .../frictionH/100K/inst.instanton_1.ener | 17 - .../frictionH/100K/inst.instanton_1.xyz | 48 - .../frictionH/100K/inst.instanton_2.ener | 17 - .../frictionH/100K/inst.instanton_2.xyz | 48 - .../100K/inst.instanton_FINAL.hess_2 | 1 - .../100K/inst.instanton_FINAL_2.ener | 17 - .../frictionH/100K/inst.instanton_FINAL_2.xyz | 48 - .../100K/inst.instanton_FINAL_forces_2.xyz | 48 - .../100K/inst.instanton_forces_0.xyz | 48 - .../100K/inst.instanton_forces_1.xyz | 48 - .../100K/inst.instanton_forces_2.xyz | 48 - .../100K/inst.instantonfric_FINAL.hess_2 | 1 - .../pes/friction/frictionH/100K/inst.raw_00 | 8 - .../pes/friction/frictionH/100K/inst.raw_01 | 8 - .../pes/friction/frictionH/100K/inst.raw_02 | 8 - .../pes/friction/frictionH/100K/inst.raw_03 | 8 - .../pes/friction/frictionH/100K/inst.raw_04 | 8 - .../pes/friction/frictionH/100K/inst.raw_05 | 8 - .../pes/friction/frictionH/100K/inst.raw_06 | 8 - .../pes/friction/frictionH/100K/inst.raw_07 | 8 - .../pes/friction/frictionH/100K/inst.raw_08 | 8 - .../pes/friction/frictionH/100K/inst.raw_09 | 8 - .../pes/friction/frictionH/100K/inst.raw_10 | 8 - .../pes/friction/frictionH/100K/inst.raw_11 | 8 - .../pes/friction/frictionH/100K/inst.raw_12 | 8 - .../pes/friction/frictionH/100K/inst.raw_13 | 8 - .../pes/friction/frictionH/100K/inst.raw_14 | 8 - .../pes/friction/frictionH/100K/inst.raw_15 | 8 - .../py/pes/friction/frictionH/100K/inst1D.dat | 16 - .../friction/frictionH/100K/z_friction.dat | 1003 ----------- .../py/pes/friction/frictionH/120K/RESTART | 612 ------- .../py/pes/friction/frictionH/120K/clean.sh | 4 - .../py/pes/friction/frictionH/120K/get1D.sh | 5 - .../py/pes/friction/frictionH/120K/init.xyz | 48 - .../py/pes/friction/frictionH/120K/input.xml | 45 - .../pes/friction/frictionH/120K/inst.fric_00 | 124 -- .../pes/friction/frictionH/120K/inst.fric_01 | 124 -- .../pes/friction/frictionH/120K/inst.fric_02 | 124 -- .../pes/friction/frictionH/120K/inst.fric_03 | 124 -- .../pes/friction/frictionH/120K/inst.fric_04 | 124 -- .../pes/friction/frictionH/120K/inst.fric_05 | 124 -- .../pes/friction/frictionH/120K/inst.fric_06 | 124 -- .../pes/friction/frictionH/120K/inst.fric_07 | 124 -- .../pes/friction/frictionH/120K/inst.fric_08 | 124 -- .../pes/friction/frictionH/120K/inst.fric_09 | 124 -- .../pes/friction/frictionH/120K/inst.fric_10 | 124 -- .../pes/friction/frictionH/120K/inst.fric_11 | 124 -- .../pes/friction/frictionH/120K/inst.fric_12 | 124 -- .../pes/friction/frictionH/120K/inst.fric_13 | 124 -- .../pes/friction/frictionH/120K/inst.fric_14 | 124 -- .../pes/friction/frictionH/120K/inst.fric_15 | 124 -- .../frictionH/120K/inst.instanton.hess_0 | 1 - .../frictionH/120K/inst.instanton.hess_1 | 1 - .../frictionH/120K/inst.instanton.hess_10 | 1 - .../frictionH/120K/inst.instanton.hess_11 | 1 - .../frictionH/120K/inst.instanton.hess_12 | 1 - .../frictionH/120K/inst.instanton.hess_13 | 1 - .../frictionH/120K/inst.instanton.hess_14 | 1 - .../frictionH/120K/inst.instanton.hess_15 | 1 - .../frictionH/120K/inst.instanton.hess_16 | 1 - .../frictionH/120K/inst.instanton.hess_17 | 1 - .../frictionH/120K/inst.instanton.hess_18 | 1 - .../frictionH/120K/inst.instanton.hess_19 | 1 - .../frictionH/120K/inst.instanton.hess_2 | 1 - .../frictionH/120K/inst.instanton.hess_20 | 1 - .../frictionH/120K/inst.instanton.hess_21 | 1 - .../frictionH/120K/inst.instanton.hess_22 | 1 - .../frictionH/120K/inst.instanton.hess_23 | 1 - .../frictionH/120K/inst.instanton.hess_24 | 1 - .../frictionH/120K/inst.instanton.hess_25 | 1 - .../frictionH/120K/inst.instanton.hess_26 | 1 - .../frictionH/120K/inst.instanton.hess_27 | 1 - .../frictionH/120K/inst.instanton.hess_28 | 1 - .../frictionH/120K/inst.instanton.hess_29 | 1 - .../frictionH/120K/inst.instanton.hess_3 | 1 - .../frictionH/120K/inst.instanton.hess_4 | 1 - .../frictionH/120K/inst.instanton.hess_5 | 1 - .../frictionH/120K/inst.instanton.hess_6 | 1 - .../frictionH/120K/inst.instanton.hess_7 | 1 - .../frictionH/120K/inst.instanton.hess_8 | 1 - .../frictionH/120K/inst.instanton.hess_9 | 1 - .../frictionH/120K/inst.instanton_0.ener | 17 - .../frictionH/120K/inst.instanton_0.xyz | 48 - .../frictionH/120K/inst.instanton_1.ener | 17 - .../frictionH/120K/inst.instanton_1.xyz | 48 - .../frictionH/120K/inst.instanton_10.ener | 17 - .../frictionH/120K/inst.instanton_10.xyz | 48 - .../frictionH/120K/inst.instanton_11.ener | 17 - .../frictionH/120K/inst.instanton_11.xyz | 48 - .../frictionH/120K/inst.instanton_12.ener | 17 - .../frictionH/120K/inst.instanton_12.xyz | 48 - .../frictionH/120K/inst.instanton_13.ener | 17 - .../frictionH/120K/inst.instanton_13.xyz | 48 - .../frictionH/120K/inst.instanton_14.ener | 17 - .../frictionH/120K/inst.instanton_14.xyz | 48 - .../frictionH/120K/inst.instanton_15.ener | 17 - .../frictionH/120K/inst.instanton_15.xyz | 48 - .../frictionH/120K/inst.instanton_16.ener | 17 - .../frictionH/120K/inst.instanton_16.xyz | 48 - .../frictionH/120K/inst.instanton_17.ener | 17 - .../frictionH/120K/inst.instanton_17.xyz | 48 - .../frictionH/120K/inst.instanton_18.ener | 17 - .../frictionH/120K/inst.instanton_18.xyz | 48 - .../frictionH/120K/inst.instanton_19.ener | 17 - .../frictionH/120K/inst.instanton_19.xyz | 48 - .../frictionH/120K/inst.instanton_2.ener | 17 - .../frictionH/120K/inst.instanton_2.xyz | 48 - .../frictionH/120K/inst.instanton_20.ener | 17 - .../frictionH/120K/inst.instanton_20.xyz | 48 - .../frictionH/120K/inst.instanton_21.ener | 17 - .../frictionH/120K/inst.instanton_21.xyz | 48 - .../frictionH/120K/inst.instanton_22.ener | 17 - .../frictionH/120K/inst.instanton_22.xyz | 48 - .../frictionH/120K/inst.instanton_23.ener | 17 - .../frictionH/120K/inst.instanton_23.xyz | 48 - .../frictionH/120K/inst.instanton_24.ener | 17 - .../frictionH/120K/inst.instanton_24.xyz | 48 - .../frictionH/120K/inst.instanton_25.ener | 17 - .../frictionH/120K/inst.instanton_25.xyz | 48 - .../frictionH/120K/inst.instanton_26.ener | 17 - .../frictionH/120K/inst.instanton_26.xyz | 48 - .../frictionH/120K/inst.instanton_27.ener | 17 - .../frictionH/120K/inst.instanton_27.xyz | 48 - .../frictionH/120K/inst.instanton_28.ener | 17 - .../frictionH/120K/inst.instanton_28.xyz | 48 - .../frictionH/120K/inst.instanton_29.ener | 17 - .../frictionH/120K/inst.instanton_29.xyz | 48 - .../frictionH/120K/inst.instanton_3.ener | 17 - .../frictionH/120K/inst.instanton_3.xyz | 48 - .../frictionH/120K/inst.instanton_4.ener | 17 - .../frictionH/120K/inst.instanton_4.xyz | 48 - .../frictionH/120K/inst.instanton_5.ener | 17 - .../frictionH/120K/inst.instanton_5.xyz | 48 - .../frictionH/120K/inst.instanton_6.ener | 17 - .../frictionH/120K/inst.instanton_6.xyz | 48 - .../frictionH/120K/inst.instanton_7.ener | 17 - .../frictionH/120K/inst.instanton_7.xyz | 48 - .../frictionH/120K/inst.instanton_8.ener | 17 - .../frictionH/120K/inst.instanton_8.xyz | 48 - .../frictionH/120K/inst.instanton_9.ener | 17 - .../frictionH/120K/inst.instanton_9.xyz | 48 - .../120K/inst.instanton_FINAL.hess_29 | 1 - .../120K/inst.instanton_FINAL_29.ener | 17 - .../120K/inst.instanton_FINAL_29.xyz | 48 - .../120K/inst.instanton_FINAL_forces_29.xyz | 48 - .../120K/inst.instanton_forces_0.xyz | 48 - .../120K/inst.instanton_forces_1.xyz | 48 - .../120K/inst.instanton_forces_10.xyz | 48 - .../120K/inst.instanton_forces_11.xyz | 48 - .../120K/inst.instanton_forces_12.xyz | 48 - .../120K/inst.instanton_forces_13.xyz | 48 - .../120K/inst.instanton_forces_14.xyz | 48 - .../120K/inst.instanton_forces_15.xyz | 48 - .../120K/inst.instanton_forces_16.xyz | 48 - .../120K/inst.instanton_forces_17.xyz | 48 - .../120K/inst.instanton_forces_18.xyz | 48 - .../120K/inst.instanton_forces_19.xyz | 48 - .../120K/inst.instanton_forces_2.xyz | 48 - .../120K/inst.instanton_forces_20.xyz | 48 - .../120K/inst.instanton_forces_21.xyz | 48 - .../120K/inst.instanton_forces_22.xyz | 48 - .../120K/inst.instanton_forces_23.xyz | 48 - .../120K/inst.instanton_forces_24.xyz | 48 - .../120K/inst.instanton_forces_25.xyz | 48 - .../120K/inst.instanton_forces_26.xyz | 48 - .../120K/inst.instanton_forces_27.xyz | 48 - .../120K/inst.instanton_forces_28.xyz | 48 - .../120K/inst.instanton_forces_29.xyz | 48 - .../120K/inst.instanton_forces_3.xyz | 48 - .../120K/inst.instanton_forces_4.xyz | 48 - .../120K/inst.instanton_forces_5.xyz | 48 - .../120K/inst.instanton_forces_6.xyz | 48 - .../120K/inst.instanton_forces_7.xyz | 48 - .../120K/inst.instanton_forces_8.xyz | 48 - .../120K/inst.instanton_forces_9.xyz | 48 - .../120K/inst.instantonfric_FINAL.hess_29 | 1 - .../pes/friction/frictionH/120K/inst.raw_00 | 62 - .../pes/friction/frictionH/120K/inst.raw_01 | 62 - .../pes/friction/frictionH/120K/inst.raw_02 | 62 - .../pes/friction/frictionH/120K/inst.raw_03 | 62 - .../pes/friction/frictionH/120K/inst.raw_04 | 62 - .../pes/friction/frictionH/120K/inst.raw_05 | 62 - .../pes/friction/frictionH/120K/inst.raw_06 | 62 - .../pes/friction/frictionH/120K/inst.raw_07 | 62 - .../pes/friction/frictionH/120K/inst.raw_08 | 62 - .../pes/friction/frictionH/120K/inst.raw_09 | 62 - .../pes/friction/frictionH/120K/inst.raw_10 | 62 - .../pes/friction/frictionH/120K/inst.raw_11 | 62 - .../pes/friction/frictionH/120K/inst.raw_12 | 62 - .../pes/friction/frictionH/120K/inst.raw_13 | 62 - .../pes/friction/frictionH/120K/inst.raw_14 | 62 - .../pes/friction/frictionH/120K/inst.raw_15 | 62 - .../py/pes/friction/frictionH/120K/inst1D.dat | 16 - .../friction/frictionH/120K/z_friction.dat | 1003 ----------- drivers/py/pes/friction/onheH/060K/RESTART | 309 ---- drivers/py/pes/friction/onheH/060K/clean.sh | 4 - drivers/py/pes/friction/onheH/060K/control.in | 181 -- .../py/pes/friction/onheH/060K/geometry.in | 11 - drivers/py/pes/friction/onheH/060K/get1D.sh | 5 - .../py/pes/friction/onheH/060K/hessian.dat | 1 - drivers/py/pes/friction/onheH/060K/init.xyz | 192 --- drivers/py/pes/friction/onheH/060K/input.xml | 37 - .../friction/onheH/060K/inst.instanton.hess_0 | 1 - .../friction/onheH/060K/inst.instanton.hess_1 | 1 - .../onheH/060K/inst.instanton.hess_10 | 1 - .../onheH/060K/inst.instanton.hess_11 | 1 - .../onheH/060K/inst.instanton.hess_12 | 1 - .../friction/onheH/060K/inst.instanton.hess_2 | 1 - .../friction/onheH/060K/inst.instanton.hess_3 | 1 - .../friction/onheH/060K/inst.instanton.hess_4 | 1 - .../friction/onheH/060K/inst.instanton.hess_5 | 1 - .../friction/onheH/060K/inst.instanton.hess_6 | 1 - .../friction/onheH/060K/inst.instanton.hess_7 | 1 - .../friction/onheH/060K/inst.instanton.hess_8 | 1 - .../friction/onheH/060K/inst.instanton.hess_9 | 1 - .../friction/onheH/060K/inst.instanton_0.ener | 65 - .../friction/onheH/060K/inst.instanton_0.xyz | 192 --- .../friction/onheH/060K/inst.instanton_1.ener | 65 - .../friction/onheH/060K/inst.instanton_1.xyz | 192 --- .../onheH/060K/inst.instanton_10.ener | 65 - .../friction/onheH/060K/inst.instanton_10.xyz | 192 --- .../onheH/060K/inst.instanton_11.ener | 65 - .../friction/onheH/060K/inst.instanton_11.xyz | 192 --- .../onheH/060K/inst.instanton_12.ener | 65 - .../friction/onheH/060K/inst.instanton_12.xyz | 192 --- .../friction/onheH/060K/inst.instanton_2.ener | 65 - .../friction/onheH/060K/inst.instanton_2.xyz | 192 --- .../friction/onheH/060K/inst.instanton_3.ener | 65 - .../friction/onheH/060K/inst.instanton_3.xyz | 192 --- .../friction/onheH/060K/inst.instanton_4.ener | 65 - .../friction/onheH/060K/inst.instanton_4.xyz | 192 --- .../friction/onheH/060K/inst.instanton_5.ener | 65 - .../friction/onheH/060K/inst.instanton_5.xyz | 192 --- .../friction/onheH/060K/inst.instanton_6.ener | 65 - .../friction/onheH/060K/inst.instanton_6.xyz | 192 --- .../friction/onheH/060K/inst.instanton_7.ener | 65 - .../friction/onheH/060K/inst.instanton_7.xyz | 192 --- .../friction/onheH/060K/inst.instanton_8.ener | 65 - .../friction/onheH/060K/inst.instanton_8.xyz | 192 --- .../friction/onheH/060K/inst.instanton_9.ener | 65 - .../friction/onheH/060K/inst.instanton_9.xyz | 192 --- .../onheH/060K/inst.instanton_FINAL.hess_12 | 1 - .../onheH/060K/inst.instanton_FINAL_12.ener | 65 - .../onheH/060K/inst.instanton_FINAL_12.xyz | 192 --- .../060K/inst.instanton_FINAL_forces_12.xyz | 192 --- .../onheH/060K/inst.instanton_forces_0.xyz | 192 --- .../onheH/060K/inst.instanton_forces_1.xyz | 192 --- .../onheH/060K/inst.instanton_forces_10.xyz | 192 --- .../onheH/060K/inst.instanton_forces_11.xyz | 192 --- .../onheH/060K/inst.instanton_forces_12.xyz | 192 --- .../onheH/060K/inst.instanton_forces_2.xyz | 192 --- .../onheH/060K/inst.instanton_forces_3.xyz | 192 --- .../onheH/060K/inst.instanton_forces_4.xyz | 192 --- .../onheH/060K/inst.instanton_forces_5.xyz | 192 --- .../onheH/060K/inst.instanton_forces_6.xyz | 192 --- .../onheH/060K/inst.instanton_forces_7.xyz | 192 --- .../onheH/060K/inst.instanton_forces_8.xyz | 192 --- .../onheH/060K/inst.instanton_forces_9.xyz | 192 --- drivers/py/pes/friction/onheH/060K/inst1D.dat | 64 - drivers/py/pes/friction/onheH/080K/RESTART | 309 ---- drivers/py/pes/friction/onheH/080K/clean.sh | 4 - drivers/py/pes/friction/onheH/080K/control.in | 181 -- .../py/pes/friction/onheH/080K/geometry.in | 11 - drivers/py/pes/friction/onheH/080K/get1D.sh | 5 - .../py/pes/friction/onheH/080K/hessian.dat | 1 - drivers/py/pes/friction/onheH/080K/init.xyz | 192 --- drivers/py/pes/friction/onheH/080K/input.xml | 37 - .../friction/onheH/080K/inst.instanton.hess_0 | 1 - .../friction/onheH/080K/inst.instanton.hess_1 | 1 - .../friction/onheH/080K/inst.instanton.hess_2 | 1 - .../friction/onheH/080K/inst.instanton.hess_3 | 1 - .../friction/onheH/080K/inst.instanton.hess_4 | 1 - .../friction/onheH/080K/inst.instanton.hess_5 | 1 - .../friction/onheH/080K/inst.instanton.hess_6 | 1 - .../friction/onheH/080K/inst.instanton.hess_7 | 1 - .../friction/onheH/080K/inst.instanton.hess_8 | 1 - .../friction/onheH/080K/inst.instanton_0.ener | 65 - .../friction/onheH/080K/inst.instanton_0.xyz | 192 --- .../friction/onheH/080K/inst.instanton_1.ener | 65 - .../friction/onheH/080K/inst.instanton_1.xyz | 192 --- .../friction/onheH/080K/inst.instanton_2.ener | 65 - .../friction/onheH/080K/inst.instanton_2.xyz | 192 --- .../friction/onheH/080K/inst.instanton_3.ener | 65 - .../friction/onheH/080K/inst.instanton_3.xyz | 192 --- .../friction/onheH/080K/inst.instanton_4.ener | 65 - .../friction/onheH/080K/inst.instanton_4.xyz | 192 --- .../friction/onheH/080K/inst.instanton_5.ener | 65 - .../friction/onheH/080K/inst.instanton_5.xyz | 192 --- .../friction/onheH/080K/inst.instanton_6.ener | 65 - .../friction/onheH/080K/inst.instanton_6.xyz | 192 --- .../friction/onheH/080K/inst.instanton_7.ener | 65 - .../friction/onheH/080K/inst.instanton_7.xyz | 192 --- .../friction/onheH/080K/inst.instanton_8.ener | 65 - .../friction/onheH/080K/inst.instanton_8.xyz | 192 --- .../onheH/080K/inst.instanton_FINAL.hess_8 | 1 - .../onheH/080K/inst.instanton_FINAL_8.ener | 65 - .../onheH/080K/inst.instanton_FINAL_8.xyz | 192 --- .../080K/inst.instanton_FINAL_forces_8.xyz | 192 --- .../onheH/080K/inst.instanton_forces_0.xyz | 192 --- .../onheH/080K/inst.instanton_forces_1.xyz | 192 --- .../onheH/080K/inst.instanton_forces_2.xyz | 192 --- .../onheH/080K/inst.instanton_forces_3.xyz | 192 --- .../onheH/080K/inst.instanton_forces_4.xyz | 192 --- .../onheH/080K/inst.instanton_forces_5.xyz | 192 --- .../onheH/080K/inst.instanton_forces_6.xyz | 192 --- .../onheH/080K/inst.instanton_forces_7.xyz | 192 --- .../onheH/080K/inst.instanton_forces_8.xyz | 192 --- drivers/py/pes/friction/onheH/080K/inst1D.dat | 64 - drivers/py/pes/friction/onheH/100K/RESTART | 117 -- drivers/py/pes/friction/onheH/100K/control.in | 181 -- .../py/pes/friction/onheH/100K/geometry.in | 11 - drivers/py/pes/friction/onheH/100K/get1D.sh | 6 - .../py/pes/friction/onheH/100K/hessian.dat | 1 - drivers/py/pes/friction/onheH/100K/init.xyz | 48 - drivers/py/pes/friction/onheH/100K/input.xml | 37 - .../friction/onheH/100K/inst.instanton.hess_0 | 1 - .../friction/onheH/100K/inst.instanton.hess_1 | 1 - .../friction/onheH/100K/inst.instanton.hess_2 | 1 - .../friction/onheH/100K/inst.instanton_0.ener | 17 - .../friction/onheH/100K/inst.instanton_0.xyz | 48 - .../friction/onheH/100K/inst.instanton_1.ener | 17 - .../friction/onheH/100K/inst.instanton_1.xyz | 48 - .../friction/onheH/100K/inst.instanton_2.ener | 17 - .../friction/onheH/100K/inst.instanton_2.xyz | 48 - .../onheH/100K/inst.instanton_FINAL.hess_2 | 1 - .../onheH/100K/inst.instanton_FINAL_2.ener | 17 - .../onheH/100K/inst.instanton_FINAL_2.xyz | 48 - .../100K/inst.instanton_FINAL_forces_2.xyz | 48 - .../onheH/100K/inst.instanton_forces_0.xyz | 48 - .../onheH/100K/inst.instanton_forces_1.xyz | 48 - .../onheH/100K/inst.instanton_forces_2.xyz | 48 - drivers/py/pes/friction/onheH/100K/inst1D.dat | 16 - drivers/py/pes/friction/onheH/120K/RESTART | 117 -- drivers/py/pes/friction/onheH/120K/clean.sh | 4 - drivers/py/pes/friction/onheH/120K/control.in | 181 -- .../py/pes/friction/onheH/120K/geometry.in | 11 - drivers/py/pes/friction/onheH/120K/get1D.sh | 6 - drivers/py/pes/friction/onheH/120K/init.xyz | 48 - drivers/py/pes/friction/onheH/120K/input.xml | 37 - .../friction/onheH/120K/inst.instanton.hess_0 | 1 - .../friction/onheH/120K/inst.instanton.hess_1 | 1 - .../onheH/120K/inst.instanton.hess_10 | 1 - .../onheH/120K/inst.instanton.hess_11 | 1 - .../onheH/120K/inst.instanton.hess_12 | 1 - .../onheH/120K/inst.instanton.hess_13 | 1 - .../friction/onheH/120K/inst.instanton.hess_2 | 1 - .../friction/onheH/120K/inst.instanton.hess_3 | 1 - .../friction/onheH/120K/inst.instanton.hess_4 | 1 - .../friction/onheH/120K/inst.instanton.hess_5 | 1 - .../friction/onheH/120K/inst.instanton.hess_6 | 1 - .../friction/onheH/120K/inst.instanton.hess_7 | 1 - .../friction/onheH/120K/inst.instanton.hess_8 | 1 - .../friction/onheH/120K/inst.instanton.hess_9 | 1 - .../friction/onheH/120K/inst.instanton_0.ener | 17 - .../friction/onheH/120K/inst.instanton_0.xyz | 48 - .../friction/onheH/120K/inst.instanton_1.ener | 17 - .../friction/onheH/120K/inst.instanton_1.xyz | 48 - .../onheH/120K/inst.instanton_10.ener | 17 - .../friction/onheH/120K/inst.instanton_10.xyz | 48 - .../onheH/120K/inst.instanton_11.ener | 17 - .../friction/onheH/120K/inst.instanton_11.xyz | 48 - .../onheH/120K/inst.instanton_12.ener | 17 - .../friction/onheH/120K/inst.instanton_12.xyz | 48 - .../onheH/120K/inst.instanton_13.ener | 17 - .../friction/onheH/120K/inst.instanton_13.xyz | 48 - .../friction/onheH/120K/inst.instanton_2.ener | 17 - .../friction/onheH/120K/inst.instanton_2.xyz | 48 - .../friction/onheH/120K/inst.instanton_3.ener | 17 - .../friction/onheH/120K/inst.instanton_3.xyz | 48 - .../friction/onheH/120K/inst.instanton_4.ener | 17 - .../friction/onheH/120K/inst.instanton_4.xyz | 48 - .../friction/onheH/120K/inst.instanton_5.ener | 17 - .../friction/onheH/120K/inst.instanton_5.xyz | 48 - .../friction/onheH/120K/inst.instanton_6.ener | 17 - .../friction/onheH/120K/inst.instanton_6.xyz | 48 - .../friction/onheH/120K/inst.instanton_7.ener | 17 - .../friction/onheH/120K/inst.instanton_7.xyz | 48 - .../friction/onheH/120K/inst.instanton_8.ener | 17 - .../friction/onheH/120K/inst.instanton_8.xyz | 48 - .../friction/onheH/120K/inst.instanton_9.ener | 17 - .../friction/onheH/120K/inst.instanton_9.xyz | 48 - .../onheH/120K/inst.instanton_FINAL.hess_13 | 1 - .../onheH/120K/inst.instanton_FINAL_13.ener | 17 - .../onheH/120K/inst.instanton_FINAL_13.xyz | 48 - .../120K/inst.instanton_FINAL_forces_13.xyz | 48 - .../onheH/120K/inst.instanton_forces_0.xyz | 48 - .../onheH/120K/inst.instanton_forces_1.xyz | 48 - .../onheH/120K/inst.instanton_forces_10.xyz | 48 - .../onheH/120K/inst.instanton_forces_11.xyz | 48 - .../onheH/120K/inst.instanton_forces_12.xyz | 48 - .../onheH/120K/inst.instanton_forces_13.xyz | 48 - .../onheH/120K/inst.instanton_forces_2.xyz | 48 - .../onheH/120K/inst.instanton_forces_3.xyz | 48 - .../onheH/120K/inst.instanton_forces_4.xyz | 48 - .../onheH/120K/inst.instanton_forces_5.xyz | 48 - .../onheH/120K/inst.instanton_forces_6.xyz | 48 - .../onheH/120K/inst.instanton_forces_7.xyz | 48 - .../onheH/120K/inst.instanton_forces_8.xyz | 48 - .../onheH/120K/inst.instanton_forces_9.xyz | 48 - drivers/py/pes/friction/onheH/120K/inst1D.dat | 16 - drivers/py/pes/friction/template.agr | 1502 ----------------- drivers/py/pes/friction/test-ohne80/RESTART | 117 -- .../py/pes/friction/test-ohne80/control.in | 181 -- .../py/pes/friction/test-ohne80/geometry.in | 11 - drivers/py/pes/friction/test-ohne80/get1D.sh | 6 - .../py/pes/friction/test-ohne80/hessian.dat | 1 - drivers/py/pes/friction/test-ohne80/init.xyz | 48 - drivers/py/pes/friction/test-ohne80/input.xml | 37 - .../test-ohne80/inst.instanton.hess_0 | 1 - .../test-ohne80/inst.instanton.hess_1 | 1 - .../test-ohne80/inst.instanton.hess_2 | 1 - .../test-ohne80/inst.instanton.hess_3 | 1 - .../test-ohne80/inst.instanton.hess_4 | 1 - .../test-ohne80/inst.instanton.hess_5 | 1 - .../test-ohne80/inst.instanton.hess_6 | 1 - .../test-ohne80/inst.instanton.hess_7 | 1 - .../test-ohne80/inst.instanton.hess_8 | 1 - .../test-ohne80/inst.instanton_0.ener | 17 - .../friction/test-ohne80/inst.instanton_0.xyz | 48 - .../test-ohne80/inst.instanton_1.ener | 17 - .../friction/test-ohne80/inst.instanton_1.xyz | 48 - .../test-ohne80/inst.instanton_2.ener | 17 - .../friction/test-ohne80/inst.instanton_2.xyz | 48 - .../test-ohne80/inst.instanton_3.ener | 17 - .../friction/test-ohne80/inst.instanton_3.xyz | 48 - .../test-ohne80/inst.instanton_4.ener | 17 - .../friction/test-ohne80/inst.instanton_4.xyz | 48 - .../test-ohne80/inst.instanton_5.ener | 17 - .../friction/test-ohne80/inst.instanton_5.xyz | 48 - .../test-ohne80/inst.instanton_6.ener | 17 - .../friction/test-ohne80/inst.instanton_6.xyz | 48 - .../test-ohne80/inst.instanton_7.ener | 17 - .../friction/test-ohne80/inst.instanton_7.xyz | 48 - .../test-ohne80/inst.instanton_8.ener | 17 - .../friction/test-ohne80/inst.instanton_8.xyz | 48 - .../test-ohne80/inst.instanton_FINAL.hess_8 | 1 - .../test-ohne80/inst.instanton_FINAL_8.ener | 17 - .../test-ohne80/inst.instanton_FINAL_8.xyz | 48 - .../inst.instanton_FINAL_forces_8.xyz | 48 - .../test-ohne80/inst.instanton_forces_0.xyz | 48 - .../test-ohne80/inst.instanton_forces_1.xyz | 48 - .../test-ohne80/inst.instanton_forces_2.xyz | 48 - .../test-ohne80/inst.instanton_forces_3.xyz | 48 - .../test-ohne80/inst.instanton_forces_4.xyz | 48 - .../test-ohne80/inst.instanton_forces_5.xyz | 48 - .../test-ohne80/inst.instanton_forces_6.xyz | 48 - .../test-ohne80/inst.instanton_forces_7.xyz | 48 - .../test-ohne80/inst.instanton_forces_8.xyz | 48 - .../py/pes/friction/test-ohne80/inst1D.dat | 16 - drivers/py/pes/friction/test2/clean.sh | 4 - drivers/py/pes/friction/test2/init.xyz | 48 - drivers/py/pes/friction/test2/input.xml | 45 - drivers/py/pes/friction/test2/z_friction.dat | 1003 ----------- .../RESTART | 417 ----- .../simulation.instanton_FINAL.hess_22 | 1 - .../simulation.instanton_FINAL_22.ener | 11 - .../simulation.instanton_FINAL_22.xyz | 60 - .../simulation.instanton_FINAL_forces_22.xyz | 60 - .../README.md | 0 .../clean.sh | 0 .../init.xyz | 0 .../input.xml | 0 .../run.sh | 0 .../README.md | 0 .../clean.sh | 0 .../init.xyz | 0 .../input.xml | 0 .../run.sh | 0 .../README | 0 .../implicit_bath_pos_independent/clean.sh | 2 + .../fric_spec_dens.dat | 0 .../init.xyz | 0 .../input.xml | 2 +- .../implicit_bath_pos_independent/run.sh | 23 + .../z_friction.dat | 1003 ----------- 932 files changed, 26 insertions(+), 59581 deletions(-) delete mode 100644 drivers/pes/harmonic_bath.f90 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/MEP.dat delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/RESTART delete mode 100755 drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh delete mode 100755 drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 delete mode 100644 drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat delete mode 100644 drivers/py/pes/friction/frictionH/060K/MEP.dat delete mode 100644 drivers/py/pes/friction/frictionH/060K/RESTART delete mode 100755 drivers/py/pes/friction/frictionH/060K/clean.sh delete mode 100755 drivers/py/pes/friction/frictionH/060K/get1D.sh delete mode 100644 drivers/py/pes/friction/frictionH/060K/init.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/input.xml delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_00 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_01 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_02 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_03 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_04 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_05 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_06 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_07 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_08 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_09 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_10 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_11 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_12 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_13 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_14 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_15 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_16 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_17 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_18 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_19 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_20 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_21 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_22 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_23 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_24 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_25 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_26 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_27 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_28 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_29 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_30 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_31 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_32 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_33 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_34 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_35 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_36 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_37 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_38 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_39 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_40 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_41 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_42 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_43 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_44 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_45 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_46 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_47 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_48 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_49 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_50 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_51 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_52 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_53 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_54 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_55 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_56 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_57 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_58 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_59 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_60 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_61 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_62 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.fric_63 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_00 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_01 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_02 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_03 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_04 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_05 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_06 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_07 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_08 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_09 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_10 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_11 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_12 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_13 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_14 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_15 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_16 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_17 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_18 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_19 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_20 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_21 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_22 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_23 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_24 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_25 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_26 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_27 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_28 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_29 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_30 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_31 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_32 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_33 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_34 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_35 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_36 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_37 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_38 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_39 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_40 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_41 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_42 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_43 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_44 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_45 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_46 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_47 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_48 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_49 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_50 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_51 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_52 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_53 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_54 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_55 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_56 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_57 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_58 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_59 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_60 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_61 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_62 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst.raw_63 delete mode 100644 drivers/py/pes/friction/frictionH/060K/inst1D.dat delete mode 100644 drivers/py/pes/friction/frictionH/060K/z_friction.dat delete mode 100644 drivers/py/pes/friction/frictionH/080K/RESTART delete mode 100755 drivers/py/pes/friction/frictionH/080K/clean.sh delete mode 100755 drivers/py/pes/friction/frictionH/080K/get1D.sh delete mode 100644 drivers/py/pes/friction/frictionH/080K/init.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/input.xml delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_00 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_01 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_02 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_03 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_04 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_05 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_06 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_07 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_08 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_09 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_10 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_11 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_12 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_13 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_14 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.fric_15 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_00 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_01 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_02 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_03 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_04 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_05 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_06 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_07 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_08 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_09 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_10 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_11 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_12 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_13 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_14 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst.raw_15 delete mode 100644 drivers/py/pes/friction/frictionH/080K/inst1D.dat delete mode 100644 drivers/py/pes/friction/frictionH/080K/z_friction.dat delete mode 100644 drivers/py/pes/friction/frictionH/100K/MEP.dat delete mode 100644 drivers/py/pes/friction/frictionH/100K/RESTART delete mode 100755 drivers/py/pes/friction/frictionH/100K/clean.sh delete mode 100755 drivers/py/pes/friction/frictionH/100K/get1D.sh delete mode 100644 drivers/py/pes/friction/frictionH/100K/init.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/input.xml delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_00 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_01 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_02 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_03 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_04 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_05 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_06 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_07 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_08 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_09 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_10 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_11 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_12 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_13 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_14 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.fric_15 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_00 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_01 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_02 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_03 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_04 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_05 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_06 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_07 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_08 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_09 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_10 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_11 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_12 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_13 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_14 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst.raw_15 delete mode 100644 drivers/py/pes/friction/frictionH/100K/inst1D.dat delete mode 100644 drivers/py/pes/friction/frictionH/100K/z_friction.dat delete mode 100644 drivers/py/pes/friction/frictionH/120K/RESTART delete mode 100755 drivers/py/pes/friction/frictionH/120K/clean.sh delete mode 100755 drivers/py/pes/friction/frictionH/120K/get1D.sh delete mode 100644 drivers/py/pes/friction/frictionH/120K/init.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/input.xml delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_00 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_01 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_02 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_03 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_04 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_05 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_06 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_07 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_08 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_09 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_10 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_11 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_12 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_13 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_14 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.fric_15 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_00 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_01 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_02 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_03 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_04 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_05 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_06 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_07 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_08 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_09 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_10 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_11 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_12 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_13 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_14 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst.raw_15 delete mode 100644 drivers/py/pes/friction/frictionH/120K/inst1D.dat delete mode 100644 drivers/py/pes/friction/frictionH/120K/z_friction.dat delete mode 100644 drivers/py/pes/friction/onheH/060K/RESTART delete mode 100755 drivers/py/pes/friction/onheH/060K/clean.sh delete mode 100644 drivers/py/pes/friction/onheH/060K/control.in delete mode 100644 drivers/py/pes/friction/onheH/060K/geometry.in delete mode 100755 drivers/py/pes/friction/onheH/060K/get1D.sh delete mode 100644 drivers/py/pes/friction/onheH/060K/hessian.dat delete mode 100644 drivers/py/pes/friction/onheH/060K/init.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/input.xml delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz delete mode 100644 drivers/py/pes/friction/onheH/060K/inst1D.dat delete mode 100644 drivers/py/pes/friction/onheH/080K/RESTART delete mode 100755 drivers/py/pes/friction/onheH/080K/clean.sh delete mode 100644 drivers/py/pes/friction/onheH/080K/control.in delete mode 100644 drivers/py/pes/friction/onheH/080K/geometry.in delete mode 100755 drivers/py/pes/friction/onheH/080K/get1D.sh delete mode 100644 drivers/py/pes/friction/onheH/080K/hessian.dat delete mode 100644 drivers/py/pes/friction/onheH/080K/init.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/input.xml delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/080K/inst1D.dat delete mode 100644 drivers/py/pes/friction/onheH/100K/RESTART delete mode 100644 drivers/py/pes/friction/onheH/100K/control.in delete mode 100644 drivers/py/pes/friction/onheH/100K/geometry.in delete mode 100755 drivers/py/pes/friction/onheH/100K/get1D.sh delete mode 100644 drivers/py/pes/friction/onheH/100K/hessian.dat delete mode 100644 drivers/py/pes/friction/onheH/100K/init.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/input.xml delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/100K/inst1D.dat delete mode 100644 drivers/py/pes/friction/onheH/120K/RESTART delete mode 100755 drivers/py/pes/friction/onheH/120K/clean.sh delete mode 100644 drivers/py/pes/friction/onheH/120K/control.in delete mode 100644 drivers/py/pes/friction/onheH/120K/geometry.in delete mode 100755 drivers/py/pes/friction/onheH/120K/get1D.sh delete mode 100644 drivers/py/pes/friction/onheH/120K/init.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/input.xml delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz delete mode 100644 drivers/py/pes/friction/onheH/120K/inst1D.dat delete mode 100644 drivers/py/pes/friction/template.agr delete mode 100644 drivers/py/pes/friction/test-ohne80/RESTART delete mode 100644 drivers/py/pes/friction/test-ohne80/control.in delete mode 100644 drivers/py/pes/friction/test-ohne80/geometry.in delete mode 100755 drivers/py/pes/friction/test-ohne80/get1D.sh delete mode 100644 drivers/py/pes/friction/test-ohne80/hessian.dat delete mode 100644 drivers/py/pes/friction/test-ohne80/init.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/input.xml delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz delete mode 100644 drivers/py/pes/friction/test-ohne80/inst1D.dat delete mode 100755 drivers/py/pes/friction/test2/clean.sh delete mode 100644 drivers/py/pes/friction/test2/init.xyz delete mode 100644 drivers/py/pes/friction/test2/input.xml delete mode 100644 drivers/py/pes/friction/test2/z_friction.dat delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_dependent => explicit_harmonic_bath_pos_independent_fortran}/README.md (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_dependent => explicit_harmonic_bath_pos_independent_fortran}/clean.sh (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_dependent => explicit_harmonic_bath_pos_independent_fortran}/init.xyz (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_dependent => explicit_harmonic_bath_pos_independent_fortran}/input.xml (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent => explicit_harmonic_bath_pos_independent_fortran}/run.sh (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent => explicit_harmonic_bath_pos_independent_python}/README.md (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent => explicit_harmonic_bath_pos_independent_python}/clean.sh (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent => explicit_harmonic_bath_pos_independent_python}/init.xyz (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent => explicit_harmonic_bath_pos_independent_python}/input.xml (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_dependent => explicit_harmonic_bath_pos_independent_python}/run.sh (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{meanfield_bath_pos_dependent => implicit_bath_pos_independent}/README (100%) create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/clean.sh rename drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat => examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/fric_spec_dens.dat (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{meanfield_bath_pos_dependent => implicit_bath_pos_independent}/init.xyz (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{meanfield_bath_pos_dependent => implicit_bath_pos_independent}/input.xml (93%) create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/z_friction.dat diff --git a/drivers/pes/harmonic_bath.f90 b/drivers/pes/harmonic_bath.f90 deleted file mode 100644 index 5edb0a24c..000000000 --- a/drivers/pes/harmonic_bath.f90 +++ /dev/null @@ -1,125 +0,0 @@ -!Harmonic bath - -! V(q,x1,..,xn) = sum_1^(nat-1) [ 0.5 m omega_i^2(q - (c_i s(q))/(m omega_i)^2)^2 ] -! s(q) = q *sd(q) -! sd(q) = [1+eps exp( (q-0)^2 / (2deltaQ^2) ) ] + delta tanh(q/deltaQ) -! If eps=delta=0 then sd(q) =1 and s(q) = q - - - SUBROUTINE get_harmonic_bath(nat,bath_type,friction,omega_c,eps,delta,deltaQ,q,pot,force) - IMPLICIT NONE - integer :: nat, i - real(kind=8),PARAMETER :: pi= 3.141592653589793D0 - real(kind=8) :: bath_type,friction,omega_c,mass - real(kind=8) :: eps,delta,deltaQ,S,dSD_dq - real(kind=8) :: A,B - real(kind=8) :: q(nat*3),pot,force(nat*3),x(nat*3-1) - real(kind=8) :: c(nat*3-1),omega(nat*3-1), omega2(nat*3-1),aux - mass = 1837.36223469 - pot = 0.0 - A = -0.00476705894242374 - B = 0.0005980249683218661 - - DO i = 1, 3*nat -1 - x(i) = q(i+1) - ENDDO - - !Get omega and c_i - IF (IDINT(bath_type) .EQ. 1 ) THEN !Ohmic - DO i = 1, 3*nat -1 - omega(i) = - omega_c * LOG( (i - 0.5 ) / (3*nat-1) ) - omega2(i) = omega(i)**2 - c(i) = omega(i) * ( ( 2 * friction * mass *omega_c) / ( (3*nat-1) * pi ) )**0.5 - ENDDO - END IF - - !SYSTEM - pot = A * (q(1) ** 2) + B * (q(1) ** 4) - force(1) = - ( 2 * A * (q(1)) + 4 * B * (q(1) ** 3) ) - - !BATH - DO i = 1,3*nat-1 - aux = x(i) - ( c(i)*S(q(1),eps,delta,deltaQ) / ( mass*omega2(i) ) ) - - pot = pot + 0.5 * mass * omega2(i) * aux **2 - - force(1) = force(1) + aux * c(i)*dSD_dq(q(1),eps,delta,deltaQ) - force(i+1) = -mass * omega2(i) * aux - - - ENDDO - - return - end - - REAL*8 FUNCTION SD(q,eps,delta,deltaQ) - IMPLICIT NONE - real(kind=8), intent(in) :: q,eps,delta,deltaQ ! q system position - real(kind=8) :: dx - - dx = q / deltaQ - SD = 1.0 + eps*DEXP(-0.5 * (dx**2) ) + delta*DTANH(dx) - END FUNCTION SD - - REAL*8 FUNCTION S(q,eps,delta,deltaQ) - IMPLICIT NONE - real(kind=8), intent(in) :: q,eps,delta,deltaQ - real(kind=8) :: SD - S = q* SD(q,eps,delta,deltaQ) - END FUNCTION S - - REAL*8 FUNCTION dSD_dq(q,eps,delta,deltaQ) - IMPLICIT NONE - real(kind=8), intent(in) :: q,eps,delta,deltaQ - real(kind=8) :: dx,dsddq1,dsddq2,SD - dx = q / deltaQ - dsddq1 = eps*DEXP(-0.5 * (dx**2))*(-dx/deltaQ) - dsddq2 = delta* (1- DTANH(DX)**2) / deltaQ - dSD_dq = q *(dsddq1 + dsddq2) + SD(q,eps,delta,deltaQ) - - END FUNCTION dSD_dq - - SUBROUTINE get_meanfield_harmonic_bath(nat,eta,eps,delta,deltaQ,q,pot,force,friction) - IMPLICIT NONE - integer :: nat, i - real(kind=8) :: A,B,k,eta - real(kind=8) :: eps,delta,deltaQ,dSD_dq - real(kind=8) :: x,y,z,fx,fy,fz - real(kind=8) :: q(nat,3),pot,force(nat,3) - real(kind=8) :: friction(3*nat,3*nat) - - k = 1836*(3800.0d0/219323d0)**2 - - A = -0.00476705894242374 - B = 0.0005980249683218661 - - DO i = 1,nat - x = q(i,1) - y = q(i,2) - z = q(i,3) - - pot = 0.0 - - pot = pot+ 0.5*k*y**2 - fy = -k*y - pot = pot+ 0.5*k*z**2 - fz = -k*z - - pot = pot + A * (x ** 2) + B * (x ** 4) - - - fx = - ( 2 * A * (x) + 4 * B * (x ** 3) ) - - force(i,1) = fx - force(i,2) = fy - force(i,3) = fz - - friction(nat*3*(i-1)+1,nat*3*(i-1)+1) = eta * (dSD_dq(x,eps,delta,deltaQ) )**2 - friction(nat*3*(i-1)+2,nat*3*(i-1)+2) = eta * (dSD_dq(y,eps,delta,deltaQ) )**2 - friction(nat*3*(i-1)+3,nat*3*(i-1)+3) = eta * (dSD_dq(z,eps,delta,deltaQ) )**2 - - ENDDO - - return - end - diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/MEP.dat b/drivers/py/pes/friction/frictionD/test_friction_80K_D/MEP.dat deleted file mode 100644 index e69de29bb..000000000 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/RESTART b/drivers/py/pes/friction/frictionD/test_friction_80K_D/RESTART deleted file mode 100644 index fa89de511..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/RESTART +++ /dev/null @@ -1,1064 +0,0 @@ - - - [ step, potential{electronvolt} ] - extras - extras - - 11 - 30 - - - - - - [ friction ] - - - - 2.53345216e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 4.90385829e-03, 4.90625462e-03, 4.91102409e-03, 4.91812052e-03, 4.92747508e-03, - 4.93899681e-03, 4.95257338e-03, 4.96807192e-03, 4.98534016e-03, 5.00420762e-03, - 5.02448708e-03, 5.04597614e-03, 5.06845903e-03, 5.09170852e-03, 5.11548797e-03, - 5.13955360e-03, 5.16365681e-03, 5.18754660e-03, 5.21097190e-03, 5.23368044e-03, - 5.25542127e-03, 5.27594988e-03, 5.29503094e-03, 5.31244102e-03, 5.32797115e-03, - 5.34142936e-03, 5.35264299e-03, 5.36146086e-03, 5.36775515e-03, 5.37142307e-03, - 5.37238812e-03, 5.37060494e-03, 5.36611363e-03, 5.35902652e-03, 5.34948199e-03, - 5.33764028e-03, 5.32368042e-03, 5.30779711e-03, 5.29019746e-03, 5.27109795e-03, - 5.25072130e-03, 5.22929365e-03, 5.20704181e-03, 5.18419079e-03, 5.16096154e-03, - 5.13756901e-03, 5.11422040e-03, 5.09110619e-03, 5.06837947e-03, 5.04618568e-03, - 5.02467041e-03, 5.00397781e-03, 4.98424917e-03, 4.96562136e-03, 4.94822548e-03, - 4.93218542e-03, 4.91761660e-03, 4.90462479e-03, 4.89330501e-03, 4.88374057e-03, - 4.87600221e-03, 4.87014740e-03, 4.86621973e-03, 4.86424853e-03 ] - - - [ -1.86605187e-03, 3.62281246e-05, 3.60194726e-05, -1.86204436e-03, 3.61488376e-05, - 3.59423494e-05, -1.85402475e-03, 3.59902112e-05, 3.57880221e-05, -1.84198418e-03, - 3.57521448e-05, 3.55563287e-05, -1.82591006e-03, 3.54345062e-05, 3.52470401e-05, - -1.80578693e-03, 3.50371546e-05, 3.48598813e-05, -1.78159758e-03, 3.45599725e-05, - 3.43945572e-05, -1.75332438e-03, 3.40029023e-05, 3.38507842e-05, -1.72095087e-03, - 3.33659849e-05, 3.32283259e-05, -1.68446349e-03, 3.26494000e-05, 3.25270323e-05, - -1.64385345e-03, 3.18535050e-05, 3.17468814e-05, -1.59911884e-03, 3.09788720e-05, - 3.08880220e-05, -1.55026659e-03, 3.00263180e-05, 2.99508153e-05, -1.49731470e-03, - 2.89969292e-05, 2.89358754e-05, -1.44029426e-03, 2.78920753e-05, 2.78441061e-05, - -1.37925151e-03, 2.67134124e-05, 2.66767334e-05, -1.31424973e-03, 2.54628739e-05, - 2.54353306e-05, -1.24537099e-03, 2.41426459e-05, 2.41218371e-05, -1.17271904e-03, - 2.27551288e-05, 2.27385675e-05, -1.09644028e-03, 2.13028851e-05, 2.12882113e-05, - -1.01672523e-03, 1.97886422e-05, 1.97738361e-05, -9.33796096e-04, 1.82153281e-05, - 1.81988871e-05, -8.47906049e-04, 1.65861416e-05, 1.65671910e-05, -7.59338194e-04, - 1.49046177e-05, 1.48829539e-05, -6.68403813e-04, 1.31746812e-05, 1.31507529e-05, - -5.75439973e-04, 1.14006895e-05, 1.13755214e-05, -4.80806502e-04, 9.58747177e-06, - 9.56253032e-06, -3.84882385e-04, 7.74034218e-06, 7.71736085e-06, -2.88061673e-04, - 5.86507734e-06, 5.84586648e-06, -1.90748969e-04, 3.96787623e-06, 3.95412873e-06, - -9.33546152e-05, 2.05529975e-06, 2.04840652e-06, 3.71417025e-06, 1.34185630e-07, - 1.35079651e-07, 1.00113455e-04, -1.78846546e-06, -1.77941339e-06, 1.95553580e-04, - -3.70563164e-06, -3.68864231e-06, 2.89756403e-04, -5.61040099e-06, -5.58625078e-06, - 3.82455758e-04, -7.49607953e-06, -7.46601794e-06, 4.73398965e-04, -9.35627924e-06, - -9.32191491e-06, 5.62348155e-04, -1.11849845e-05, -1.11481550e-05, 6.49081380e-04, - -1.29765974e-05, -1.29392371e-05, 7.33393496e-04, -1.47259672e-05, -1.46899815e-05, - 8.15096815e-04, -1.64284054e-05, -1.63955582e-05, 8.94021512e-04, -1.80796860e-05, - -1.80515076e-05, 9.70015786e-04, -1.96760354e-05, -1.96537533e-05, 1.04294579e-03, - -2.12141105e-05, -2.11986077e-05, 1.11269531e-03, -2.26909720e-05, -2.26827684e-05, - 1.17916529e-03, -2.41040488e-05, -2.41033095e-05, 1.24227306e-03, -2.54510972e-05, - -2.54576683e-05, 1.30194694e-03, -2.67301559e-05, -2.67436274e-05, 1.35811356e-03, - -2.79395059e-05, -2.79592933e-05, 1.41071501e-03, -2.90776593e-05, -2.91030736e-05, - 1.45971263e-03, -3.01433485e-05, -3.01736528e-05, 1.50508497e-03, -3.11355124e-05, - -3.11699657e-05, 1.54682564e-03, -3.20532797e-05, -3.20911696e-05, 1.58494096e-03, - -3.28959500e-05, -3.29366168e-05, 1.61944756e-03, -3.36629739e-05, -3.37058265e-05, - 1.65036997e-03, -3.43539327e-05, -3.43984580e-05, 1.67773822e-03, -3.49685190e-05, - -3.50142851e-05, 1.70158558e-03, -3.55065170e-05, -3.55531714e-05, 1.72194635e-03, - -3.59677834e-05, -3.60150483e-05, 1.73885391e-03, -3.63522303e-05, -3.63998952e-05, - 1.75233895e-03, -3.66598097e-05, -3.67077223e-05, 1.76242789e-03, -3.68904993e-05, - -3.69385551e-05, 1.76914171e-03, -3.70442924e-05, -3.70924232e-05, 1.77249490e-03, - -3.71211887e-05, -3.71693509e-05 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] - - True - - [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, - 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, - 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, - 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, - 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, - 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, - 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, - 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, - 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, - 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, - 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, - 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, - 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, - 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, - 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, - 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, - 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, - 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, - 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, - 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, - 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, - 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, - 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, - 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, - 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, - 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, - 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, - 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, - 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, - 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, - 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, - 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, - 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, - 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, - 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, - 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, - 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, - 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, - 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, - 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, - 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, - 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, - 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, - 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, - 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, - 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, - 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, - 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, - 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, - 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, - 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, - 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, - 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, - 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, - 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, - 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, - 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, - 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, - 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, - 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, - 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, - 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, - 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, - 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, - 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, - 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, - 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, - 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, - 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, - 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, - 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, - 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, - 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, - 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, - 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, - 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, - 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, - 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, - 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, - 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, - 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, - 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, - 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, - 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, - 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, - 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, - 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, - 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, - 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, - 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, - 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, - 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, - 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, - 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, - 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, - 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, - 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, - 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, - 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, - 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, - 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, - 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, - 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, - 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, - 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, - 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, - 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, - 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, - 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, - 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, - 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, - 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, - 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, - 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, - 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, - 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, - 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, - 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, - 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, - 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, - 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, - 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, - 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, - 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, - 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, - 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, - 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, - 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, - 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, - 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, - 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, - 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, - 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, - 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, - 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, - 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, - 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, - 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, - 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, - 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, - 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, - 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, - 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, - 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, - 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, - 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, - 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, - 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, - 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, - 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, - 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, - 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, - 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, - 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, - 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, - 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, - 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, - 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, - 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, - 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, - 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, - 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, - 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, - 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, - 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, - 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, - 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, - 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, - 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, - 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, - 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, - 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, - 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, - 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, - 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, - 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, - 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, - 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, - 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, - 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, - 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, - 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, - 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, - 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, - 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, - 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, - 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, - 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, - 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, - 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, - 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, - 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, - 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, - 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, - 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, - 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, - 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, - 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, - 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, - 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, - 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, - 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, - 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, - 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, - 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, - 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, - 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, - 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, - 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, - 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, - 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, - 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, - 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, - 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, - 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, - 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, - 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, - 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, - 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, - 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, - 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, - 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, - 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, - 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, - 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, - 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, - 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, - 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, - 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, - 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, - 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, - 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, - 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, - 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, - 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, - 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, - 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, - 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, - 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, - 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, - 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, - 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, - 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, - 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, - 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, - 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, - 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, - 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, - 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, - 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, - 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, - 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, - 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, - 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, - 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, - 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, - 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, - 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, - 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, - 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, - 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, - 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, - 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, - 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, - 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, - 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, - 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, - 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, - 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, - 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, - 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, - 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, - 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, - 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, - 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, - 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, - 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, - 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, - 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, - 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, - 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, - 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, - 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, - 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, - 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, - 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, - 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, - 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, - 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, - 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, - 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, - 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, - 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, - 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, - 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, - 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, - 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, - 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, - 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, - 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, - 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, - 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, - 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, - 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, - 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, - 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, - 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, - 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, - 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, - 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, - 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, - 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, - 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, - 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, - 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, - 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, - 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, - 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, - 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, - 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, - 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, - 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, - 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, - 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, - 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, - 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, - 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, - 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, - 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, - 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, - 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, - 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, - 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, - 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, - 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, - 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, - 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, - 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, - 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, - 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, - 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, - 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, - 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, - 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, - 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, - 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, - 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, - 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, - 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, - 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, - 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, - 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, - 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, - 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, - 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, - 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, - 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, - 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, - 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, - 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, - 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, - 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, - 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, - 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, - 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, - 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, - 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, - 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, - 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, - 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, - 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, - 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, - 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, - 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, - 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, - 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, - 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, - 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, - 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, - 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, - 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, - 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, - 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, - 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, - 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, - 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, - 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, - 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, - 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, - 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, - 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, - 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, - 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, - 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, - 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, - 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, - 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, - 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, - 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, - 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] - - 10 - - [ -9.06185538e-03, 2.66454093e-05, 3.09875724e-05, -9.07205353e-03, 2.64830393e-05, - 3.08218407e-05, -9.09236222e-03, 2.61616867e-05, 3.04924098e-05, -9.12260692e-03, - 2.56880480e-05, 3.00033276e-05, -9.16252758e-03, 2.50719726e-05, 2.93606226e-05, - -9.21178072e-03, 2.43262301e-05, 2.85722484e-05, -9.26994220e-03, 2.34662022e-05, - 2.76480059e-05, -9.33651075e-03, 2.25095026e-05, 2.65994400e-05, -9.41091206e-03, - 2.14755282e-05, 2.54397065e-05, -9.49250372e-03, 2.03849470e-05, 2.41834068e-05, - -9.58058069e-03, 1.92591300e-05, 2.28463884e-05, -9.67438149e-03, 1.81195366e-05, - 2.14455084e-05, -9.77309502e-03, 1.69870632e-05, 1.99983623e-05, -9.87586792e-03, - 1.58813705e-05, 1.85229780e-05, -9.98181250e-03, 1.48202042e-05, 1.70374800e-05, - -1.00900152e-02, 1.38187256e-05, 1.55597298e-05, -1.01995452e-02, 1.28888722e-05, - 1.41069502e-05, -1.03094640e-02, 1.20387663e-05, 1.26953430e-05, -1.04178973e-02, - 1.12422854e-05, 1.13338055e-05, -1.05199860e-02, 1.03863608e-05, 1.00123680e-05, - -1.06138305e-02, 9.46773782e-06, 8.74062853e-06, -1.06979801e-02, 8.49951861e-06, - 7.53032784e-06, -1.07710604e-02, 7.49804740e-06, 6.39279450e-06, -1.08317902e-02, - 6.48286888e-06, 5.33893146e-06, -1.08789974e-02, 5.47659609e-06, 4.37920048e-06, - -1.09116336e-02, 4.50467851e-06, 3.52359627e-06, -1.09287873e-02, 3.59506240e-06, - 2.78160195e-06, -1.09296960e-02, 2.77773763e-06, 2.16211815e-06, -1.09137564e-02, - 2.08416931e-06, 1.67335901e-06, -1.08805317e-02, 1.54661755e-06, 1.32271117e-06, - -1.08297588e-02, 1.19735520e-06, 1.11655532e-06, -1.07635385e-02, 1.06800647e-06, - 1.06008055e-06, -1.06909953e-02, 1.16990685e-06, 1.15459987e-06, -1.06133728e-02, - 1.48629510e-06, 1.39623149e-06, -1.05309349e-02, 1.99650449e-06, 1.77893677e-06, - -1.04439954e-02, 2.67789048e-06, 2.29487874e-06, -1.03529154e-02, 3.50642907e-06, - 2.93464749e-06, -1.02581000e-02, 4.45732197e-06, 3.68751293e-06, -1.01599950e-02, - 5.50558792e-06, 4.54169338e-06, -1.00590830e-02, 6.62662136e-06, 5.48462865e-06, - -9.95587859e-03, 7.79670230e-06, 6.50324721e-06, -9.85092462e-03, 8.99344451e-06, - 7.58421879e-06, -9.74478692e-03, 1.01961725e-05, 8.71418507e-06, -9.63804973e-03, - 1.13862219e-05, 9.87996380e-06, -9.53131072e-03, 1.25471601e-05, 1.10687231e-05, - -9.42517610e-03, 1.36649294e-05, 1.22681248e-05, -9.32024888e-03, 1.47279909e-05, - 1.34664427e-05, -9.21501335e-03, 1.57526606e-05, 1.46542469e-05, -9.10826221e-03, - 1.67584712e-05, 1.58228548e-05, -9.00119532e-03, 1.77390165e-05, 1.69625538e-05, - -8.89500729e-03, 1.86878584e-05, 1.80643010e-05, -8.79086547e-03, 1.95987114e-05, - 1.91197564e-05, -8.68989932e-03, 2.04654986e-05, 2.01212943e-05, -8.59319040e-03, - 2.12824044e-05, 2.10620029e-05, -8.50176308e-03, 2.20439227e-05, 2.19356737e-05, - -8.41657593e-03, 2.27449018e-05, 2.27367839e-05, -8.33851390e-03, 2.33805854e-05, - 2.34604732e-05, -8.26838124e-03, 2.39466496e-05, 2.41025171e-05, -8.20689523e-03, - 2.44392364e-05, 2.46592987e-05, -8.15468078e-03, 2.48549831e-05, 2.51277805e-05, - -8.11226570e-03, 2.51910482e-05, 2.55054776e-05, -8.08007685e-03, 2.54451319e-05, - 2.57904337e-05, -8.05843708e-03, 2.56154944e-05, 2.59812005e-05, -8.04756287e-03, - 2.57009686e-05, 2.60768215e-05, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, - 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, - 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.32348898e-20, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.11758237e-19, - 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, - 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, - 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, - 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, -6.77626358e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -3.38813179e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, - 5.51152161e-01 ] - - - [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] - - True - - - - - [ 2.37277310e+00, -6.57316204e-05, -6.53530460e-05, 2.37321115e+00, -6.55877636e-05, - -6.52131152e-05, 2.37408634e+00, -6.52999548e-05, -6.49331068e-05, 2.37539682e+00, - -6.48680117e-05, -6.45127266e-05, 2.37713984e+00, -6.42916942e-05, -6.39515592e-05, - 2.37931171e+00, -6.35707470e-05, -6.32491056e-05, 2.38190782e+00, -6.27049569e-05, - -6.24048306e-05, 2.38492261e+00, -6.16942193e-05, -6.14182192e-05, 2.38834957e+00, - -6.05386085e-05, -6.02888426e-05, 2.39218126e+00, -5.92384504e-05, -5.90164288e-05, - 2.39640924e+00, -5.77943938e-05, -5.76009379e-05, 2.40102415e+00, -5.62074763e-05, - -5.60426398e-05, 2.40601562e+00, -5.44791804e-05, -5.43421898e-05, 2.41137234e+00, - -5.26114770e-05, -5.25007021e-05, 2.41708200e+00, -5.06068510e-05, -5.05198167e-05, - 2.42313133e+00, -4.84683075e-05, -4.84017577e-05, 2.42950611e+00, -4.61993541e-05, - -4.61493801e-05, 2.43619116e+00, -4.38039576e-05, -4.37662025e-05, 2.44317037e+00, - -4.12864729e-05, -4.12564244e-05, 2.45042670e+00, -3.86515496e-05, -3.86249257e-05, - 2.45794224e+00, -3.59041361e-05, -3.58772721e-05, 2.46569826e+00, -3.30495449e-05, - -3.30197146e-05, 2.47367522e+00, -3.00935800e-05, -3.00591963e-05, 2.48185286e+00, - -2.70426550e-05, -2.70033486e-05, 2.49021027e+00, -2.39038911e-05, -2.38604759e-05, - 2.49872594e+00, -2.06851943e-05, -2.06395297e-05, 2.50737788e+00, -1.73953265e-05, - -1.73500732e-05, 2.51614366e+00, -1.40439297e-05, -1.40022328e-05, 2.52500055e+00, - -1.06414848e-05, -1.06066290e-05, 2.53392557e+00, -7.19923918e-06, -7.17429598e-06, - 2.54289563e+00, -3.72909677e-06, -3.71658984e-06, 2.55188761e+00, -2.43463856e-07, - -2.45085950e-07, 2.56087847e+00, 3.24495771e-06, 3.22853381e-06, 2.56984532e+00, - 6.72342758e-06, 6.69260246e-06, 2.57876549e+00, 1.01794049e-05, 1.01355872e-05, - 2.58761664e+00, 1.36007442e-05, 1.35462010e-05, 2.59637677e+00, 1.69758551e-05, - 1.69135051e-05, 2.60502429e+00, 2.02938232e-05, 2.02270005e-05, 2.61353812e+00, - 2.35444916e-05, 2.34767058e-05, 2.62189771e+00, 2.67185149e-05, 2.66532231e-05, - 2.63008306e+00, 2.98073863e-05, 2.97477890e-05, 2.63807486e+00, 3.28034385e-05, - 3.27523121e-05, 2.64585440e+00, 3.56998244e-05, 3.56593962e-05, 2.65340374e+00, - 3.84904787e-05, 3.84623507e-05, 2.66070563e+00, 4.11700681e-05, 4.11551836e-05, - 2.66774361e+00, 4.37339277e-05, 4.37325863e-05, 2.67450200e+00, 4.61779868e-05, - 4.61899092e-05, 2.68096592e+00, 4.84986865e-05, 4.85231290e-05, 2.68712132e+00, - 5.06929082e-05, 5.07288100e-05, 2.69295499e+00, 5.27579521e-05, 5.28040632e-05, - 2.69845456e+00, 5.46915183e-05, 5.47465018e-05, 2.70360853e+00, 5.64916817e-05, - 5.65541930e-05, 2.70840625e+00, 5.81568612e-05, 5.82256079e-05, 2.71283795e+00, - 5.96857861e-05, 5.97595711e-05, 2.71689470e+00, 6.10774597e-05, 6.11552106e-05, - 2.72056845e+00, 6.23311222e-05, 6.24119081e-05, 2.72385195e+00, 6.34462159e-05, - 6.35292531e-05, 2.72673884e+00, 6.44223492e-05, 6.45069981e-05, 2.72922354e+00, - 6.52592621e-05, 6.53450187e-05, 2.73130132e+00, 6.59567954e-05, 6.60432777e-05, - 2.73296825e+00, 6.65148615e-05, 6.66017932e-05, 2.73422117e+00, 6.69334204e-05, - 6.70206119e-05, 2.73505776e+00, 6.72124597e-05, 6.72997873e-05, 2.73547644e+00, - 6.73519789e-05, 6.74393635e-05 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] -

- [ 3.67147973e+03 ] - [ D ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh b/drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh b/drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh deleted file mode 100755 index a76591d7b..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/get1D.sh +++ /dev/null @@ -1,6 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep D inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 -xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz deleted file mode 100644 index 730791a08..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/init.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1441466 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1448613 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1460477 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1477077 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1498430 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1524556 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1555471 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1591193 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1631742 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1677134 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1727363 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1782411 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1842257 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1906879 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.1976222 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2050185 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2128665 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2211559 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2298731 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2389979 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2485087 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2583844 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2686011 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2791254 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.2899215 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3009534 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3121847 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3235746 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3350802 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3466586 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3582672 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3698644 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3814100 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.3928638 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4041854 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4153390 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4262942 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4370210 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4474895 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4576725 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4675494 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4771003 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4863054 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.4951464 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5036114 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5116899 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5193718 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5266471 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5335107 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5399597 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5459909 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5516014 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5567903 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5615583 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5659063 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5698349 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5733452 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5764386 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5791165 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5813803 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5832315 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5846716 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5857018 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -D 1.5863237 0.0000000 0.0000000 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml b/drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml deleted file mode 100644 index c386426bd..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/input.xml +++ /dev/null @@ -1,45 +0,0 @@ - - - [ step, potential{electronvolt}] - extras - extras - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - ['friction'] - - - - 80 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 10 - powell - true - - z_friction.dat - true - true - none - 0.1 - - - -
diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 deleted file mode 100644 index 58a3da761..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_00 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 - 0.00013194 -0.00003135 -0.00003130 - -0.00003135 0.00013218 -0.00003131 - -0.00003130 -0.00003131 0.00013173 - #*EXTRAS*# Step: 1 Bead: 0 - 0.00012935 -0.00003618 -0.00003590 - -0.00003618 0.00012952 -0.00003622 - -0.00003590 -0.00003622 0.00012901 - #*EXTRAS*# Step: 2 Bead: 0 - 0.00012681 -0.00003950 -0.00003898 - -0.00003950 0.00012690 -0.00003958 - -0.00003898 -0.00003958 0.00012646 - #*EXTRAS*# Step: 3 Bead: 0 - 0.00012527 -0.00004109 -0.00004054 - -0.00004109 0.00012534 -0.00004119 - -0.00004054 -0.00004119 0.00012497 - #*EXTRAS*# Step: 4 Bead: 0 - 0.00012453 -0.00004176 -0.00004126 - -0.00004176 0.00012459 -0.00004186 - -0.00004126 -0.00004186 0.00012426 - #*EXTRAS*# Step: 5 Bead: 0 - 0.00012411 -0.00004211 -0.00004167 - -0.00004211 0.00012417 -0.00004221 - -0.00004167 -0.00004221 0.00012386 - #*EXTRAS*# Step: 6 Bead: 0 - 0.00012386 -0.00004230 -0.00004190 - -0.00004230 0.00012392 -0.00004240 - -0.00004190 -0.00004240 0.00012363 - #*EXTRAS*# Step: 7 Bead: 0 - 0.00012370 -0.00004241 -0.00004204 - -0.00004241 0.00012377 -0.00004251 - -0.00004204 -0.00004251 0.00012348 - #*EXTRAS*# Step: 8 Bead: 0 - 0.00012360 -0.00004248 -0.00004212 - -0.00004248 0.00012367 -0.00004258 - -0.00004212 -0.00004258 0.00012339 - #*EXTRAS*# Step: 9 Bead: 0 - 0.00012354 -0.00004253 -0.00004218 - -0.00004253 0.00012361 -0.00004262 - -0.00004218 -0.00004262 0.00012333 - #*EXTRAS*# Step: 10 Bead: 0 - 0.00012350 -0.00004256 -0.00004222 - -0.00004256 0.00012357 -0.00004265 - -0.00004222 -0.00004265 0.00012329 - #*EXTRAS*# Step: 11 Bead: 0 - 0.00012347 -0.00004258 -0.00004224 - -0.00004258 0.00012354 -0.00004267 - -0.00004224 -0.00004267 0.00012326 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 deleted file mode 100644 index c2d1696ff..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_01 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 - 0.00013190 -0.00003145 -0.00003140 - -0.00003145 0.00013214 -0.00003142 - -0.00003140 -0.00003142 0.00013168 - #*EXTRAS*# Step: 1 Bead: 1 - 0.00012930 -0.00003624 -0.00003596 - -0.00003624 0.00012948 -0.00003628 - -0.00003596 -0.00003628 0.00012896 - #*EXTRAS*# Step: 2 Bead: 1 - 0.00012678 -0.00003953 -0.00003901 - -0.00003953 0.00012687 -0.00003961 - -0.00003901 -0.00003961 0.00012643 - #*EXTRAS*# Step: 3 Bead: 1 - 0.00012525 -0.00004111 -0.00004056 - -0.00004111 0.00012531 -0.00004121 - -0.00004056 -0.00004121 0.00012495 - #*EXTRAS*# Step: 4 Bead: 1 - 0.00012451 -0.00004178 -0.00004128 - -0.00004178 0.00012457 -0.00004188 - -0.00004128 -0.00004188 0.00012425 - #*EXTRAS*# Step: 5 Bead: 1 - 0.00012409 -0.00004212 -0.00004168 - -0.00004212 0.00012415 -0.00004222 - -0.00004168 -0.00004222 0.00012385 - #*EXTRAS*# Step: 6 Bead: 1 - 0.00012384 -0.00004231 -0.00004191 - -0.00004231 0.00012391 -0.00004241 - -0.00004191 -0.00004241 0.00012361 - #*EXTRAS*# Step: 7 Bead: 1 - 0.00012369 -0.00004242 -0.00004205 - -0.00004242 0.00012375 -0.00004252 - -0.00004205 -0.00004252 0.00012347 - #*EXTRAS*# Step: 8 Bead: 1 - 0.00012359 -0.00004250 -0.00004214 - -0.00004250 0.00012365 -0.00004259 - -0.00004214 -0.00004259 0.00012337 - #*EXTRAS*# Step: 9 Bead: 1 - 0.00012352 -0.00004254 -0.00004219 - -0.00004254 0.00012359 -0.00004263 - -0.00004219 -0.00004263 0.00012331 - #*EXTRAS*# Step: 10 Bead: 1 - 0.00012348 -0.00004257 -0.00004223 - -0.00004257 0.00012355 -0.00004266 - -0.00004223 -0.00004266 0.00012328 - #*EXTRAS*# Step: 11 Bead: 1 - 0.00012345 -0.00004259 -0.00004225 - -0.00004259 0.00012352 -0.00004268 - -0.00004225 -0.00004268 0.00012325 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 deleted file mode 100644 index 51ecc8a36..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_02 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 - 0.00013182 -0.00003163 -0.00003158 - -0.00003163 0.00013207 -0.00003160 - -0.00003158 -0.00003160 0.00013160 - #*EXTRAS*# Step: 1 Bead: 2 - 0.00012923 -0.00003635 -0.00003606 - -0.00003635 0.00012940 -0.00003639 - -0.00003606 -0.00003639 0.00012889 - #*EXTRAS*# Step: 2 Bead: 2 - 0.00012672 -0.00003959 -0.00003907 - -0.00003959 0.00012681 -0.00003967 - -0.00003907 -0.00003967 0.00012638 - #*EXTRAS*# Step: 3 Bead: 2 - 0.00012521 -0.00004115 -0.00004061 - -0.00004115 0.00012527 -0.00004125 - -0.00004061 -0.00004125 0.00012491 - #*EXTRAS*# Step: 4 Bead: 2 - 0.00012447 -0.00004181 -0.00004132 - -0.00004181 0.00012454 -0.00004191 - -0.00004132 -0.00004191 0.00012421 - #*EXTRAS*# Step: 5 Bead: 2 - 0.00012406 -0.00004215 -0.00004171 - -0.00004215 0.00012412 -0.00004225 - -0.00004171 -0.00004225 0.00012381 - #*EXTRAS*# Step: 6 Bead: 2 - 0.00012381 -0.00004234 -0.00004194 - -0.00004234 0.00012387 -0.00004243 - -0.00004194 -0.00004243 0.00012358 - #*EXTRAS*# Step: 7 Bead: 2 - 0.00012365 -0.00004245 -0.00004208 - -0.00004245 0.00012372 -0.00004254 - -0.00004208 -0.00004254 0.00012344 - #*EXTRAS*# Step: 8 Bead: 2 - 0.00012356 -0.00004252 -0.00004216 - -0.00004252 0.00012362 -0.00004261 - -0.00004216 -0.00004261 0.00012335 - #*EXTRAS*# Step: 9 Bead: 2 - 0.00012349 -0.00004256 -0.00004222 - -0.00004256 0.00012356 -0.00004265 - -0.00004222 -0.00004265 0.00012329 - #*EXTRAS*# Step: 10 Bead: 2 - 0.00012345 -0.00004259 -0.00004226 - -0.00004259 0.00012352 -0.00004268 - -0.00004226 -0.00004268 0.00012325 - #*EXTRAS*# Step: 11 Bead: 2 - 0.00012342 -0.00004261 -0.00004228 - -0.00004261 0.00012349 -0.00004270 - -0.00004228 -0.00004270 0.00012322 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 deleted file mode 100644 index 842276674..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_03 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 - 0.00013172 -0.00003187 -0.00003181 - -0.00003187 0.00013196 -0.00003184 - -0.00003181 -0.00003184 0.00013149 - #*EXTRAS*# Step: 1 Bead: 3 - 0.00012912 -0.00003651 -0.00003621 - -0.00003651 0.00012929 -0.00003655 - -0.00003621 -0.00003655 0.00012878 - #*EXTRAS*# Step: 2 Bead: 3 - 0.00012664 -0.00003969 -0.00003915 - -0.00003969 0.00012672 -0.00003977 - -0.00003915 -0.00003977 0.00012630 - #*EXTRAS*# Step: 3 Bead: 3 - 0.00012514 -0.00004122 -0.00004067 - -0.00004122 0.00012520 -0.00004132 - -0.00004067 -0.00004132 0.00012484 - #*EXTRAS*# Step: 4 Bead: 3 - 0.00012442 -0.00004186 -0.00004137 - -0.00004186 0.00012448 -0.00004196 - -0.00004137 -0.00004196 0.00012416 - #*EXTRAS*# Step: 5 Bead: 3 - 0.00012400 -0.00004219 -0.00004176 - -0.00004219 0.00012407 -0.00004229 - -0.00004176 -0.00004229 0.00012376 - #*EXTRAS*# Step: 6 Bead: 3 - 0.00012376 -0.00004237 -0.00004198 - -0.00004237 0.00012382 -0.00004247 - -0.00004198 -0.00004247 0.00012354 - #*EXTRAS*# Step: 7 Bead: 3 - 0.00012361 -0.00004248 -0.00004212 - -0.00004248 0.00012367 -0.00004258 - -0.00004212 -0.00004258 0.00012339 - #*EXTRAS*# Step: 8 Bead: 3 - 0.00012351 -0.00004255 -0.00004221 - -0.00004255 0.00012358 -0.00004264 - -0.00004221 -0.00004264 0.00012330 - #*EXTRAS*# Step: 9 Bead: 3 - 0.00012345 -0.00004259 -0.00004226 - -0.00004259 0.00012352 -0.00004269 - -0.00004226 -0.00004269 0.00012324 - #*EXTRAS*# Step: 10 Bead: 3 - 0.00012341 -0.00004262 -0.00004229 - -0.00004262 0.00012347 -0.00004271 - -0.00004229 -0.00004271 0.00012320 - #*EXTRAS*# Step: 11 Bead: 3 - 0.00012338 -0.00004264 -0.00004232 - -0.00004264 0.00012345 -0.00004273 - -0.00004232 -0.00004273 0.00012318 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 deleted file mode 100644 index 95d0021dd..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_04 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 - 0.00013158 -0.00003218 -0.00003211 - -0.00003218 0.00013182 -0.00003215 - -0.00003211 -0.00003215 0.00013134 - #*EXTRAS*# Step: 1 Bead: 4 - 0.00012898 -0.00003672 -0.00003640 - -0.00003672 0.00012914 -0.00003676 - -0.00003640 -0.00003676 0.00012864 - #*EXTRAS*# Step: 2 Bead: 4 - 0.00012653 -0.00003981 -0.00003927 - -0.00003981 0.00012661 -0.00003989 - -0.00003927 -0.00003989 0.00012619 - #*EXTRAS*# Step: 3 Bead: 4 - 0.00012505 -0.00004130 -0.00004076 - -0.00004130 0.00012511 -0.00004140 - -0.00004076 -0.00004140 0.00012476 - #*EXTRAS*# Step: 4 Bead: 4 - 0.00012434 -0.00004192 -0.00004144 - -0.00004192 0.00012441 -0.00004202 - -0.00004144 -0.00004202 0.00012409 - #*EXTRAS*# Step: 5 Bead: 4 - 0.00012394 -0.00004224 -0.00004182 - -0.00004224 0.00012400 -0.00004234 - -0.00004182 -0.00004234 0.00012370 - #*EXTRAS*# Step: 6 Bead: 4 - 0.00012369 -0.00004242 -0.00004204 - -0.00004242 0.00012376 -0.00004252 - -0.00004204 -0.00004252 0.00012347 - #*EXTRAS*# Step: 7 Bead: 4 - 0.00012354 -0.00004253 -0.00004218 - -0.00004253 0.00012361 -0.00004262 - -0.00004218 -0.00004262 0.00012333 - #*EXTRAS*# Step: 8 Bead: 4 - 0.00012345 -0.00004259 -0.00004226 - -0.00004259 0.00012352 -0.00004268 - -0.00004226 -0.00004268 0.00012324 - #*EXTRAS*# Step: 9 Bead: 4 - 0.00012339 -0.00004263 -0.00004231 - -0.00004263 0.00012345 -0.00004273 - -0.00004231 -0.00004273 0.00012319 - #*EXTRAS*# Step: 10 Bead: 4 - 0.00012335 -0.00004266 -0.00004235 - -0.00004266 0.00012341 -0.00004275 - -0.00004235 -0.00004275 0.00012315 - #*EXTRAS*# Step: 11 Bead: 4 - 0.00012332 -0.00004268 -0.00004237 - -0.00004268 0.00012339 -0.00004277 - -0.00004237 -0.00004277 0.00012312 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 deleted file mode 100644 index 3ffbedbe0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_05 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 - 0.00013141 -0.00003255 -0.00003248 - -0.00003255 0.00013164 -0.00003253 - -0.00003248 -0.00003253 0.00013115 - #*EXTRAS*# Step: 1 Bead: 5 - 0.00012881 -0.00003697 -0.00003663 - -0.00003697 0.00012896 -0.00003701 - -0.00003663 -0.00003701 0.00012846 - #*EXTRAS*# Step: 2 Bead: 5 - 0.00012639 -0.00003996 -0.00003942 - -0.00003996 0.00012647 -0.00004004 - -0.00003942 -0.00004004 0.00012605 - #*EXTRAS*# Step: 3 Bead: 5 - 0.00012495 -0.00004140 -0.00004086 - -0.00004140 0.00012501 -0.00004150 - -0.00004086 -0.00004150 0.00012466 - #*EXTRAS*# Step: 4 Bead: 5 - 0.00012425 -0.00004199 -0.00004153 - -0.00004199 0.00012431 -0.00004209 - -0.00004153 -0.00004209 0.00012400 - #*EXTRAS*# Step: 5 Bead: 5 - 0.00012385 -0.00004230 -0.00004190 - -0.00004230 0.00012392 -0.00004240 - -0.00004190 -0.00004240 0.00012362 - #*EXTRAS*# Step: 6 Bead: 5 - 0.00012361 -0.00004248 -0.00004211 - -0.00004248 0.00012368 -0.00004257 - -0.00004211 -0.00004257 0.00012340 - #*EXTRAS*# Step: 7 Bead: 5 - 0.00012347 -0.00004258 -0.00004224 - -0.00004258 0.00012353 -0.00004267 - -0.00004224 -0.00004267 0.00012326 - #*EXTRAS*# Step: 8 Bead: 5 - 0.00012337 -0.00004264 -0.00004232 - -0.00004264 0.00012344 -0.00004273 - -0.00004232 -0.00004273 0.00012317 - #*EXTRAS*# Step: 9 Bead: 5 - 0.00012331 -0.00004268 -0.00004238 - -0.00004268 0.00012338 -0.00004277 - -0.00004238 -0.00004277 0.00012312 - #*EXTRAS*# Step: 10 Bead: 5 - 0.00012327 -0.00004271 -0.00004241 - -0.00004271 0.00012334 -0.00004280 - -0.00004241 -0.00004280 0.00012308 - #*EXTRAS*# Step: 11 Bead: 5 - 0.00012324 -0.00004273 -0.00004243 - -0.00004273 0.00012331 -0.00004282 - -0.00004243 -0.00004282 0.00012305 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 deleted file mode 100644 index c65256e90..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_06 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 - 0.00013120 -0.00003298 -0.00003290 - -0.00003298 0.00013143 -0.00003297 - -0.00003290 -0.00003297 0.00013093 - #*EXTRAS*# Step: 1 Bead: 6 - 0.00012860 -0.00003726 -0.00003690 - -0.00003726 0.00012875 -0.00003731 - -0.00003690 -0.00003731 0.00012825 - #*EXTRAS*# Step: 2 Bead: 6 - 0.00012623 -0.00004013 -0.00003958 - -0.00004013 0.00012630 -0.00004022 - -0.00003958 -0.00004022 0.00012590 - #*EXTRAS*# Step: 3 Bead: 6 - 0.00012482 -0.00004151 -0.00004099 - -0.00004151 0.00012488 -0.00004161 - -0.00004099 -0.00004161 0.00012454 - #*EXTRAS*# Step: 4 Bead: 6 - 0.00012414 -0.00004208 -0.00004163 - -0.00004208 0.00012420 -0.00004218 - -0.00004163 -0.00004218 0.00012390 - #*EXTRAS*# Step: 5 Bead: 6 - 0.00012375 -0.00004238 -0.00004199 - -0.00004238 0.00012382 -0.00004248 - -0.00004199 -0.00004248 0.00012353 - #*EXTRAS*# Step: 6 Bead: 6 - 0.00012352 -0.00004254 -0.00004220 - -0.00004254 0.00012359 -0.00004264 - -0.00004220 -0.00004264 0.00012331 - #*EXTRAS*# Step: 7 Bead: 6 - 0.00012337 -0.00004264 -0.00004232 - -0.00004264 0.00012344 -0.00004273 - -0.00004232 -0.00004273 0.00012317 - #*EXTRAS*# Step: 8 Bead: 6 - 0.00012328 -0.00004270 -0.00004240 - -0.00004270 0.00012335 -0.00004279 - -0.00004240 -0.00004279 0.00012309 - #*EXTRAS*# Step: 9 Bead: 6 - 0.00012322 -0.00004274 -0.00004245 - -0.00004274 0.00012329 -0.00004283 - -0.00004245 -0.00004283 0.00012303 - #*EXTRAS*# Step: 10 Bead: 6 - 0.00012318 -0.00004277 -0.00004248 - -0.00004277 0.00012325 -0.00004286 - -0.00004248 -0.00004286 0.00012299 - #*EXTRAS*# Step: 11 Bead: 6 - 0.00012316 -0.00004278 -0.00004250 - -0.00004278 0.00012322 -0.00004287 - -0.00004250 -0.00004287 0.00012297 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 deleted file mode 100644 index c20f150b1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_07 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 - 0.00013094 -0.00003348 -0.00003337 - -0.00003348 0.00013117 -0.00003348 - -0.00003337 -0.00003348 0.00013066 - #*EXTRAS*# Step: 1 Bead: 7 - 0.00012836 -0.00003759 -0.00003720 - -0.00003759 0.00012849 -0.00003764 - -0.00003720 -0.00003764 0.00012800 - #*EXTRAS*# Step: 2 Bead: 7 - 0.00012604 -0.00004033 -0.00003978 - -0.00004033 0.00012611 -0.00004042 - -0.00003978 -0.00004042 0.00012571 - #*EXTRAS*# Step: 3 Bead: 7 - 0.00012467 -0.00004164 -0.00004113 - -0.00004164 0.00012473 -0.00004174 - -0.00004113 -0.00004174 0.00012440 - #*EXTRAS*# Step: 4 Bead: 7 - 0.00012402 -0.00004218 -0.00004175 - -0.00004218 0.00012408 -0.00004228 - -0.00004175 -0.00004228 0.00012378 - #*EXTRAS*# Step: 5 Bead: 7 - 0.00012363 -0.00004246 -0.00004210 - -0.00004246 0.00012370 -0.00004256 - -0.00004210 -0.00004256 0.00012342 - #*EXTRAS*# Step: 6 Bead: 7 - 0.00012341 -0.00004262 -0.00004229 - -0.00004262 0.00012348 -0.00004271 - -0.00004229 -0.00004271 0.00012321 - #*EXTRAS*# Step: 7 Bead: 7 - 0.00012327 -0.00004271 -0.00004241 - -0.00004271 0.00012333 -0.00004280 - -0.00004241 -0.00004280 0.00012307 - #*EXTRAS*# Step: 8 Bead: 7 - 0.00012317 -0.00004277 -0.00004249 - -0.00004277 0.00012324 -0.00004286 - -0.00004249 -0.00004286 0.00012299 - #*EXTRAS*# Step: 9 Bead: 7 - 0.00012312 -0.00004281 -0.00004254 - -0.00004281 0.00012319 -0.00004289 - -0.00004254 -0.00004289 0.00012293 - #*EXTRAS*# Step: 10 Bead: 7 - 0.00012308 -0.00004283 -0.00004257 - -0.00004283 0.00012315 -0.00004292 - -0.00004257 -0.00004292 0.00012290 - #*EXTRAS*# Step: 11 Bead: 7 - 0.00012305 -0.00004285 -0.00004259 - -0.00004285 0.00012312 -0.00004293 - -0.00004259 -0.00004293 0.00012287 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 deleted file mode 100644 index d507f6da1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_08 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 - 0.00013065 -0.00003403 -0.00003390 - -0.00003403 0.00013086 -0.00003404 - -0.00003390 -0.00003404 0.00013035 - #*EXTRAS*# Step: 1 Bead: 8 - 0.00012808 -0.00003795 -0.00003754 - -0.00003795 0.00012821 -0.00003801 - -0.00003754 -0.00003801 0.00012773 - #*EXTRAS*# Step: 2 Bead: 8 - 0.00012583 -0.00004055 -0.00003999 - -0.00004055 0.00012590 -0.00004064 - -0.00003999 -0.00004064 0.00012551 - #*EXTRAS*# Step: 3 Bead: 8 - 0.00012451 -0.00004178 -0.00004129 - -0.00004178 0.00012457 -0.00004188 - -0.00004129 -0.00004188 0.00012424 - #*EXTRAS*# Step: 4 Bead: 8 - 0.00012387 -0.00004229 -0.00004188 - -0.00004229 0.00012394 -0.00004239 - -0.00004188 -0.00004239 0.00012364 - #*EXTRAS*# Step: 5 Bead: 8 - 0.00012350 -0.00004255 -0.00004221 - -0.00004255 0.00012357 -0.00004265 - -0.00004221 -0.00004265 0.00012330 - #*EXTRAS*# Step: 6 Bead: 8 - 0.00012328 -0.00004270 -0.00004240 - -0.00004270 0.00012335 -0.00004279 - -0.00004240 -0.00004279 0.00012309 - #*EXTRAS*# Step: 7 Bead: 8 - 0.00012314 -0.00004279 -0.00004251 - -0.00004279 0.00012321 -0.00004288 - -0.00004251 -0.00004288 0.00012296 - #*EXTRAS*# Step: 8 Bead: 8 - 0.00012306 -0.00004285 -0.00004259 - -0.00004285 0.00012312 -0.00004293 - -0.00004259 -0.00004293 0.00012288 - #*EXTRAS*# Step: 9 Bead: 8 - 0.00012300 -0.00004288 -0.00004263 - -0.00004288 0.00012307 -0.00004296 - -0.00004263 -0.00004296 0.00012282 - #*EXTRAS*# Step: 10 Bead: 8 - 0.00012296 -0.00004291 -0.00004266 - -0.00004291 0.00012303 -0.00004299 - -0.00004266 -0.00004299 0.00012279 - #*EXTRAS*# Step: 11 Bead: 8 - 0.00012294 -0.00004292 -0.00004268 - -0.00004292 0.00012300 -0.00004300 - -0.00004268 -0.00004300 0.00012276 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 deleted file mode 100644 index 407ff2c4e..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_09 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 - 0.00013031 -0.00003464 -0.00003447 - -0.00003464 0.00013051 -0.00003465 - -0.00003447 -0.00003465 0.00012999 - #*EXTRAS*# Step: 1 Bead: 9 - 0.00012777 -0.00003835 -0.00003790 - -0.00003835 0.00012789 -0.00003841 - -0.00003790 -0.00003841 0.00012742 - #*EXTRAS*# Step: 2 Bead: 9 - 0.00012560 -0.00004078 -0.00004022 - -0.00004078 0.00012566 -0.00004088 - -0.00004022 -0.00004088 0.00012528 - #*EXTRAS*# Step: 3 Bead: 9 - 0.00012433 -0.00004193 -0.00004146 - -0.00004193 0.00012439 -0.00004203 - -0.00004146 -0.00004203 0.00012407 - #*EXTRAS*# Step: 4 Bead: 9 - 0.00012372 -0.00004240 -0.00004202 - -0.00004240 0.00012378 -0.00004250 - -0.00004202 -0.00004250 0.00012350 - #*EXTRAS*# Step: 5 Bead: 9 - 0.00012336 -0.00004265 -0.00004234 - -0.00004265 0.00012343 -0.00004274 - -0.00004234 -0.00004274 0.00012316 - #*EXTRAS*# Step: 6 Bead: 9 - 0.00012314 -0.00004279 -0.00004252 - -0.00004279 0.00012321 -0.00004288 - -0.00004252 -0.00004288 0.00012296 - #*EXTRAS*# Step: 7 Bead: 9 - 0.00012301 -0.00004288 -0.00004262 - -0.00004288 0.00012308 -0.00004296 - -0.00004262 -0.00004296 0.00012283 - #*EXTRAS*# Step: 8 Bead: 9 - 0.00012292 -0.00004293 -0.00004269 - -0.00004293 0.00012299 -0.00004301 - -0.00004269 -0.00004301 0.00012275 - #*EXTRAS*# Step: 9 Bead: 9 - 0.00012287 -0.00004296 -0.00004274 - -0.00004296 0.00012293 -0.00004304 - -0.00004274 -0.00004304 0.00012270 - #*EXTRAS*# Step: 10 Bead: 9 - 0.00012283 -0.00004298 -0.00004276 - -0.00004298 0.00012290 -0.00004306 - -0.00004276 -0.00004306 0.00012267 - #*EXTRAS*# Step: 11 Bead: 9 - 0.00012280 -0.00004300 -0.00004278 - -0.00004300 0.00012287 -0.00004307 - -0.00004278 -0.00004307 0.00012264 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 deleted file mode 100644 index f633b9b74..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_10 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 - 0.00012992 -0.00003529 -0.00003508 - -0.00003529 0.00013011 -0.00003531 - -0.00003508 -0.00003531 0.00012959 - #*EXTRAS*# Step: 1 Bead: 10 - 0.00012743 -0.00003877 -0.00003830 - -0.00003877 0.00012753 -0.00003884 - -0.00003830 -0.00003884 0.00012707 - #*EXTRAS*# Step: 2 Bead: 10 - 0.00012534 -0.00004103 -0.00004047 - -0.00004103 0.00012541 -0.00004112 - -0.00004047 -0.00004112 0.00012504 - #*EXTRAS*# Step: 3 Bead: 10 - 0.00012413 -0.00004209 -0.00004164 - -0.00004209 0.00012419 -0.00004219 - -0.00004164 -0.00004219 0.00012388 - #*EXTRAS*# Step: 4 Bead: 10 - 0.00012355 -0.00004252 -0.00004217 - -0.00004252 0.00012361 -0.00004262 - -0.00004217 -0.00004262 0.00012334 - #*EXTRAS*# Step: 5 Bead: 10 - 0.00012320 -0.00004276 -0.00004247 - -0.00004276 0.00012327 -0.00004284 - -0.00004247 -0.00004284 0.00012301 - #*EXTRAS*# Step: 6 Bead: 10 - 0.00012299 -0.00004289 -0.00004264 - -0.00004289 0.00012306 -0.00004297 - -0.00004264 -0.00004297 0.00012282 - #*EXTRAS*# Step: 7 Bead: 10 - 0.00012286 -0.00004297 -0.00004274 - -0.00004297 0.00012293 -0.00004304 - -0.00004274 -0.00004304 0.00012269 - #*EXTRAS*# Step: 8 Bead: 10 - 0.00012277 -0.00004301 -0.00004281 - -0.00004301 0.00012284 -0.00004309 - -0.00004281 -0.00004309 0.00012261 - #*EXTRAS*# Step: 9 Bead: 10 - 0.00012272 -0.00004305 -0.00004285 - -0.00004305 0.00012279 -0.00004312 - -0.00004285 -0.00004312 0.00012256 - #*EXTRAS*# Step: 10 Bead: 10 - 0.00012268 -0.00004307 -0.00004287 - -0.00004307 0.00012275 -0.00004314 - -0.00004287 -0.00004314 0.00012253 - #*EXTRAS*# Step: 11 Bead: 10 - 0.00012266 -0.00004308 -0.00004289 - -0.00004308 0.00012273 -0.00004315 - -0.00004289 -0.00004315 0.00012251 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 deleted file mode 100644 index fadd4bea4..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_11 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 - 0.00012948 -0.00003598 -0.00003572 - -0.00003598 0.00012966 -0.00003601 - -0.00003572 -0.00003601 0.00012914 - #*EXTRAS*# Step: 1 Bead: 11 - 0.00012705 -0.00003921 -0.00003871 - -0.00003921 0.00012715 -0.00003929 - -0.00003871 -0.00003929 0.00012671 - #*EXTRAS*# Step: 2 Bead: 11 - 0.00012507 -0.00004128 -0.00004074 - -0.00004128 0.00012513 -0.00004138 - -0.00004074 -0.00004138 0.00012478 - #*EXTRAS*# Step: 3 Bead: 11 - 0.00012392 -0.00004225 -0.00004184 - -0.00004225 0.00012398 -0.00004235 - -0.00004184 -0.00004235 0.00012369 - #*EXTRAS*# Step: 4 Bead: 11 - 0.00012336 -0.00004265 -0.00004233 - -0.00004265 0.00012343 -0.00004274 - -0.00004233 -0.00004274 0.00012316 - #*EXTRAS*# Step: 5 Bead: 11 - 0.00012302 -0.00004287 -0.00004261 - -0.00004287 0.00012309 -0.00004295 - -0.00004261 -0.00004295 0.00012285 - #*EXTRAS*# Step: 6 Bead: 11 - 0.00012282 -0.00004299 -0.00004277 - -0.00004299 0.00012289 -0.00004306 - -0.00004277 -0.00004306 0.00012266 - #*EXTRAS*# Step: 7 Bead: 11 - 0.00012270 -0.00004306 -0.00004286 - -0.00004306 0.00012276 -0.00004313 - -0.00004286 -0.00004313 0.00012254 - #*EXTRAS*# Step: 8 Bead: 11 - 0.00012261 -0.00004310 -0.00004292 - -0.00004310 0.00012268 -0.00004317 - -0.00004292 -0.00004317 0.00012246 - #*EXTRAS*# Step: 9 Bead: 11 - 0.00012256 -0.00004313 -0.00004296 - -0.00004313 0.00012263 -0.00004320 - -0.00004296 -0.00004320 0.00012242 - #*EXTRAS*# Step: 10 Bead: 11 - 0.00012253 -0.00004315 -0.00004299 - -0.00004315 0.00012259 -0.00004322 - -0.00004299 -0.00004322 0.00012238 - #*EXTRAS*# Step: 11 Bead: 11 - 0.00012250 -0.00004317 -0.00004300 - -0.00004317 0.00012257 -0.00004323 - -0.00004300 -0.00004323 0.00012236 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 deleted file mode 100644 index 5b5e45b66..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_12 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 - 0.00012899 -0.00003670 -0.00003639 - -0.00003670 0.00012915 -0.00003675 - -0.00003639 -0.00003675 0.00012865 - #*EXTRAS*# Step: 1 Bead: 12 - 0.00012665 -0.00003967 -0.00003914 - -0.00003967 0.00012674 -0.00003975 - -0.00003914 -0.00003975 0.00012631 - #*EXTRAS*# Step: 2 Bead: 12 - 0.00012479 -0.00004153 -0.00004101 - -0.00004153 0.00012485 -0.00004164 - -0.00004101 -0.00004164 0.00012451 - #*EXTRAS*# Step: 3 Bead: 12 - 0.00012369 -0.00004242 -0.00004204 - -0.00004242 0.00012376 -0.00004252 - -0.00004204 -0.00004252 0.00012347 - #*EXTRAS*# Step: 4 Bead: 12 - 0.00012316 -0.00004278 -0.00004250 - -0.00004278 0.00012323 -0.00004287 - -0.00004250 -0.00004287 0.00012297 - #*EXTRAS*# Step: 5 Bead: 12 - 0.00012284 -0.00004298 -0.00004276 - -0.00004298 0.00012291 -0.00004305 - -0.00004276 -0.00004305 0.00012267 - #*EXTRAS*# Step: 6 Bead: 12 - 0.00012264 -0.00004309 -0.00004290 - -0.00004309 0.00012271 -0.00004316 - -0.00004290 -0.00004316 0.00012249 - #*EXTRAS*# Step: 7 Bead: 12 - 0.00012252 -0.00004316 -0.00004299 - -0.00004316 0.00012258 -0.00004322 - -0.00004299 -0.00004322 0.00012238 - #*EXTRAS*# Step: 8 Bead: 12 - 0.00012244 -0.00004320 -0.00004305 - -0.00004320 0.00012250 -0.00004326 - -0.00004305 -0.00004326 0.00012230 - #*EXTRAS*# Step: 9 Bead: 12 - 0.00012239 -0.00004323 -0.00004308 - -0.00004323 0.00012245 -0.00004328 - -0.00004308 -0.00004328 0.00012225 - #*EXTRAS*# Step: 10 Bead: 12 - 0.00012236 -0.00004324 -0.00004311 - -0.00004324 0.00012242 -0.00004330 - -0.00004311 -0.00004330 0.00012222 - #*EXTRAS*# Step: 11 Bead: 12 - 0.00012233 -0.00004325 -0.00004312 - -0.00004325 0.00012239 -0.00004331 - -0.00004312 -0.00004331 0.00012220 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 deleted file mode 100644 index 4cc68ff38..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_13 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 - 0.00012846 -0.00003745 -0.00003707 - -0.00003745 0.00012860 -0.00003750 - -0.00003707 -0.00003750 0.00012811 - #*EXTRAS*# Step: 1 Bead: 13 - 0.00012623 -0.00004013 -0.00003958 - -0.00004013 0.00012630 -0.00004022 - -0.00003958 -0.00004022 0.00012590 - #*EXTRAS*# Step: 2 Bead: 13 - 0.00012450 -0.00004179 -0.00004130 - -0.00004179 0.00012456 -0.00004189 - -0.00004130 -0.00004189 0.00012423 - #*EXTRAS*# Step: 3 Bead: 13 - 0.00012346 -0.00004259 -0.00004225 - -0.00004259 0.00012352 -0.00004268 - -0.00004225 -0.00004268 0.00012325 - #*EXTRAS*# Step: 4 Bead: 13 - 0.00012295 -0.00004291 -0.00004267 - -0.00004291 0.00012302 -0.00004299 - -0.00004267 -0.00004299 0.00012278 - #*EXTRAS*# Step: 5 Bead: 13 - 0.00012264 -0.00004309 -0.00004291 - -0.00004309 0.00012270 -0.00004316 - -0.00004291 -0.00004316 0.00012249 - #*EXTRAS*# Step: 6 Bead: 13 - 0.00012245 -0.00004319 -0.00004304 - -0.00004319 0.00012251 -0.00004325 - -0.00004304 -0.00004325 0.00012231 - #*EXTRAS*# Step: 7 Bead: 13 - 0.00012233 -0.00004326 -0.00004312 - -0.00004326 0.00012239 -0.00004331 - -0.00004312 -0.00004331 0.00012220 - #*EXTRAS*# Step: 8 Bead: 13 - 0.00012225 -0.00004329 -0.00004317 - -0.00004329 0.00012231 -0.00004334 - -0.00004317 -0.00004334 0.00012213 - #*EXTRAS*# Step: 9 Bead: 13 - 0.00012220 -0.00004332 -0.00004321 - -0.00004332 0.00012226 -0.00004337 - -0.00004321 -0.00004337 0.00012208 - #*EXTRAS*# Step: 10 Bead: 13 - 0.00012217 -0.00004334 -0.00004323 - -0.00004334 0.00012223 -0.00004338 - -0.00004323 -0.00004338 0.00012205 - #*EXTRAS*# Step: 11 Bead: 13 - 0.00012215 -0.00004335 -0.00004324 - -0.00004335 0.00012221 -0.00004339 - -0.00004324 -0.00004339 0.00012203 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 deleted file mode 100644 index 8a78d1b95..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_14 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 - 0.00012788 -0.00003821 -0.00003777 - -0.00003821 0.00012800 -0.00003827 - -0.00003777 -0.00003827 0.00012753 - #*EXTRAS*# Step: 1 Bead: 14 - 0.00012578 -0.00004059 -0.00004004 - -0.00004059 0.00012585 -0.00004069 - -0.00004004 -0.00004069 0.00012546 - #*EXTRAS*# Step: 2 Bead: 14 - 0.00012419 -0.00004204 -0.00004159 - -0.00004204 0.00012425 -0.00004214 - -0.00004159 -0.00004214 0.00012394 - #*EXTRAS*# Step: 3 Bead: 14 - 0.00012321 -0.00004275 -0.00004246 - -0.00004275 0.00012327 -0.00004284 - -0.00004246 -0.00004284 0.00012302 - #*EXTRAS*# Step: 4 Bead: 14 - 0.00012272 -0.00004305 -0.00004285 - -0.00004305 0.00012279 -0.00004312 - -0.00004285 -0.00004312 0.00012256 - #*EXTRAS*# Step: 5 Bead: 14 - 0.00012242 -0.00004321 -0.00004306 - -0.00004321 0.00012249 -0.00004327 - -0.00004306 -0.00004327 0.00012228 - #*EXTRAS*# Step: 6 Bead: 14 - 0.00012224 -0.00004330 -0.00004318 - -0.00004330 0.00012230 -0.00004335 - -0.00004318 -0.00004335 0.00012212 - #*EXTRAS*# Step: 7 Bead: 14 - 0.00012213 -0.00004336 -0.00004326 - -0.00004336 0.00012218 -0.00004340 - -0.00004326 -0.00004340 0.00012201 - #*EXTRAS*# Step: 8 Bead: 14 - 0.00012205 -0.00004339 -0.00004330 - -0.00004339 0.00012211 -0.00004343 - -0.00004330 -0.00004343 0.00012194 - #*EXTRAS*# Step: 9 Bead: 14 - 0.00012201 -0.00004342 -0.00004333 - -0.00004342 0.00012206 -0.00004345 - -0.00004333 -0.00004345 0.00012189 - #*EXTRAS*# Step: 10 Bead: 14 - 0.00012197 -0.00004343 -0.00004335 - -0.00004343 0.00012202 -0.00004346 - -0.00004335 -0.00004346 0.00012186 - #*EXTRAS*# Step: 11 Bead: 14 - 0.00012195 -0.00004344 -0.00004336 - -0.00004344 0.00012200 -0.00004347 - -0.00004336 -0.00004347 0.00012184 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 deleted file mode 100644 index 38b6bf286..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_15 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 - 0.00012726 -0.00003897 -0.00003848 - -0.00003897 0.00012736 -0.00003904 - -0.00003848 -0.00003904 0.00012691 - #*EXTRAS*# Step: 1 Bead: 15 - 0.00012532 -0.00004104 -0.00004049 - -0.00004104 0.00012539 -0.00004114 - -0.00004049 -0.00004114 0.00012502 - #*EXTRAS*# Step: 2 Bead: 15 - 0.00012387 -0.00004229 -0.00004188 - -0.00004229 0.00012394 -0.00004239 - -0.00004188 -0.00004239 0.00012364 - #*EXTRAS*# Step: 3 Bead: 15 - 0.00012294 -0.00004292 -0.00004268 - -0.00004292 0.00012301 -0.00004300 - -0.00004268 -0.00004300 0.00012277 - #*EXTRAS*# Step: 4 Bead: 15 - 0.00012248 -0.00004318 -0.00004302 - -0.00004318 0.00012255 -0.00004324 - -0.00004302 -0.00004324 0.00012234 - #*EXTRAS*# Step: 5 Bead: 15 - 0.00012219 -0.00004332 -0.00004321 - -0.00004332 0.00012225 -0.00004337 - -0.00004321 -0.00004337 0.00012207 - #*EXTRAS*# Step: 6 Bead: 15 - 0.00012202 -0.00004341 -0.00004332 - -0.00004341 0.00012207 -0.00004344 - -0.00004332 -0.00004344 0.00012191 - #*EXTRAS*# Step: 7 Bead: 15 - 0.00012191 -0.00004346 -0.00004339 - -0.00004346 0.00012196 -0.00004349 - -0.00004339 -0.00004349 0.00012180 - #*EXTRAS*# Step: 8 Bead: 15 - 0.00012184 -0.00004349 -0.00004343 - -0.00004349 0.00012188 -0.00004352 - -0.00004343 -0.00004352 0.00012174 - #*EXTRAS*# Step: 9 Bead: 15 - 0.00012179 -0.00004351 -0.00004345 - -0.00004351 0.00012183 -0.00004353 - -0.00004345 -0.00004353 0.00012169 - #*EXTRAS*# Step: 10 Bead: 15 - 0.00012176 -0.00004353 -0.00004347 - -0.00004353 0.00012180 -0.00004354 - -0.00004347 -0.00004354 0.00012166 - #*EXTRAS*# Step: 11 Bead: 15 - 0.00012174 -0.00004354 -0.00004348 - -0.00004354 0.00012178 -0.00004355 - -0.00004348 -0.00004355 0.00012165 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 deleted file mode 100644 index 90bd9b912..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_16 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 16 - 0.00012661 -0.00003971 -0.00003918 - -0.00003971 0.00012670 -0.00003980 - -0.00003918 -0.00003980 0.00012627 - #*EXTRAS*# Step: 1 Bead: 16 - 0.00012486 -0.00004148 -0.00004095 - -0.00004148 0.00012492 -0.00004158 - -0.00004095 -0.00004158 0.00012457 - #*EXTRAS*# Step: 2 Bead: 16 - 0.00012355 -0.00004252 -0.00004217 - -0.00004252 0.00012361 -0.00004262 - -0.00004217 -0.00004262 0.00012334 - #*EXTRAS*# Step: 3 Bead: 16 - 0.00012266 -0.00004308 -0.00004289 - -0.00004308 0.00012273 -0.00004315 - -0.00004289 -0.00004315 0.00012251 - #*EXTRAS*# Step: 4 Bead: 16 - 0.00012223 -0.00004331 -0.00004319 - -0.00004331 0.00012229 -0.00004336 - -0.00004319 -0.00004336 0.00012210 - #*EXTRAS*# Step: 5 Bead: 16 - 0.00012195 -0.00004344 -0.00004336 - -0.00004344 0.00012200 -0.00004347 - -0.00004336 -0.00004347 0.00012184 - #*EXTRAS*# Step: 6 Bead: 16 - 0.00012179 -0.00004352 -0.00004346 - -0.00004352 0.00012183 -0.00004354 - -0.00004346 -0.00004354 0.00012169 - #*EXTRAS*# Step: 7 Bead: 16 - 0.00012168 -0.00004356 -0.00004352 - -0.00004356 0.00012171 -0.00004357 - -0.00004352 -0.00004357 0.00012159 - #*EXTRAS*# Step: 8 Bead: 16 - 0.00012161 -0.00004359 -0.00004355 - -0.00004359 0.00012164 -0.00004360 - -0.00004355 -0.00004360 0.00012152 - #*EXTRAS*# Step: 9 Bead: 16 - 0.00012157 -0.00004361 -0.00004358 - -0.00004361 0.00012159 -0.00004361 - -0.00004358 -0.00004361 0.00012148 - #*EXTRAS*# Step: 10 Bead: 16 - 0.00012154 -0.00004362 -0.00004359 - -0.00004362 0.00012156 -0.00004362 - -0.00004359 -0.00004362 0.00012145 - #*EXTRAS*# Step: 11 Bead: 16 - 0.00012152 -0.00004363 -0.00004360 - -0.00004363 0.00012154 -0.00004363 - -0.00004360 -0.00004363 0.00012143 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 deleted file mode 100644 index e0a6a0ae0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_17 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 17 - 0.00012594 -0.00004043 -0.00003988 - -0.00004043 0.00012601 -0.00004052 - -0.00003988 -0.00004052 0.00012562 - #*EXTRAS*# Step: 1 Bead: 17 - 0.00012439 -0.00004188 -0.00004140 - -0.00004188 0.00012445 -0.00004198 - -0.00004140 -0.00004198 0.00012413 - #*EXTRAS*# Step: 2 Bead: 17 - 0.00012321 -0.00004275 -0.00004246 - -0.00004275 0.00012328 -0.00004284 - -0.00004246 -0.00004284 0.00012302 - #*EXTRAS*# Step: 3 Bead: 17 - 0.00012237 -0.00004323 -0.00004309 - -0.00004323 0.00012244 -0.00004329 - -0.00004309 -0.00004329 0.00012224 - #*EXTRAS*# Step: 4 Bead: 17 - 0.00012196 -0.00004344 -0.00004336 - -0.00004344 0.00012201 -0.00004347 - -0.00004336 -0.00004347 0.00012185 - #*EXTRAS*# Step: 5 Bead: 17 - 0.00012170 -0.00004356 -0.00004351 - -0.00004356 0.00012173 -0.00004357 - -0.00004351 -0.00004357 0.00012160 - #*EXTRAS*# Step: 6 Bead: 17 - 0.00012154 -0.00004363 -0.00004359 - -0.00004363 0.00012156 -0.00004362 - -0.00004359 -0.00004362 0.00012145 - #*EXTRAS*# Step: 7 Bead: 17 - 0.00012143 -0.00004367 -0.00004364 - -0.00004367 0.00012145 -0.00004366 - -0.00004364 -0.00004366 0.00012135 - #*EXTRAS*# Step: 8 Bead: 17 - 0.00012137 -0.00004369 -0.00004367 - -0.00004369 0.00012138 -0.00004368 - -0.00004367 -0.00004368 0.00012129 - #*EXTRAS*# Step: 9 Bead: 17 - 0.00012133 -0.00004371 -0.00004369 - -0.00004371 0.00012134 -0.00004369 - -0.00004369 -0.00004369 0.00012125 - #*EXTRAS*# Step: 10 Bead: 17 - 0.00012130 -0.00004372 -0.00004371 - -0.00004372 0.00012131 -0.00004370 - -0.00004371 -0.00004370 0.00012122 - #*EXTRAS*# Step: 11 Bead: 17 - 0.00012128 -0.00004373 -0.00004372 - -0.00004373 0.00012129 -0.00004371 - -0.00004372 -0.00004371 0.00012120 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 deleted file mode 100644 index 37527c2cf..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_18 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 18 - 0.00012526 -0.00004110 -0.00004055 - -0.00004110 0.00012533 -0.00004120 - -0.00004055 -0.00004120 0.00012496 - #*EXTRAS*# Step: 1 Bead: 18 - 0.00012392 -0.00004225 -0.00004184 - -0.00004225 0.00012398 -0.00004235 - -0.00004184 -0.00004235 0.00012369 - #*EXTRAS*# Step: 2 Bead: 18 - 0.00012286 -0.00004296 -0.00004274 - -0.00004296 0.00012293 -0.00004304 - -0.00004274 -0.00004304 0.00012269 - #*EXTRAS*# Step: 3 Bead: 18 - 0.00012207 -0.00004339 -0.00004329 - -0.00004339 0.00012212 -0.00004342 - -0.00004329 -0.00004342 0.00012195 - #*EXTRAS*# Step: 4 Bead: 18 - 0.00012167 -0.00004357 -0.00004352 - -0.00004357 0.00012171 -0.00004358 - -0.00004352 -0.00004358 0.00012158 - #*EXTRAS*# Step: 5 Bead: 18 - 0.00012142 -0.00004367 -0.00004365 - -0.00004367 0.00012144 -0.00004366 - -0.00004365 -0.00004366 0.00012134 - #*EXTRAS*# Step: 6 Bead: 18 - 0.00012127 -0.00004373 -0.00004372 - -0.00004373 0.00012128 -0.00004371 - -0.00004372 -0.00004371 0.00012120 - #*EXTRAS*# Step: 7 Bead: 18 - 0.00012117 -0.00004377 -0.00004376 - -0.00004377 0.00012117 -0.00004374 - -0.00004376 -0.00004374 0.00012110 - #*EXTRAS*# Step: 8 Bead: 18 - 0.00012111 -0.00004380 -0.00004379 - -0.00004380 0.00012110 -0.00004376 - -0.00004379 -0.00004376 0.00012104 - #*EXTRAS*# Step: 9 Bead: 18 - 0.00012107 -0.00004381 -0.00004381 - -0.00004381 0.00012106 -0.00004377 - -0.00004381 -0.00004377 0.00012100 - #*EXTRAS*# Step: 10 Bead: 18 - 0.00012104 -0.00004382 -0.00004382 - -0.00004382 0.00012103 -0.00004378 - -0.00004382 -0.00004378 0.00012098 - #*EXTRAS*# Step: 11 Bead: 18 - 0.00012102 -0.00004383 -0.00004382 - -0.00004383 0.00012101 -0.00004378 - -0.00004382 -0.00004378 0.00012096 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 deleted file mode 100644 index b080fb25f..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_19 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 19 - 0.00012460 -0.00004170 -0.00004120 - -0.00004170 0.00012466 -0.00004181 - -0.00004120 -0.00004181 0.00012432 - #*EXTRAS*# Step: 1 Bead: 19 - 0.00012344 -0.00004259 -0.00004226 - -0.00004259 0.00012351 -0.00004269 - -0.00004226 -0.00004269 0.00012324 - #*EXTRAS*# Step: 2 Bead: 19 - 0.00012250 -0.00004317 -0.00004301 - -0.00004317 0.00012256 -0.00004323 - -0.00004301 -0.00004323 0.00012236 - #*EXTRAS*# Step: 3 Bead: 19 - 0.00012175 -0.00004353 -0.00004348 - -0.00004353 0.00012178 -0.00004355 - -0.00004348 -0.00004355 0.00012165 - #*EXTRAS*# Step: 4 Bead: 19 - 0.00012137 -0.00004369 -0.00004367 - -0.00004369 0.00012139 -0.00004368 - -0.00004367 -0.00004368 0.00012130 - #*EXTRAS*# Step: 5 Bead: 19 - 0.00012113 -0.00004379 -0.00004378 - -0.00004379 0.00012113 -0.00004375 - -0.00004378 -0.00004375 0.00012107 - #*EXTRAS*# Step: 6 Bead: 19 - 0.00012099 -0.00004384 -0.00004384 - -0.00004384 0.00012097 -0.00004379 - -0.00004384 -0.00004379 0.00012093 - #*EXTRAS*# Step: 7 Bead: 19 - 0.00012090 -0.00004388 -0.00004387 - -0.00004388 0.00012087 -0.00004382 - -0.00004387 -0.00004382 0.00012084 - #*EXTRAS*# Step: 8 Bead: 19 - 0.00012084 -0.00004390 -0.00004390 - -0.00004390 0.00012080 -0.00004383 - -0.00004390 -0.00004383 0.00012078 - #*EXTRAS*# Step: 9 Bead: 19 - 0.00012080 -0.00004392 -0.00004391 - -0.00004392 0.00012076 -0.00004384 - -0.00004391 -0.00004384 0.00012074 - #*EXTRAS*# Step: 10 Bead: 19 - 0.00012077 -0.00004392 -0.00004392 - -0.00004392 0.00012073 -0.00004385 - -0.00004392 -0.00004385 0.00012072 - #*EXTRAS*# Step: 11 Bead: 19 - 0.00012075 -0.00004393 -0.00004393 - -0.00004393 0.00012071 -0.00004385 - -0.00004393 -0.00004385 0.00012070 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 deleted file mode 100644 index e7d77a4e8..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_20 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 20 - 0.00012394 -0.00004224 -0.00004182 - -0.00004224 0.00012400 -0.00004234 - -0.00004182 -0.00004234 0.00012371 - #*EXTRAS*# Step: 1 Bead: 20 - 0.00012296 -0.00004291 -0.00004266 - -0.00004291 0.00012303 -0.00004299 - -0.00004266 -0.00004299 0.00012279 - #*EXTRAS*# Step: 2 Bead: 20 - 0.00012212 -0.00004336 -0.00004326 - -0.00004336 0.00012218 -0.00004340 - -0.00004326 -0.00004340 0.00012200 - #*EXTRAS*# Step: 3 Bead: 20 - 0.00012141 -0.00004368 -0.00004366 - -0.00004368 0.00012142 -0.00004367 - -0.00004366 -0.00004367 0.00012133 - #*EXTRAS*# Step: 4 Bead: 20 - 0.00012106 -0.00004382 -0.00004381 - -0.00004382 0.00012104 -0.00004377 - -0.00004381 -0.00004377 0.00012099 - #*EXTRAS*# Step: 5 Bead: 20 - 0.00012083 -0.00004390 -0.00004390 - -0.00004390 0.00012080 -0.00004383 - -0.00004390 -0.00004383 0.00012077 - #*EXTRAS*# Step: 6 Bead: 20 - 0.00012069 -0.00004395 -0.00004395 - -0.00004395 0.00012064 -0.00004387 - -0.00004395 -0.00004387 0.00012064 - #*EXTRAS*# Step: 7 Bead: 20 - 0.00012060 -0.00004398 -0.00004398 - -0.00004398 0.00012055 -0.00004389 - -0.00004398 -0.00004389 0.00012055 - #*EXTRAS*# Step: 8 Bead: 20 - 0.00012055 -0.00004400 -0.00004400 - -0.00004400 0.00012048 -0.00004390 - -0.00004400 -0.00004390 0.00012050 - #*EXTRAS*# Step: 9 Bead: 20 - 0.00012051 -0.00004402 -0.00004401 - -0.00004402 0.00012044 -0.00004391 - -0.00004401 -0.00004391 0.00012046 - #*EXTRAS*# Step: 10 Bead: 20 - 0.00012048 -0.00004402 -0.00004401 - -0.00004402 0.00012042 -0.00004392 - -0.00004401 -0.00004392 0.00012044 - #*EXTRAS*# Step: 11 Bead: 20 - 0.00012047 -0.00004403 -0.00004402 - -0.00004403 0.00012040 -0.00004392 - -0.00004402 -0.00004392 0.00012042 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 deleted file mode 100644 index 4bbdac89e..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_21 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 21 - 0.00012329 -0.00004270 -0.00004239 - -0.00004270 0.00012336 -0.00004279 - -0.00004239 -0.00004279 0.00012310 - #*EXTRAS*# Step: 1 Bead: 21 - 0.00012246 -0.00004319 -0.00004303 - -0.00004319 0.00012253 -0.00004325 - -0.00004303 -0.00004325 0.00012232 - #*EXTRAS*# Step: 2 Bead: 21 - 0.00012173 -0.00004354 -0.00004349 - -0.00004354 0.00012177 -0.00004356 - -0.00004349 -0.00004356 0.00012163 - #*EXTRAS*# Step: 3 Bead: 21 - 0.00012105 -0.00004382 -0.00004381 - -0.00004382 0.00012103 -0.00004378 - -0.00004381 -0.00004378 0.00012098 - #*EXTRAS*# Step: 4 Bead: 21 - 0.00012072 -0.00004394 -0.00004394 - -0.00004394 0.00012067 -0.00004386 - -0.00004394 -0.00004386 0.00012067 - #*EXTRAS*# Step: 5 Bead: 21 - 0.00012051 -0.00004402 -0.00004401 - -0.00004402 0.00012044 -0.00004391 - -0.00004401 -0.00004391 0.00012046 - #*EXTRAS*# Step: 6 Bead: 21 - 0.00012038 -0.00004406 -0.00004405 - -0.00004406 0.00012029 -0.00004394 - -0.00004405 -0.00004394 0.00012034 - #*EXTRAS*# Step: 7 Bead: 21 - 0.00012029 -0.00004409 -0.00004407 - -0.00004409 0.00012020 -0.00004396 - -0.00004407 -0.00004396 0.00012026 - #*EXTRAS*# Step: 8 Bead: 21 - 0.00012024 -0.00004410 -0.00004408 - -0.00004410 0.00012014 -0.00004397 - -0.00004408 -0.00004397 0.00012020 - #*EXTRAS*# Step: 9 Bead: 21 - 0.00012021 -0.00004412 -0.00004409 - -0.00004412 0.00012011 -0.00004398 - -0.00004409 -0.00004398 0.00012017 - #*EXTRAS*# Step: 10 Bead: 21 - 0.00012018 -0.00004412 -0.00004410 - -0.00004412 0.00012008 -0.00004398 - -0.00004410 -0.00004398 0.00012015 - #*EXTRAS*# Step: 11 Bead: 21 - 0.00012017 -0.00004413 -0.00004410 - -0.00004413 0.00012006 -0.00004399 - -0.00004410 -0.00004399 0.00012013 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 deleted file mode 100644 index ce91ab982..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_22 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 22 - 0.00012263 -0.00004310 -0.00004291 - -0.00004310 0.00012270 -0.00004316 - -0.00004291 -0.00004316 0.00012248 - #*EXTRAS*# Step: 1 Bead: 22 - 0.00012195 -0.00004344 -0.00004337 - -0.00004344 0.00012199 -0.00004347 - -0.00004337 -0.00004347 0.00012184 - #*EXTRAS*# Step: 2 Bead: 22 - 0.00012131 -0.00004372 -0.00004370 - -0.00004372 0.00012133 -0.00004370 - -0.00004370 -0.00004370 0.00012124 - #*EXTRAS*# Step: 3 Bead: 22 - 0.00012067 -0.00004396 -0.00004396 - -0.00004396 0.00012062 -0.00004388 - -0.00004396 -0.00004388 0.00012062 - #*EXTRAS*# Step: 4 Bead: 22 - 0.00012036 -0.00004407 -0.00004405 - -0.00004407 0.00012028 -0.00004395 - -0.00004405 -0.00004395 0.00012032 - #*EXTRAS*# Step: 5 Bead: 22 - 0.00012017 -0.00004413 -0.00004410 - -0.00004413 0.00012006 -0.00004399 - -0.00004410 -0.00004399 0.00012013 - #*EXTRAS*# Step: 6 Bead: 22 - 0.00012005 -0.00004417 -0.00004413 - -0.00004417 0.00011993 -0.00004401 - -0.00004413 -0.00004401 0.00012002 - #*EXTRAS*# Step: 7 Bead: 22 - 0.00011997 -0.00004419 -0.00004415 - -0.00004419 0.00011984 -0.00004402 - -0.00004415 -0.00004402 0.00011994 - #*EXTRAS*# Step: 8 Bead: 22 - 0.00011992 -0.00004420 -0.00004416 - -0.00004420 0.00011979 -0.00004403 - -0.00004416 -0.00004403 0.00011989 - #*EXTRAS*# Step: 9 Bead: 22 - 0.00011989 -0.00004421 -0.00004417 - -0.00004421 0.00011975 -0.00004404 - -0.00004417 -0.00004404 0.00011986 - #*EXTRAS*# Step: 10 Bead: 22 - 0.00011987 -0.00004422 -0.00004417 - -0.00004422 0.00011973 -0.00004404 - -0.00004417 -0.00004404 0.00011984 - #*EXTRAS*# Step: 11 Bead: 22 - 0.00011986 -0.00004422 -0.00004418 - -0.00004422 0.00011971 -0.00004404 - -0.00004418 -0.00004404 0.00011983 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 deleted file mode 100644 index 9d19ad624..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_23 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 23 - 0.00012195 -0.00004344 -0.00004336 - -0.00004344 0.00012200 -0.00004347 - -0.00004336 -0.00004347 0.00012184 - #*EXTRAS*# Step: 1 Bead: 23 - 0.00012140 -0.00004368 -0.00004366 - -0.00004368 0.00012142 -0.00004367 - -0.00004366 -0.00004367 0.00012132 - #*EXTRAS*# Step: 2 Bead: 23 - 0.00012088 -0.00004389 -0.00004388 - -0.00004389 0.00012085 -0.00004382 - -0.00004388 -0.00004382 0.00012082 - #*EXTRAS*# Step: 3 Bead: 23 - 0.00012027 -0.00004410 -0.00004408 - -0.00004410 0.00012017 -0.00004397 - -0.00004408 -0.00004397 0.00012023 - #*EXTRAS*# Step: 4 Bead: 23 - 0.00011999 -0.00004418 -0.00004415 - -0.00004418 0.00011987 -0.00004402 - -0.00004415 -0.00004402 0.00011996 - #*EXTRAS*# Step: 5 Bead: 23 - 0.00011981 -0.00004423 -0.00004419 - -0.00004423 0.00011966 -0.00004405 - -0.00004419 -0.00004405 0.00011979 - #*EXTRAS*# Step: 6 Bead: 23 - 0.00011971 -0.00004426 -0.00004421 - -0.00004426 0.00011954 -0.00004407 - -0.00004421 -0.00004407 0.00011968 - #*EXTRAS*# Step: 7 Bead: 23 - 0.00011964 -0.00004428 -0.00004422 - -0.00004428 0.00011947 -0.00004408 - -0.00004422 -0.00004408 0.00011962 - #*EXTRAS*# Step: 8 Bead: 23 - 0.00011959 -0.00004429 -0.00004423 - -0.00004429 0.00011942 -0.00004409 - -0.00004423 -0.00004409 0.00011957 - #*EXTRAS*# Step: 9 Bead: 23 - 0.00011957 -0.00004430 -0.00004423 - -0.00004430 0.00011939 -0.00004409 - -0.00004423 -0.00004409 0.00011954 - #*EXTRAS*# Step: 10 Bead: 23 - 0.00011955 -0.00004431 -0.00004424 - -0.00004431 0.00011936 -0.00004409 - -0.00004424 -0.00004409 0.00011953 - #*EXTRAS*# Step: 11 Bead: 23 - 0.00011953 -0.00004431 -0.00004424 - -0.00004431 0.00011935 -0.00004410 - -0.00004424 -0.00004410 0.00011951 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 deleted file mode 100644 index b70c1e946..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_24 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 24 - 0.00012123 -0.00004375 -0.00004374 - -0.00004375 0.00012123 -0.00004372 - -0.00004374 -0.00004372 0.00012116 - #*EXTRAS*# Step: 1 Bead: 24 - 0.00012082 -0.00004391 -0.00004390 - -0.00004391 0.00012079 -0.00004384 - -0.00004390 -0.00004384 0.00012077 - #*EXTRAS*# Step: 2 Bead: 24 - 0.00012041 -0.00004405 -0.00004404 - -0.00004405 0.00012034 -0.00004393 - -0.00004404 -0.00004393 0.00012037 - #*EXTRAS*# Step: 3 Bead: 24 - 0.00011985 -0.00004422 -0.00004418 - -0.00004422 0.00011970 -0.00004404 - -0.00004418 -0.00004404 0.00011982 - #*EXTRAS*# Step: 4 Bead: 24 - 0.00011961 -0.00004429 -0.00004423 - -0.00004429 0.00011943 -0.00004408 - -0.00004423 -0.00004408 0.00011959 - #*EXTRAS*# Step: 5 Bead: 24 - 0.00011945 -0.00004433 -0.00004425 - -0.00004433 0.00011925 -0.00004411 - -0.00004425 -0.00004411 0.00011943 - #*EXTRAS*# Step: 6 Bead: 24 - 0.00011935 -0.00004436 -0.00004427 - -0.00004436 0.00011915 -0.00004412 - -0.00004427 -0.00004412 0.00011934 - #*EXTRAS*# Step: 7 Bead: 24 - 0.00011929 -0.00004437 -0.00004428 - -0.00004437 0.00011908 -0.00004413 - -0.00004428 -0.00004413 0.00011928 - #*EXTRAS*# Step: 8 Bead: 24 - 0.00011925 -0.00004438 -0.00004428 - -0.00004438 0.00011904 -0.00004413 - -0.00004428 -0.00004413 0.00011924 - #*EXTRAS*# Step: 9 Bead: 24 - 0.00011923 -0.00004439 -0.00004429 - -0.00004439 0.00011901 -0.00004414 - -0.00004429 -0.00004414 0.00011921 - #*EXTRAS*# Step: 10 Bead: 24 - 0.00011921 -0.00004439 -0.00004429 - -0.00004439 0.00011899 -0.00004414 - -0.00004429 -0.00004414 0.00011920 - #*EXTRAS*# Step: 11 Bead: 24 - 0.00011920 -0.00004439 -0.00004429 - -0.00004439 0.00011898 -0.00004414 - -0.00004429 -0.00004414 0.00011919 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 deleted file mode 100644 index e11cb25ad..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_25 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 25 - 0.00012045 -0.00004404 -0.00004402 - -0.00004404 0.00012038 -0.00004393 - -0.00004402 -0.00004393 0.00012041 - #*EXTRAS*# Step: 1 Bead: 25 - 0.00012021 -0.00004412 -0.00004409 - -0.00004412 0.00012011 -0.00004398 - -0.00004409 -0.00004398 0.00012017 - #*EXTRAS*# Step: 2 Bead: 25 - 0.00011993 -0.00004420 -0.00004416 - -0.00004420 0.00011979 -0.00004403 - -0.00004416 -0.00004403 0.00011990 - #*EXTRAS*# Step: 3 Bead: 25 - 0.00011942 -0.00004434 -0.00004426 - -0.00004434 0.00011922 -0.00004411 - -0.00004426 -0.00004411 0.00011940 - #*EXTRAS*# Step: 4 Bead: 25 - 0.00011921 -0.00004439 -0.00004429 - -0.00004439 0.00011899 -0.00004414 - -0.00004429 -0.00004414 0.00011920 - #*EXTRAS*# Step: 5 Bead: 25 - 0.00011907 -0.00004442 -0.00004431 - -0.00004442 0.00011883 -0.00004416 - -0.00004431 -0.00004416 0.00011906 - #*EXTRAS*# Step: 6 Bead: 25 - 0.00011899 -0.00004444 -0.00004432 - -0.00004444 0.00011874 -0.00004416 - -0.00004432 -0.00004416 0.00011898 - #*EXTRAS*# Step: 7 Bead: 25 - 0.00011894 -0.00004445 -0.00004432 - -0.00004445 0.00011868 -0.00004417 - -0.00004432 -0.00004417 0.00011893 - #*EXTRAS*# Step: 8 Bead: 25 - 0.00011890 -0.00004446 -0.00004433 - -0.00004446 0.00011864 -0.00004417 - -0.00004433 -0.00004417 0.00011889 - #*EXTRAS*# Step: 9 Bead: 25 - 0.00011888 -0.00004446 -0.00004433 - -0.00004446 0.00011862 -0.00004417 - -0.00004433 -0.00004417 0.00011887 - #*EXTRAS*# Step: 10 Bead: 25 - 0.00011887 -0.00004446 -0.00004433 - -0.00004446 0.00011860 -0.00004418 - -0.00004433 -0.00004418 0.00011886 - #*EXTRAS*# Step: 11 Bead: 25 - 0.00011886 -0.00004446 -0.00004433 - -0.00004446 0.00011859 -0.00004418 - -0.00004433 -0.00004418 0.00011885 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 deleted file mode 100644 index d039005ef..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_26 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 26 - 0.00011962 -0.00004429 -0.00004422 - -0.00004429 0.00011945 -0.00004408 - -0.00004422 -0.00004408 0.00011960 - #*EXTRAS*# Step: 1 Bead: 26 - 0.00011956 -0.00004430 -0.00004423 - -0.00004430 0.00011938 -0.00004409 - -0.00004423 -0.00004409 0.00011954 - #*EXTRAS*# Step: 2 Bead: 26 - 0.00011943 -0.00004434 -0.00004426 - -0.00004434 0.00011923 -0.00004411 - -0.00004426 -0.00004411 0.00011941 - #*EXTRAS*# Step: 3 Bead: 26 - 0.00011897 -0.00004444 -0.00004432 - -0.00004444 0.00011872 -0.00004417 - -0.00004432 -0.00004417 0.00011896 - #*EXTRAS*# Step: 4 Bead: 26 - 0.00011880 -0.00004447 -0.00004434 - -0.00004447 0.00011853 -0.00004418 - -0.00004434 -0.00004418 0.00011880 - #*EXTRAS*# Step: 5 Bead: 26 - 0.00011869 -0.00004450 -0.00004435 - -0.00004450 0.00011840 -0.00004419 - -0.00004435 -0.00004419 0.00011868 - #*EXTRAS*# Step: 6 Bead: 26 - 0.00011862 -0.00004451 -0.00004435 - -0.00004451 0.00011833 -0.00004420 - -0.00004435 -0.00004420 0.00011861 - #*EXTRAS*# Step: 7 Bead: 26 - 0.00011857 -0.00004452 -0.00004435 - -0.00004452 0.00011828 -0.00004420 - -0.00004435 -0.00004420 0.00011857 - #*EXTRAS*# Step: 8 Bead: 26 - 0.00011855 -0.00004452 -0.00004436 - -0.00004452 0.00011825 -0.00004420 - -0.00004436 -0.00004420 0.00011854 - #*EXTRAS*# Step: 9 Bead: 26 - 0.00011853 -0.00004452 -0.00004436 - -0.00004452 0.00011823 -0.00004420 - -0.00004436 -0.00004420 0.00011852 - #*EXTRAS*# Step: 10 Bead: 26 - 0.00011852 -0.00004452 -0.00004436 - -0.00004452 0.00011821 -0.00004421 - -0.00004436 -0.00004421 0.00011851 - #*EXTRAS*# Step: 11 Bead: 26 - 0.00011851 -0.00004453 -0.00004436 - -0.00004453 0.00011820 -0.00004421 - -0.00004436 -0.00004421 0.00011850 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 deleted file mode 100644 index 1e1323b11..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_27 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 27 - 0.00011876 -0.00004448 -0.00004434 - -0.00004448 0.00011848 -0.00004419 - -0.00004434 -0.00004419 0.00011875 - #*EXTRAS*# Step: 1 Bead: 27 - 0.00011890 -0.00004446 -0.00004433 - -0.00004446 0.00011864 -0.00004417 - -0.00004433 -0.00004417 0.00011889 - #*EXTRAS*# Step: 2 Bead: 27 - 0.00011891 -0.00004445 -0.00004433 - -0.00004445 0.00011865 -0.00004417 - -0.00004433 -0.00004417 0.00011890 - #*EXTRAS*# Step: 3 Bead: 27 - 0.00011852 -0.00004452 -0.00004436 - -0.00004452 0.00011822 -0.00004421 - -0.00004436 -0.00004421 0.00011852 - #*EXTRAS*# Step: 4 Bead: 27 - 0.00011839 -0.00004454 -0.00004437 - -0.00004454 0.00011807 -0.00004421 - -0.00004437 -0.00004421 0.00011839 - #*EXTRAS*# Step: 5 Bead: 27 - 0.00011830 -0.00004456 -0.00004437 - -0.00004456 0.00011797 -0.00004422 - -0.00004437 -0.00004422 0.00011829 - #*EXTRAS*# Step: 6 Bead: 27 - 0.00011824 -0.00004456 -0.00004437 - -0.00004456 0.00011791 -0.00004422 - -0.00004437 -0.00004422 0.00011824 - #*EXTRAS*# Step: 7 Bead: 27 - 0.00011821 -0.00004457 -0.00004437 - -0.00004457 0.00011787 -0.00004422 - -0.00004437 -0.00004422 0.00011820 - #*EXTRAS*# Step: 8 Bead: 27 - 0.00011818 -0.00004457 -0.00004437 - -0.00004457 0.00011785 -0.00004423 - -0.00004437 -0.00004423 0.00011818 - #*EXTRAS*# Step: 9 Bead: 27 - 0.00011817 -0.00004457 -0.00004437 - -0.00004457 0.00011783 -0.00004423 - -0.00004437 -0.00004423 0.00011817 - #*EXTRAS*# Step: 10 Bead: 27 - 0.00011816 -0.00004457 -0.00004437 - -0.00004457 0.00011782 -0.00004423 - -0.00004437 -0.00004423 0.00011816 - #*EXTRAS*# Step: 11 Bead: 27 - 0.00011815 -0.00004458 -0.00004437 - -0.00004458 0.00011781 -0.00004423 - -0.00004437 -0.00004423 0.00011815 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 deleted file mode 100644 index 79e156a1b..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_28 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 28 - 0.00011788 -0.00004460 -0.00004438 - -0.00004460 0.00011751 -0.00004424 - -0.00004438 -0.00004424 0.00011788 - #*EXTRAS*# Step: 1 Bead: 28 - 0.00011822 -0.00004457 -0.00004437 - -0.00004457 0.00011788 -0.00004422 - -0.00004437 -0.00004422 0.00011822 - #*EXTRAS*# Step: 2 Bead: 28 - 0.00011839 -0.00004454 -0.00004437 - -0.00004454 0.00011807 -0.00004421 - -0.00004437 -0.00004421 0.00011838 - #*EXTRAS*# Step: 3 Bead: 28 - 0.00011806 -0.00004459 -0.00004438 - -0.00004459 0.00011771 -0.00004423 - -0.00004438 -0.00004423 0.00011806 - #*EXTRAS*# Step: 4 Bead: 28 - 0.00011797 -0.00004460 -0.00004438 - -0.00004460 0.00011761 -0.00004423 - -0.00004438 -0.00004423 0.00011797 - #*EXTRAS*# Step: 5 Bead: 28 - 0.00011790 -0.00004460 -0.00004438 - -0.00004460 0.00011754 -0.00004424 - -0.00004438 -0.00004424 0.00011790 - #*EXTRAS*# Step: 6 Bead: 28 - 0.00011786 -0.00004461 -0.00004438 - -0.00004461 0.00011749 -0.00004424 - -0.00004438 -0.00004424 0.00011786 - #*EXTRAS*# Step: 7 Bead: 28 - 0.00011783 -0.00004461 -0.00004438 - -0.00004461 0.00011746 -0.00004424 - -0.00004438 -0.00004424 0.00011784 - #*EXTRAS*# Step: 8 Bead: 28 - 0.00011782 -0.00004461 -0.00004438 - -0.00004461 0.00011745 -0.00004424 - -0.00004438 -0.00004424 0.00011782 - #*EXTRAS*# Step: 9 Bead: 28 - 0.00011781 -0.00004461 -0.00004438 - -0.00004461 0.00011743 -0.00004424 - -0.00004438 -0.00004424 0.00011781 - #*EXTRAS*# Step: 10 Bead: 28 - 0.00011780 -0.00004461 -0.00004438 - -0.00004461 0.00011743 -0.00004424 - -0.00004438 -0.00004424 0.00011780 - #*EXTRAS*# Step: 11 Bead: 28 - 0.00011780 -0.00004461 -0.00004438 - -0.00004461 0.00011742 -0.00004424 - -0.00004438 -0.00004424 0.00011780 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 deleted file mode 100644 index d15ab3788..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_29 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 29 - 0.00011700 -0.00004463 -0.00004435 - -0.00004463 0.00011658 -0.00004423 - -0.00004435 -0.00004423 0.00011701 - #*EXTRAS*# Step: 1 Bead: 29 - 0.00011753 -0.00004463 -0.00004437 - -0.00004463 0.00011714 -0.00004424 - -0.00004437 -0.00004424 0.00011754 - #*EXTRAS*# Step: 2 Bead: 29 - 0.00011785 -0.00004461 -0.00004438 - -0.00004461 0.00011749 -0.00004424 - -0.00004438 -0.00004424 0.00011786 - #*EXTRAS*# Step: 3 Bead: 29 - 0.00011760 -0.00004462 -0.00004438 - -0.00004462 0.00011721 -0.00004424 - -0.00004438 -0.00004424 0.00011760 - #*EXTRAS*# Step: 4 Bead: 29 - 0.00011755 -0.00004463 -0.00004438 - -0.00004463 0.00011716 -0.00004424 - -0.00004438 -0.00004424 0.00011755 - #*EXTRAS*# Step: 5 Bead: 29 - 0.00011750 -0.00004463 -0.00004437 - -0.00004463 0.00011711 -0.00004424 - -0.00004437 -0.00004424 0.00011751 - #*EXTRAS*# Step: 6 Bead: 29 - 0.00011748 -0.00004463 -0.00004437 - -0.00004463 0.00011708 -0.00004424 - -0.00004437 -0.00004424 0.00011748 - #*EXTRAS*# Step: 7 Bead: 29 - 0.00011746 -0.00004463 -0.00004437 - -0.00004463 0.00011706 -0.00004424 - -0.00004437 -0.00004424 0.00011747 - #*EXTRAS*# Step: 8 Bead: 29 - 0.00011745 -0.00004463 -0.00004437 - -0.00004463 0.00011705 -0.00004424 - -0.00004437 -0.00004424 0.00011745 - #*EXTRAS*# Step: 9 Bead: 29 - 0.00011744 -0.00004463 -0.00004437 - -0.00004463 0.00011704 -0.00004424 - -0.00004437 -0.00004424 0.00011745 - #*EXTRAS*# Step: 10 Bead: 29 - 0.00011744 -0.00004463 -0.00004437 - -0.00004463 0.00011704 -0.00004424 - -0.00004437 -0.00004424 0.00011744 - #*EXTRAS*# Step: 11 Bead: 29 - 0.00011744 -0.00004463 -0.00004437 - -0.00004463 0.00011704 -0.00004424 - -0.00004437 -0.00004424 0.00011744 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 deleted file mode 100644 index eee513202..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_30 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 30 - 0.00011614 -0.00004454 -0.00004426 - -0.00004454 0.00011572 -0.00004416 - -0.00004426 -0.00004416 0.00011615 - #*EXTRAS*# Step: 1 Bead: 30 - 0.00011685 -0.00004462 -0.00004434 - -0.00004462 0.00011643 -0.00004422 - -0.00004434 -0.00004422 0.00011686 - #*EXTRAS*# Step: 2 Bead: 30 - 0.00011732 -0.00004463 -0.00004437 - -0.00004463 0.00011692 -0.00004424 - -0.00004437 -0.00004424 0.00011733 - #*EXTRAS*# Step: 3 Bead: 30 - 0.00011714 -0.00004463 -0.00004436 - -0.00004463 0.00011673 -0.00004423 - -0.00004436 -0.00004423 0.00011715 - #*EXTRAS*# Step: 4 Bead: 30 - 0.00011713 -0.00004463 -0.00004436 - -0.00004463 0.00011671 -0.00004423 - -0.00004436 -0.00004423 0.00011714 - #*EXTRAS*# Step: 5 Bead: 30 - 0.00011710 -0.00004463 -0.00004436 - -0.00004463 0.00011669 -0.00004423 - -0.00004436 -0.00004423 0.00011711 - #*EXTRAS*# Step: 6 Bead: 30 - 0.00011709 -0.00004463 -0.00004435 - -0.00004463 0.00011668 -0.00004423 - -0.00004435 -0.00004423 0.00011710 - #*EXTRAS*# Step: 7 Bead: 30 - 0.00011709 -0.00004463 -0.00004435 - -0.00004463 0.00011667 -0.00004423 - -0.00004435 -0.00004423 0.00011709 - #*EXTRAS*# Step: 8 Bead: 30 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011667 -0.00004423 - -0.00004435 -0.00004423 0.00011709 - #*EXTRAS*# Step: 9 Bead: 30 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011709 - #*EXTRAS*# Step: 10 Bead: 30 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011709 - #*EXTRAS*# Step: 11 Bead: 30 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011708 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 deleted file mode 100644 index 2d3655a41..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_31 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 31 - 0.00011529 -0.00004435 -0.00004411 - -0.00004435 0.00011492 -0.00004403 - -0.00004411 -0.00004403 0.00011532 - #*EXTRAS*# Step: 1 Bead: 31 - 0.00011618 -0.00004455 -0.00004426 - -0.00004455 0.00011576 -0.00004416 - -0.00004426 -0.00004416 0.00011620 - #*EXTRAS*# Step: 2 Bead: 31 - 0.00011680 -0.00004462 -0.00004433 - -0.00004462 0.00011637 -0.00004422 - -0.00004433 -0.00004422 0.00011681 - #*EXTRAS*# Step: 3 Bead: 31 - 0.00011668 -0.00004461 -0.00004432 - -0.00004461 0.00011626 -0.00004421 - -0.00004432 -0.00004421 0.00011669 - #*EXTRAS*# Step: 4 Bead: 31 - 0.00011671 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011672 - #*EXTRAS*# Step: 5 Bead: 31 - 0.00011671 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011672 - #*EXTRAS*# Step: 6 Bead: 31 - 0.00011671 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011673 - #*EXTRAS*# Step: 7 Bead: 31 - 0.00011672 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011673 - #*EXTRAS*# Step: 8 Bead: 31 - 0.00011672 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011673 - #*EXTRAS*# Step: 9 Bead: 31 - 0.00011672 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011673 - #*EXTRAS*# Step: 10 Bead: 31 - 0.00011672 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011673 - #*EXTRAS*# Step: 11 Bead: 31 - 0.00011672 -0.00004461 -0.00004432 - -0.00004461 0.00011629 -0.00004421 - -0.00004432 -0.00004421 0.00011673 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 deleted file mode 100644 index 6d9aee4b9..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_32 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 32 - 0.00011447 -0.00004408 -0.00004390 - -0.00004408 0.00011418 -0.00004385 - -0.00004390 -0.00004385 0.00011451 - #*EXTRAS*# Step: 1 Bead: 32 - 0.00011553 -0.00004442 -0.00004415 - -0.00004442 0.00011514 -0.00004407 - -0.00004415 -0.00004407 0.00011555 - #*EXTRAS*# Step: 2 Bead: 32 - 0.00011628 -0.00004456 -0.00004427 - -0.00004456 0.00011585 -0.00004417 - -0.00004427 -0.00004417 0.00011629 - #*EXTRAS*# Step: 3 Bead: 32 - 0.00011623 -0.00004456 -0.00004427 - -0.00004456 0.00011581 -0.00004417 - -0.00004427 -0.00004417 0.00011625 - #*EXTRAS*# Step: 4 Bead: 32 - 0.00011630 -0.00004457 -0.00004428 - -0.00004457 0.00011587 -0.00004418 - -0.00004428 -0.00004418 0.00011631 - #*EXTRAS*# Step: 5 Bead: 32 - 0.00011632 -0.00004457 -0.00004428 - -0.00004457 0.00011590 -0.00004418 - -0.00004428 -0.00004418 0.00011634 - #*EXTRAS*# Step: 6 Bead: 32 - 0.00011634 -0.00004457 -0.00004428 - -0.00004457 0.00011592 -0.00004418 - -0.00004428 -0.00004418 0.00011635 - #*EXTRAS*# Step: 7 Bead: 32 - 0.00011635 -0.00004457 -0.00004428 - -0.00004457 0.00011593 -0.00004418 - -0.00004428 -0.00004418 0.00011636 - #*EXTRAS*# Step: 8 Bead: 32 - 0.00011635 -0.00004458 -0.00004429 - -0.00004458 0.00011593 -0.00004418 - -0.00004429 -0.00004418 0.00011637 - #*EXTRAS*# Step: 9 Bead: 32 - 0.00011636 -0.00004458 -0.00004429 - -0.00004458 0.00011594 -0.00004418 - -0.00004429 -0.00004418 0.00011637 - #*EXTRAS*# Step: 10 Bead: 32 - 0.00011636 -0.00004458 -0.00004429 - -0.00004458 0.00011594 -0.00004418 - -0.00004429 -0.00004418 0.00011638 - #*EXTRAS*# Step: 11 Bead: 32 - 0.00011636 -0.00004458 -0.00004429 - -0.00004458 0.00011594 -0.00004418 - -0.00004429 -0.00004418 0.00011638 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 deleted file mode 100644 index 81dde4738..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_33 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 33 - 0.00011368 -0.00004374 -0.00004364 - -0.00004374 0.00011347 -0.00004360 - -0.00004364 -0.00004360 0.00011372 - #*EXTRAS*# Step: 1 Bead: 33 - 0.00011489 -0.00004423 -0.00004401 - -0.00004423 0.00011455 -0.00004395 - -0.00004401 -0.00004395 0.00011491 - #*EXTRAS*# Step: 2 Bead: 33 - 0.00011576 -0.00004447 -0.00004420 - -0.00004447 0.00011536 -0.00004411 - -0.00004420 -0.00004411 0.00011578 - #*EXTRAS*# Step: 3 Bead: 33 - 0.00011578 -0.00004448 -0.00004420 - -0.00004448 0.00011538 -0.00004411 - -0.00004420 -0.00004411 0.00011581 - #*EXTRAS*# Step: 4 Bead: 33 - 0.00011589 -0.00004450 -0.00004422 - -0.00004450 0.00011548 -0.00004413 - -0.00004422 -0.00004413 0.00011591 - #*EXTRAS*# Step: 5 Bead: 33 - 0.00011594 -0.00004451 -0.00004423 - -0.00004451 0.00011553 -0.00004413 - -0.00004423 -0.00004413 0.00011595 - #*EXTRAS*# Step: 6 Bead: 33 - 0.00011597 -0.00004451 -0.00004423 - -0.00004451 0.00011556 -0.00004414 - -0.00004423 -0.00004414 0.00011599 - #*EXTRAS*# Step: 7 Bead: 33 - 0.00011599 -0.00004452 -0.00004423 - -0.00004452 0.00011557 -0.00004414 - -0.00004423 -0.00004414 0.00011600 - #*EXTRAS*# Step: 8 Bead: 33 - 0.00011600 -0.00004452 -0.00004424 - -0.00004452 0.00011559 -0.00004414 - -0.00004424 -0.00004414 0.00011602 - #*EXTRAS*# Step: 9 Bead: 33 - 0.00011601 -0.00004452 -0.00004424 - -0.00004452 0.00011559 -0.00004414 - -0.00004424 -0.00004414 0.00011602 - #*EXTRAS*# Step: 10 Bead: 33 - 0.00011601 -0.00004452 -0.00004424 - -0.00004452 0.00011560 -0.00004414 - -0.00004424 -0.00004414 0.00011603 - #*EXTRAS*# Step: 11 Bead: 33 - 0.00011602 -0.00004452 -0.00004424 - -0.00004452 0.00011560 -0.00004414 - -0.00004424 -0.00004414 0.00011603 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 deleted file mode 100644 index be9d27b93..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_34 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 34 - 0.00011291 -0.00004336 -0.00004333 - -0.00004336 0.00011279 -0.00004331 - -0.00004333 -0.00004331 0.00011296 - #*EXTRAS*# Step: 1 Bead: 34 - 0.00011426 -0.00004400 -0.00004383 - -0.00004400 0.00011399 -0.00004379 - -0.00004383 -0.00004379 0.00011430 - #*EXTRAS*# Step: 2 Bead: 34 - 0.00011526 -0.00004435 -0.00004410 - -0.00004435 0.00011489 -0.00004403 - -0.00004410 -0.00004403 0.00011529 - #*EXTRAS*# Step: 3 Bead: 34 - 0.00011535 -0.00004437 -0.00004412 - -0.00004437 0.00011497 -0.00004404 - -0.00004412 -0.00004404 0.00011537 - #*EXTRAS*# Step: 4 Bead: 34 - 0.00011549 -0.00004441 -0.00004415 - -0.00004441 0.00011510 -0.00004407 - -0.00004415 -0.00004407 0.00011551 - #*EXTRAS*# Step: 5 Bead: 34 - 0.00011556 -0.00004442 -0.00004416 - -0.00004442 0.00011517 -0.00004408 - -0.00004416 -0.00004408 0.00011558 - #*EXTRAS*# Step: 6 Bead: 34 - 0.00011560 -0.00004443 -0.00004417 - -0.00004443 0.00011521 -0.00004409 - -0.00004417 -0.00004409 0.00011562 - #*EXTRAS*# Step: 7 Bead: 34 - 0.00011563 -0.00004444 -0.00004417 - -0.00004444 0.00011523 -0.00004409 - -0.00004417 -0.00004409 0.00011565 - #*EXTRAS*# Step: 8 Bead: 34 - 0.00011565 -0.00004445 -0.00004418 - -0.00004445 0.00011525 -0.00004409 - -0.00004418 -0.00004409 0.00011567 - #*EXTRAS*# Step: 9 Bead: 34 - 0.00011566 -0.00004445 -0.00004418 - -0.00004445 0.00011526 -0.00004409 - -0.00004418 -0.00004409 0.00011568 - #*EXTRAS*# Step: 10 Bead: 34 - 0.00011567 -0.00004445 -0.00004418 - -0.00004445 0.00011527 -0.00004410 - -0.00004418 -0.00004410 0.00011569 - #*EXTRAS*# Step: 11 Bead: 34 - 0.00011567 -0.00004445 -0.00004418 - -0.00004445 0.00011527 -0.00004410 - -0.00004418 -0.00004410 0.00011569 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 deleted file mode 100644 index 348e9ab64..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_35 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 35 - 0.00011217 -0.00004295 -0.00004298 - -0.00004295 0.00011212 -0.00004296 - -0.00004298 -0.00004296 0.00011223 - #*EXTRAS*# Step: 1 Bead: 35 - 0.00011365 -0.00004373 -0.00004363 - -0.00004373 0.00011345 -0.00004359 - -0.00004363 -0.00004359 0.00011370 - #*EXTRAS*# Step: 2 Bead: 35 - 0.00011477 -0.00004419 -0.00004398 - -0.00004419 0.00011445 -0.00004392 - -0.00004398 -0.00004392 0.00011480 - #*EXTRAS*# Step: 3 Bead: 35 - 0.00011492 -0.00004424 -0.00004402 - -0.00004424 0.00011458 -0.00004395 - -0.00004402 -0.00004395 0.00011495 - #*EXTRAS*# Step: 4 Bead: 35 - 0.00011510 -0.00004430 -0.00004406 - -0.00004430 0.00011474 -0.00004399 - -0.00004406 -0.00004399 0.00011512 - #*EXTRAS*# Step: 5 Bead: 35 - 0.00011519 -0.00004432 -0.00004408 - -0.00004432 0.00011482 -0.00004401 - -0.00004408 -0.00004401 0.00011521 - #*EXTRAS*# Step: 6 Bead: 35 - 0.00011524 -0.00004434 -0.00004409 - -0.00004434 0.00011488 -0.00004402 - -0.00004409 -0.00004402 0.00011527 - #*EXTRAS*# Step: 7 Bead: 35 - 0.00011528 -0.00004435 -0.00004410 - -0.00004435 0.00011491 -0.00004403 - -0.00004410 -0.00004403 0.00011530 - #*EXTRAS*# Step: 8 Bead: 35 - 0.00011530 -0.00004436 -0.00004411 - -0.00004436 0.00011493 -0.00004403 - -0.00004411 -0.00004403 0.00011533 - #*EXTRAS*# Step: 9 Bead: 35 - 0.00011532 -0.00004436 -0.00004411 - -0.00004436 0.00011494 -0.00004404 - -0.00004411 -0.00004404 0.00011534 - #*EXTRAS*# Step: 10 Bead: 35 - 0.00011533 -0.00004436 -0.00004411 - -0.00004436 0.00011495 -0.00004404 - -0.00004411 -0.00004404 0.00011535 - #*EXTRAS*# Step: 11 Bead: 35 - 0.00011533 -0.00004437 -0.00004411 - -0.00004437 0.00011496 -0.00004404 - -0.00004411 -0.00004404 0.00011536 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 deleted file mode 100644 index e9864a1c6..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_36 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 36 - 0.00011145 -0.00004252 -0.00004258 - -0.00004252 0.00011145 -0.00004256 - -0.00004258 -0.00004256 0.00011152 - #*EXTRAS*# Step: 1 Bead: 36 - 0.00011307 -0.00004344 -0.00004340 - -0.00004344 0.00011293 -0.00004337 - -0.00004340 -0.00004337 0.00011311 - #*EXTRAS*# Step: 2 Bead: 36 - 0.00011429 -0.00004401 -0.00004384 - -0.00004401 0.00011402 -0.00004380 - -0.00004384 -0.00004380 0.00011433 - #*EXTRAS*# Step: 3 Bead: 36 - 0.00011450 -0.00004409 -0.00004391 - -0.00004409 0.00011420 -0.00004385 - -0.00004391 -0.00004385 0.00011454 - #*EXTRAS*# Step: 4 Bead: 36 - 0.00011471 -0.00004417 -0.00004396 - -0.00004417 0.00011439 -0.00004391 - -0.00004396 -0.00004391 0.00011474 - #*EXTRAS*# Step: 5 Bead: 36 - 0.00011482 -0.00004421 -0.00004399 - -0.00004421 0.00011449 -0.00004393 - -0.00004399 -0.00004393 0.00011485 - #*EXTRAS*# Step: 6 Bead: 36 - 0.00011489 -0.00004423 -0.00004401 - -0.00004423 0.00011455 -0.00004395 - -0.00004401 -0.00004395 0.00011492 - #*EXTRAS*# Step: 7 Bead: 36 - 0.00011494 -0.00004425 -0.00004402 - -0.00004425 0.00011459 -0.00004396 - -0.00004402 -0.00004396 0.00011496 - #*EXTRAS*# Step: 8 Bead: 36 - 0.00011496 -0.00004425 -0.00004403 - -0.00004425 0.00011462 -0.00004396 - -0.00004403 -0.00004396 0.00011499 - #*EXTRAS*# Step: 9 Bead: 36 - 0.00011498 -0.00004426 -0.00004403 - -0.00004426 0.00011464 -0.00004397 - -0.00004403 -0.00004397 0.00011501 - #*EXTRAS*# Step: 10 Bead: 36 - 0.00011499 -0.00004426 -0.00004404 - -0.00004426 0.00011465 -0.00004397 - -0.00004404 -0.00004397 0.00011502 - #*EXTRAS*# Step: 11 Bead: 36 - 0.00011500 -0.00004427 -0.00004404 - -0.00004427 0.00011465 -0.00004397 - -0.00004404 -0.00004397 0.00011503 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 deleted file mode 100644 index 4c105a6d7..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_37 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 37 - 0.00011076 -0.00004208 -0.00004216 - -0.00004208 0.00011078 -0.00004213 - -0.00004216 -0.00004213 0.00011084 - #*EXTRAS*# Step: 1 Bead: 37 - 0.00011250 -0.00004313 -0.00004314 - -0.00004313 0.00011242 -0.00004312 - -0.00004314 -0.00004312 0.00011255 - #*EXTRAS*# Step: 2 Bead: 37 - 0.00011383 -0.00004381 -0.00004369 - -0.00004381 0.00011360 -0.00004365 - -0.00004369 -0.00004365 0.00011387 - #*EXTRAS*# Step: 3 Bead: 37 - 0.00011409 -0.00004393 -0.00004378 - -0.00004393 0.00011384 -0.00004374 - -0.00004378 -0.00004374 0.00011413 - #*EXTRAS*# Step: 4 Bead: 37 - 0.00011434 -0.00004403 -0.00004386 - -0.00004403 0.00011405 -0.00004381 - -0.00004386 -0.00004381 0.00011437 - #*EXTRAS*# Step: 5 Bead: 37 - 0.00011447 -0.00004408 -0.00004390 - -0.00004408 0.00011417 -0.00004384 - -0.00004390 -0.00004384 0.00011450 - #*EXTRAS*# Step: 6 Bead: 37 - 0.00011455 -0.00004411 -0.00004392 - -0.00004411 0.00011424 -0.00004386 - -0.00004392 -0.00004386 0.00011458 - #*EXTRAS*# Step: 7 Bead: 37 - 0.00011460 -0.00004413 -0.00004393 - -0.00004413 0.00011429 -0.00004388 - -0.00004393 -0.00004388 0.00011463 - #*EXTRAS*# Step: 8 Bead: 37 - 0.00011463 -0.00004414 -0.00004394 - -0.00004414 0.00011432 -0.00004389 - -0.00004394 -0.00004389 0.00011466 - #*EXTRAS*# Step: 9 Bead: 37 - 0.00011465 -0.00004415 -0.00004395 - -0.00004415 0.00011434 -0.00004389 - -0.00004395 -0.00004389 0.00011469 - #*EXTRAS*# Step: 10 Bead: 37 - 0.00011467 -0.00004415 -0.00004395 - -0.00004415 0.00011435 -0.00004390 - -0.00004395 -0.00004390 0.00011470 - #*EXTRAS*# Step: 11 Bead: 37 - 0.00011468 -0.00004416 -0.00004396 - -0.00004416 0.00011436 -0.00004390 - -0.00004396 -0.00004390 0.00011471 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 deleted file mode 100644 index 439333822..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_38 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 38 - 0.00011010 -0.00004163 -0.00004170 - -0.00004163 0.00011012 -0.00004168 - -0.00004170 -0.00004168 0.00011018 - #*EXTRAS*# Step: 1 Bead: 38 - 0.00011194 -0.00004281 -0.00004286 - -0.00004281 0.00011191 -0.00004284 - -0.00004286 -0.00004284 0.00011201 - #*EXTRAS*# Step: 2 Bead: 38 - 0.00011337 -0.00004360 -0.00004352 - -0.00004360 0.00011320 -0.00004349 - -0.00004352 -0.00004349 0.00011342 - #*EXTRAS*# Step: 3 Bead: 38 - 0.00011370 -0.00004375 -0.00004365 - -0.00004375 0.00011349 -0.00004361 - -0.00004365 -0.00004361 0.00011374 - #*EXTRAS*# Step: 4 Bead: 38 - 0.00011397 -0.00004388 -0.00004374 - -0.00004388 0.00011373 -0.00004370 - -0.00004374 -0.00004370 0.00011401 - #*EXTRAS*# Step: 5 Bead: 38 - 0.00011412 -0.00004394 -0.00004379 - -0.00004394 0.00011386 -0.00004374 - -0.00004379 -0.00004374 0.00011416 - #*EXTRAS*# Step: 6 Bead: 38 - 0.00011421 -0.00004398 -0.00004382 - -0.00004398 0.00011394 -0.00004377 - -0.00004382 -0.00004377 0.00011425 - #*EXTRAS*# Step: 7 Bead: 38 - 0.00011427 -0.00004400 -0.00004384 - -0.00004400 0.00011400 -0.00004379 - -0.00004384 -0.00004379 0.00011431 - #*EXTRAS*# Step: 8 Bead: 38 - 0.00011431 -0.00004402 -0.00004385 - -0.00004402 0.00011403 -0.00004380 - -0.00004385 -0.00004380 0.00011434 - #*EXTRAS*# Step: 9 Bead: 38 - 0.00011433 -0.00004403 -0.00004386 - -0.00004403 0.00011405 -0.00004381 - -0.00004386 -0.00004381 0.00011437 - #*EXTRAS*# Step: 10 Bead: 38 - 0.00011435 -0.00004403 -0.00004386 - -0.00004403 0.00011407 -0.00004381 - -0.00004386 -0.00004381 0.00011439 - #*EXTRAS*# Step: 11 Bead: 38 - 0.00011436 -0.00004404 -0.00004387 - -0.00004404 0.00011408 -0.00004381 - -0.00004387 -0.00004381 0.00011440 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 deleted file mode 100644 index 1d99bdeb6..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_39 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 39 - 0.00010946 -0.00004117 -0.00004123 - -0.00004117 0.00010948 -0.00004120 - -0.00004123 -0.00004120 0.00010953 - #*EXTRAS*# Step: 1 Bead: 39 - 0.00011141 -0.00004249 -0.00004256 - -0.00004249 0.00011141 -0.00004254 - -0.00004256 -0.00004254 0.00011148 - #*EXTRAS*# Step: 2 Bead: 39 - 0.00011293 -0.00004337 -0.00004334 - -0.00004337 0.00011281 -0.00004331 - -0.00004334 -0.00004331 0.00011298 - #*EXTRAS*# Step: 3 Bead: 39 - 0.00011331 -0.00004357 -0.00004350 - -0.00004357 0.00011315 -0.00004347 - -0.00004350 -0.00004347 0.00011336 - #*EXTRAS*# Step: 4 Bead: 39 - 0.00011361 -0.00004371 -0.00004361 - -0.00004371 0.00011341 -0.00004358 - -0.00004361 -0.00004358 0.00011366 - #*EXTRAS*# Step: 5 Bead: 39 - 0.00011378 -0.00004379 -0.00004368 - -0.00004379 0.00011356 -0.00004364 - -0.00004368 -0.00004364 0.00011382 - #*EXTRAS*# Step: 6 Bead: 39 - 0.00011389 -0.00004384 -0.00004371 - -0.00004384 0.00011366 -0.00004367 - -0.00004371 -0.00004367 0.00011393 - #*EXTRAS*# Step: 7 Bead: 39 - 0.00011395 -0.00004387 -0.00004373 - -0.00004387 0.00011371 -0.00004369 - -0.00004373 -0.00004369 0.00011399 - #*EXTRAS*# Step: 8 Bead: 39 - 0.00011400 -0.00004389 -0.00004375 - -0.00004389 0.00011375 -0.00004371 - -0.00004375 -0.00004371 0.00011403 - #*EXTRAS*# Step: 9 Bead: 39 - 0.00011402 -0.00004390 -0.00004376 - -0.00004390 0.00011378 -0.00004372 - -0.00004376 -0.00004372 0.00011406 - #*EXTRAS*# Step: 10 Bead: 39 - 0.00011404 -0.00004391 -0.00004376 - -0.00004391 0.00011379 -0.00004372 - -0.00004376 -0.00004372 0.00011408 - #*EXTRAS*# Step: 11 Bead: 39 - 0.00011405 -0.00004391 -0.00004377 - -0.00004391 0.00011380 -0.00004372 - -0.00004377 -0.00004372 0.00011409 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 deleted file mode 100644 index 8dd3b4823..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_40 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 40 - 0.00010885 -0.00004069 -0.00004073 - -0.00004069 0.00010886 -0.00004071 - -0.00004073 -0.00004071 0.00010891 - #*EXTRAS*# Step: 1 Bead: 40 - 0.00011090 -0.00004217 -0.00004225 - -0.00004217 0.00011091 -0.00004222 - -0.00004225 -0.00004222 0.00011097 - #*EXTRAS*# Step: 2 Bead: 40 - 0.00011250 -0.00004314 -0.00004314 - -0.00004314 0.00011242 -0.00004312 - -0.00004314 -0.00004312 0.00011256 - #*EXTRAS*# Step: 3 Bead: 40 - 0.00011294 -0.00004337 -0.00004334 - -0.00004337 0.00011281 -0.00004332 - -0.00004334 -0.00004332 0.00011299 - #*EXTRAS*# Step: 4 Bead: 40 - 0.00011327 -0.00004355 -0.00004348 - -0.00004355 0.00011311 -0.00004345 - -0.00004348 -0.00004345 0.00011332 - #*EXTRAS*# Step: 5 Bead: 40 - 0.00011345 -0.00004364 -0.00004355 - -0.00004364 0.00011327 -0.00004352 - -0.00004355 -0.00004352 0.00011350 - #*EXTRAS*# Step: 6 Bead: 40 - 0.00011357 -0.00004369 -0.00004360 - -0.00004369 0.00011338 -0.00004356 - -0.00004360 -0.00004356 0.00011361 - #*EXTRAS*# Step: 7 Bead: 40 - 0.00011364 -0.00004373 -0.00004363 - -0.00004373 0.00011344 -0.00004359 - -0.00004363 -0.00004359 0.00011369 - #*EXTRAS*# Step: 8 Bead: 40 - 0.00011369 -0.00004375 -0.00004364 - -0.00004375 0.00011348 -0.00004361 - -0.00004364 -0.00004361 0.00011373 - #*EXTRAS*# Step: 9 Bead: 40 - 0.00011372 -0.00004376 -0.00004365 - -0.00004376 0.00011351 -0.00004362 - -0.00004365 -0.00004362 0.00011376 - #*EXTRAS*# Step: 10 Bead: 40 - 0.00011374 -0.00004377 -0.00004366 - -0.00004377 0.00011353 -0.00004362 - -0.00004366 -0.00004362 0.00011378 - #*EXTRAS*# Step: 11 Bead: 40 - 0.00011375 -0.00004378 -0.00004367 - -0.00004378 0.00011354 -0.00004363 - -0.00004367 -0.00004363 0.00011380 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 deleted file mode 100644 index 87466bf84..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_41 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 41 - 0.00010826 -0.00004021 -0.00004023 - -0.00004021 0.00010826 -0.00004022 - -0.00004023 -0.00004022 0.00010830 - #*EXTRAS*# Step: 1 Bead: 41 - 0.00011041 -0.00004184 -0.00004192 - -0.00004184 0.00011043 -0.00004189 - -0.00004192 -0.00004189 0.00011048 - #*EXTRAS*# Step: 2 Bead: 41 - 0.00011209 -0.00004290 -0.00004294 - -0.00004290 0.00011205 -0.00004292 - -0.00004294 -0.00004292 0.00011215 - #*EXTRAS*# Step: 3 Bead: 41 - 0.00011258 -0.00004318 -0.00004318 - -0.00004318 0.00011249 -0.00004316 - -0.00004318 -0.00004316 0.00011263 - #*EXTRAS*# Step: 4 Bead: 41 - 0.00011294 -0.00004337 -0.00004334 - -0.00004337 0.00011281 -0.00004332 - -0.00004334 -0.00004332 0.00011299 - #*EXTRAS*# Step: 5 Bead: 41 - 0.00011314 -0.00004348 -0.00004343 - -0.00004348 0.00011299 -0.00004340 - -0.00004343 -0.00004340 0.00011319 - #*EXTRAS*# Step: 6 Bead: 41 - 0.00011326 -0.00004354 -0.00004348 - -0.00004354 0.00011311 -0.00004345 - -0.00004348 -0.00004345 0.00011331 - #*EXTRAS*# Step: 7 Bead: 41 - 0.00011334 -0.00004358 -0.00004351 - -0.00004358 0.00011318 -0.00004348 - -0.00004351 -0.00004348 0.00011339 - #*EXTRAS*# Step: 8 Bead: 41 - 0.00011340 -0.00004361 -0.00004353 - -0.00004361 0.00011322 -0.00004350 - -0.00004353 -0.00004350 0.00011344 - #*EXTRAS*# Step: 9 Bead: 41 - 0.00011343 -0.00004362 -0.00004354 - -0.00004362 0.00011325 -0.00004351 - -0.00004354 -0.00004351 0.00011347 - #*EXTRAS*# Step: 10 Bead: 41 - 0.00011345 -0.00004363 -0.00004355 - -0.00004363 0.00011327 -0.00004352 - -0.00004355 -0.00004352 0.00011350 - #*EXTRAS*# Step: 11 Bead: 41 - 0.00011347 -0.00004364 -0.00004356 - -0.00004364 0.00011328 -0.00004353 - -0.00004356 -0.00004353 0.00011351 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 deleted file mode 100644 index c3e7db5b4..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_42 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 42 - 0.00010769 -0.00003973 -0.00003972 - -0.00003973 0.00010769 -0.00003973 - -0.00003972 -0.00003973 0.00010770 - #*EXTRAS*# Step: 1 Bead: 42 - 0.00010993 -0.00004151 -0.00004158 - -0.00004151 0.00010996 -0.00004155 - -0.00004158 -0.00004155 0.00011001 - #*EXTRAS*# Step: 2 Bead: 42 - 0.00011169 -0.00004267 -0.00004272 - -0.00004267 0.00011168 -0.00004270 - -0.00004272 -0.00004270 0.00011176 - #*EXTRAS*# Step: 3 Bead: 42 - 0.00011223 -0.00004298 -0.00004301 - -0.00004298 0.00011217 -0.00004299 - -0.00004301 -0.00004299 0.00011229 - #*EXTRAS*# Step: 4 Bead: 42 - 0.00011261 -0.00004320 -0.00004320 - -0.00004320 0.00011252 -0.00004317 - -0.00004320 -0.00004317 0.00011267 - #*EXTRAS*# Step: 5 Bead: 42 - 0.00011283 -0.00004332 -0.00004330 - -0.00004332 0.00011272 -0.00004327 - -0.00004330 -0.00004327 0.00011288 - #*EXTRAS*# Step: 6 Bead: 42 - 0.00011297 -0.00004339 -0.00004336 - -0.00004339 0.00011284 -0.00004333 - -0.00004336 -0.00004333 0.00011302 - #*EXTRAS*# Step: 7 Bead: 42 - 0.00011306 -0.00004344 -0.00004339 - -0.00004344 0.00011292 -0.00004337 - -0.00004339 -0.00004337 0.00011310 - #*EXTRAS*# Step: 8 Bead: 42 - 0.00011311 -0.00004346 -0.00004342 - -0.00004346 0.00011297 -0.00004339 - -0.00004342 -0.00004339 0.00011316 - #*EXTRAS*# Step: 9 Bead: 42 - 0.00011315 -0.00004348 -0.00004343 - -0.00004348 0.00011300 -0.00004340 - -0.00004343 -0.00004340 0.00011319 - #*EXTRAS*# Step: 10 Bead: 42 - 0.00011317 -0.00004349 -0.00004344 - -0.00004349 0.00011302 -0.00004341 - -0.00004344 -0.00004341 0.00011322 - #*EXTRAS*# Step: 11 Bead: 42 - 0.00011319 -0.00004350 -0.00004345 - -0.00004350 0.00011303 -0.00004342 - -0.00004345 -0.00004342 0.00011323 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 deleted file mode 100644 index dc58becf7..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_43 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 43 - 0.00010715 -0.00003923 -0.00003921 - -0.00003923 0.00010715 -0.00003925 - -0.00003921 -0.00003925 0.00010712 - #*EXTRAS*# Step: 1 Bead: 43 - 0.00010948 -0.00004118 -0.00004124 - -0.00004118 0.00010950 -0.00004121 - -0.00004124 -0.00004121 0.00010955 - #*EXTRAS*# Step: 2 Bead: 43 - 0.00011131 -0.00004243 -0.00004250 - -0.00004243 0.00011131 -0.00004248 - -0.00004250 -0.00004248 0.00011138 - #*EXTRAS*# Step: 3 Bead: 43 - 0.00011189 -0.00004278 -0.00004283 - -0.00004278 0.00011186 -0.00004281 - -0.00004283 -0.00004281 0.00011196 - #*EXTRAS*# Step: 4 Bead: 43 - 0.00011231 -0.00004302 -0.00004305 - -0.00004302 0.00011224 -0.00004303 - -0.00004305 -0.00004303 0.00011236 - #*EXTRAS*# Step: 5 Bead: 43 - 0.00011254 -0.00004316 -0.00004316 - -0.00004316 0.00011246 -0.00004314 - -0.00004316 -0.00004314 0.00011259 - #*EXTRAS*# Step: 6 Bead: 43 - 0.00011268 -0.00004324 -0.00004323 - -0.00004324 0.00011259 -0.00004321 - -0.00004323 -0.00004321 0.00011274 - #*EXTRAS*# Step: 7 Bead: 43 - 0.00011278 -0.00004329 -0.00004327 - -0.00004329 0.00011267 -0.00004325 - -0.00004327 -0.00004325 0.00011283 - #*EXTRAS*# Step: 8 Bead: 43 - 0.00011284 -0.00004332 -0.00004330 - -0.00004332 0.00011272 -0.00004327 - -0.00004330 -0.00004327 0.00011289 - #*EXTRAS*# Step: 9 Bead: 43 - 0.00011287 -0.00004334 -0.00004331 - -0.00004334 0.00011276 -0.00004329 - -0.00004331 -0.00004329 0.00011293 - #*EXTRAS*# Step: 10 Bead: 43 - 0.00011290 -0.00004335 -0.00004333 - -0.00004335 0.00011278 -0.00004330 - -0.00004333 -0.00004330 0.00011295 - #*EXTRAS*# Step: 11 Bead: 43 - 0.00011292 -0.00004336 -0.00004333 - -0.00004336 0.00011279 -0.00004331 - -0.00004333 -0.00004331 0.00011297 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 deleted file mode 100644 index 7c3778b4d..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_44 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 44 - 0.00010664 -0.00003874 -0.00003871 - -0.00003874 0.00010664 -0.00003877 - -0.00003871 -0.00003877 0.00010656 - #*EXTRAS*# Step: 1 Bead: 44 - 0.00010905 -0.00004085 -0.00004090 - -0.00004085 0.00010906 -0.00004087 - -0.00004090 -0.00004087 0.00010911 - #*EXTRAS*# Step: 2 Bead: 44 - 0.00011095 -0.00004220 -0.00004228 - -0.00004220 0.00011096 -0.00004225 - -0.00004228 -0.00004225 0.00011102 - #*EXTRAS*# Step: 3 Bead: 44 - 0.00011157 -0.00004259 -0.00004265 - -0.00004259 0.00011156 -0.00004263 - -0.00004265 -0.00004263 0.00011164 - #*EXTRAS*# Step: 4 Bead: 44 - 0.00011201 -0.00004285 -0.00004289 - -0.00004285 0.00011197 -0.00004288 - -0.00004289 -0.00004288 0.00011207 - #*EXTRAS*# Step: 5 Bead: 44 - 0.00011226 -0.00004300 -0.00004302 - -0.00004300 0.00011220 -0.00004300 - -0.00004302 -0.00004300 0.00011232 - #*EXTRAS*# Step: 6 Bead: 44 - 0.00011241 -0.00004309 -0.00004310 - -0.00004309 0.00011234 -0.00004308 - -0.00004310 -0.00004308 0.00011247 - #*EXTRAS*# Step: 7 Bead: 44 - 0.00011251 -0.00004314 -0.00004315 - -0.00004314 0.00011243 -0.00004313 - -0.00004315 -0.00004313 0.00011256 - #*EXTRAS*# Step: 8 Bead: 44 - 0.00011257 -0.00004317 -0.00004318 - -0.00004317 0.00011249 -0.00004315 - -0.00004318 -0.00004315 0.00011263 - #*EXTRAS*# Step: 9 Bead: 44 - 0.00011261 -0.00004320 -0.00004320 - -0.00004320 0.00011252 -0.00004317 - -0.00004320 -0.00004317 0.00011267 - #*EXTRAS*# Step: 10 Bead: 44 - 0.00011264 -0.00004321 -0.00004321 - -0.00004321 0.00011255 -0.00004319 - -0.00004321 -0.00004319 0.00011269 - #*EXTRAS*# Step: 11 Bead: 44 - 0.00011266 -0.00004322 -0.00004322 - -0.00004322 0.00011256 -0.00004319 - -0.00004322 -0.00004319 0.00011271 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 deleted file mode 100644 index d03a35aa1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_45 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 45 - 0.00010616 -0.00003826 -0.00003821 - -0.00003826 0.00010615 -0.00003831 - -0.00003821 -0.00003831 0.00010603 - #*EXTRAS*# Step: 1 Bead: 45 - 0.00010863 -0.00004052 -0.00004055 - -0.00004052 0.00010865 -0.00004053 - -0.00004055 -0.00004053 0.00010869 - #*EXTRAS*# Step: 2 Bead: 45 - 0.00011060 -0.00004197 -0.00004205 - -0.00004197 0.00011062 -0.00004202 - -0.00004205 -0.00004202 0.00011067 - #*EXTRAS*# Step: 3 Bead: 45 - 0.00011126 -0.00004240 -0.00004247 - -0.00004240 0.00011127 -0.00004245 - -0.00004247 -0.00004245 0.00011134 - #*EXTRAS*# Step: 4 Bead: 45 - 0.00011172 -0.00004268 -0.00004274 - -0.00004268 0.00011171 -0.00004272 - -0.00004274 -0.00004272 0.00011179 - #*EXTRAS*# Step: 5 Bead: 45 - 0.00011199 -0.00004284 -0.00004288 - -0.00004284 0.00011195 -0.00004286 - -0.00004288 -0.00004286 0.00011205 - #*EXTRAS*# Step: 6 Bead: 45 - 0.00011215 -0.00004294 -0.00004297 - -0.00004294 0.00011210 -0.00004295 - -0.00004297 -0.00004295 0.00011221 - #*EXTRAS*# Step: 7 Bead: 45 - 0.00011225 -0.00004299 -0.00004302 - -0.00004299 0.00011220 -0.00004300 - -0.00004302 -0.00004300 0.00011231 - #*EXTRAS*# Step: 8 Bead: 45 - 0.00011232 -0.00004303 -0.00004305 - -0.00004303 0.00011226 -0.00004303 - -0.00004305 -0.00004303 0.00011238 - #*EXTRAS*# Step: 9 Bead: 45 - 0.00011236 -0.00004306 -0.00004307 - -0.00004306 0.00011230 -0.00004305 - -0.00004307 -0.00004305 0.00011242 - #*EXTRAS*# Step: 10 Bead: 45 - 0.00011239 -0.00004307 -0.00004309 - -0.00004307 0.00011232 -0.00004307 - -0.00004309 -0.00004307 0.00011245 - #*EXTRAS*# Step: 11 Bead: 45 - 0.00011241 -0.00004308 -0.00004310 - -0.00004308 0.00011234 -0.00004308 - -0.00004310 -0.00004308 0.00011247 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 deleted file mode 100644 index fb7af2cb0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_46 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 46 - 0.00010571 -0.00003778 -0.00003773 - -0.00003778 0.00010570 -0.00003786 - -0.00003773 -0.00003786 0.00010554 - #*EXTRAS*# Step: 1 Bead: 46 - 0.00010824 -0.00004020 -0.00004022 - -0.00004020 0.00010825 -0.00004020 - -0.00004022 -0.00004020 0.00010828 - #*EXTRAS*# Step: 2 Bead: 46 - 0.00011026 -0.00004174 -0.00004182 - -0.00004174 0.00011029 -0.00004179 - -0.00004182 -0.00004179 0.00011034 - #*EXTRAS*# Step: 3 Bead: 46 - 0.00011097 -0.00004221 -0.00004229 - -0.00004221 0.00011098 -0.00004227 - -0.00004229 -0.00004227 0.00011105 - #*EXTRAS*# Step: 4 Bead: 46 - 0.00011145 -0.00004252 -0.00004258 - -0.00004252 0.00011145 -0.00004257 - -0.00004258 -0.00004257 0.00011152 - #*EXTRAS*# Step: 5 Bead: 46 - 0.00011173 -0.00004269 -0.00004274 - -0.00004269 0.00011171 -0.00004272 - -0.00004274 -0.00004272 0.00011179 - #*EXTRAS*# Step: 6 Bead: 46 - 0.00011190 -0.00004279 -0.00004284 - -0.00004279 0.00011187 -0.00004282 - -0.00004284 -0.00004282 0.00011196 - #*EXTRAS*# Step: 7 Bead: 46 - 0.00011201 -0.00004285 -0.00004289 - -0.00004285 0.00011197 -0.00004288 - -0.00004289 -0.00004288 0.00011207 - #*EXTRAS*# Step: 8 Bead: 46 - 0.00011208 -0.00004289 -0.00004293 - -0.00004289 0.00011204 -0.00004291 - -0.00004293 -0.00004291 0.00011214 - #*EXTRAS*# Step: 9 Bead: 46 - 0.00011212 -0.00004292 -0.00004295 - -0.00004292 0.00011208 -0.00004294 - -0.00004295 -0.00004294 0.00011218 - #*EXTRAS*# Step: 10 Bead: 46 - 0.00011215 -0.00004294 -0.00004297 - -0.00004294 0.00011210 -0.00004295 - -0.00004297 -0.00004295 0.00011221 - #*EXTRAS*# Step: 11 Bead: 46 - 0.00011217 -0.00004295 -0.00004298 - -0.00004295 0.00011212 -0.00004296 - -0.00004298 -0.00004296 0.00011223 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 deleted file mode 100644 index b9d92fdd2..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_47 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 47 - 0.00010529 -0.00003732 -0.00003726 - -0.00003732 0.00010529 -0.00003742 - -0.00003726 -0.00003742 0.00010507 - #*EXTRAS*# Step: 1 Bead: 47 - 0.00010787 -0.00003988 -0.00003988 - -0.00003988 0.00010787 -0.00003988 - -0.00003988 -0.00003988 0.00010789 - #*EXTRAS*# Step: 2 Bead: 47 - 0.00010995 -0.00004152 -0.00004159 - -0.00004152 0.00010997 -0.00004157 - -0.00004159 -0.00004157 0.00011003 - #*EXTRAS*# Step: 3 Bead: 47 - 0.00011069 -0.00004203 -0.00004211 - -0.00004203 0.00011071 -0.00004209 - -0.00004211 -0.00004209 0.00011077 - #*EXTRAS*# Step: 4 Bead: 47 - 0.00011120 -0.00004236 -0.00004243 - -0.00004236 0.00011120 -0.00004241 - -0.00004243 -0.00004241 0.00011127 - #*EXTRAS*# Step: 5 Bead: 47 - 0.00011148 -0.00004254 -0.00004260 - -0.00004254 0.00011148 -0.00004258 - -0.00004260 -0.00004258 0.00011155 - #*EXTRAS*# Step: 6 Bead: 47 - 0.00011166 -0.00004265 -0.00004271 - -0.00004265 0.00011165 -0.00004269 - -0.00004271 -0.00004269 0.00011173 - #*EXTRAS*# Step: 7 Bead: 47 - 0.00011178 -0.00004272 -0.00004277 - -0.00004272 0.00011175 -0.00004275 - -0.00004277 -0.00004275 0.00011184 - #*EXTRAS*# Step: 8 Bead: 47 - 0.00011185 -0.00004276 -0.00004281 - -0.00004276 0.00011182 -0.00004279 - -0.00004281 -0.00004279 0.00011191 - #*EXTRAS*# Step: 9 Bead: 47 - 0.00011190 -0.00004279 -0.00004283 - -0.00004279 0.00011187 -0.00004282 - -0.00004283 -0.00004282 0.00011196 - #*EXTRAS*# Step: 10 Bead: 47 - 0.00011193 -0.00004281 -0.00004285 - -0.00004281 0.00011190 -0.00004283 - -0.00004285 -0.00004283 0.00011199 - #*EXTRAS*# Step: 11 Bead: 47 - 0.00011195 -0.00004282 -0.00004286 - -0.00004282 0.00011191 -0.00004284 - -0.00004286 -0.00004284 0.00011201 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 deleted file mode 100644 index 57ebaf0c8..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_48 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 48 - 0.00010490 -0.00003687 -0.00003681 - -0.00003687 0.00010490 -0.00003699 - -0.00003681 -0.00003699 0.00010465 - #*EXTRAS*# Step: 1 Bead: 48 - 0.00010752 -0.00003957 -0.00003956 - -0.00003957 0.00010752 -0.00003958 - -0.00003956 -0.00003958 0.00010751 - #*EXTRAS*# Step: 2 Bead: 48 - 0.00010965 -0.00004131 -0.00004137 - -0.00004131 0.00010967 -0.00004134 - -0.00004137 -0.00004134 0.00010972 - #*EXTRAS*# Step: 3 Bead: 48 - 0.00011043 -0.00004186 -0.00004193 - -0.00004186 0.00011045 -0.00004191 - -0.00004193 -0.00004191 0.00011051 - #*EXTRAS*# Step: 4 Bead: 48 - 0.00011095 -0.00004220 -0.00004228 - -0.00004220 0.00011097 -0.00004226 - -0.00004228 -0.00004226 0.00011103 - #*EXTRAS*# Step: 5 Bead: 48 - 0.00011125 -0.00004239 -0.00004247 - -0.00004239 0.00011126 -0.00004244 - -0.00004247 -0.00004244 0.00011132 - #*EXTRAS*# Step: 6 Bead: 48 - 0.00011144 -0.00004251 -0.00004258 - -0.00004251 0.00011143 -0.00004256 - -0.00004258 -0.00004256 0.00011151 - #*EXTRAS*# Step: 7 Bead: 48 - 0.00011156 -0.00004258 -0.00004264 - -0.00004258 0.00011155 -0.00004263 - -0.00004264 -0.00004263 0.00011162 - #*EXTRAS*# Step: 8 Bead: 48 - 0.00011163 -0.00004263 -0.00004269 - -0.00004263 0.00011162 -0.00004267 - -0.00004269 -0.00004267 0.00011170 - #*EXTRAS*# Step: 9 Bead: 48 - 0.00011168 -0.00004266 -0.00004272 - -0.00004266 0.00011166 -0.00004270 - -0.00004272 -0.00004270 0.00011175 - #*EXTRAS*# Step: 10 Bead: 48 - 0.00011171 -0.00004268 -0.00004273 - -0.00004268 0.00011169 -0.00004271 - -0.00004273 -0.00004271 0.00011178 - #*EXTRAS*# Step: 11 Bead: 48 - 0.00011173 -0.00004269 -0.00004275 - -0.00004269 0.00011172 -0.00004273 - -0.00004275 -0.00004273 0.00011180 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 deleted file mode 100644 index 82e38da1f..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_49 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 49 - 0.00010455 -0.00003644 -0.00003638 - -0.00003644 0.00010454 -0.00003659 - -0.00003638 -0.00003659 0.00010425 - #*EXTRAS*# Step: 1 Bead: 49 - 0.00010719 -0.00003927 -0.00003925 - -0.00003927 0.00010719 -0.00003928 - -0.00003925 -0.00003928 0.00010716 - #*EXTRAS*# Step: 2 Bead: 49 - 0.00010937 -0.00004110 -0.00004115 - -0.00004110 0.00010939 -0.00004113 - -0.00004115 -0.00004113 0.00010944 - #*EXTRAS*# Step: 3 Bead: 49 - 0.00011018 -0.00004168 -0.00004176 - -0.00004168 0.00011021 -0.00004173 - -0.00004176 -0.00004173 0.00011026 - #*EXTRAS*# Step: 4 Bead: 49 - 0.00011072 -0.00004205 -0.00004213 - -0.00004205 0.00011074 -0.00004211 - -0.00004213 -0.00004211 0.00011080 - #*EXTRAS*# Step: 5 Bead: 49 - 0.00011103 -0.00004225 -0.00004233 - -0.00004225 0.00011105 -0.00004231 - -0.00004233 -0.00004231 0.00011111 - #*EXTRAS*# Step: 6 Bead: 49 - 0.00011123 -0.00004238 -0.00004245 - -0.00004238 0.00011123 -0.00004243 - -0.00004245 -0.00004243 0.00011130 - #*EXTRAS*# Step: 7 Bead: 49 - 0.00011135 -0.00004245 -0.00004252 - -0.00004245 0.00011135 -0.00004250 - -0.00004252 -0.00004250 0.00011142 - #*EXTRAS*# Step: 8 Bead: 49 - 0.00011143 -0.00004250 -0.00004257 - -0.00004250 0.00011142 -0.00004255 - -0.00004257 -0.00004255 0.00011150 - #*EXTRAS*# Step: 9 Bead: 49 - 0.00011148 -0.00004253 -0.00004260 - -0.00004253 0.00011147 -0.00004258 - -0.00004260 -0.00004258 0.00011155 - #*EXTRAS*# Step: 10 Bead: 49 - 0.00011151 -0.00004255 -0.00004262 - -0.00004255 0.00011150 -0.00004260 - -0.00004262 -0.00004260 0.00011158 - #*EXTRAS*# Step: 11 Bead: 49 - 0.00011153 -0.00004257 -0.00004263 - -0.00004257 0.00011153 -0.00004261 - -0.00004263 -0.00004261 0.00011160 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 deleted file mode 100644 index 480adba2c..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_50 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 50 - 0.00010422 -0.00003604 -0.00003597 - -0.00003604 0.00010422 -0.00003619 - -0.00003597 -0.00003619 0.00010390 - #*EXTRAS*# Step: 1 Bead: 50 - 0.00010688 -0.00003898 -0.00003895 - -0.00003898 0.00010688 -0.00003900 - -0.00003895 -0.00003900 0.00010683 - #*EXTRAS*# Step: 2 Bead: 50 - 0.00010910 -0.00004090 -0.00004094 - -0.00004090 0.00010912 -0.00004092 - -0.00004094 -0.00004092 0.00010917 - #*EXTRAS*# Step: 3 Bead: 50 - 0.00010995 -0.00004152 -0.00004159 - -0.00004152 0.00010997 -0.00004156 - -0.00004159 -0.00004156 0.00011002 - #*EXTRAS*# Step: 4 Bead: 50 - 0.00011051 -0.00004191 -0.00004199 - -0.00004191 0.00011053 -0.00004196 - -0.00004199 -0.00004196 0.00011058 - #*EXTRAS*# Step: 5 Bead: 50 - 0.00011083 -0.00004212 -0.00004220 - -0.00004212 0.00011085 -0.00004218 - -0.00004220 -0.00004218 0.00011090 - #*EXTRAS*# Step: 6 Bead: 50 - 0.00011103 -0.00004225 -0.00004233 - -0.00004225 0.00011104 -0.00004231 - -0.00004233 -0.00004231 0.00011110 - #*EXTRAS*# Step: 7 Bead: 50 - 0.00011115 -0.00004233 -0.00004241 - -0.00004233 0.00011116 -0.00004238 - -0.00004241 -0.00004238 0.00011123 - #*EXTRAS*# Step: 8 Bead: 50 - 0.00011124 -0.00004238 -0.00004245 - -0.00004238 0.00011124 -0.00004243 - -0.00004245 -0.00004243 0.00011131 - #*EXTRAS*# Step: 9 Bead: 50 - 0.00011129 -0.00004242 -0.00004249 - -0.00004242 0.00011129 -0.00004247 - -0.00004249 -0.00004247 0.00011136 - #*EXTRAS*# Step: 10 Bead: 50 - 0.00011132 -0.00004244 -0.00004251 - -0.00004244 0.00011132 -0.00004249 - -0.00004251 -0.00004249 0.00011139 - #*EXTRAS*# Step: 11 Bead: 50 - 0.00011135 -0.00004245 -0.00004252 - -0.00004245 0.00011135 -0.00004250 - -0.00004252 -0.00004250 0.00011142 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 deleted file mode 100644 index 8aa146f06..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_51 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 51 - 0.00010393 -0.00003565 -0.00003558 - -0.00003565 0.00010392 -0.00003582 - -0.00003558 -0.00003582 0.00010358 - #*EXTRAS*# Step: 1 Bead: 51 - 0.00010660 -0.00003870 -0.00003866 - -0.00003870 0.00010659 -0.00003873 - -0.00003866 -0.00003873 0.00010652 - #*EXTRAS*# Step: 2 Bead: 51 - 0.00010886 -0.00004070 -0.00004074 - -0.00004070 0.00010887 -0.00004072 - -0.00004074 -0.00004072 0.00010892 - #*EXTRAS*# Step: 3 Bead: 51 - 0.00010973 -0.00004136 -0.00004143 - -0.00004136 0.00010975 -0.00004140 - -0.00004143 -0.00004140 0.00010981 - #*EXTRAS*# Step: 4 Bead: 51 - 0.00011031 -0.00004177 -0.00004185 - -0.00004177 0.00011033 -0.00004182 - -0.00004185 -0.00004182 0.00011038 - #*EXTRAS*# Step: 5 Bead: 51 - 0.00011064 -0.00004200 -0.00004207 - -0.00004200 0.00011066 -0.00004205 - -0.00004207 -0.00004205 0.00011071 - #*EXTRAS*# Step: 6 Bead: 51 - 0.00011084 -0.00004213 -0.00004221 - -0.00004213 0.00011086 -0.00004219 - -0.00004221 -0.00004219 0.00011092 - #*EXTRAS*# Step: 7 Bead: 51 - 0.00011097 -0.00004222 -0.00004229 - -0.00004222 0.00011099 -0.00004227 - -0.00004229 -0.00004227 0.00011105 - #*EXTRAS*# Step: 8 Bead: 51 - 0.00011106 -0.00004227 -0.00004234 - -0.00004227 0.00011107 -0.00004232 - -0.00004234 -0.00004232 0.00011113 - #*EXTRAS*# Step: 9 Bead: 51 - 0.00011111 -0.00004230 -0.00004238 - -0.00004230 0.00011112 -0.00004236 - -0.00004238 -0.00004236 0.00011118 - #*EXTRAS*# Step: 10 Bead: 51 - 0.00011115 -0.00004233 -0.00004240 - -0.00004233 0.00011115 -0.00004238 - -0.00004240 -0.00004238 0.00011122 - #*EXTRAS*# Step: 11 Bead: 51 - 0.00011117 -0.00004234 -0.00004241 - -0.00004234 0.00011118 -0.00004239 - -0.00004241 -0.00004239 0.00011124 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 deleted file mode 100644 index 2f2ef6334..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_52 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 52 - 0.00010366 -0.00003529 -0.00003522 - -0.00003529 0.00010365 -0.00003547 - -0.00003522 -0.00003547 0.00010329 - #*EXTRAS*# Step: 1 Bead: 52 - 0.00010634 -0.00003844 -0.00003839 - -0.00003844 0.00010633 -0.00003848 - -0.00003839 -0.00003848 0.00010623 - #*EXTRAS*# Step: 2 Bead: 52 - 0.00010863 -0.00004052 -0.00004055 - -0.00004052 0.00010864 -0.00004053 - -0.00004055 -0.00004053 0.00010868 - #*EXTRAS*# Step: 3 Bead: 52 - 0.00010953 -0.00004122 -0.00004128 - -0.00004122 0.00010955 -0.00004125 - -0.00004128 -0.00004125 0.00010960 - #*EXTRAS*# Step: 4 Bead: 52 - 0.00011012 -0.00004164 -0.00004172 - -0.00004164 0.00011014 -0.00004169 - -0.00004172 -0.00004169 0.00011020 - #*EXTRAS*# Step: 5 Bead: 52 - 0.00011046 -0.00004188 -0.00004195 - -0.00004188 0.00011048 -0.00004193 - -0.00004195 -0.00004193 0.00011054 - #*EXTRAS*# Step: 6 Bead: 52 - 0.00011067 -0.00004202 -0.00004210 - -0.00004202 0.00011069 -0.00004207 - -0.00004210 -0.00004207 0.00011075 - #*EXTRAS*# Step: 7 Bead: 52 - 0.00011080 -0.00004211 -0.00004218 - -0.00004211 0.00011082 -0.00004216 - -0.00004218 -0.00004216 0.00011088 - #*EXTRAS*# Step: 8 Bead: 52 - 0.00011089 -0.00004216 -0.00004224 - -0.00004216 0.00011091 -0.00004222 - -0.00004224 -0.00004222 0.00011096 - #*EXTRAS*# Step: 9 Bead: 52 - 0.00011095 -0.00004220 -0.00004227 - -0.00004220 0.00011096 -0.00004225 - -0.00004227 -0.00004225 0.00011102 - #*EXTRAS*# Step: 10 Bead: 52 - 0.00011098 -0.00004222 -0.00004230 - -0.00004222 0.00011099 -0.00004228 - -0.00004230 -0.00004228 0.00011106 - #*EXTRAS*# Step: 11 Bead: 52 - 0.00011101 -0.00004224 -0.00004231 - -0.00004224 0.00011102 -0.00004229 - -0.00004231 -0.00004229 0.00011108 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 deleted file mode 100644 index 215993bc2..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_53 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 53 - 0.00010343 -0.00003495 -0.00003489 - -0.00003495 0.00010341 -0.00003514 - -0.00003489 -0.00003514 0.00010304 - #*EXTRAS*# Step: 1 Bead: 53 - 0.00010610 -0.00003820 -0.00003814 - -0.00003820 0.00010609 -0.00003825 - -0.00003814 -0.00003825 0.00010597 - #*EXTRAS*# Step: 2 Bead: 53 - 0.00010842 -0.00004035 -0.00004037 - -0.00004035 0.00010843 -0.00004036 - -0.00004037 -0.00004036 0.00010847 - #*EXTRAS*# Step: 3 Bead: 53 - 0.00010934 -0.00004108 -0.00004113 - -0.00004108 0.00010936 -0.00004111 - -0.00004113 -0.00004111 0.00010941 - #*EXTRAS*# Step: 4 Bead: 53 - 0.00010995 -0.00004152 -0.00004159 - -0.00004152 0.00010997 -0.00004156 - -0.00004159 -0.00004156 0.00011002 - #*EXTRAS*# Step: 5 Bead: 53 - 0.00011030 -0.00004177 -0.00004184 - -0.00004177 0.00011032 -0.00004182 - -0.00004184 -0.00004182 0.00011037 - #*EXTRAS*# Step: 6 Bead: 53 - 0.00011051 -0.00004191 -0.00004199 - -0.00004191 0.00011054 -0.00004197 - -0.00004199 -0.00004197 0.00011059 - #*EXTRAS*# Step: 7 Bead: 53 - 0.00011065 -0.00004200 -0.00004208 - -0.00004200 0.00011067 -0.00004206 - -0.00004208 -0.00004206 0.00011073 - #*EXTRAS*# Step: 8 Bead: 53 - 0.00011074 -0.00004206 -0.00004214 - -0.00004206 0.00011076 -0.00004212 - -0.00004214 -0.00004212 0.00011081 - #*EXTRAS*# Step: 9 Bead: 53 - 0.00011079 -0.00004210 -0.00004218 - -0.00004210 0.00011081 -0.00004215 - -0.00004218 -0.00004215 0.00011087 - #*EXTRAS*# Step: 10 Bead: 53 - 0.00011083 -0.00004212 -0.00004220 - -0.00004212 0.00011085 -0.00004218 - -0.00004220 -0.00004218 0.00011091 - #*EXTRAS*# Step: 11 Bead: 53 - 0.00011086 -0.00004214 -0.00004222 - -0.00004214 0.00011087 -0.00004219 - -0.00004222 -0.00004219 0.00011093 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 deleted file mode 100644 index c921bcee0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_54 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 54 - 0.00010322 -0.00003464 -0.00003459 - -0.00003464 0.00010320 -0.00003483 - -0.00003459 -0.00003483 0.00010282 - #*EXTRAS*# Step: 1 Bead: 54 - 0.00010588 -0.00003797 -0.00003791 - -0.00003797 0.00010588 -0.00003803 - -0.00003791 -0.00003803 0.00010573 - #*EXTRAS*# Step: 2 Bead: 54 - 0.00010823 -0.00004019 -0.00004020 - -0.00004019 0.00010823 -0.00004019 - -0.00004020 -0.00004019 0.00010827 - #*EXTRAS*# Step: 3 Bead: 54 - 0.00010917 -0.00004095 -0.00004100 - -0.00004095 0.00010919 -0.00004097 - -0.00004100 -0.00004097 0.00010924 - #*EXTRAS*# Step: 4 Bead: 54 - 0.00010979 -0.00004141 -0.00004148 - -0.00004141 0.00010982 -0.00004145 - -0.00004148 -0.00004145 0.00010987 - #*EXTRAS*# Step: 5 Bead: 54 - 0.00011015 -0.00004166 -0.00004174 - -0.00004166 0.00011017 -0.00004171 - -0.00004174 -0.00004171 0.00011023 - #*EXTRAS*# Step: 6 Bead: 54 - 0.00011037 -0.00004181 -0.00004189 - -0.00004181 0.00011039 -0.00004187 - -0.00004189 -0.00004187 0.00011045 - #*EXTRAS*# Step: 7 Bead: 54 - 0.00011051 -0.00004191 -0.00004199 - -0.00004191 0.00011053 -0.00004196 - -0.00004199 -0.00004196 0.00011058 - #*EXTRAS*# Step: 8 Bead: 54 - 0.00011060 -0.00004197 -0.00004205 - -0.00004197 0.00011062 -0.00004202 - -0.00004205 -0.00004202 0.00011067 - #*EXTRAS*# Step: 9 Bead: 54 - 0.00011066 -0.00004201 -0.00004209 - -0.00004201 0.00011068 -0.00004206 - -0.00004209 -0.00004206 0.00011073 - #*EXTRAS*# Step: 10 Bead: 54 - 0.00011069 -0.00004203 -0.00004211 - -0.00004203 0.00011071 -0.00004209 - -0.00004211 -0.00004209 0.00011077 - #*EXTRAS*# Step: 11 Bead: 54 - 0.00011072 -0.00004205 -0.00004213 - -0.00004205 0.00011074 -0.00004210 - -0.00004213 -0.00004210 0.00011079 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 deleted file mode 100644 index bd8a7fc4c..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_55 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 55 - 0.00010303 -0.00003435 -0.00003431 - -0.00003435 0.00010301 -0.00003455 - -0.00003431 -0.00003455 0.00010262 - #*EXTRAS*# Step: 1 Bead: 55 - 0.00010569 -0.00003776 -0.00003770 - -0.00003776 0.00010568 -0.00003784 - -0.00003770 -0.00003784 0.00010551 - #*EXTRAS*# Step: 2 Bead: 55 - 0.00010806 -0.00004004 -0.00004005 - -0.00004004 0.00010806 -0.00004005 - -0.00004005 -0.00004005 0.00010808 - #*EXTRAS*# Step: 3 Bead: 55 - 0.00010902 -0.00004083 -0.00004088 - -0.00004083 0.00010904 -0.00004085 - -0.00004088 -0.00004085 0.00010909 - #*EXTRAS*# Step: 4 Bead: 55 - 0.00010965 -0.00004131 -0.00004137 - -0.00004131 0.00010967 -0.00004134 - -0.00004137 -0.00004134 0.00010972 - #*EXTRAS*# Step: 5 Bead: 55 - 0.00011001 -0.00004157 -0.00004164 - -0.00004157 0.00011004 -0.00004161 - -0.00004164 -0.00004161 0.00011009 - #*EXTRAS*# Step: 6 Bead: 55 - 0.00011024 -0.00004172 -0.00004180 - -0.00004172 0.00011026 -0.00004177 - -0.00004180 -0.00004177 0.00011032 - #*EXTRAS*# Step: 7 Bead: 55 - 0.00011038 -0.00004182 -0.00004190 - -0.00004182 0.00011040 -0.00004187 - -0.00004190 -0.00004187 0.00011046 - #*EXTRAS*# Step: 8 Bead: 55 - 0.00011047 -0.00004188 -0.00004196 - -0.00004188 0.00011049 -0.00004194 - -0.00004196 -0.00004194 0.00011055 - #*EXTRAS*# Step: 9 Bead: 55 - 0.00011053 -0.00004192 -0.00004200 - -0.00004192 0.00011055 -0.00004198 - -0.00004200 -0.00004198 0.00011061 - #*EXTRAS*# Step: 10 Bead: 55 - 0.00011057 -0.00004195 -0.00004203 - -0.00004195 0.00011059 -0.00004200 - -0.00004203 -0.00004200 0.00011065 - #*EXTRAS*# Step: 11 Bead: 55 - 0.00011059 -0.00004197 -0.00004205 - -0.00004197 0.00011062 -0.00004202 - -0.00004205 -0.00004202 0.00011067 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 deleted file mode 100644 index 902b8e476..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_56 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 56 - 0.00010287 -0.00003410 -0.00003406 - -0.00003410 0.00010284 -0.00003429 - -0.00003406 -0.00003429 0.00010245 - #*EXTRAS*# Step: 1 Bead: 56 - 0.00010551 -0.00003757 -0.00003751 - -0.00003757 0.00010551 -0.00003766 - -0.00003751 -0.00003766 0.00010532 - #*EXTRAS*# Step: 2 Bead: 56 - 0.00010790 -0.00003991 -0.00003991 - -0.00003991 0.00010790 -0.00003991 - -0.00003991 -0.00003991 0.00010792 - #*EXTRAS*# Step: 3 Bead: 56 - 0.00010888 -0.00004072 -0.00004076 - -0.00004072 0.00010890 -0.00004074 - -0.00004076 -0.00004074 0.00010895 - #*EXTRAS*# Step: 4 Bead: 56 - 0.00010952 -0.00004121 -0.00004127 - -0.00004121 0.00010955 -0.00004125 - -0.00004127 -0.00004125 0.00010960 - #*EXTRAS*# Step: 5 Bead: 56 - 0.00010989 -0.00004148 -0.00004155 - -0.00004148 0.00010992 -0.00004152 - -0.00004155 -0.00004152 0.00010997 - #*EXTRAS*# Step: 6 Bead: 56 - 0.00011012 -0.00004164 -0.00004172 - -0.00004164 0.00011015 -0.00004169 - -0.00004172 -0.00004169 0.00011020 - #*EXTRAS*# Step: 7 Bead: 56 - 0.00011027 -0.00004174 -0.00004182 - -0.00004174 0.00011029 -0.00004179 - -0.00004182 -0.00004179 0.00011034 - #*EXTRAS*# Step: 8 Bead: 56 - 0.00011036 -0.00004181 -0.00004188 - -0.00004181 0.00011038 -0.00004186 - -0.00004188 -0.00004186 0.00011044 - #*EXTRAS*# Step: 9 Bead: 56 - 0.00011042 -0.00004185 -0.00004193 - -0.00004185 0.00011044 -0.00004190 - -0.00004193 -0.00004190 0.00011050 - #*EXTRAS*# Step: 10 Bead: 56 - 0.00011046 -0.00004188 -0.00004195 - -0.00004188 0.00011048 -0.00004193 - -0.00004195 -0.00004193 0.00011054 - #*EXTRAS*# Step: 11 Bead: 56 - 0.00011048 -0.00004189 -0.00004197 - -0.00004189 0.00011051 -0.00004195 - -0.00004197 -0.00004195 0.00011056 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 deleted file mode 100644 index acc470c7c..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_57 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 57 - 0.00010273 -0.00003387 -0.00003384 - -0.00003387 0.00010269 -0.00003406 - -0.00003384 -0.00003406 0.00010231 - #*EXTRAS*# Step: 1 Bead: 57 - 0.00010536 -0.00003741 -0.00003734 - -0.00003741 0.00010536 -0.00003750 - -0.00003734 -0.00003750 0.00010516 - #*EXTRAS*# Step: 2 Bead: 57 - 0.00010777 -0.00003979 -0.00003979 - -0.00003979 0.00010777 -0.00003979 - -0.00003979 -0.00003979 0.00010778 - #*EXTRAS*# Step: 3 Bead: 57 - 0.00010876 -0.00004063 -0.00004066 - -0.00004063 0.00010878 -0.00004064 - -0.00004066 -0.00004064 0.00010882 - #*EXTRAS*# Step: 4 Bead: 57 - 0.00010941 -0.00004113 -0.00004119 - -0.00004113 0.00010943 -0.00004116 - -0.00004119 -0.00004116 0.00010949 - #*EXTRAS*# Step: 5 Bead: 57 - 0.00010979 -0.00004141 -0.00004147 - -0.00004141 0.00010981 -0.00004145 - -0.00004147 -0.00004145 0.00010986 - #*EXTRAS*# Step: 6 Bead: 57 - 0.00011002 -0.00004157 -0.00004165 - -0.00004157 0.00011005 -0.00004162 - -0.00004165 -0.00004162 0.00011010 - #*EXTRAS*# Step: 7 Bead: 57 - 0.00011017 -0.00004167 -0.00004175 - -0.00004167 0.00011019 -0.00004172 - -0.00004175 -0.00004172 0.00011024 - #*EXTRAS*# Step: 8 Bead: 57 - 0.00011026 -0.00004174 -0.00004182 - -0.00004174 0.00011028 -0.00004179 - -0.00004182 -0.00004179 0.00011034 - #*EXTRAS*# Step: 9 Bead: 57 - 0.00011032 -0.00004178 -0.00004186 - -0.00004178 0.00011035 -0.00004183 - -0.00004186 -0.00004183 0.00011040 - #*EXTRAS*# Step: 10 Bead: 57 - 0.00011036 -0.00004181 -0.00004189 - -0.00004181 0.00011038 -0.00004186 - -0.00004189 -0.00004186 0.00011044 - #*EXTRAS*# Step: 11 Bead: 57 - 0.00011039 -0.00004183 -0.00004191 - -0.00004183 0.00011041 -0.00004188 - -0.00004191 -0.00004188 0.00011046 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 deleted file mode 100644 index 75a01bb8c..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_58 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 58 - 0.00010261 -0.00003368 -0.00003365 - -0.00003368 0.00010257 -0.00003386 - -0.00003365 -0.00003386 0.00010219 - #*EXTRAS*# Step: 1 Bead: 58 - 0.00010524 -0.00003726 -0.00003720 - -0.00003726 0.00010523 -0.00003736 - -0.00003720 -0.00003736 0.00010501 - #*EXTRAS*# Step: 2 Bead: 58 - 0.00010765 -0.00003969 -0.00003968 - -0.00003969 0.00010765 -0.00003969 - -0.00003968 -0.00003969 0.00010766 - #*EXTRAS*# Step: 3 Bead: 58 - 0.00010866 -0.00004055 -0.00004058 - -0.00004055 0.00010867 -0.00004056 - -0.00004058 -0.00004056 0.00010872 - #*EXTRAS*# Step: 4 Bead: 58 - 0.00010932 -0.00004106 -0.00004111 - -0.00004106 0.00010934 -0.00004109 - -0.00004111 -0.00004109 0.00010939 - #*EXTRAS*# Step: 5 Bead: 58 - 0.00010970 -0.00004134 -0.00004141 - -0.00004134 0.00010972 -0.00004138 - -0.00004141 -0.00004138 0.00010977 - #*EXTRAS*# Step: 6 Bead: 58 - 0.00010993 -0.00004151 -0.00004158 - -0.00004151 0.00010996 -0.00004155 - -0.00004158 -0.00004155 0.00011001 - #*EXTRAS*# Step: 7 Bead: 58 - 0.00011008 -0.00004161 -0.00004169 - -0.00004161 0.00011011 -0.00004166 - -0.00004169 -0.00004166 0.00011016 - #*EXTRAS*# Step: 8 Bead: 58 - 0.00011018 -0.00004168 -0.00004176 - -0.00004168 0.00011020 -0.00004173 - -0.00004176 -0.00004173 0.00011025 - #*EXTRAS*# Step: 9 Bead: 58 - 0.00011024 -0.00004172 -0.00004180 - -0.00004172 0.00011026 -0.00004177 - -0.00004180 -0.00004177 0.00011031 - #*EXTRAS*# Step: 10 Bead: 58 - 0.00011028 -0.00004175 -0.00004183 - -0.00004175 0.00011030 -0.00004180 - -0.00004183 -0.00004180 0.00011035 - #*EXTRAS*# Step: 11 Bead: 58 - 0.00011030 -0.00004177 -0.00004185 - -0.00004177 0.00011033 -0.00004182 - -0.00004185 -0.00004182 0.00011038 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 deleted file mode 100644 index f9f4bec45..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_59 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 59 - 0.00010252 -0.00003351 -0.00003348 - -0.00003351 0.00010246 -0.00003369 - -0.00003348 -0.00003369 0.00010209 - #*EXTRAS*# Step: 1 Bead: 59 - 0.00010513 -0.00003714 -0.00003707 - -0.00003714 0.00010513 -0.00003725 - -0.00003707 -0.00003725 0.00010490 - #*EXTRAS*# Step: 2 Bead: 59 - 0.00010755 -0.00003960 -0.00003959 - -0.00003960 0.00010755 -0.00003961 - -0.00003959 -0.00003961 0.00010755 - #*EXTRAS*# Step: 3 Bead: 59 - 0.00010858 -0.00004048 -0.00004050 - -0.00004048 0.00010859 -0.00004049 - -0.00004050 -0.00004049 0.00010863 - #*EXTRAS*# Step: 4 Bead: 59 - 0.00010924 -0.00004100 -0.00004105 - -0.00004100 0.00010926 -0.00004102 - -0.00004105 -0.00004102 0.00010931 - #*EXTRAS*# Step: 5 Bead: 59 - 0.00010962 -0.00004129 -0.00004135 - -0.00004129 0.00010965 -0.00004132 - -0.00004135 -0.00004132 0.00010970 - #*EXTRAS*# Step: 6 Bead: 59 - 0.00010986 -0.00004146 -0.00004153 - -0.00004146 0.00010988 -0.00004150 - -0.00004153 -0.00004150 0.00010994 - #*EXTRAS*# Step: 7 Bead: 59 - 0.00011001 -0.00004156 -0.00004164 - -0.00004156 0.00011003 -0.00004161 - -0.00004164 -0.00004161 0.00011009 - #*EXTRAS*# Step: 8 Bead: 59 - 0.00011010 -0.00004163 -0.00004171 - -0.00004163 0.00011013 -0.00004168 - -0.00004171 -0.00004168 0.00011018 - #*EXTRAS*# Step: 9 Bead: 59 - 0.00011017 -0.00004168 -0.00004175 - -0.00004168 0.00011019 -0.00004172 - -0.00004175 -0.00004172 0.00011024 - #*EXTRAS*# Step: 10 Bead: 59 - 0.00011021 -0.00004170 -0.00004178 - -0.00004170 0.00011023 -0.00004175 - -0.00004178 -0.00004175 0.00011029 - #*EXTRAS*# Step: 11 Bead: 59 - 0.00011023 -0.00004172 -0.00004180 - -0.00004172 0.00011026 -0.00004177 - -0.00004180 -0.00004177 0.00011031 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 deleted file mode 100644 index 0491723b4..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_60 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 60 - 0.00010243 -0.00003337 -0.00003335 - -0.00003337 0.00010238 -0.00003355 - -0.00003335 -0.00003355 0.00010201 - #*EXTRAS*# Step: 1 Bead: 60 - 0.00010504 -0.00003704 -0.00003697 - -0.00003704 0.00010504 -0.00003715 - -0.00003697 -0.00003715 0.00010480 - #*EXTRAS*# Step: 2 Bead: 60 - 0.00010748 -0.00003953 -0.00003952 - -0.00003953 0.00010747 -0.00003954 - -0.00003952 -0.00003954 0.00010747 - #*EXTRAS*# Step: 3 Bead: 60 - 0.00010851 -0.00004042 -0.00004045 - -0.00004042 0.00010852 -0.00004043 - -0.00004045 -0.00004043 0.00010856 - #*EXTRAS*# Step: 4 Bead: 60 - 0.00010917 -0.00004095 -0.00004100 - -0.00004095 0.00010919 -0.00004097 - -0.00004100 -0.00004097 0.00010924 - #*EXTRAS*# Step: 5 Bead: 60 - 0.00010956 -0.00004124 -0.00004130 - -0.00004124 0.00010958 -0.00004127 - -0.00004130 -0.00004127 0.00010964 - #*EXTRAS*# Step: 6 Bead: 60 - 0.00010980 -0.00004142 -0.00004148 - -0.00004142 0.00010983 -0.00004146 - -0.00004148 -0.00004146 0.00010988 - #*EXTRAS*# Step: 7 Bead: 60 - 0.00010995 -0.00004152 -0.00004159 - -0.00004152 0.00010998 -0.00004157 - -0.00004159 -0.00004157 0.00011003 - #*EXTRAS*# Step: 8 Bead: 60 - 0.00011005 -0.00004159 -0.00004166 - -0.00004159 0.00011007 -0.00004164 - -0.00004166 -0.00004164 0.00011012 - #*EXTRAS*# Step: 9 Bead: 60 - 0.00011011 -0.00004164 -0.00004171 - -0.00004164 0.00011014 -0.00004168 - -0.00004171 -0.00004168 0.00011019 - #*EXTRAS*# Step: 10 Bead: 60 - 0.00011015 -0.00004166 -0.00004174 - -0.00004166 0.00011018 -0.00004171 - -0.00004174 -0.00004171 0.00011023 - #*EXTRAS*# Step: 11 Bead: 60 - 0.00011018 -0.00004168 -0.00004176 - -0.00004168 0.00011020 -0.00004173 - -0.00004176 -0.00004173 0.00011026 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 deleted file mode 100644 index 1f23cd1a4..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_61 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 61 - 0.00010237 -0.00003327 -0.00003325 - -0.00003327 0.00010231 -0.00003345 - -0.00003325 -0.00003345 0.00010195 - #*EXTRAS*# Step: 1 Bead: 61 - 0.00010498 -0.00003696 -0.00003690 - -0.00003696 0.00010498 -0.00003708 - -0.00003690 -0.00003708 0.00010473 - #*EXTRAS*# Step: 2 Bead: 61 - 0.00010742 -0.00003948 -0.00003947 - -0.00003948 0.00010742 -0.00003949 - -0.00003947 -0.00003949 0.00010741 - #*EXTRAS*# Step: 3 Bead: 61 - 0.00010846 -0.00004038 -0.00004040 - -0.00004038 0.00010846 -0.00004039 - -0.00004040 -0.00004039 0.00010850 - #*EXTRAS*# Step: 4 Bead: 61 - 0.00010913 -0.00004091 -0.00004096 - -0.00004091 0.00010915 -0.00004094 - -0.00004096 -0.00004094 0.00010919 - #*EXTRAS*# Step: 5 Bead: 61 - 0.00010952 -0.00004121 -0.00004127 - -0.00004121 0.00010954 -0.00004124 - -0.00004127 -0.00004124 0.00010959 - #*EXTRAS*# Step: 6 Bead: 61 - 0.00010976 -0.00004138 -0.00004145 - -0.00004138 0.00010978 -0.00004142 - -0.00004145 -0.00004142 0.00010983 - #*EXTRAS*# Step: 7 Bead: 61 - 0.00010991 -0.00004149 -0.00004156 - -0.00004149 0.00010993 -0.00004154 - -0.00004156 -0.00004154 0.00010998 - #*EXTRAS*# Step: 8 Bead: 61 - 0.00011000 -0.00004156 -0.00004163 - -0.00004156 0.00011003 -0.00004161 - -0.00004163 -0.00004161 0.00011008 - #*EXTRAS*# Step: 9 Bead: 61 - 0.00011007 -0.00004161 -0.00004168 - -0.00004161 0.00011009 -0.00004165 - -0.00004168 -0.00004165 0.00011015 - #*EXTRAS*# Step: 10 Bead: 61 - 0.00011011 -0.00004164 -0.00004171 - -0.00004164 0.00011013 -0.00004168 - -0.00004171 -0.00004168 0.00011019 - #*EXTRAS*# Step: 11 Bead: 61 - 0.00011014 -0.00004165 -0.00004173 - -0.00004165 0.00011016 -0.00004170 - -0.00004173 -0.00004170 0.00011021 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 deleted file mode 100644 index 2bbd529cc..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_62 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 62 - 0.00010233 -0.00003319 -0.00003317 - -0.00003319 0.00010227 -0.00003337 - -0.00003317 -0.00003337 0.00010191 - #*EXTRAS*# Step: 1 Bead: 62 - 0.00010493 -0.00003691 -0.00003684 - -0.00003691 0.00010493 -0.00003703 - -0.00003684 -0.00003703 0.00010468 - #*EXTRAS*# Step: 2 Bead: 62 - 0.00010738 -0.00003944 -0.00003943 - -0.00003944 0.00010738 -0.00003945 - -0.00003943 -0.00003945 0.00010737 - #*EXTRAS*# Step: 3 Bead: 62 - 0.00010842 -0.00004035 -0.00004037 - -0.00004035 0.00010843 -0.00004036 - -0.00004037 -0.00004036 0.00010847 - #*EXTRAS*# Step: 4 Bead: 62 - 0.00010910 -0.00004089 -0.00004094 - -0.00004089 0.00010911 -0.00004091 - -0.00004094 -0.00004091 0.00010916 - #*EXTRAS*# Step: 5 Bead: 62 - 0.00010949 -0.00004118 -0.00004124 - -0.00004118 0.00010951 -0.00004122 - -0.00004124 -0.00004122 0.00010956 - #*EXTRAS*# Step: 6 Bead: 62 - 0.00010973 -0.00004136 -0.00004143 - -0.00004136 0.00010975 -0.00004140 - -0.00004143 -0.00004140 0.00010980 - #*EXTRAS*# Step: 7 Bead: 62 - 0.00010988 -0.00004147 -0.00004154 - -0.00004147 0.00010990 -0.00004151 - -0.00004154 -0.00004151 0.00010996 - #*EXTRAS*# Step: 8 Bead: 62 - 0.00010998 -0.00004154 -0.00004161 - -0.00004154 0.00011000 -0.00004159 - -0.00004161 -0.00004159 0.00011005 - #*EXTRAS*# Step: 9 Bead: 62 - 0.00011004 -0.00004159 -0.00004166 - -0.00004159 0.00011007 -0.00004163 - -0.00004166 -0.00004163 0.00011012 - #*EXTRAS*# Step: 10 Bead: 62 - 0.00011008 -0.00004162 -0.00004169 - -0.00004162 0.00011011 -0.00004166 - -0.00004169 -0.00004166 0.00011016 - #*EXTRAS*# Step: 11 Bead: 62 - 0.00011011 -0.00004164 -0.00004171 - -0.00004164 0.00011013 -0.00004168 - -0.00004171 -0.00004168 0.00011019 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 deleted file mode 100644 index 77fd0ce26..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.fric_63 +++ /dev/null @@ -1,48 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 63 - 0.00010230 -0.00003314 -0.00003313 - -0.00003314 0.00010224 -0.00003332 - -0.00003313 -0.00003332 0.00010188 - #*EXTRAS*# Step: 1 Bead: 63 - 0.00010491 -0.00003688 -0.00003681 - -0.00003688 0.00010491 -0.00003700 - -0.00003681 -0.00003700 0.00010465 - #*EXTRAS*# Step: 2 Bead: 63 - 0.00010736 -0.00003943 -0.00003941 - -0.00003943 0.00010736 -0.00003944 - -0.00003941 -0.00003944 0.00010734 - #*EXTRAS*# Step: 3 Bead: 63 - 0.00010840 -0.00004034 -0.00004036 - -0.00004034 0.00010841 -0.00004034 - -0.00004036 -0.00004034 0.00010845 - #*EXTRAS*# Step: 4 Bead: 63 - 0.00010908 -0.00004088 -0.00004092 - -0.00004088 0.00010910 -0.00004090 - -0.00004092 -0.00004090 0.00010915 - #*EXTRAS*# Step: 5 Bead: 63 - 0.00010947 -0.00004117 -0.00004123 - -0.00004117 0.00010949 -0.00004120 - -0.00004123 -0.00004120 0.00010954 - #*EXTRAS*# Step: 6 Bead: 63 - 0.00010971 -0.00004135 -0.00004142 - -0.00004135 0.00010974 -0.00004139 - -0.00004142 -0.00004139 0.00010979 - #*EXTRAS*# Step: 7 Bead: 63 - 0.00010986 -0.00004146 -0.00004153 - -0.00004146 0.00010989 -0.00004150 - -0.00004153 -0.00004150 0.00010994 - #*EXTRAS*# Step: 8 Bead: 63 - 0.00010996 -0.00004153 -0.00004160 - -0.00004153 0.00010999 -0.00004158 - -0.00004160 -0.00004158 0.00011004 - #*EXTRAS*# Step: 9 Bead: 63 - 0.00011003 -0.00004158 -0.00004165 - -0.00004158 0.00011005 -0.00004162 - -0.00004165 -0.00004162 0.00011010 - #*EXTRAS*# Step: 10 Bead: 63 - 0.00011007 -0.00004161 -0.00004168 - -0.00004161 0.00011009 -0.00004165 - -0.00004168 -0.00004165 0.00011014 - #*EXTRAS*# Step: 11 Bead: 63 - 0.00011010 -0.00004163 -0.00004170 - -0.00004163 0.00011012 -0.00004167 - -0.00004170 -0.00004167 0.00011017 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 deleted file mode 100644 index ca2a04ca5..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ --1.790762173407876596e-03 1.605996708104646693e-04 1.595916396470224664e-04 -1.865952984358739200e-03 1.599634670600206773e-04 1.587470278452119386e-04 -1.994572598333122209e-03 1.587706057530746261e-04 1.572060344017630262e-04 -2.175467384291874737e-03 1.570356441542739240e-04 1.549787358663584137e-04 -2.406717299867169781e-03 1.547767297439942057e-04 1.520812623441293945e-04 -2.685661674185229990e-03 1.519652560665271668e-04 1.485439278503754745e-04 -3.009095499643968819e-03 1.485747572264602503e-04 1.444006059991063777e-04 -3.373238898267761146e-03 1.445920890004210202e-04 1.396855421153240010e-04 -3.773719163610178822e-03 1.400027559321057491e-04 1.344349109612397717e-04 -4.205531464273506992e-03 1.347914585320797009e-04 1.286857972704309001e-04 -4.662929502800216078e-03 1.289434222723618141e-04 1.224757707829939447e-04 -5.139540688331577234e-03 1.224450957239504108e-04 1.158410834817677948e-04 -5.628463992118844759e-03 1.152851100242362545e-04 1.088152659529708624e-04 -6.122312297430441801e-03 1.074559531693518717e-04 1.014285701502294293e-04 -6.613072053176566670e-03 9.895838841287254062e-05 9.370980670402189491e-05 -7.092146248172816192e-03 8.980668421959980168e-05 8.568830320195296212e-05 -7.550723985622619615e-03 8.003180714547837712e-05 7.739452396395819723e-05 -7.982599710937045290e-03 6.968833021344260955e-05 6.886461790645049023e-05 -8.389082199238027948e-03 5.886629397722456416e-05 6.014902991958995444e-05 -8.778758742441241519e-03 4.801696343188001256e-05 5.140830347323791948e-05 -9.155907795781735234e-03 3.860795411460528690e-05 4.313150821412856757e-05 -9.516685965926779955e-03 3.087543721385691383e-05 3.552617297838205047e-05 -9.857053399566929192e-03 2.482555356826129196e-05 2.873422449340736008e-05 -1.017295518607843480e-02 2.037493864570317440e-05 2.286090969003024516e-05 -1.045919393358357360e-02 1.734130615999967452e-05 1.796271961534478612e-05 -1.068976105282406185e-02 1.480214502866266986e-05 1.390997041516032444e-05 -1.084845349531760386e-02 1.198392136869672118e-05 1.053915700988434733e-05 -1.093160112608608688e-02 9.186868665706770455e-06 7.880499124445369900e-06 -1.093546640215261288e-02 6.762628071574709450e-06 5.975803840689837166e-06 -1.085830535054584794e-02 5.099997747754664706e-06 4.875650107791152627e-06 -1.071058020571687662e-02 4.639594924859498120e-06 4.637485225435656302e-06 -1.053231173536757492e-02 5.437001916182493629e-06 5.259025246760167451e-06 -1.033063190062910933e-02 7.231322209186677700e-06 6.674833131379043045e-06 -1.010656385562406362e-02 9.737608861080378781e-06 8.795576305930843502e-06 -9.861443622532859582e-03 1.266342784300513477e-05 1.151588164992699536e-05 -9.596821746567394881e-03 1.572424795354245084e-05 1.472305346666804650e-05 -9.311051924263985535e-03 1.890045096812509209e-05 1.832003065196420328e-05 -8.992328451482839782e-03 2.233710636174199120e-05 2.222121207259048246e-05 -8.632373655985249236e-03 2.600890513402304979e-05 2.633397970751588877e-05 -8.230608385642336142e-03 2.988780488961053521e-05 3.057253088478920490e-05 -7.791701296678669314e-03 3.394480600009372630e-05 3.486047680355928996e-05 -7.320877460381595633e-03 3.814993308439641371e-05 3.913091776052559587e-05 -6.823768575359857001e-03 4.246658856763628844e-05 4.333434776334996609e-05 -6.312173212824001393e-03 4.679857762976839987e-05 4.750383697911697052e-05 -5.802943216707425085e-03 5.108832858723529106e-05 5.162245578004016216e-05 -5.308674577987209514e-03 5.529747604706746405e-05 5.565524907735003508e-05 -4.838216588861554354e-03 5.939162468818634603e-05 5.957060411701156345e-05 -4.397573686602709690e-03 6.334046150710285149e-05 6.334048385287951554e-05 -3.989615775878550819e-03 6.711884816969423148e-05 6.694151489467973061e-05 -3.613696003885667404e-03 7.070614318361829272e-05 7.035448691266677282e-05 -3.268663445671344224e-03 7.408543489853747699e-05 7.356374611135706437e-05 -2.953405177046155173e-03 7.724337545513171213e-05 7.655709394487028076e-05 -2.666785569923133502e-03 8.017018540896247492e-05 7.932580653638889436e-05 -2.407675360174985069e-03 8.285915596542620294e-05 8.186418405742385755e-05 -2.175015995982612117e-03 8.530522510526870525e-05 8.416897844124702111e-05 -1.967813790605789717e-03 8.748897019788161452e-05 8.624133307690208137e-05 -1.785105955680670823e-03 8.940776741226141606e-05 8.808311909062810959e-05 -1.626048918521727808e-03 9.106929472288936844e-05 8.969550369193561427e-05 -1.489925578307425185e-03 9.248106921719925777e-05 9.107967001656994924e-05 -1.376132238663086219e-03 9.365013635479569947e-05 9.223673149919608461e-05 -1.284164425000997468e-03 9.458284401899358102e-05 9.316770162922415944e-05 -1.213612301108031935e-03 9.528464250431165387e-05 9.387345821614870008e-05 -1.164165089509900568e-03 9.575990791656120314e-05 9.435469397061122627e-05 -1.135580283876044599e-03 9.601195545944826704e-05 9.461203550353332195e-05 2.917903169062088044e-13 5.511521614660179758e-01 3.762236597462519431e-10 2.957856523887286367e-13 5.511521614684432580e-01 3.785114476734373942e-10 3.012790611229457929e-13 5.511521614716138329e-01 3.814146774464362102e-10 3.079887321215927070e-13 5.511521614751169196e-01 3.845291608903082408e-10 3.154646124472693945e-13 5.511521614783438938e-01 3.872607528579846991e-10 3.237340729534500045e-13 5.511521614812954217e-01 3.896325427734285649e-10 3.327642027980257029e-13 5.511521614839027805e-01 3.916034197826572668e-10 3.422785857222165250e-13 5.511521614858165830e-01 3.928570373010328319e-10 3.519395728199752597e-13 5.511521614866456975e-01 3.930394183234752154e-10 3.613406266158588660e-13 5.511521614859632434e-01 3.917639836607266749e-10 3.699849808081311154e-13 5.511521614833087002e-01 3.886123443983367585e-10 3.773033644962079921e-13 5.511521614782124434e-01 3.831558232240210059e-10 3.826811513409983586e-13 5.511521614702247218e-01 3.749812955030002183e-10 3.854875568059762506e-13 5.511521614589453000e-01 3.637166114893790760e-10 3.850580275988814748e-13 5.511521614440334504e-01 3.490362131117335107e-10 3.807024236075795410e-13 5.511521614252311574e-01 3.306798275607005259e-10 3.718268158288078532e-13 5.511521614024329496e-01 3.085178360856541414e-10 3.593709730154878086e-13 5.511521613768211036e-01 2.836693740542055867e-10 3.499966691197678774e-13 5.511521613537336828e-01 2.613482412458561146e-10 3.552895784918116902e-13 5.511521613407461828e-01 2.490087128754098251e-10 3.662886436740215341e-13 5.511521613293756117e-01 2.382204380396184745e-10 3.851374197344128210e-13 5.511521613191717739e-01 2.284988702250335225e-10 4.209148213379204003e-13 5.511521613121628249e-01 2.218428492478117728e-10 4.960568229338628674e-13 5.511521613124187313e-01 2.223077886449103002e-10 6.787299110193688439e-13 5.511521613284796617e-01 2.384193930938614710e-10 1.299662818891701278e-12 5.511521613860900226e-01 2.958536120146215118e-10 2.497686512579768927e-11 5.511521626327681167e-01 1.538306107400407574e-09 -2.571026561102797369e-13 5.511521611352059313e-01 4.563208164190086108e-11 -1.289061491509387892e-14 5.511521610966300111e-01 7.204039665178186534e-12 -4.068022567755670722e-15 5.511521610946271688e-01 5.204191130155853619e-12 -4.701871804353251686e-16 5.511521610909093649e-01 1.505792504171232336e-12 -1.218461742793128835e-18 5.511521610894231094e-01 3.187802854807988938e-14 9.318285259121748696e-17 5.511521610900386170e-01 6.518978386080218023e-13 8.522084109704415865e-16 5.511521610925173009e-01 3.131832285555420460e-12 2.728653096768182918e-15 5.511521610967710094e-01 7.389834803728156104e-12 5.943731731812185206e-15 5.511521611027214718e-01 1.335369331516320988e-11 1.120859017714450194e-14 5.511521611114884589e-01 2.214923663479915020e-11 1.943108419359773055e-14 5.511521611242313767e-01 3.493976196307410421e-11 3.064367916407166726e-14 5.511521611404694987e-01 5.124041713116720969e-11 4.467173015948575559e-14 5.511521611596652548e-01 7.050365023416428727e-11 6.136648730967301820e-14 5.511521611815077826e-01 9.240648013159238102e-11 8.049214250213229299e-14 5.511521612056466957e-01 1.165875134921801809e-10 1.013231125575992112e-13 5.511521612311072182e-01 1.420632540469662323e-10 1.193756286162059827e-13 5.511521612519036939e-01 1.628384302517587930e-10 1.338852177565731384e-13 5.511521612675374104e-01 1.784256163430550392e-10 1.454708021526184375e-13 5.511521612792381619e-01 1.900674107267893595e-10 1.548123255291868056e-13 5.511521612881321586e-01 1.988986129559824627e-10 1.625688037630611931e-13 5.511521612951898463e-01 2.058950093770817486e-10 1.692076761866166035e-13 5.511521613010689213e-01 2.117167153453242961e-10 1.748388341017253284e-13 5.511521613059403579e-01 2.165356048070802835e-10 1.795291671286952711e-13 5.511521613099008565e-01 2.204490575784933533e-10 1.833601478043232285e-13 5.511521613130522246e-01 2.235590832465329311e-10 1.864136284131981866e-13 5.511521613154918287e-01 2.259630422445095734e-10 1.887691568753339069e-13 5.511521613173105960e-01 2.277521299509455696e-10 1.905119289545006617e-13 5.511521613186008972e-01 2.290192997072288420e-10 1.918278436039366542e-13 5.511521613195713432e-01 2.299737036142419700e-10 1.927974500070088851e-13 5.511521613203026471e-01 2.306960099813668255e-10 1.934416107933002934e-13 5.511521613208049120e-01 2.311954234080971175e-10 1.937845150475534032e-13 5.511521613210934589e-01 2.314857582850626343e-10 1.938509534173833018e-13 5.511521613211857185e-01 2.315828712320134599e-10 1.936636987108705143e-13 5.511521613210987880e-01 2.315023177842070176e-10 1.932424632218286303e-13 5.511521613208482107e-01 2.312581544388908067e-10 1.926043305817225132e-13 5.511521613204476422e-01 2.308628156874353704e-10 1.917597370821630045e-13 5.511521613199058534e-01 2.303242326023405397e-10 2.914770098097496775e-13 3.762236597462519431e-10 5.511521614652096224e-01 2.953627542668251830e-13 3.785114476734373942e-10 5.511521614673602354e-01 3.006412285111191367e-13 3.814146774464362102e-10 5.511521614699971261e-01 3.070322424798602194e-13 3.845291608903082408e-10 5.511521614727249441e-01 3.140912787876028295e-13 3.872607528579846991e-10 5.511521614749648190e-01 3.218564330041569143e-13 3.896325427734285649e-10 5.511521614767626032e-01 3.303100961669066259e-13 3.916034197826572668e-10 5.511521614781053069e-01 3.391965172488887947e-13 3.928570373010328319e-10 5.511521614787094903e-01 3.482041837493549591e-13 3.930394183234752154e-10 5.511521614782577405e-01 3.569585325262896888e-13 3.917639836607266749e-10 5.511521614764028909e-01 3.650008807196300206e-13 3.886123443983367585e-10 5.511521614727672436e-01 3.718044249731046856e-13 3.831558232240210059e-10 5.511521614669615543e-01 3.767992327422659656e-13 3.749812955030002183e-10 5.511521614586076812e-01 3.793970779048742926e-13 3.637166114893790760e-10 5.511521614473600117e-01 3.789697725684088057e-13 3.490362131117335107e-10 5.511521614329074614e-01 3.748515438003003418e-13 3.306798275607005259e-10 5.511521614149876847e-01 3.664518059791819068e-13 3.085178360856541414e-10 5.511521613934479147e-01 3.546676469407251613e-13 2.836693740542055867e-10 5.511521613693466382e-01 3.460305506348096790e-13 2.613482412458561146e-10 5.511521613477765591e-01 3.519713947314324399e-13 2.490087128754098251e-10 5.511521613360730321e-01 3.635943018199743826e-13 2.382204380396184745e-10 5.511521613258580921e-01 3.829869362194525848e-13 2.284988702250335225e-10 5.511521613166129319e-01 4.191574141576137796e-13 2.218428492478117728e-10 5.511521613103065320e-01 4.944530953595475109e-13 2.223077886449103002e-10 5.511521613109789941e-01 6.768270429300947446e-13 2.384193930938614710e-10 5.511521613271408437e-01 1.295954793830916163e-12 2.958536120146215118e-10 5.511521613843994860e-01 2.489478166074976138e-11 1.538306107400407574e-09 5.511521626226405512e-01 -2.560706813505254947e-13 4.563208164190086108e-11 5.511521611348387806e-01 -1.282632654918462956e-14 7.204039665178186534e-12 5.511521610965580686e-01 -4.042313720325914064e-15 5.204191130155853619e-12 5.511521610945612215e-01 -4.659692242885138246e-16 1.505792504171232336e-12 5.511521610908821645e-01 -1.168849800890052429e-18 3.187802854807988938e-14 5.511521610894205558e-01 9.364667811185155955e-17 6.518978386080218023e-13 5.511521610900450563e-01 8.534326518830655716e-16 3.131832285555420460e-12 5.511521610925262937e-01 2.731858101855840766e-15 7.389834803728156104e-12 5.511521610967884399e-01 5.953566132290205333e-15 1.335369331516320988e-11 5.511521611027657697e-01 1.123426011102706971e-14 2.214923663479915020e-11 5.511521611115899333e-01 1.948591090213573537e-14 3.493976196307410421e-11 5.511521611244282193e-01 3.074018416988690272e-14 5.124041713116720969e-11 5.511521611407916854e-01 4.481685206580395314e-14 7.050365023416428727e-11 5.511521611601225556e-01 6.155878571499652915e-14 9.240648013159238102e-11 5.511521611820859867e-01 8.072109447938792039e-14 1.165875134921801809e-10 5.511521612063090547e-01 1.015704886568069310e-13 1.420632540469662323e-10 5.511521612317999974e-01 1.196140930770360122e-13 1.628384302517587930e-10 5.511521612525536185e-01 1.340942223753508955e-13 1.784256163430550392e-10 5.511521612680940763e-01 1.456387485432831504e-13 1.900674107267893595e-10 5.511521612796767000e-01 1.549341673964346293e-13 1.988986129559824627e-10 5.511521612884450194e-01 1.626439234548387534e-13 2.058950093770817486e-10 5.511521612953800275e-01 1.692377553196744847e-13 2.117167153453242961e-10 5.511521613011443055e-01 1.748268916381843161e-13 2.165356048070802835e-10 5.511521613059107150e-01 1.794788210213369962e-13 2.204490575784933533e-10 5.511521613097771777e-01 1.832755029612072646e-13 2.235590832465329311e-10 5.511521613128458341e-01 1.862991198612206671e-13 2.259630422445095734e-10 5.511521613152141619e-01 1.886295781008394587e-13 2.277521299509455696e-10 5.511521613169736433e-01 1.903525832588072012e-13 2.290192997072288420e-10 5.511521613182176482e-01 1.916546949250127911e-13 2.299737036142419700e-10 5.511521613191560087e-01 1.926164735276632674e-13 2.306960099813668255e-10 5.511521613198693270e-01 1.932580301655525106e-13 2.311954234080971175e-10 5.511521613203659298e-01 1.936023658377226721e-13 2.314857582850626343e-10 5.511521613206581405e-01 1.936729103326485733e-13 2.315828712320134599e-10 5.511521613207600589e-01 1.934910851295204005e-13 2.315023177842070176e-10 5.511521613206858961e-01 1.930753831788128060e-13 2.312581544388908067e-10 5.511521613204480863e-01 1.924418794948273105e-13 2.308628156874353704e-10 5.511521613200579539e-01 1.916002651525291040e-13 2.303242326023405397e-10 5.511521613195226044e-01 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 deleted file mode 100644 index f3ba6c3dd..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton.hess_10 +++ /dev/null @@ -1 +0,0 @@ --9.134585674756787524e-03 1.605996697703740211e-04 1.595916386145714320e-04 -9.144532982844077312e-03 1.599634660174528169e-04 1.587470268104653230e-04 -9.164342846567859885e-03 1.587706047093321682e-04 1.572060333661626284e-04 -9.193846310522167317e-03 1.570356431110901283e-04 1.549787348317591140e-04 -9.232791522661456390e-03 1.547767287037380270e-04 1.520812613130185966e-04 -9.280845626512433319e-03 1.519652550314838321e-04 1.485439268251339780e-04 -9.337597305892307575e-03 1.485747561989581109e-04 1.444006049821049804e-04 -9.402559959871078024e-03 1.445920879831169949e-04 1.396855411092674077e-04 -9.475175508921617265e-03 1.400027549280998429e-04 1.344349099691424169e-04 -9.554818835432788565e-03 1.347914575449034042e-04 1.286857962957567013e-04 -9.640802849380540260e-03 1.289434213060983137e-04 1.224757698296349438e-04 -9.732384165960216230e-03 1.224450947832014401e-04 1.158410825541208788e-04 -9.828769377779456376e-03 1.152851091141699613e-04 1.088152650559172586e-04 -9.929121895779305720e-03 1.074559522953622161e-04 1.014285692888477439e-04 -1.003256932601343139e-02 9.895838758027230295e-05 9.370980588325678105e-05 -1.013821133741583946e-02 8.980668343309010967e-05 8.568830242619467964e-05 -1.024512796672480061e-02 8.003180640836042310e-05 7.739452323621849714e-05 -1.035238829816895190e-02 6.968832952575748478e-05 6.886461722659471460e-05 -1.045821809045083435e-02 5.886629333037813683e-05 6.014902927905128660e-05 -1.055758734344286638e-02 4.801696280467194925e-05 5.140830285104853992e-05 -1.064853224472725977e-02 3.860795349979551588e-05 4.313150760319287453e-05 -1.072961158330703463e-02 3.087543660206195669e-05 3.552617236955072608e-05 -1.079946386909111725e-02 2.482555293997900790e-05 2.873422386744954111e-05 -1.085682402640415593e-02 2.037493795734258829e-05 2.286090900373599592e-05 -1.090053913910639383e-02 1.734130530100820431e-05 1.796271875868967334e-05 -1.092958286660121285e-02 1.480214354598296480e-05 1.390996893669586021e-05 -1.094306882098045747e-02 1.198389572245599350e-05 1.053913144792366896e-05 -1.094026230323302817e-02 9.186869631838545392e-06 7.880500086016272216e-06 -1.092058966944080105e-02 6.762628077373690130e-06 5.975803846457316691e-06 -1.088364586240226847e-02 5.099997747322703314e-06 4.875650107391955316e-06 -1.082919936765017882e-02 4.639594928384924632e-06 4.637485229135868911e-06 -1.075937296322886441e-02 5.437001804225335302e-06 5.259025121501226591e-06 -1.068338152818447059e-02 7.231322190195440928e-06 6.674833112169900272e-06 -1.060247603834036864e-02 9.737608830191536813e-06 8.795576274982602502e-06 -1.051691657052899499e-02 1.266342782034454026e-05 1.151588162709417364e-05 -1.042701574244117406e-02 1.572424791643158267e-05 1.472305342930445589e-05 -1.033313207784622434e-02 1.890045091165988361e-05 1.832003059515666812e-05 -1.023566697414743723e-02 2.233710627915953822e-05 2.222121198951196295e-05 -1.013506130957510590e-02 2.600890501813623711e-05 2.633397959095025372e-05 -1.003179183592989646e-02 2.988780473355668495e-05 3.057253072787688674e-05 -9.926367196984716909e-03 3.394480579773957453e-05 3.486047660017605414e-05 -9.819323673323023666e-03 3.814993283058235409e-05 3.913091750553747406e-05 -9.711220708661625484e-03 4.246658825885934508e-05 4.333434745331461637e-05 -9.602636274378540185e-03 4.679857727069864487e-05 4.750383661883215015e-05 -9.494162111248634003e-03 5.108832818476109452e-05 5.162245537644658786e-05 -9.386398925789738931e-03 5.529747560776130018e-05 5.565524863711876892e-05 -9.279948067703644443e-03 5.939162421809424791e-05 5.957060364620464407e-05 -9.173100131361088677e-03 6.334046101163236556e-05 6.334048335694134545e-05 -9.064822689088310875e-03 6.711884765364202401e-05 6.694151437841268848e-05 -8.956325924974565048e-03 7.070614265113855208e-05 7.035448638023209433e-05 -8.848803997371163660e-03 7.408543435322276129e-05 7.356374556631735655e-05 -8.743423879258227158e-03 7.724337490001736734e-05 7.655709339023917843e-05 -8.641314747217070102e-03 8.017018484658000469e-05 7.932580597467117558e-05 -8.543557981316908176e-03 8.285915539783338232e-05 8.186418349067851711e-05 -8.451177838363873804e-03 8.530522453417113335e-05 8.416897787112252065e-05 -8.365132843959378894e-03 8.748896962446158670e-05 8.624133250456588980e-05 -8.286307950334909425e-03 8.940776683740736823e-05 8.808311851692895392e-05 -8.215507466022148320e-03 9.106929414731420420e-05 8.969550311757711460e-05 -8.153448778697386726e-03 9.248106864149548004e-05 9.107966944211040193e-05 -8.100756879468703348e-03 9.365013577946037430e-05 9.223673092514861544e-05 -8.057959686418742981e-03 9.458284344440486457e-05 9.316770105594586395e-05 -8.025484163255441547e-03 9.528464193080743775e-05 9.387345764397551830e-05 -8.003653226428590617e-03 9.575990734438512113e-05 9.435469339977519104e-05 -7.992683433764509113e-03 9.601195488887822726e-05 9.461203493429742005e-05 -7.483003202404360143e-13 5.511521630592635113e-01 1.950433492338031679e-09 -7.467822336432144076e-13 5.511521630528296578e-01 1.943887612175451405e-09 -7.424633965591639142e-13 5.511521630366444935e-01 1.927504806754901734e-09 -7.351950197119874141e-13 5.511521630105943315e-01 1.901194709446427386e-09 -7.247915545355249730e-13 5.511521629745177453e-01 1.864828782379255170e-09 -7.113092410027872709e-13 5.511521629290222490e-01 1.819057495629983268e-09 -6.947379486093860546e-13 5.511521628746913759e-01 1.764514895794754439e-09 -6.750254592903715136e-13 5.511521628119100402e-01 1.701641827540130308e-09 -6.520663099606242417e-13 5.511521627411013480e-01 1.630919481476733441e-09 -6.258356526432894739e-13 5.511521626627149395e-01 1.552855364155636037e-09 -5.962784819267787314e-13 5.511521625772056732e-01 1.467955904721621694e-09 -5.634456159170440122e-13 5.511521624850478362e-01 1.376737200805610928e-09 -5.273851652511155482e-13 5.511521623867956521e-01 1.279777767621318787e-09 -4.885020879868745322e-13 5.511521622835908740e-01 1.178210518165897854e-09 -4.475422262987236969e-13 5.511521621774148061e-01 1.073966533697004767e-09 -4.058072887769604884e-13 5.511521620712674929e-01 9.699557672950329612e-10 -3.652911426235096115e-13 5.511521619697711261e-01 8.706753201224190841e-10 -3.283141682074856635e-13 5.511521618782208032e-01 7.812740225656417570e-10 -2.968497573266147482e-13 5.511521618009173062e-01 7.058926315170208715e-10 -2.719184910912001884e-13 5.511521617399753881e-01 6.465125841978830745e-10 -2.485211218605026062e-13 5.511521616831341897e-01 5.909166394908877933e-10 -2.266575438936469122e-13 5.511521616303285409e-01 5.390139672353974600e-10 -2.073674646553466954e-13 5.511521615841503685e-01 4.934041156686709911e-10 -1.923037611453043131e-13 5.511521615487129377e-01 4.582401107553448210e-10 -1.802615593085004876e-13 5.511521615215272396e-01 4.310956822094511443e-10 -1.830168869410507323e-13 5.511521615316815614e-01 4.410601460370881875e-10 -6.693756002553272955e-13 5.511521627331743556e-01 1.638346781416880319e-09 7.090291198329738528e-13 5.511521592931275526e-01 -1.787309851468304170e-09 -7.091634614254713780e-15 5.511521611085256067e-01 1.902474022695203447e-11 -4.499983764801206577e-15 5.511521611036604984e-01 1.412081182063033575e-11 3.055240393526796985e-15 5.511521610624007250e-01 -2.863978515047060873e-11 -1.119583768356680608e-13 5.511521611469352155e-01 6.437404641550518016e-11 -1.889805490473001018e-14 5.511521611152149225e-01 2.612309231072588059e-11 -3.003663296094454200e-14 5.511521611377221408e-01 4.842590719892837176e-11 -1.993194251456543679e-14 5.511521611235767892e-01 3.447517372232903879e-11 -3.116713886200589859e-14 5.511521611449047287e-01 5.593229909991251289e-11 -4.525661852729104143e-14 5.511521611719949476e-01 8.319418854742271374e-11 -6.315137161200492963e-14 5.511521612068179810e-01 1.182412632061175200e-10 -8.524313270574344290e-14 5.511521612502920942e-01 1.619798940047533896e-10 -1.113821218594378333e-13 5.511521613024108479e-01 2.143805845197719288e-10 -1.409876690394606122e-13 5.511521613622980542e-01 2.745350560728434943e-10 -1.733219031283839236e-13 5.511521614288286131e-01 3.412783307253936490e-10 -2.074538359915610872e-13 5.511521615003264207e-01 4.128952456500381835e-10 -2.396941187017842320e-13 5.511521615694587872e-01 4.820208638937688527e-10 -2.685889892611795456e-13 5.511521616332641926e-01 5.456903263116505828e-10 -2.938353639413805308e-13 5.511521616908627852e-01 6.030377825188995409e-10 -3.152797735016569503e-13 5.511521617417585173e-01 6.535914503269308961e-10 -3.329016837379614098e-13 5.511521617856158795e-01 6.970447825635150204e-10 -3.468445580724778784e-13 5.511521618224917152e-01 7.334858996619357849e-10 -3.576409185945777955e-13 5.511521618531881606e-01 7.637441078043701409e-10 -3.657855427855871772e-13 5.511521618785782950e-01 7.887128251004856215e-10 -3.717542145471976632e-13 5.511521618994686955e-01 8.092118556976023894e-10 -3.759688489624243073e-13 5.511521619165721253e-01 8.259609827781065927e-10 -3.788236748860460725e-13 5.511521619305010944e-01 8.395765825141937332e-10 -3.805856620362843027e-13 5.511521619417839579e-01 8.505878450562890946e-10 -3.815921972707132274e-13 5.511521619509902603e-01 8.595644467396184492e-10 -3.820565636356893194e-13 5.511521619584920373e-01 8.668769177654488538e-10 -3.821335482532235436e-13 5.511521619645083359e-01 8.727407589053309958e-10 -3.819192538046216436e-13 5.511521619691801543e-01 8.772930845561105519e-10 -3.814843745454020607e-13 5.511521619726192922e-01 8.806410044932100141e-10 -3.809250302960740857e-13 5.511521619749152334e-01 8.828705429280707850e-10 -3.802617527723831028e-13 5.511521619761369228e-01 8.840461064994709127e-10 -3.795717456186566548e-13 5.511521619763303237e-01 8.842119447270536309e-10 -3.788102969013693589e-13 5.511521619755157531e-01 8.833849688511907989e-10 -7.409740865752962462e-13 1.950433492338031679e-09 5.511521630207968370e-01 -7.393838678820082808e-13 1.943887612175451405e-09 5.511521630141350547e-01 -7.349591372360591444e-13 1.927504806754901734e-09 5.511521629975484338e-01 -7.275670734586942571e-13 1.901194709446427386e-09 5.511521629709713599e-01 -7.170195003592227926e-13 1.864828782379255170e-09 5.511521629343111295e-01 -7.033850664819394991e-13 1.819057495629983268e-09 5.511521628882630752e-01 -6.866912998001137219e-13 1.764514895794754439e-09 5.511521628335125378e-01 -6.668600825293554758e-13 1.701641827540130308e-09 5.511521627705567861e-01 -6.438931861732227125e-13 1.630919481476733441e-09 5.511521626999335011e-01 -6.177156332282134610e-13 1.552855364155636037e-09 5.511521626222037895e-01 -5.883581008443319309e-13 1.467955904721621694e-09 5.511521625379224298e-01 -5.558425003499410317e-13 1.376737200805610928e-09 5.511521624476424241e-01 -5.202543741418641632e-13 1.279777767621318787e-09 5.511521623519624047e-01 -4.819846107532807769e-13 1.178210518165897854e-09 5.511521622520028085e-01 -4.417953504128917034e-13 1.073966533697004767e-09 5.511521621496451306e-01 -4.009067547721292502e-13 9.699557672950329612e-10 5.511521620477126682e-01 -3.612878784548760895e-13 8.706753201224190841e-10 5.511521619505823644e-01 -3.251881499856974526e-13 7.812740225656417570e-10 5.511521618632655439e-01 -2.945081192575381609e-13 7.058926315170208715e-10 5.511521617897496839e-01 -2.702179881650770759e-13 6.465125841978830745e-10 5.511521617318896338e-01 -2.473414023412526163e-13 5.909166394908877933e-10 5.511521616775105770e-01 -2.258443886320920973e-13 5.390139672353974600e-10 5.511521616264947188e-01 -2.068004040486082865e-13 4.934041156686709911e-10 5.511521615814450881e-01 -1.918411561858523601e-13 4.582401107553448210e-10 5.511521615465508894e-01 -1.798280647397963795e-13 4.310956822094511443e-10 5.511521615194467927e-01 -1.825096707088932227e-13 4.410601460370881875e-10 5.511521615292220844e-01 -6.671790192788908519e-13 1.638346781416880319e-09 5.511521627223172626e-01 7.055002205548085339e-13 -1.787309851468304170e-09 5.511521593109881545e-01 -7.058846470327387290e-15 1.902474022695203447e-11 5.511521611083038952e-01 -4.441512338525951313e-15 1.412081182063033575e-11 5.511521611033577406e-01 3.234244534484312401e-15 -2.863978515047060873e-11 5.511521610590157660e-01 -1.252601093389717515e-13 6.437404641550518016e-11 5.511521611614242921e-01 -1.911549544083326266e-14 2.612309231072588059e-11 5.511521611158218814e-01 -3.009480883395256689e-14 4.842590719892837176e-11 5.511521611379172070e-01 -2.010096261576720063e-14 3.447517372232903879e-11 5.511521611241616547e-01 -3.141002556785286156e-14 5.593229909991251289e-11 5.511521611457508296e-01 -4.557328285594743294e-14 8.319418854742271374e-11 5.511521611731887704e-01 -6.359260712829053158e-14 1.182412632061175200e-10 5.511521612084641086e-01 -8.582545541618341495e-14 1.619798940047533896e-10 5.511521612524713509e-01 -1.120954659747499941e-13 2.143805845197719288e-10 5.511521613051558743e-01 -1.418244462527408258e-13 2.745350560728434943e-10 5.511521613655777641e-01 -1.742670296518714827e-13 3.412783307253936490e-10 5.511521614325316509e-01 -2.084648463852934498e-13 4.128952456500381835e-10 5.511521615042647149e-01 -2.406707188651362149e-13 4.820208638937688527e-10 5.511521615733796509e-01 -2.694993527665115072e-13 5.456903263116505828e-10 5.511521616369104981e-01 -2.945925242414211081e-13 6.030377825188995409e-10 5.511521616940044943e-01 -3.158727427438499607e-13 6.535914503269308961e-10 5.511521617442154408e-01 -3.332942350131144151e-13 6.970447825635150204e-10 5.511521617872651158e-01 -3.470292750684539133e-13 7.334858996619357849e-10 5.511521618232720909e-01 -3.576077962969625311e-13 7.637441078043701409e-10 5.511521618530935696e-01 -3.655608997653463428e-13 7.887128251004856215e-10 5.511521618776423770e-01 -3.713556124622089800e-13 8.092118556976023894e-10 5.511521618977516246e-01 -3.754186008966252415e-13 8.259609827781065927e-10 5.511521619141482864e-01 -3.781157787599434088e-13 8.395765825141937332e-10 5.511521619274515338e-01 -3.797719182271167421e-13 8.505878450562890946e-10 5.511521619381926085e-01 -3.806814940607898947e-13 8.595644467396184492e-10 5.511521619469410549e-01 -3.810826607138152456e-13 8.668769177654488538e-10 5.511521619540653560e-01 -3.811004771263811418e-13 8.727407589053309958e-10 5.511521619597780086e-01 -3.808571815327970605e-13 8.772930845561105519e-10 5.511521619642114622e-01 -3.803745309966029981e-13 8.806410044932100141e-10 5.511521619674690786e-01 -3.797872008797974982e-13 8.828705429280707850e-10 5.511521619696325702e-01 -3.790978202893884445e-13 8.840461064994709127e-10 5.511521619707627773e-01 -3.783941382897008405e-13 8.842119447270536309e-10 5.511521619709012221e-01 -3.776356458228757440e-13 8.833849688511907989e-10 5.511521619700623376e-01 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener deleted file mode 100644 index 8347f77c9..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.10435200024310802 -1 0.10458012014029815 -2 0.10499336099755491 -3 0.1055903684118013 -4 0.10636890870065621 -5 0.10732582252175506 -6 0.1084567564170259 -7 0.10975608515312206 -8 0.1112166964706233 -9 0.11282965375699106 -10 0.11458365648787314 -11 0.11646496885951468 -12 0.11845732347460955 -13 0.12054171034796743 -14 0.12269568388566807 -15 0.12489306789087287 -16 0.12710456437010614 -17 0.12930135770236537 -18 0.13145910540160105 -19 0.13355346652224132 -20 0.1355604730428064 -21 0.13745689822787427 -22 0.13922015616731154 -23 0.14082815062633774 -24 0.14226026905521147 -25 0.14349668290480055 -26 0.1445186751021504 -27 0.1453095567724877 -28 0.1458551691373635 -29 0.14614421061539154 -30 0.1461684237444241 -31 0.14592731087197264 -32 0.1454364904448951 -33 0.14471663894713344 -34 0.14379070378611125 -35 0.14268312766495347 -36 0.14141910229929616 -37 0.1400242568593778 -38 0.13852405524475148 -39 0.13693594937009554 -40 0.1352682259843752 -41 0.133530088851709 -42 0.13173228208063156 -43 0.12988686223111062 -44 0.1280064142542446 -45 0.126104251696744 -46 0.12419434117840034 -47 0.12229117015464314 -48 0.12041038086778931 -49 0.11857101694303926 -50 0.11679097652800079 -51 0.11508603372495745 -52 0.11346972772486705 -53 0.1119535425369769 -54 0.11054725529955563 -55 0.10925917485864142 -56 0.10809619024229951 -57 0.10706395108882347 -58 0.1061670534108405 -59 0.10540916889161556 -60 0.1047931438779291 -61 0.10432111251010957 -62 0.1039946237220952 -63 0.10381459623806397 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz deleted file mode 100644 index d6711156d..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D 2.2296719463915484 -2.619441202791937e-05 -2.6166286010633166e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D 2.230617074640179 -2.6234153915720484e-05 -2.619664575684127e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D 2.2323317070469857 -2.6309681191672105e-05 -2.6253981418693242e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D 2.2348148290413676 -2.641586372459864e-05 -2.6333828822051484e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D 2.2380643108115446 -2.65460915583343e-05 -2.64305288024654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D 2.242077214427925 -2.6691994585651368e-05 -2.653718465905387e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D 2.246849313017528 -2.6843564233083084e-05 -2.6645599610578535e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D 2.2523755365111215 -2.6989297331060924e-05 -2.6746274832008708e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D 2.2586499638311768 -2.7116268994223346e-05 -2.682846655016019e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D 2.265665388765594 -2.7210259926653055e-05 -2.6880276609364334e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -D 2.273412032854628 -2.7255948508480735e-05 -2.6888783397516332e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -D 2.281878277202424 -2.7237192205197823e-05 -2.6840233088108822e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -D 2.2910513338601612 -2.7137394308182474e-05 -2.672028703024727e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -D 2.3009174265372856 -2.6939958468471007e-05 -2.6514325109784784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -D 2.311459546216867 -2.6628843862797897e-05 -2.6207812942785776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -D 2.3226565843471394 -2.618926020561152e-05 -2.5786766803768926e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -D 2.3344865661383136 -2.5608516200641137e-05 -2.5238327658769665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -D 2.3469268811324886 -2.487699729592541e-05 -2.4551412592374673e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -D 2.359952011487809 -2.3989288093695455e-05 -2.371744448270224e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -D 2.37353126610515 -2.2945468023562507e-05 -2.2731171618017035e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -D 2.3876325316647677 -2.175116135890678e-05 -2.159116441649958e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -D 2.4022233802242314 -2.0412515652782555e-05 -2.0298538729681438e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -D 2.4172687075307477 -1.8935538694906212e-05 -1.885648268839713e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -D 2.432725969230559 -1.7325939536104076e-05 -1.7269925616441828e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -D 2.4485503064867014 -1.5588932779216884e-05 -1.5545228085405195e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -D 2.46469615527222 -1.3729066458709845e-05 -1.3689896512368749e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -D 2.4811171835788226 -1.1751242237951108e-05 -1.1712623192823262e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -D 2.4977635128299713 -9.662535019590646e-06 -9.623750930721992e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -D 2.514583382308031 -7.472733524923033e-06 -7.435465340049839e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -D 2.531524666420477 -5.194656323082042e-06 -5.161827444091524e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -D 2.548535102403122 -2.8442411108649427e-06 -2.8186563065845445e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -D 2.565562921961005 -4.4040082342622287e-07 -4.232647950645104e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -D 2.582557327970536 1.9960879304868e-06 2.0060236350761574e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -D 2.599467543600721 4.444061232253395e-06 4.450445354543358e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -D 2.616242724409365 6.883244848747797e-06 6.891358407030648e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -D 2.632835458664418 9.295368841649292e-06 9.310780525940801e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -D 2.649202404631441 1.1665141468743203e-05 1.1691876136713952e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -D 2.6653005308853692 1.3979842586168898e-05 1.401928807386366e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -D 2.6810867494753 1.6228240627875306e-05 1.627934764442009e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -D 2.696519889094831 1.8400496922922536e-05 1.8460273307934843e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -D 2.7115636094186732 2.048809367016108e-05 2.0552295298367443e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -D 2.7261822935677107 2.2483750255993763e-05 2.2547703060070993e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -D 2.7403407406711877 2.4381315717553052e-05 2.4440835706522454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -D 2.754005373195774 2.6175670235409408e-05 2.6227963899455168e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -D 2.7671486730219543 2.7863090338675164e-05 2.790658666136301e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -D 2.779745778921899 2.9441286805462265e-05 2.9475267909154095e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -D 2.791773698961617 3.0909295120082775e-05 3.093362164973135e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -D 2.803211017371933 3.226735152150357e-05 3.228226161825952e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -D 2.8140412525317133 3.351675504218708e-05 3.352272117891817e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -D 2.8242508315357053 3.4659715253690844e-05 3.465734781024439e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -D 2.833827205344768 3.569919368757156e-05 3.568918241311985e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -D 2.8427591875132294 3.6638743119884046e-05 3.662182949246522e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -D 2.8510380836591898 3.748234645453314e-05 3.745932212989862e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -D 2.8586573172985394 3.823425857406711e-05 3.820598756932762e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -D 2.8656113418938256 3.889885434704505e-05 3.8866319008232235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -D 2.8718952024910136 3.9480491470659595e-05 3.9444855380407995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -D 2.8775050182670574 3.9983568373437155e-05 3.994603634823055e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -D 2.8824377705832016 4.041242303321893e-05 4.037407071557091e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -D 2.8866910353355717 4.077116512913104e-05 4.073284197537209e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -D 2.890262936170148 4.10635521318485e-05 4.1025837172872314e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -D 2.8931521754468346 4.129290057783304e-05 4.125609596835846e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -D 2.895357927995945 4.1462026899210815e-05 4.142617824902743e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -D 2.8968795979101114 4.1573214020175913e-05 4.153814931884134e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -D 2.89771729893857 4.162820136403926e-05 4.15935823410379e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener deleted file mode 100644 index ec83dc3f1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.13344076815778944 -1 0.13350597554029547 -2 0.13363575948820305 -3 0.1338288632110306 -4 0.134083413638433 -5 0.13439693597364508 -6 0.13476637311767872 -7 0.13518810997043584 -8 0.13565800260347652 -9 0.13617141228015153 -10 0.13672324427064092 -11 0.13730799137215854 -12 0.13791978199771937 -13 0.13855243264065165 -14 0.13919950445753013 -15 0.13985436364001252 -16 0.14051024516837346 -17 0.1411603194579342 -18 0.14179775445635487 -19 0.14241568519506387 -20 0.14300728328348783 -21 0.14356589508503978 -22 0.1440851172115186 -23 0.14455886944443586 -24 0.14498146573989762 -25 0.14534768216272217 -26 0.1456528205872441 -27 0.1458927670262171 -28 0.14606404350729021 -29 0.14616385250803637 -30 0.14619011308405766 -31 0.1461415902639429 -32 0.14601937534911896 -33 0.1458265254311242 -34 0.145566805530133 -35 0.14524457610961072 -36 0.14486470916780467 -37 0.14443250216916687 -38 0.14395359154023069 -39 0.1434338673450423 -40 0.14287939061258836 -41 0.14229631461851475 -42 0.14169081123268026 -43 0.1410690032391952 -44 0.14043690332361008 -45 0.1398003602086623 -46 0.1391650122122337 -47 0.13853604243049505 -48 0.13791761692261295 -49 0.13731369340396973 -50 0.13672823296400757 -51 0.13616515878196916 -52 0.13562831507462428 -53 0.13512142682802297 -54 0.13464806082706757 -55 0.13421158845277156 -56 0.13381515066910485 -57 0.13346162557208227 -58 0.13315359882371663 -59 0.13289333724556276 -60 0.13268276580079472 -61 0.13252344815140743 -62 0.13241657093852707 -63 0.1323629318989296 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz deleted file mode 100644 index fca756684..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D 2.3727731017022706 -6.573162036991345e-05 -6.535304604594781e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D 2.373211152535036 -6.558776358100927e-05 -6.521311521270003e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D 2.374086336849262 -6.529995479117887e-05 -6.493310677907257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D 2.3753968183111454 -6.486801167613696e-05 -6.451272657833811e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D 2.377139838420972 -6.429169423402565e-05 -6.395155921203273e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D 2.37931171193371 -6.357074700803162e-05 -6.324910564364996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D 2.381907821115009 -6.270495691282956e-05 -6.240483055032214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D 2.3849226091344726 -6.169421933174741e-05 -6.141821921289561e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D 2.3883495729623347 -6.053860853196572e-05 -6.0288842625615316e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D 2.3921812561951343 -5.923845041678968e-05 -5.901642876229827e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -D 2.3964092422848546 -5.7794393811117935e-05 -5.760093792169858e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -D 2.401024148687287 -5.620747626197443e-05 -5.6042639786074694e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -D 2.4060156224757043 -5.447918039126816e-05 -5.434218976683748e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -D 2.411372337984157 -5.2611476953714386e-05 -5.2500702052363254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -D 2.4170819970525947 -5.060685097332284e-05 -5.0519816664465235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -D 2.4231313324387553 -4.846830752071089e-05 -4.840175769929152e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -D 2.4295061149433943 -4.61993541414527e-05 -4.614938008733449e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -D 2.4361911647625227 -4.3803957614910634e-05 -4.3766202545027057e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -D 2.4431703675355485 -4.128647289336364e-05 -4.1256424416465107e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -D 2.4504266958110636 -3.865154957532089e-05 -3.862492573237442e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -D 2.4579422413457497 -3.590413613928061e-05 -3.5877272101938436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -D 2.465698258604672 -3.304954489475672e-05 -3.301971463923961e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -D 2.473675216355156 -3.0093579979163408e-05 -3.0059196327528187e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -D 2.481852857235644 -2.7042654959074005e-05 -2.7003348559266155e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -D 2.490210265066654 -2.3903891078600977e-05 -2.3860475946633696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -D 2.4987259394908965 -2.0685194279615693e-05 -2.0639529680564187e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -D 2.5073778773600814 -1.739532645244757e-05 -1.7350073171218784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -D 2.5161436601187166 -1.4043929653684157e-05 -1.400223276082765e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -D 2.5250005462861926 -1.0641484783303672e-05 -1.0606628969640474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -D 2.5339255680037502 -7.1992391755792265e-06 -7.174295979514513e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -D 2.542895630503215 -3.729096774266929e-06 -3.716589844259222e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -D 2.5518876132687565 -2.434638561861346e-07 -2.450859502842762e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -D 2.5608784706097456 3.2449577144353783e-06 3.2285338108183623e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -D 2.569845316057347 6.723427581273953e-06 6.692602463791477e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -D 2.578765492870325 1.0179404857873026e-05 1.0135587183684696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -D 2.58761664169884 1.3600744151105706e-05 1.3546200977389311e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -D 2.596376765285668 1.6975855133435043e-05 1.6913505143121867e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -D 2.6050242898107223 2.0293823241201297e-05 2.0227000487118942e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -D 2.6135381225336554 2.3544491559150596e-05 2.3476705789993175e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -D 2.6218977054462664 2.671851491144886e-05 2.6653223087983003e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -D 2.6300830647037903 2.98073862802409e-05 2.974778902402017e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -D 2.6380748556678935 3.280343851672054e-05 3.275231211043777e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -D 2.6458544034562985 3.56998244383029e-05 3.565939623610022e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -D 2.6534037389585743 3.849047874248332e-05 3.846235069520494e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -D 2.660705630338084 4.1170068121325584e-05 4.115518359382816e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -D 2.6677436101028182 4.373392769027831e-05 4.3732586316821016e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -D 2.674501997880584 4.617798677051143e-05 4.6189909246984204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -D 2.6809659190822788 4.849868649273772e-05 4.8523129041839296e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -D 2.687121320810235 5.069290824180629e-05 5.072881000319861e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -D 2.6929549884902007 5.2757952109481076e-05 5.280406322766094e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -D 2.6984545585902553 5.4691518299640154e-05 5.474650183757304e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -D 2.7036085265029537 5.649168165979415e-05 5.655419297152121e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -D 2.7084062501095665 5.815686119753453e-05 5.822560785216067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -D 2.7128379495945523 5.968578611152712e-05 5.975957112232412e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -D 2.716894704112094 6.10774596780074e-05 6.115521055529296e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -D 2.720568445925636 6.233112224936453e-05 6.241190813176001e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -D 2.7238519526475953 6.344621594798394e-05 6.352925310555834e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -D 2.726738838193951 6.442234915949323e-05 6.450699806621023e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -D 2.729223543049307 6.525926214838458e-05 6.534501871021933e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -D 2.7313013244007887 6.595679542998242e-05 6.604327773127232e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -D 2.7329682466547207 6.651486149761198e-05 6.660179322256007e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -D 2.734221172794841 6.693342041753533e-05 6.702061189531636e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -D 2.735057756976749 6.721245971941856e-05 6.729978734375631e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -D 2.735476438682034 6.735197892177608e-05 6.743936352210504e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 deleted file mode 100644 index 6cd984f2a..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL.hess_10 +++ /dev/null @@ -1 +0,0 @@ --9.061855378392017976e-03 2.664540927089443698e-05 3.098757237676578232e-05 -9.072053528254145349e-03 2.648303929952405410e-05 3.082184066544540026e-05 -9.092362216305384728e-03 2.616168673230740891e-05 3.049240975682717498e-05 -9.122606915449724824e-03 2.568804803030458913e-05 3.000332763420027801e-05 -9.162527575992391107e-03 2.507197263931204546e-05 2.936062264378969371e-05 -9.211780715335984165e-03 2.432623011473526091e-05 2.857224838494952729e-05 -9.269942204386894327e-03 2.346620221581877845e-05 2.764800590812681530e-05 -9.336510748974126764e-03 2.250950263470058205e-05 2.659944004226394649e-05 -9.410912062185926991e-03 2.147552821286094959e-05 2.543970652544972916e-05 -9.492503719778503518e-03 2.038494697072270310e-05 2.418340684512274496e-05 -9.580580685669930555e-03 1.925913004264360475e-05 2.284638836163663668e-05 -9.674381488035810675e-03 1.811953662004888669e-05 2.144550838153734301e-05 -9.773095018593174615e-03 1.698706318526408722e-05 1.999836233855441800e-05 -9.875867918488823172e-03 1.588137053854111319e-05 1.852297804801410176e-05 -9.981812504054431504e-03 1.482020420525246315e-05 1.703748000937455346e-05 -1.009001517479298816e-02 1.381872555787605039e-05 1.555972976453388174e-05 -1.019954523481683695e-02 1.288887216337633959e-05 1.410695018409457665e-05 -1.030946404794483122e-02 1.203876625476238177e-05 1.269534303320755183e-05 -1.041789729204695668e-02 1.124228541854011920e-05 1.133380549800700756e-05 -1.051998595374178426e-02 1.038636080321890423e-05 1.001236803883887808e-05 -1.061383054297925475e-02 9.467737823937576202e-06 8.740628533707002165e-06 -1.069798013925073524e-02 8.499518605155226563e-06 7.530327839595928768e-06 -1.077106040793990305e-02 7.498047398141633466e-06 6.392794499864175696e-06 -1.083179021556197712e-02 6.482868882941178750e-06 5.338931460944801744e-06 -1.087899741725244229e-02 5.476596089059168539e-06 4.379200484349797496e-06 -1.091163356150816506e-02 4.504678513910079013e-06 3.523596266807426779e-06 -1.092878726714692841e-02 3.595062404477224389e-06 2.781601951854822854e-06 -1.092969604389205408e-02 2.777737627850703894e-06 2.162118154689148138e-06 -1.091375635065014275e-02 2.084169305987699101e-06 1.673359005177432426e-06 -1.088053171366664372e-02 1.546617553563474460e-06 1.322711166878409706e-06 -1.082975875955774839e-02 1.197355195285058731e-06 1.116555317809405249e-06 -1.076353854942566080e-02 1.068006474978134338e-06 1.060080547164248661e-06 -1.069099529109772927e-02 1.169906854527051106e-06 1.154599868374194460e-06 -1.061337279037817202e-02 1.486295098906186625e-06 1.396231485365216933e-06 -1.053093490500627179e-02 1.996504492928880106e-06 1.778936772905664578e-06 -1.044399541042680818e-02 2.677890481066476738e-06 2.294878744941987686e-06 -1.035291536296295729e-02 3.506429071035120637e-06 2.934647490896683409e-06 -1.025809996984188878e-02 4.457321973146198373e-06 3.687512930973994667e-06 -1.015999502282908737e-02 5.505587920859737251e-06 4.541693384029557850e-06 -1.005908295573720163e-02 6.626621355816490495e-06 5.484628645749040142e-06 -9.955878588082679378e-03 7.796702302285152286e-06 6.503247213743984512e-06 -9.850924617395230912e-03 8.993444509902587020e-06 7.584218793064951376e-06 -9.744786921511846070e-03 1.019617251285177730e-05 8.714185074676665185e-06 -9.638049730067791906e-03 1.138622185281087777e-05 9.879963795279185783e-06 -9.531310721386460419e-03 1.254716010420819819e-05 1.106872307432706743e-05 -9.425176097275295845e-03 1.366492935404761320e-05 1.226812484475597799e-05 -9.320248876645582242e-03 1.472799091894280330e-05 1.346644268193181128e-05 -9.215013348092947892e-03 1.575266061802714068e-05 1.465424686214770664e-05 -9.108262214701524570e-03 1.675847123034744505e-05 1.582285479264752457e-05 -9.001195322586681355e-03 1.773901651225156845e-05 1.696255382079780657e-05 -8.895007293771139273e-03 1.868785839976834593e-05 1.806430099942642848e-05 -8.790865473274591529e-03 1.959871135919774099e-05 1.911975637315744343e-05 -8.689899316998784054e-03 2.046549859414538279e-05 2.012129430498647452e-05 -8.593190395993882333e-03 2.128240440308712552e-05 2.106200289595980789e-05 -8.501763078222847325e-03 2.204392271547839775e-05 2.193567370050881755e-05 -8.416575934625750849e-03 2.274490183362351016e-05 2.273678392755690931e-05 -8.338513903419154244e-03 2.338058539784866824e-05 2.346047324084274909e-05 -8.268381235134358159e-03 2.394664956397403780e-05 2.410251713802320718e-05 -8.206895231242511760e-03 2.443923635818371774e-05 2.465929872491314174e-05 -8.154680781603199785e-03 2.485498314865283742e-05 2.512778050773649082e-05 -8.112265700042919914e-03 2.519104815084123442e-05 2.550547762280921667e-05 -8.080076853535841236e-03 2.544513187984290010e-05 2.579043371399642099e-05 -8.058437078099105200e-03 2.561549444958719488e-05 2.598120045509114584e-05 -8.047562874109801326e-03 2.570096863777318239e-05 2.607682150862987956e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.323488980084844280e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener deleted file mode 100644 index ec83dc3f1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.13344076815778944 -1 0.13350597554029547 -2 0.13363575948820305 -3 0.1338288632110306 -4 0.134083413638433 -5 0.13439693597364508 -6 0.13476637311767872 -7 0.13518810997043584 -8 0.13565800260347652 -9 0.13617141228015153 -10 0.13672324427064092 -11 0.13730799137215854 -12 0.13791978199771937 -13 0.13855243264065165 -14 0.13919950445753013 -15 0.13985436364001252 -16 0.14051024516837346 -17 0.1411603194579342 -18 0.14179775445635487 -19 0.14241568519506387 -20 0.14300728328348783 -21 0.14356589508503978 -22 0.1440851172115186 -23 0.14455886944443586 -24 0.14498146573989762 -25 0.14534768216272217 -26 0.1456528205872441 -27 0.1458927670262171 -28 0.14606404350729021 -29 0.14616385250803637 -30 0.14619011308405766 -31 0.1461415902639429 -32 0.14601937534911896 -33 0.1458265254311242 -34 0.145566805530133 -35 0.14524457610961072 -36 0.14486470916780467 -37 0.14443250216916687 -38 0.14395359154023069 -39 0.1434338673450423 -40 0.14287939061258836 -41 0.14229631461851475 -42 0.14169081123268026 -43 0.1410690032391952 -44 0.14043690332361008 -45 0.1398003602086623 -46 0.1391650122122337 -47 0.13853604243049505 -48 0.13791761692261295 -49 0.13731369340396973 -50 0.13672823296400757 -51 0.13616515878196916 -52 0.13562831507462428 -53 0.13512142682802297 -54 0.13464806082706757 -55 0.13421158845277156 -56 0.13381515066910485 -57 0.13346162557208227 -58 0.13315359882371663 -59 0.13289333724556276 -60 0.13268276580079472 -61 0.13252344815140743 -62 0.13241657093852707 -63 0.1323629318989296 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz deleted file mode 100644 index fca756684..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D 2.3727731017022706 -6.573162036991345e-05 -6.535304604594781e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D 2.373211152535036 -6.558776358100927e-05 -6.521311521270003e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D 2.374086336849262 -6.529995479117887e-05 -6.493310677907257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D 2.3753968183111454 -6.486801167613696e-05 -6.451272657833811e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D 2.377139838420972 -6.429169423402565e-05 -6.395155921203273e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D 2.37931171193371 -6.357074700803162e-05 -6.324910564364996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D 2.381907821115009 -6.270495691282956e-05 -6.240483055032214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D 2.3849226091344726 -6.169421933174741e-05 -6.141821921289561e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D 2.3883495729623347 -6.053860853196572e-05 -6.0288842625615316e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D 2.3921812561951343 -5.923845041678968e-05 -5.901642876229827e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -D 2.3964092422848546 -5.7794393811117935e-05 -5.760093792169858e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -D 2.401024148687287 -5.620747626197443e-05 -5.6042639786074694e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -D 2.4060156224757043 -5.447918039126816e-05 -5.434218976683748e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -D 2.411372337984157 -5.2611476953714386e-05 -5.2500702052363254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -D 2.4170819970525947 -5.060685097332284e-05 -5.0519816664465235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -D 2.4231313324387553 -4.846830752071089e-05 -4.840175769929152e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -D 2.4295061149433943 -4.61993541414527e-05 -4.614938008733449e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -D 2.4361911647625227 -4.3803957614910634e-05 -4.3766202545027057e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -D 2.4431703675355485 -4.128647289336364e-05 -4.1256424416465107e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -D 2.4504266958110636 -3.865154957532089e-05 -3.862492573237442e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -D 2.4579422413457497 -3.590413613928061e-05 -3.5877272101938436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -D 2.465698258604672 -3.304954489475672e-05 -3.301971463923961e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -D 2.473675216355156 -3.0093579979163408e-05 -3.0059196327528187e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -D 2.481852857235644 -2.7042654959074005e-05 -2.7003348559266155e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -D 2.490210265066654 -2.3903891078600977e-05 -2.3860475946633696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -D 2.4987259394908965 -2.0685194279615693e-05 -2.0639529680564187e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -D 2.5073778773600814 -1.739532645244757e-05 -1.7350073171218784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -D 2.5161436601187166 -1.4043929653684157e-05 -1.400223276082765e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -D 2.5250005462861926 -1.0641484783303672e-05 -1.0606628969640474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -D 2.5339255680037502 -7.1992391755792265e-06 -7.174295979514513e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -D 2.542895630503215 -3.729096774266929e-06 -3.716589844259222e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -D 2.5518876132687565 -2.434638561861346e-07 -2.450859502842762e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -D 2.5608784706097456 3.2449577144353783e-06 3.2285338108183623e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -D 2.569845316057347 6.723427581273953e-06 6.692602463791477e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -D 2.578765492870325 1.0179404857873026e-05 1.0135587183684696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -D 2.58761664169884 1.3600744151105706e-05 1.3546200977389311e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -D 2.596376765285668 1.6975855133435043e-05 1.6913505143121867e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -D 2.6050242898107223 2.0293823241201297e-05 2.0227000487118942e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -D 2.6135381225336554 2.3544491559150596e-05 2.3476705789993175e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -D 2.6218977054462664 2.671851491144886e-05 2.6653223087983003e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -D 2.6300830647037903 2.98073862802409e-05 2.974778902402017e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -D 2.6380748556678935 3.280343851672054e-05 3.275231211043777e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -D 2.6458544034562985 3.56998244383029e-05 3.565939623610022e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -D 2.6534037389585743 3.849047874248332e-05 3.846235069520494e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -D 2.660705630338084 4.1170068121325584e-05 4.115518359382816e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -D 2.6677436101028182 4.373392769027831e-05 4.3732586316821016e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -D 2.674501997880584 4.617798677051143e-05 4.6189909246984204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -D 2.6809659190822788 4.849868649273772e-05 4.8523129041839296e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -D 2.687121320810235 5.069290824180629e-05 5.072881000319861e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -D 2.6929549884902007 5.2757952109481076e-05 5.280406322766094e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -D 2.6984545585902553 5.4691518299640154e-05 5.474650183757304e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -D 2.7036085265029537 5.649168165979415e-05 5.655419297152121e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -D 2.7084062501095665 5.815686119753453e-05 5.822560785216067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -D 2.7128379495945523 5.968578611152712e-05 5.975957112232412e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -D 2.716894704112094 6.10774596780074e-05 6.115521055529296e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -D 2.720568445925636 6.233112224936453e-05 6.241190813176001e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -D 2.7238519526475953 6.344621594798394e-05 6.352925310555834e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -D 2.726738838193951 6.442234915949323e-05 6.450699806621023e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -D 2.729223543049307 6.525926214838458e-05 6.534501871021933e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -D 2.7313013244007887 6.595679542998242e-05 6.604327773127232e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -D 2.7329682466547207 6.651486149761198e-05 6.660179322256007e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -D 2.734221172794841 6.693342041753533e-05 6.702061189531636e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -D 2.735057756976749 6.721245971941856e-05 6.729978734375631e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -D 2.735476438682034 6.735197892177608e-05 6.743936352210504e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz deleted file mode 100644 index 8b1d1f419..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_FINAL_forces_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D -0.0018660518736817906 3.622812461878516e-05 3.6019472561998554e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D -0.0018620443607219002 3.6148837638693244e-05 3.5942349380850994e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D -0.001854024754273556 3.59902112021977e-05 3.578802212753396e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D -0.0018419841830200066 3.5752144820874666e-05 3.555632867141997e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D -0.0018259100593112124 3.543450621718151e-05 3.524704006474792e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D -0.0018057869282991023 3.5037154595543496e-05 3.48598812624688e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D -0.0017815975767378565 3.4559972513523094e-05 3.439455722022724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D -0.0017533243815192926 3.40029023114154e-05 3.3850784249449306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D -0.001720950873206811 3.336598492173749e-05 3.322832590268601e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D -0.0016844634851634337 3.2649399966800306e-05 3.252703225211872e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -D -0.0016438534544539064 3.1853505047848914e-05 3.174688141631996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -D -0.001599118836589558 3.097887201116779e-05 3.0888022031249295e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -D -0.0015502665925036078 3.0026318007026155e-05 2.9950815328322207e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -D -0.0014973147030178146 2.8996929221144317e-05 2.8935875394870175e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -D -0.001440294263591693 2.7892075279875578e-05 2.7844106132459788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -D -0.001379251510509959 2.671341243438494e-05 2.667673335648954e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -D -0.0013142497289489847 2.546287387599571e-05 2.5435330568070065e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -D -0.0012453709937240009 2.4142645903726033e-05 2.412183711536762e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -D -0.001172719038224144 2.2755128758935888e-05 2.2738567475955815e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -D -0.001096440284274665 2.1302885077891803e-05 2.128821128931535e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -D -0.0010167252348586406 1.9788642225212173e-05 1.977383605297545e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -D -0.0009337960960280491 1.821532809176598e-05 1.8198887081971875e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -D -0.0008479060490378361 1.658614164043231e-05 1.6567191016527414e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -D -0.000759338193633965 1.4904617722288343e-05 1.4882953915089605e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -D -0.0006684038125637904 1.3174681226416316e-05 1.3150752882608568e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -D -0.0005754399731936938 1.1400689529764076e-05 1.1375521387311559e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -D -0.00048080650176049195 9.587471767121907e-06 9.562530323376277e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -D -0.000384882385097928 7.74034217881539e-06 7.717360846206815e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -D -0.00028806167277086446 5.8650773355176765e-06 5.845866478490677e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -D -0.0001907489687453904 3.9678762298198896e-06 3.9541287334043455e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -D -9.335461524651834e-05 2.055299746048691e-06 2.0484065245463495e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -D 3.7141702529989687e-06 1.3418563048414451e-07 1.350796511518256e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -D 0.00010011345542751705 -1.7884654569547458e-06 -1.7794133869827038e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -D 0.0001955535800291956 -3.705631641347149e-06 -3.6886423112308482e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -D 0.00028975640300377565 -5.610400986020552e-06 -5.586250780197743e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -D 0.0003824557576763887 -7.496079531305789e-06 -7.466017943239325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -D 0.00047339896489504227 -9.356279243133138e-06 -9.321914911228127e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -D 0.0005623481551086827 -1.1184984536154181e-05 -1.1148155030831748e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -D 0.000649081379604965 -1.297659740457675e-05 -1.2939237131414532e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -D 0.0007333934956959757 -1.4725967234544127e-05 -1.4689981504939455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -D 0.0008150968154294055 -1.6428405364781007e-05 -1.639555820821995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -D 0.0008940215123513424 -1.8079686029653455e-05 -1.8051507600341975e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -D 0.00097001578574858 -1.967603538968246e-05 -1.9653753298669492e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -D 0.0010429457865782131 -2.1214110540284903e-05 -2.11986077062402e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -D 0.0011126953137798967 -2.2690972017265998e-05 -2.2682768377768998e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -D 0.001179165293834631 -2.4104048759424007e-05 -2.4103309458544184e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -D 0.0012422730600919493 -2.545109720332463e-05 -2.545766830199814e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -D 0.0013019469358093625 -2.6730155870469197e-05 -2.6743627434229065e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -D 0.001358113556344446 -2.793950592937768e-05 -2.7959293262755972e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -D 0.0014107150112688874 -2.907765931979103e-05 -2.9103073562226113e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -D 0.0014597126287351088 -3.0143348504106588e-05 -3.0173652799862635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -D 0.0015050849715898614 -3.1135512430369404e-05 -3.11699656749203e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -D 0.0015468256434708813 -3.2053279731196844e-05 -3.20911695984617e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -D 0.0015849409626666976 -3.289595000168727e-05 -3.293661676984403e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -D 0.0016194475614604241 -3.366297389538385e-05 -3.3705826459426384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -D 0.0016503699673877056 -3.435393273086422e-05 -3.4398458044531996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -D 0.0016777382204925697 -3.496851903267546e-05 -3.5014285141523315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -D 0.0017015855773900833 -3.550651696170993e-05 -3.555317138958086e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -D 0.0017219463490160747 -3.5967783364181184e-05 -3.6015048278564015e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -D 0.0017388539144249891 -3.6352230339765606e-05 -3.6399895247017525e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -D 0.001752338948120828 -3.66598096589703e-05 -3.670772226704267e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -D 0.0017624278932598908 -3.689049931222929e-05 -3.693855508363688e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -D 0.0017691417077559607 -3.7044292426491116e-05 -3.709242323536766e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -D 0.0017724949049269768 -3.712118873638392e-05 -3.716935094770116e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz deleted file mode 100644 index 0293755ee..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D -0.0028588579706978886 1.4437106797653668e-05 1.4421605082443541e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D -0.0028551564247003705 1.4459010625001025e-05 1.4438337922176264e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D -0.0028483146135055283 1.4500637646362955e-05 1.4469938596113468e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D -0.002838119629476885 1.4559160378855359e-05 1.451394666503174e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D -0.002824272329815609 1.4630935730852758e-05 1.4567243068214171e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D -0.002806393715298487 1.4711350499668045e-05 1.4626026674065744e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D -0.0027840370905967177 1.4794888438405592e-05 1.4685779808892968e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D -0.0027566984747163454 1.487520955029833e-05 1.474126717475236e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D -0.0027238308567461298 1.4945190256847413e-05 1.4786567317835198e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D -0.0026848627268221776 1.4996993562378853e-05 1.4815122543931731e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -D -0.002639224296545019 1.5022174922990288e-05 1.4819811078605635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -D -0.0025863649926720924 1.5011837345901864e-05 1.479305247065413e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -D -0.0025257710245732705 1.4956833519289678e-05 1.4726943941649579e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -D -0.002456985599109257 1.4848016329556204e-05 1.4613427584084559e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -D -0.002379647097387393 1.4676544842292996e-05 1.4444492740842866e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -D -0.0022935208785061856 1.443426735965515e-05 1.4212432251405383e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -D -0.002198496825014237 1.4114189046276015e-05 1.3910158831413024e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -D -0.00209449730515764 1.3711010821064202e-05 1.3531564108084563e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -D -0.00198138253957698 1.322174797583622e-05 1.3071920782158967e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -D -0.0018591130561937258 1.2646444288393968e-05 1.2528334361363893e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -D -0.0017277450161351329 1.1988199589165502e-05 1.190001692859008e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -D -0.0015874256303747673 1.1250402115302105e-05 1.1187583487820604e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -D -0.0014384197782641485 1.0436363073089324e-05 1.0392791184254749e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -D -0.0012811634591928473 9.549229018227864e-06 9.518356825354928e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -D -0.0011162330290022046 8.591873990342615e-06 8.567786053898553e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -D -0.0009445452725943722 7.566804648457788e-06 7.545216047882138e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -D -0.000767324303871637 6.4767225549316715e-06 6.455437584750251e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -D -0.0005859579966761682 5.325527057649295e-06 5.304151123253453e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -D -0.0004019534967415484 4.118613231506464e-06 4.098072790873724e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -D -0.00021689327846641465 2.8630460585833316e-06 2.8449523509815655e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -D -3.2402216865165805e-05 1.5676096349125004e-06 1.5535085147423096e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -D 0.0001500635154829055 2.427278655769095e-07 2.3328330651286266e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -D 0.00032956586908914666 -1.1001481766122476e-06 -1.1056242616686178e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -D 0.0005052872624287663 -2.449353952170036e-06 -2.4528725749668077e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -D 0.0006764530861017888 -3.7937152736947585e-06 -3.7981870788764773e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -D 0.0008423747761222727 -5.123162625197986e-06 -5.13165680830128e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -D 0.001002459763718507 -6.429267929911277e-06 -6.444002799939363e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -D 0.0011561774965601554 -7.705020453056475e-06 -7.726760918844667e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -D 0.0013030558057977916 -8.944229892732112e-06 -8.972397635347602e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -D 0.00144254321424588 -1.0141473644187425e-05 -1.0174419527969069e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -D 0.0015740251248491234 -1.1292057102911129e-05 -1.1327441969042524e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -D 0.001697004053532831 -1.2391967542985086e-05 -1.2427215269159977e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -D 0.0018111141271062892 -1.3437814847932076e-05 -1.3470619418480576e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -D 0.0019161311730233597 -1.4426777218209114e-05 -1.4455598984159218e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -D 0.0020120003026955933 -1.5356802454789717e-05 -1.5380775547038565e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -D 0.00209879751990021 -1.6226628848083073e-05 -1.6245357606819023e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -D 0.002176713317353931 -1.7035724803183355e-05 -1.704913242257097e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -D 0.0022460393231655148 -1.7784220523707708e-05 -1.77924382557568e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -D 0.00230723567759177 -1.8472831974205114e-05 -1.8476120223357813e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -D 0.0023609954763357897 -1.91027769648146e-05 -1.910147214324283e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -D 0.0024080144349016962 -1.9675687750053773e-05 -1.9670170014504455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -D 0.002448946007925917 -2.019352245012311e-05 -2.0184200467819362e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -D 0.002484404160650643 -2.065847625111717e-05 -2.064578634483723e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -D 0.0025149590659542705 -2.1072894240747624e-05 -2.1057312615389286e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -D 0.0025411316221171944 -2.1439187637275288e-05 -2.142125571497683e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -D 0.0025633922413990473 -2.1759758194925263e-05 -2.1740117286770314e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -D 0.0025821633286377517 -2.203703011708527e-05 -2.2016344260282588e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -D 0.002597819161153955 -2.227339428961725e-05 -2.2252256326862757e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -D 0.002610685935909768 -2.2471115771052947e-05 -2.244999388203894e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -D 0.0026210426822979417 -2.2632265499475123e-05 -2.261147881833e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -D 0.002629122356213608 -2.2758671391121997e-05 -2.273838645107203e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -D 0.0026351124641959905 -2.285188572864646e-05 -2.2832127667625746e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -D 0.0026391552667620957 -2.2913166750651677e-05 -2.2893840764733173e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -D 0.0026413497719772455 -2.294347314405453e-05 -2.2924392794712523e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz deleted file mode 100644 index 8b1d1f419..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instanton_forces_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -D -0.0018660518736817906 3.622812461878516e-05 3.6019472561998554e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -D -0.0018620443607219002 3.6148837638693244e-05 3.5942349380850994e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -D -0.001854024754273556 3.59902112021977e-05 3.578802212753396e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -D -0.0018419841830200066 3.5752144820874666e-05 3.555632867141997e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -D -0.0018259100593112124 3.543450621718151e-05 3.524704006474792e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -D -0.0018057869282991023 3.5037154595543496e-05 3.48598812624688e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -D -0.0017815975767378565 3.4559972513523094e-05 3.439455722022724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -D -0.0017533243815192926 3.40029023114154e-05 3.3850784249449306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -D -0.001720950873206811 3.336598492173749e-05 3.322832590268601e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -D -0.0016844634851634337 3.2649399966800306e-05 3.252703225211872e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -D -0.0016438534544539064 3.1853505047848914e-05 3.174688141631996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -D -0.001599118836589558 3.097887201116779e-05 3.0888022031249295e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -D -0.0015502665925036078 3.0026318007026155e-05 2.9950815328322207e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -D -0.0014973147030178146 2.8996929221144317e-05 2.8935875394870175e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -D -0.001440294263591693 2.7892075279875578e-05 2.7844106132459788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -D -0.001379251510509959 2.671341243438494e-05 2.667673335648954e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -D -0.0013142497289489847 2.546287387599571e-05 2.5435330568070065e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -D -0.0012453709937240009 2.4142645903726033e-05 2.412183711536762e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -D -0.001172719038224144 2.2755128758935888e-05 2.2738567475955815e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -D -0.001096440284274665 2.1302885077891803e-05 2.128821128931535e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -D -0.0010167252348586406 1.9788642225212173e-05 1.977383605297545e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -D -0.0009337960960280491 1.821532809176598e-05 1.8198887081971875e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -D -0.0008479060490378361 1.658614164043231e-05 1.6567191016527414e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -D -0.000759338193633965 1.4904617722288343e-05 1.4882953915089605e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -D -0.0006684038125637904 1.3174681226416316e-05 1.3150752882608568e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -D -0.0005754399731936938 1.1400689529764076e-05 1.1375521387311559e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -D -0.00048080650176049195 9.587471767121907e-06 9.562530323376277e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -D -0.000384882385097928 7.74034217881539e-06 7.717360846206815e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -D -0.00028806167277086446 5.8650773355176765e-06 5.845866478490677e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -D -0.0001907489687453904 3.9678762298198896e-06 3.9541287334043455e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -D -9.335461524651834e-05 2.055299746048691e-06 2.0484065245463495e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -D 3.7141702529989687e-06 1.3418563048414451e-07 1.350796511518256e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -D 0.00010011345542751705 -1.7884654569547458e-06 -1.7794133869827038e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -D 0.0001955535800291956 -3.705631641347149e-06 -3.6886423112308482e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -D 0.00028975640300377565 -5.610400986020552e-06 -5.586250780197743e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -D 0.0003824557576763887 -7.496079531305789e-06 -7.466017943239325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -D 0.00047339896489504227 -9.356279243133138e-06 -9.321914911228127e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -D 0.0005623481551086827 -1.1184984536154181e-05 -1.1148155030831748e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -D 0.000649081379604965 -1.297659740457675e-05 -1.2939237131414532e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -D 0.0007333934956959757 -1.4725967234544127e-05 -1.4689981504939455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -D 0.0008150968154294055 -1.6428405364781007e-05 -1.639555820821995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -D 0.0008940215123513424 -1.8079686029653455e-05 -1.8051507600341975e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -D 0.00097001578574858 -1.967603538968246e-05 -1.9653753298669492e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -D 0.0010429457865782131 -2.1214110540284903e-05 -2.11986077062402e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -D 0.0011126953137798967 -2.2690972017265998e-05 -2.2682768377768998e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -D 0.001179165293834631 -2.4104048759424007e-05 -2.4103309458544184e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -D 0.0012422730600919493 -2.545109720332463e-05 -2.545766830199814e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -D 0.0013019469358093625 -2.6730155870469197e-05 -2.6743627434229065e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -D 0.001358113556344446 -2.793950592937768e-05 -2.7959293262755972e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -D 0.0014107150112688874 -2.907765931979103e-05 -2.9103073562226113e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -D 0.0014597126287351088 -3.0143348504106588e-05 -3.0173652799862635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -D 0.0015050849715898614 -3.1135512430369404e-05 -3.11699656749203e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -D 0.0015468256434708813 -3.2053279731196844e-05 -3.20911695984617e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -D 0.0015849409626666976 -3.289595000168727e-05 -3.293661676984403e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -D 0.0016194475614604241 -3.366297389538385e-05 -3.3705826459426384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -D 0.0016503699673877056 -3.435393273086422e-05 -3.4398458044531996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -D 0.0016777382204925697 -3.496851903267546e-05 -3.5014285141523315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -D 0.0017015855773900833 -3.550651696170993e-05 -3.555317138958086e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -D 0.0017219463490160747 -3.5967783364181184e-05 -3.6015048278564015e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -D 0.0017388539144249891 -3.6352230339765606e-05 -3.6399895247017525e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -D 0.001752338948120828 -3.66598096589703e-05 -3.670772226704267e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -D 0.0017624278932598908 -3.689049931222929e-05 -3.693855508363688e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -D 0.0017691417077559607 -3.7044292426491116e-05 -3.709242323536766e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -D 0.0017724949049269768 -3.712118873638392e-05 -3.716935094770116e-05 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 deleted file mode 100644 index 35f8223ca..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.instantonfric_FINAL.hess_10 +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 deleted file mode 100644 index 425ff74f1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_00 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 -{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} - #*EXTRAS*# Step: 1 Bead: 0 -{"friction": [[0.00012934543425376094, -3.618271039482692e-05, -3.5904795117197906e-05], [-3.618271039482692e-05, 0.00012951879292860837, -3.6216758470280675e-05], [-3.5904795117197906e-05, -3.6216758470280675e-05, 0.0001290051849108313]]} - #*EXTRAS*# Step: 2 Bead: 0 -{"friction": [[0.00012680530963699927, -3.9497470282282685e-05, -3.8976481610773324e-05], [-3.9497470282282685e-05, 0.00012689629007119941, -3.957872420317071e-05], [-3.8976481610773324e-05, -3.957872420317071e-05, 0.000126462327563967]]} - #*EXTRAS*# Step: 3 Bead: 0 -{"friction": [[0.00012527459299002867, -4.1091076486058416e-05, -4.054114005433311e-05], [-4.1091076486058416e-05, 0.00012533642179523015, -4.118929011080804e-05], [-4.054114005433311e-05, -4.118929011080804e-05, 0.00012497289991242086]]} - #*EXTRAS*# Step: 4 Bead: 0 -{"friction": [[0.00012453159453860614, -4.1760239475510894e-05, -4.126407323614469e-05], [-4.1760239475510894e-05, 0.000124591785976315, -4.18618000181609e-05], [-4.126407323614469e-05, -4.18618000181609e-05, 0.0001242634657316739]]} - #*EXTRAS*# Step: 5 Bead: 0 -{"friction": [[0.00012410690082153493, -4.210783838978701e-05, -4.1666054988542505e-05], [-4.210783838978701e-05, 0.00012416978581991436, -4.220865587788328e-05], [-4.1666054988542505e-05, -4.220865587788328e-05, 0.00012386209095335458]]} - #*EXTRAS*# Step: 6 Bead: 0 -{"friction": [[0.00012385705139214003, -4.229942800986635e-05, -4.189609244197549e-05], [-4.229942800986635e-05, 0.00012392203984417058, -4.2398442284290914e-05], [-4.189609244197549e-05, -4.2398442284290914e-05, 0.0001236271084636086]]} - #*EXTRAS*# Step: 7 Bead: 0 -{"friction": [[0.00012370176129122324, -4.241353228622466e-05, -4.203600358446615e-05], [-4.241353228622466e-05, 0.00012376805078787145, -4.251080414086017e-05], [-4.203600358446615e-05, -4.251080414086017e-05, 0.00012348140623677362]]} - #*EXTRAS*# Step: 8 Bead: 0 -{"friction": [[0.00012360304445542989, -4.248406094530929e-05, -4.2123558321892614e-05], [-4.248406094530929e-05, 0.00012367010507923949, -4.257994985882027e-05], [-4.2123558321892614e-05, -4.257994985882027e-05, 0.00012338889989924629]]} - #*EXTRAS*# Step: 9 Bead: 0 -{"friction": [[0.00012353910394013773, -4.252890770192973e-05, -4.2179650971995733e-05], [-4.252890770192973e-05, 0.00012360662618533794, -4.262377949672673e-05], [-4.2179650971995733e-05, -4.262377949672673e-05, 0.00012332902344596605]]} - #*EXTRAS*# Step: 10 Bead: 0 -{"friction": [[0.00012349725170453886, -4.255790584165255e-05, -4.221609150611516e-05], [-4.255790584165255e-05, 0.00012356505588193283, -4.2652058266072764e-05], [-4.221609150611516e-05, -4.2652058266072764e-05, 0.00012328984711168573]]} - #*EXTRAS*# Step: 11 Bead: 0 -{"friction": [[0.00012346964840900584, -4.2576877015557237e-05, -4.2240003216563973e-05], [-4.2576877015557237e-05, 0.00012353762860077785, -4.26705312238049e-05], [-4.2240003216563973e-05, -4.26705312238049e-05, 0.00012326401497421126]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 deleted file mode 100644 index 53dadbd49..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_01 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 -{"friction": [[0.0001318960708675288, -3.145359585337808e-05, -3.140499284046311e-05], [-3.145359585337808e-05, 0.00013214032682715794, -3.1420093958772926e-05], [-3.140499284046311e-05, -3.1420093958772926e-05, 0.00013167914079224472]]} - #*EXTRAS*# Step: 1 Bead: 1 -{"friction": [[0.00012930486527308808, -3.624364186203017e-05, -3.5961128719340115e-05], [-3.624364186203017e-05, 0.00012947681871798488, -3.627859614075686e-05], [-3.5961128719340115e-05, -3.627859614075686e-05, 0.0001289638307171534]]} - #*EXTRAS*# Step: 2 Bead: 1 -{"friction": [[0.00012677727532838827, -3.95291769519208e-05, -3.9006493758668574e-05], [-3.95291769519208e-05, 0.00012686750943694891, -3.961083324174769e-05], [-3.9006493758668574e-05, -3.961083324174769e-05, 0.000126434752641205]]} - #*EXTRAS*# Step: 3 Bead: 1 -{"friction": [[0.0001252522044209213, -4.111228799292027e-05, -4.0563165840992805e-05], [-4.111228799292027e-05, 0.00012531383636208075, -4.1210660802913846e-05], [-4.0563165840992805e-05, -4.1210660802913846e-05, 0.00012495138018070654]]} - #*EXTRAS*# Step: 4 Bead: 1 -{"friction": [[0.00012451262225947747, -4.177633752878506e-05, -4.12822648084072e-05], [-4.177633752878506e-05, 0.00012457289294147213, -4.1877916832661114e-05], [-4.12822648084072e-05, -4.1877916832661114e-05, 0.00012424547608927923]]} - #*EXTRAS*# Step: 5 Bead: 1 -{"friction": [[0.0001240895912781255, -4.2121426075714985e-05, -4.168216801064642e-05], [-4.2121426075714985e-05, 0.00012415261611248347, -4.2222155022916904e-05], [-4.168216801064642e-05, -4.2222155022916904e-05, 0.00012384578652790577]]} - #*EXTRAS*# Step: 6 Bead: 1 -{"friction": [[0.0001238406336562388, -4.2311673096820816e-05, -4.191100320291615e-05], [-4.2311673096820816e-05, 0.00012390576239946526, -4.241052700823726e-05], [-4.191100320291615e-05, -4.241052700823726e-05, 0.00012361169285551881]]} - #*EXTRAS*# Step: 7 Bead: 1 -{"friction": [[0.00012368586506925164, -4.242499505517851e-05, -4.205017809637978e-05], [-4.242499505517851e-05, 0.00012375228266420344, -4.2522059161828516e-05], [-4.205017809637978e-05, -4.2522059161828516e-05, 0.00012346650445006457]]} - #*EXTRAS*# Step: 8 Bead: 1 -{"friction": [[0.00012358746769280731, -4.249504681170327e-05, -4.213726912695905e-05], [-4.249504681170327e-05, 0.0001236546439039854, -4.259069691838904e-05], [-4.213726912695905e-05, -4.259069691838904e-05, 0.00012337431037132303]]} - #*EXTRAS*# Step: 9 Bead: 1 -{"friction": [[0.00012352372896883305, -4.253959331620743e-05, -4.219306357588242e-05], [-4.253959331620743e-05, 0.0001235913567927779, -4.263420583935721e-05], [-4.219306357588242e-05, -4.263420583935721e-05, 0.0001233146301200287]]} - #*EXTRAS*# Step: 10 Bead: 1 -{"friction": [[0.00012348200670407654, -4.256839857831431e-05, -4.222930984571026e-05], [-4.256839857831431e-05, 0.00012354990911802243, -4.266227820118861e-05], [-4.222930984571026e-05, -4.266227820118861e-05, 0.00012327557970750935]]} - #*EXTRAS*# Step: 11 Bead: 1 -{"friction": [[0.00012345448820706993, -4.258724413443976e-05, -4.2253093858474775e-05], [-4.258724413443976e-05, 0.0001235225614565618, -4.26806165627e-05], [-4.2253093858474775e-05, -4.26806165627e-05, 0.0001232498295318448]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 deleted file mode 100644 index 3d07015a5..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_02 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 -{"friction": [[0.00013182249801045433, -3.1627039924819494e-05, -3.157597998104187e-05], [-3.1627039924819494e-05, 0.00013206576277603182, -3.1595838794370805e-05], [-3.157597998104187e-05, -3.1595838794370805e-05, 0.0001315990850259919]]} - #*EXTRAS*# Step: 1 Bead: 2 -{"friction": [[0.00012923108930599453, -3.6353652737885806e-05, -3.6062785314018805e-05], [-3.6353652737885806e-05, 0.0001294004836228374, -3.639024281520528e-05], [-3.6062785314018805e-05, -3.639024281520528e-05, 0.00012888869629231863]]} - #*EXTRAS*# Step: 2 Bead: 2 -{"friction": [[0.00012672135259414853, -3.959214072162623e-05, -3.9066178140534965e-05], [-3.959214072162623e-05, 0.00012681011591002486, -3.9674590722181904e-05], [-3.9066178140534965e-05, -3.9674590722181904e-05, 0.00012637977774619612]]} - #*EXTRAS*# Step: 3 Bead: 2 -{"friction": [[0.00012520760809126187, -4.115435311482684e-05, -4.060699073178873e-05], [-4.115435311482684e-05, 0.00012526887374338333, -4.1253033813381775e-05], [-4.060699073178873e-05, -4.1253033813381775e-05, 0.00012490853993662836]]} - #*EXTRAS*# Step: 4 Bead: 2 -{"friction": [[0.0001244748132251995, -4.180826321240631e-05, -4.131846185162289e-05], [-4.180826321240631e-05, 0.00012453525576586218, -4.190986698891169e-05], [-4.131846185162289e-05, -4.190986698891169e-05, 0.00012420964268517511]]} - #*EXTRAS*# Step: 5 Bead: 2 -{"friction": [[0.00012405507440282424, -4.2148382545368785e-05, -4.171422516085467e-05], [-4.2148382545368785e-05, 0.0001241183820760016, -4.224891952595161e-05], [-4.171422516085467e-05, -4.224891952595161e-05, 0.0001238132855627299]]} - #*EXTRAS*# Step: 6 Bead: 2 -{"friction": [[0.00012380788333468055, -4.233597178315575e-05, -4.194066561728076e-05], [-4.233597178315575e-05, 0.00012387329072427913, -4.243448932825025e-05], [-4.194066561728076e-05, -4.243448932825025e-05, 0.00012358095004983145]]} - #*EXTRAS*# Step: 7 Bead: 2 -{"friction": [[0.0001236541480317297, -4.244774511008442e-05, -4.207837405027229e-05], [-4.244774511008442e-05, 0.00012372081705698038, -4.254437773092577e-05], [-4.207837405027229e-05, -4.254437773092577e-05, 0.00012343677817892472]]} - #*EXTRAS*# Step: 8 Bead: 2 -{"friction": [[0.0001235563837097352, -4.251685284128123e-05, -4.2164541506690154e-05], [-4.251685284128123e-05, 0.0001236237846671686, -4.261200917143531e-05], [-4.2164541506690154e-05, -4.261200917143531e-05, 0.00012334520194097132]]} - #*EXTRAS*# Step: 9 Bead: 2 -{"friction": [[0.0001234930449077949, -4.256080500768818e-05, -4.2219742037343975e-05], [-4.256080500768818e-05, 0.00012356087644094634, -4.265488273245225e-05], [-4.2219742037343975e-05, -4.265488273245225e-05, 0.00012328590992971488]]} - #*EXTRAS*# Step: 10 Bead: 2 -{"friction": [[0.00012345158024685302, -4.258922847965072e-05, -4.225560140408513e-05], [-4.258922847965072e-05, 0.00012351967104233012, -4.268254619250217e-05], [-4.225560140408513e-05, -4.268254619250217e-05, 0.0001232471087031815]]} - #*EXTRAS*# Step: 11 Bead: 2 -{"friction": [[0.00012342422983022242, -4.260782538427597e-05, -4.227913109305686e-05], [-4.260782538427597e-05, 0.00012349248068976987, -4.2700617915078515e-05], [-4.227913109305686e-05, -4.2700617915078515e-05, 0.0001232215207278749]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 deleted file mode 100644 index 71b6b8635..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_03 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 -{"friction": [[0.00013171780647812666, -3.186828910318049e-05, -3.181299933918628e-05], [-3.186828910318049e-05, 0.0001319594795236481, -3.184031805657655e-05], [-3.181299933918628e-05, -3.184031805657655e-05, 0.00013148559226403892]]} - #*EXTRAS*# Step: 1 Bead: 3 -{"friction": [[0.00012912386466953438, -3.651174949864347e-05, -3.620876797333617e-05], [-3.651174949864347e-05, 0.00012928953365626408, -3.6550689061982367e-05], [-3.620876797333617e-05, -3.6550689061982367e-05, 0.00012877965463459854]]} - #*EXTRAS*# Step: 2 Bead: 3 -{"friction": [[0.00012663782403959798, -3.9685482502047956e-05, -3.91548788542534e-05], [-3.9685482502047956e-05, 0.00012672443649999797, -3.976909557013233e-05], [-3.91548788542534e-05, -3.976909557013233e-05, 0.0001262977432251237]]} - #*EXTRAS*# Step: 3 Bead: 3 -{"friction": [[0.00012514116867822254, -4.1216558112123804e-05, -4.067216615037439e-05], [-4.1216558112123804e-05, 0.00012520195411322665, -4.13156743574553e-05], [-4.067216615037439e-05, -4.13156743574553e-05, 0.00012484478032243773]]} - #*EXTRAS*# Step: 4 Bead: 3 -{"friction": [[0.00012441843275073537, -4.185548321609393e-05, -4.137229290853237e-05], [-4.185548321609393e-05, 0.00012447916424876646, -4.1957090365569186e-05], [-4.137229290853237e-05, -4.1957090365569186e-05, 0.0001241562506050922]]} - #*EXTRAS*# Step: 5 Bead: 3 -{"friction": [[0.0001240035499461503, -4.2188276255689016e-05, -4.176188936820454e-05], [-4.2188276255689016e-05, 0.00012406728796906093, -4.228848751528499e-05], [-4.176188936820454e-05, -4.228848751528499e-05, 0.00012376479838601323]]} - #*EXTRAS*# Step: 6 Bead: 3 -{"friction": [[0.0001237589666101063, -4.2371946690226304e-05, -4.198476219313653e-05], [-4.2371946690226304e-05, 0.00012382478553567972, -4.246992010928841e-05], [-4.198476219313653e-05, -4.246992010928841e-05, 0.00012353505207201183]]} - #*EXTRAS*# Step: 7 Bead: 3 -{"friction": [[0.00012360675719556453, -4.2481436692528955e-05, -4.212028603587234e-05], [-4.2481436692528955e-05, 0.00012367378999340493, -4.257738168297923e-05], [-4.212028603587234e-05, -4.257738168297923e-05, 0.00012339237760933258]]} - #*EXTRAS*# Step: 8 Bead: 3 -{"friction": [[0.00012350992799244954, -4.254915259527099e-05, -4.22050777331205e-05], [-4.254915259527099e-05, 0.0001235776486247615, -4.2643527456122986e-05], [-4.22050777331205e-05, -4.2643527456122986e-05, 0.00012330171167228263]]} - #*EXTRAS*# Step: 9 Bead: 3 -{"friction": [[0.00012344718004724062, -4.259222851761747e-05, -4.225939359825561e-05], [-4.259222851761747e-05, 0.00012351529720316837, -4.2685463028546076e-05], [-4.225939359825561e-05, -4.2685463028546076e-05, 0.0001232429917578638]]} - #*EXTRAS*# Step: 10 Bead: 3 -{"friction": [[0.00012340609602805956, -4.262008911872689e-05, -4.229467667499026e-05], [-4.262008911872689e-05, 0.00012347444788070354, -4.2712522832756215e-05], [-4.229467667499026e-05, -4.2712522832756215e-05, 0.00012320455776100226]]} - #*EXTRAS*# Step: 11 Bead: 3 -{"friction": [[0.0001233789939929936, -4.2638319441954836e-05, -4.2317827557702834e-05], [-4.2638319441954836e-05, 0.00012344748874023386, -4.27302009242659e-05], [-4.2317827557702834e-05, -4.27302009242659e-05, 0.00012317920883979217]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 deleted file mode 100644 index 4ff6a1c04..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_04 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 -{"friction": [[0.00013158007460812243, -3.217616690285429e-05, -3.2114038906784815e-05], [-3.217616690285429e-05, 0.000131819341634194, -3.215236678795705e-05], [-3.2114038906784815e-05, -3.215236678795705e-05, 0.00013133701434974246]]} - #*EXTRAS*# Step: 1 Bead: 4 -{"friction": [[0.00012898291772121421, -3.6716433290988916e-05, -3.6397607689923824e-05], [-3.6716433290988916e-05, 0.00012914368547612193, -3.675841088072472e-05], [-3.6397607689923824e-05, -3.675841088072472e-05, 0.00012863659666612727]]} - #*EXTRAS*# Step: 2 Bead: 4 -{"friction": [[0.0001265271259074745, -3.980789318497056e-05, -3.927163339661499e-05], [-3.980789318497056e-05, 0.00012661097670782354, -3.989300535611183e-05], [-3.927163339661499e-05, -3.989300535611183e-05, 0.00012618917043421814]]} - #*EXTRAS*# Step: 3 Bead: 4 -{"friction": [[0.0001250534440660516, -4.129783430207893e-05, -4.0758027809534804e-05], [-4.129783430207893e-05, 0.0001251137201572557, -4.1397481961136464e-05], [-4.0758027809534804e-05, -4.1397481961136464e-05, 0.0001247607129091559]]} - #*EXTRAS*# Step: 4 Bead: 4 -{"friction": [[0.00012434386460944902, -4.1917216267443724e-05, -4.14432026786162e-05], [-4.1917216267443724e-05, 0.00012440503331043027, -4.2018763718804665e-05], [-4.14432026786162e-05, -4.2018763718804665e-05, 0.00012408571094530072]]} - #*EXTRAS*# Step: 5 Bead: 4 -{"friction": [[0.00012393530596737666, -4.224047542144724e-05, -4.182465683613586e-05], [-4.224047542144724e-05, 0.00012399962409970336, -4.23401803354425e-05], [-4.182465683613586e-05, -4.23401803354425e-05, 0.00012370062701625023]]} - #*EXTRAS*# Step: 6 Bead: 4 -{"friction": [[0.00012369412256418145, -4.241904562952834e-05, -4.204281851771903e-05], [-4.241904562952834e-05, 0.00012376047377939, -4.2516218357066624e-05], [-4.204281851771903e-05, -4.2516218357066624e-05, 0.00012347424509177052]]} - #*EXTRAS*# Step: 7 Bead: 4 -{"friction": [[0.00012354390369288286, -4.2525564077741897e-05, -4.21754577774553e-05], [-4.2525564077741897e-05, 0.00012361139252186235, -4.262051563249319e-05], [-4.21754577774553e-05, -4.262051563249319e-05, 0.00012333351708737739]]} - #*EXTRAS*# Step: 8 Bead: 4 -{"friction": [[0.0001234482948680593, -4.259146873206048e-05, -4.225843306102053e-05], [-4.259146873206048e-05, 0.00012351640536706058, -4.268472436939185e-05], [-4.225843306102053e-05, -4.268472436939185e-05, 0.00012324403480349784]]} - #*EXTRAS*# Step: 9 Bead: 4 -{"friction": [[0.00012338631823091912, -4.2633404396061115e-05, -4.231158097162441e-05], [-4.2633404396061115e-05, 0.0001234547753377799, -4.2725437014254837e-05], [-4.231158097162441e-05, -4.2725437014254837e-05, 0.00012318605893466955]]} - #*EXTRAS*# Step: 10 Bead: 4 -{"friction": [[0.00012334573119919821, -4.266053254893876e-05, -4.2346103251014005e-05], [-4.266053254893876e-05, 0.0001234143874051681, -4.2751709804351056e-05], [-4.2346103251014005e-05, -4.2751709804351056e-05, 0.0001231481026149281]]} - #*EXTRAS*# Step: 11 Bead: 4 -{"friction": [[0.0001233189535066445, -4.2678285856855534e-05, -4.2368754061403615e-05], [-4.2678285856855534e-05, 0.0001233877278869103, -4.276887470824343e-05], [-4.2368754061403615e-05, -4.276887470824343e-05, 0.00012312306467746685]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 deleted file mode 100644 index a53e9dc5a..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_05 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 -{"friction": [[0.00013140687508940286, -3.2549089934313045e-05, -3.247646875118131e-05], [-3.2549089934313045e-05, 0.00013164265398424839, -3.25304116398176e-05], [-3.247646875118131e-05, -3.25304116398176e-05, 0.0001311512838181544]]} - #*EXTRAS*# Step: 1 Bead: 5 -{"friction": [[0.0001288079823808037, -3.69657025089011e-05, -3.662739877256669e-05], [-3.69657025089011e-05, 0.00012896267323131622, -3.7011370997848594e-05], [-3.662739877256669e-05, -3.7011370997848594e-05, 0.00012845946804188578]]} - #*EXTRAS*# Step: 2 Bead: 5 -{"friction": [[0.00012638987269691492, -3.995763295503717e-05, -3.941518642172444e-05], [-3.995763295503717e-05, 0.00012647044851603315, -4.004453505428147e-05], [-3.941518642172444e-05, -4.004453505428147e-05, 0.00012605478446619836]]} - #*EXTRAS*# Step: 3 Bead: 5 -{"friction": [[0.00012494519770907947, -4.139676051589508e-05, -4.086370464643624e-05], [-4.139676051589508e-05, 0.00012500505087889932, -4.149699256725794e-05], [-4.086370464643624e-05, -4.149699256725794e-05, 0.0001246571707439191]]} - #*EXTRAS*# Step: 4 Bead: 5 -{"friction": [[0.00012425159436231653, -4.199245515910113e-05, -4.1530454345575415e-05], [-4.199245515910113e-05, 0.00012431337979354113, -4.209382066978967e-05], [-4.1530454345575415e-05, -4.209382066978967e-05, 0.00012399854140743746]]} - #*EXTRAS*# Step: 5 Bead: 5 -{"friction": [[0.00012385070527520133, -4.230416630403199e-05, -4.190185926253294e-05], [-4.230416630403199e-05, 0.0001239157479919052, -4.240311923952935e-05], [-4.190185926253294e-05, -4.240311923952935e-05, 0.00012362114936885374]]} - #*EXTRAS*# Step: 6 Bead: 5 -{"friction": [[0.0001236136512326929, -4.247655794534371e-05, -4.21142054956047e-05], [-4.247655794534371e-05, 0.00012368063208888997, -4.257260620623824e-05], [-4.21142054956047e-05, -4.257260620623824e-05, 0.00012339883551695907]]} - #*EXTRAS*# Step: 7 Bead: 5 -{"friction": [[0.00012346585176892545, -4.257947677329142e-05, -4.2243284384760026e-05], [-4.257947677329142e-05, 0.0001235338555122669, -4.2673060959365136e-05], [-4.2243284384760026e-05, -4.2673060959365136e-05, 0.0001232604623169261]]} - #*EXTRAS*# Step: 8 Bead: 5 -{"friction": [[0.00012337172708157363, -4.26431875003421e-05, -4.232401798430673e-05], [-4.26431875003421e-05, 0.00012344025844271137, -4.2734917633581366e-05], [-4.232401798430673e-05, -4.2734917633581366e-05, 0.00012317241262279352]]} - #*EXTRAS*# Step: 9 Bead: 5 -{"friction": [[0.00012331068879949458, -4.268374204746543e-05, -4.237572460029147e-05], [-4.268374204746543e-05, 0.0001233794974330599, -4.277414538378509e-05], [-4.237572460029147e-05, -4.277414538378509e-05, 0.0001231153375424629]]} - #*EXTRAS*# Step: 10 Bead: 5 -{"friction": [[0.0001232707065476205, -4.2709983060489255e-05, -4.2409308083192204e-05], [-4.2709983060489255e-05, 0.00012333966541455896, -4.2799462598772956e-05], [-4.2409308083192204e-05, -4.2799462598772956e-05, 0.00012307795965188948]]} - #*EXTRAS*# Step: 11 Bead: 5 -{"friction": [[0.00012324432361285022, -4.272715861838104e-05, -4.243134184469237e-05], [-4.272715861838104e-05, 0.0001233133669475951, -4.281600441293335e-05], [-4.243134184469237e-05, -4.281600441293335e-05, 0.00012305329834496885]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 deleted file mode 100644 index 3c56bd9b5..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_06 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 -{"friction": [[0.0001311956103908458, -3.29848470674875e-05, -3.289701440835983e-05], [-3.29848470674875e-05, 0.00013142653940500336, -3.297224398384808e-05], [-3.289701440835983e-05, -3.297224398384808e-05, 0.00013092623268750358]]} - #*EXTRAS*# Step: 1 Bead: 6 -{"friction": [[0.00012859888927482216, -3.7257001864031606e-05, -3.6895794428949855e-05], [-3.7257001864031606e-05, 0.00012874634846699243, -3.730696548405537e-05], [-3.6895794428949855e-05, -3.730696548405537e-05, 0.000128248355257521]]} - #*EXTRAS*# Step: 2 Bead: 6 -{"friction": [[0.00012622688863031512, -4.0132530808662264e-05, -3.958400771033771e-05], [-4.0132530808662264e-05, 0.0001263038061641873, -4.022145586125126e-05], [-3.958400771033771e-05, -4.022145586125126e-05, 0.00012589554316259143]]} - #*EXTRAS*# Step: 3 Bead: 6 -{"friction": [[0.00012481735091779964, -4.15116159669585e-05, -4.098811935632287e-05], [-4.15116159669585e-05, 0.0001248769967590873, -4.161242631137927e-05], [-4.098811935632287e-05, -4.161242631137927e-05, 0.00012453515446699426]]} - #*EXTRAS*# Step: 4 Bead: 6 -{"friction": [[0.0001241421877398454, -4.2079995445984995e-05, -4.163313278744122e-05], [-4.2079995445984995e-05, 0.00012420479241960082, -4.218097779161471e-05], [-4.163313278744122e-05, -4.218097779161471e-05, 0.00012389534114335568]]} - #*EXTRAS*# Step: 5 Bead: 6 -{"friction": [[0.00012375016788001176, -4.237837702137053e-05, -4.199266687931785e-05], [-4.237837702137053e-05, 0.00012381606004076534, -4.2476247163854004e-05], [-4.199266687931785e-05, -4.2476247163854004e-05, 0.00012352679882038405]]} - #*EXTRAS*# Step: 6 Bead: 6 -{"friction": [[0.0001235178981533317, -4.254363578486062e-05, -4.219814241102753e-05], [-4.254363578486062e-05, 0.0001235855654191231, -4.263814846883526e-05], [-4.219814241102753e-05, -4.263814846883526e-05, 0.00012330917200970503]]} - #*EXTRAS*# Step: 7 Bead: 6 -{"friction": [[0.00012337290455990187, -4.264239929089614e-05, -4.2323015424554125e-05], [-4.264239929089614e-05, 0.00012344143003832964, -4.273415404226355e-05], [-4.2323015424554125e-05, -4.273415404226355e-05, 0.00012317351381563153]]} - #*EXTRAS*# Step: 8 Bead: 6 -{"friction": [[0.00012328050232906653, -4.2703577587069285e-05, -4.240110131008834e-05], [-4.2703577587069285e-05, 0.00012334942681435564, -4.2793287517856307e-05], [-4.240110131008834e-05, -4.2793287517856307e-05, 0.00012308711680855648]]} - #*EXTRAS*# Step: 9 Bead: 6 -{"friction": [[0.00012322055360137644, -4.274253799267406e-05, -4.245110573095298e-05], [-4.274253799267406e-05, 0.000123289662541492, -4.283079614488638e-05], [-4.245110573095298e-05, -4.283079614488638e-05, 0.00012303108131523046]]} - #*EXTRAS*# Step: 10 Bead: 6 -{"friction": [[0.0001231812738151995, -4.2767755064023843e-05, -4.2483580554247525e-05], [-4.2767755064023843e-05, 0.00012325046830602415, -4.285500708943536e-05], [-4.2483580554247525e-05, -4.285500708943536e-05, 0.00012299437117173188]]} - #*EXTRAS*# Step: 11 Bead: 6 -{"friction": [[0.00012315534950327965, -4.2784263792314777e-05, -4.250488565202726e-05], [-4.2784263792314777e-05, 0.00012322458413573383, -4.2870827567241156e-05], [-4.250488565202726e-05, -4.2870827567241156e-05, 0.00012297014473573219]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 deleted file mode 100644 index 3e9f290de..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_07 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 -{"friction": [[0.00013094354884002888, -3.34806356918497e-05, -3.337184485038292e-05], [-3.34806356918497e-05, 0.00013116798657021497, -3.347505294528034e-05], [-3.337184485038292e-05, -3.347505294528034e-05, 0.00013065962767836692]]} - #*EXTRAS*# Step: 1 Bead: 7 -{"friction": [[0.00012835562896980067, -3.758722599408891e-05, -3.7200061518953475e-05], [-3.758722599408891e-05, 0.0001284947548057753, -3.764202536847655e-05], [-3.7200061518953475e-05, -3.764202536847655e-05, 0.000128003544495496]]} - #*EXTRAS*# Step: 2 Bead: 7 -{"friction": [[0.00012603924493984162, -4.032998469726831e-05, -3.977631404957128e-05], [-4.032998469726831e-05, 0.0001261122885205976, -4.0421094526221145e-05], [-3.977631404957128e-05, -4.0421094526221145e-05, 0.00012571267142136931]]} - #*EXTRAS*# Step: 3 Bead: 7 -{"friction": [[0.00012467088756795762, -4.164047357812715e-05, -4.1129982724709916e-05], [-4.164047357812715e-05, 0.000124730652614448, -4.174177200663041e-05], [-4.1129982724709916e-05, -4.174177200663041e-05, 0.0001243957269526685]]} - #*EXTRAS*# Step: 4 Bead: 7 -{"friction": [[0.00012401626462540824, -4.21784702134942e-05, -4.1750148725670436e-05], [-4.21784702134942e-05, 0.0001240798956836773, -4.227876628853978e-05], [-4.1750148725670436e-05, -4.227876628853978e-05, 0.00012377676048902083]]} - #*EXTRAS*# Step: 5 Bead: 7 -{"friction": [[0.0001236341498956548, -4.2462006399146805e-05, -4.2096092388679916e-05], [-4.2462006399146805e-05, 0.00012370097429352395, -4.255835518361389e-05], [-4.2096092388679916e-05, -4.255835518361389e-05, 0.00012341803964597417]]} - #*EXTRAS*# Step: 6 Bead: 7 -{"friction": [[0.0001234072358082399, -4.261931985256251e-05, -4.2293700877396644e-05], [-4.261931985256251e-05, 0.0001234755814376183, -4.271177637062584e-05], [-4.2293700877396644e-05, -4.271177637062584e-05, 0.00012320562389735268]]} - #*EXTRAS*# Step: 7 Bead: 7 -{"friction": [[0.00012326538702940397, -4.2713455071846473e-05, -4.241375886949409e-05], [-4.2713455071846473e-05, 0.00012333436389002693, -4.280280838638658e-05], [-4.241375886949409e-05, -4.280280838638658e-05, 0.00012307298707417617]]} - #*EXTRAS*# Step: 8 Bead: 7 -{"friction": [[0.00012317491711091766, -4.277181291553608e-05, -4.2488814102997204e-05], [-4.277181291553608e-05, 0.00012324412267261683, -4.285889797307674e-05], [-4.2488814102997204e-05, -4.285889797307674e-05, 0.00012298843066176158]]} - #*EXTRAS*# Step: 9 Bead: 7 -{"friction": [[0.00012311619142555202, -4.280899795221479e-05, -4.253687035360196e-05], [-4.280899795221479e-05, 0.0001231854608162728, -4.289448512354323e-05], [-4.253687035360196e-05, -4.289448512354323e-05, 0.00012293355354942668]]} - #*EXTRAS*# Step: 10 Bead: 7 -{"friction": [[0.0001230777005045906, -4.283307471242502e-05, -4.2568076413916654e-05], [-4.283307471242502e-05, 0.00012314697224134394, -4.291745962921422e-05], [-4.2568076413916654e-05, -4.291745962921422e-05, 0.00012289758773514404]]} - #*EXTRAS*# Step: 11 Bead: 7 -{"friction": [[0.00012305229136952208, -4.284884084106619e-05, -4.258854766399825e-05], [-4.284884084106619e-05, 0.0001231215465723857, -4.293247391441507e-05], [-4.258854766399825e-05, -4.293247391441507e-05, 0.00012287384616570672]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 deleted file mode 100644 index abd96dcac..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_08 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 -{"friction": [[0.00013064797267198423, -3.4032980337971224e-05, -3.389659333410311e-05], [-3.4032980337971224e-05, 0.00013086402099283612, -3.4035338460508096e-05], [-3.389659333410311e-05, -3.4035338460508096e-05, 0.00013034931536429637]]} - #*EXTRAS*# Step: 1 Bead: 8 -{"friction": [[0.00012807844777806376, -3.7952690617213006e-05, -3.7537113405919383e-05], [-3.7952690617213006e-05, 0.00012820823778086655, -3.801278499668635e-05], [-3.7537113405919383e-05, -3.801278499668635e-05, 0.00012772561270434643]]} - #*EXTRAS*# Step: 2 Bead: 8 -{"friction": [[0.00012582830157257792, -4.0546962956973825e-05, -3.999009480683545e-05], [-4.0546962956973825e-05, 0.00012589746645040435, -4.064033389794325e-05], [-3.999009480683545e-05, -4.064033389794325e-05, 0.00012550769944875078]]} - #*EXTRAS*# Step: 3 Bead: 8 -{"friction": [[0.00012450684084900325, -4.178123273873033e-05, -4.128780462218461e-05], [-4.178123273873033e-05, 0.00012456713662149682, -4.188281690759607e-05], [-4.128780462218461e-05, -4.188281690759607e-05, 0.00012423999528004116]]} - #*EXTRAS*# Step: 4 Bead: 8 -{"friction": [[0.00012387446933287608, -4.228639016586386e-05, -4.188024386586463e-05], [-4.228639016586386e-05, 0.00012393930866904483, -4.23855686299664e-05], [-4.188024386586463e-05, -4.23855686299664e-05, 0.00012364346639037112]]} - #*EXTRAS*# Step: 5 Bead: 8 -{"friction": [[0.00012350311942539195, -4.255385727120116e-05, -4.221099589317006e-05], [-4.255385727120116e-05, 0.0001235708851367965, -4.2648113153896825e-05], [-4.221099589317006e-05, -4.2648113153896825e-05, 0.00012329533896103358]]} - #*EXTRAS*# Step: 6 Bead: 8 -{"friction": [[0.00012328204245769692, -4.2702569098886565e-05, -4.239980974800376e-05], [-4.2702569098886565e-05, 0.00012335096139176415, -4.279231501217347e-05], [-4.239980974800376e-05, -4.279231501217347e-05, 0.00012308855656145668]]} - #*EXTRAS*# Step: 7 Bead: 8 -{"friction": [[0.0001231436265300466, -4.27916940463016e-05, -4.251448599054845e-05], [-4.27916940463016e-05, 0.00012321287489139567, -4.287794020685383e-05], [-4.251448599054845e-05, -4.287794020685383e-05, 0.00012295918996700454]]} - #*EXTRAS*# Step: 8 Bead: 8 -{"friction": [[0.00012305526835327274, -4.2846998892748e-05, -4.2586154561260595e-05], [-4.2846998892748e-05, 0.0001231245262563514, -4.293072105665344e-05], [-4.2586154561260595e-05, -4.293072105665344e-05, 0.00012287662775687958]]} - #*EXTRAS*# Step: 9 Bead: 8 -{"friction": [[0.00012299788029272214, -4.2882262262130436e-05, -4.263203406479509e-05], [-4.2882262262130436e-05, 0.00012306704928060705, -4.2964219653746374e-05], [-4.263203406479509e-05, -4.2964219653746374e-05, 0.00012282300653855123]]} - #*EXTRAS*# Step: 10 Bead: 8 -{"friction": [[0.00012296025260169076, -4.290510477991387e-05, -4.266182263279629e-05], [-4.290510477991387e-05, 0.000123029319527319, -4.29858502653951e-05], [-4.266182263279629e-05, -4.29858502653951e-05, 0.00012278784810298502]]} - #*EXTRAS*# Step: 11 Bead: 8 -{"friction": [[0.00012293540740692708, -4.2920067152123586e-05, -4.268136234449961e-05], [-4.2920067152123586e-05, 0.00012300438706518878, -4.299998831663051e-05], [-4.268136234449961e-05, -4.299998831663051e-05, 0.00012276463264196565]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 deleted file mode 100644 index 5f758efbe..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_09 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 -{"friction": [[0.00013030641560764987, -3.4637552590400345e-05, -3.4466313676195334e-05], [-3.4637552590400345e-05, 0.0001305119734329694, -3.464872341487375e-05], [-3.4466313676195334e-05, -3.464872341487375e-05, 0.00012999345633835313]]} - #*EXTRAS*# Step: 1 Bead: 9 -{"friction": [[0.00012776797401068684, -3.8349077216357794e-05, -3.79035254551647e-05], [-3.8349077216357794e-05, 0.00012788758740554668, -3.8414823261247424e-05], [-3.79035254551647e-05, -3.8414823261247424e-05, 0.00012741554842222853]]} - #*EXTRAS*# Step: 2 Bead: 9 -{"friction": [[0.00012559575169472087, -4.078000775732315e-05, -4.0223140918395494e-05], [-4.078000775732315e-05, 0.00012566129333089652, -4.087561547057879e-05], [-4.0223140918395494e-05, -4.087561547057879e-05, 0.00012528250339628396]]} - #*EXTRAS*# Step: 3 Bead: 9 -{"friction": [[0.00012432625074114097, -4.193167762857872e-05, -4.145990195968369e-05], [-4.193167762857872e-05, 0.00012438753110084288, -4.2033199826540666e-05], [-4.145990195968369e-05, -4.2033199826540666e-05, 0.00012406906102205601]]} - #*EXTRAS*# Step: 4 Bead: 9 -{"friction": [[0.00012371743794364442, -4.24021881917188e-05, -4.20219971389201e-05], [-4.24021881917188e-05, 0.00012378359988663142, -4.249965942919821e-05], [-4.20219971389201e-05, -4.249965942919821e-05, 0.0001234961044184532]]} - #*EXTRAS*# Step: 5 Bead: 9 -{"friction": [[0.00012335753008389734, -4.2652673509186896e-05, -4.233609091047655e-05], [-4.2652673509186896e-05, 0.00012342613083111606, -4.274410392905341e-05], [-4.233609091047655e-05, -4.274410392905341e-05, 0.0001231591359317254]]} - #*EXTRAS*# Step: 6 Bead: 9 -{"friction": [[0.00012314267895042084, -4.2792293690292754e-05, -4.2515261069752305e-05], [-4.2792293690292754e-05, 0.0001232119282989515, -4.287851400310903e-05], [-4.2515261069752305e-05, -4.287851400310903e-05, 0.00012295830449258265]]} - #*EXTRAS*# Step: 7 Bead: 9 -{"friction": [[0.00012300793153976268, -4.287612321072019e-05, -4.262403726599533e-05], [-4.287612321072019e-05, 0.00012307712181756268, -4.295839694642385e-05], [-4.262403726599533e-05, -4.295839694642385e-05, 0.00012283239805985823]]} - #*EXTRAS*# Step: 8 Bead: 9 -{"friction": [[0.00012292183332471136, -4.2928201513483356e-05, -4.2691993892038415e-05], [-4.2928201513483356e-05, 0.00012299075844019198, -4.300766414490546e-05], [-4.2691993892038415e-05, -4.300766414490546e-05, 0.00012275194863020398]]} - #*EXTRAS*# Step: 9 Bead: 9 -{"friction": [[0.0001228658781173968, -4.296143404455383e-05, -4.273548791877964e-05], [-4.296143404455383e-05, 0.00012293452546981973, -4.30389449619081e-05], [-4.273548791877964e-05, -4.30389449619081e-05, 0.00012269965913350484]]} - #*EXTRAS*# Step: 10 Bead: 9 -{"friction": [[0.00012282917571765416, -4.29829722302754e-05, -4.276372323649392e-05], [-4.29829722302754e-05, 0.00012289759293663275, -4.3059148589429764e-05], [-4.276372323649392e-05, -4.3059148589429764e-05, 0.00012266535735807075]]} - #*EXTRAS*# Step: 11 Bead: 9 -{"friction": [[0.00012280493526961627, -4.299708521284219e-05, -4.278224226318586e-05], [-4.299708521284219e-05, 0.00012287317887180066, -4.307235625533982e-05], [-4.278224226318586e-05, -4.307235625533982e-05, 0.0001226427003506479]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 deleted file mode 100644 index 51f3d17a2..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_10 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 -{"friction": [[0.00012991703273927124, -3.528883604745308e-05, -3.507531490942497e-05], [-3.528883604745308e-05, 0.00013010988907306278, -3.530960766886239e-05], [-3.507531490942497e-05, -3.530960766886239e-05, 0.00012959089167726413]]} - #*EXTRAS*# Step: 1 Bead: 10 -{"friction": [[0.00012742539155316816, -3.8771335543429635e-05, -3.8295516641351626e-05], [-3.8771335543429635e-05, 0.00012753423046271491, -3.884296188867691e-05], [-3.8295516641351626e-05, -3.884296188867691e-05, 0.00012707491852690858]]} - #*EXTRAS*# Step: 2 Bead: 10 -{"friction": [[0.00012534366717780842, -4.102524135119598e-05, -4.04730769542187e-05], [-4.102524135119598e-05, 0.00012540615664225692, -4.112294476480821e-05], [-4.04730769542187e-05, -4.112294476480821e-05, 0.0001250393466387531]]} - #*EXTRAS*# Step: 3 Bead: 10 -{"friction": [[0.00012413011502413723, -4.208954296022476e-05, -4.1644407568842224e-05], [-4.208954296022476e-05, 0.00012419281485011302, -4.219047124071295e-05], [-4.1644407568842224e-05, -4.219047124071295e-05, 0.0001238839633815352]]} - #*EXTRAS*# Step: 4 Bead: 10 -{"friction": [[0.00012354576358908833, -4.252426743214523e-05, -4.217383215084322e-05], [-4.252426743214523e-05, 0.0001236132394121735, -4.2619249743472965e-05], [-4.217383215084322e-05, -4.2619249743472965e-05, 0.0001233352584098023]]} - #*EXTRAS*# Step: 5 Bead: 10 -{"friction": [[0.00012319779289495726, -4.275717995655686e-05, -4.2469951573945315e-05], [-4.275717995655686e-05, 0.0001232669549616819, -4.2844860463195404e-05], [-4.2469951573945315e-05, -4.2844860463195404e-05, 0.00012300980912272966]]} - #*EXTRAS*# Step: 6 Bead: 10 -{"friction": [[0.00012298946417810597, -4.2887390510741024e-05, -4.263871716582828e-05], [-4.2887390510741024e-05, 0.0001230586134236721, -4.296908063385957e-05], [-4.263871716582828e-05, -4.296908063385957e-05, 0.00012281514279489683]]} - #*EXTRAS*# Step: 7 Bead: 10 -{"friction": [[0.00012285856919798114, -4.296573951758017e-05, -4.274112938323291e-05], [-4.296573951758017e-05, 0.00012292717381312678, -4.3042988127908014e-05], [-4.274112938323291e-05, -4.3042988127908014e-05, 0.0001226928285482115]]} - #*EXTRAS*# Step: 8 Bead: 10 -{"friction": [[0.00012277484844699785, -4.301447864268962e-05, -4.280508325625387e-05], [-4.301447864268962e-05, 0.00012284285195297435, -4.308859935578991e-05], [-4.280508325625387e-05, -4.308859935578991e-05, 0.00012261457620868174]]} - #*EXTRAS*# Step: 9 Bead: 10 -{"friction": [[0.00012272040232302414, -4.3045609472226036e-05, -4.284600533289691e-05], [-4.3045609472226036e-05, 0.00012278789978531225, -4.31175726831689e-05], [-4.284600533289691e-05, -4.31175726831689e-05, 0.00012256367311203086]]} - #*EXTRAS*# Step: 10 Bead: 10 -{"friction": [[0.00012268467522164476, -4.306579782479984e-05, -4.2872566184039735e-05], [-4.306579782479984e-05, 0.00012275178879229387, -4.3136291668084726e-05], [-4.2872566184039735e-05, -4.3136291668084726e-05, 0.00012253026387990798]]} - #*EXTRAS*# Step: 11 Bead: 10 -{"friction": [[0.00012266107254071265, -4.307903178963066e-05, -4.288998495556303e-05], [-4.307903178963066e-05, 0.00012272790926048976, -4.314853138009429e-05], [-4.288998495556303e-05, -4.314853138009429e-05, 0.00012250818902632428]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 deleted file mode 100644 index 4ca48ffd7..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_11 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 -{"friction": [[0.00012947879542120336, -3.5980173125907095e-05, -3.571737595016751e-05], [-3.5980173125907095e-05, 0.00012965675992702663, -3.6011208770852356e-05], [-3.571737595016751e-05, -3.6011208770852356e-05, 0.00012914132189854633]]} - #*EXTRAS*# Step: 1 Bead: 11 -{"friction": [[0.00012705252970230646, -3.921370812438338e-05, -3.870904648826126e-05], [-3.921370812438338e-05, 0.00012715033668483504, -3.92912874103169e-05], [-3.870904648826126e-05, -3.92912874103169e-05, 0.00012670595014234248]]} - #*EXTRAS*# Step: 2 Bead: 11 -{"friction": [[0.00012507454308038747, -4.127837593086452e-05, -4.073739587222327e-05], [-4.127837593086452e-05, 0.0001251349283747576, -4.137790040614989e-05], [-4.073739587222327e-05, -4.137790040614989e-05, 0.0001247809197922315]]} - #*EXTRAS*# Step: 3 Bead: 11 -{"friction": [[0.0001239193385280136, -4.2252582988567965e-05, -4.183928074955836e-05], [-4.2252582988567965e-05, 0.00012398379333133434, -4.2352156707860356e-05], [-4.183928074955836e-05, -4.2352156707860356e-05, 0.000123685620353021]]} - #*EXTRAS*# Step: 4 Bead: 11 -{"friction": [[0.000123359960663602, -4.265105176475702e-05, -4.233402595741703e-05], [-4.265105176475702e-05, 0.0001234285497355096, -4.2742533876065804e-05], [-4.233402595741703e-05, -4.2742533876065804e-05, 0.00012316140888372288]]} - #*EXTRAS*# Step: 5 Bead: 11 -{"friction": [[0.00012302424738712202, -4.2866124341593966e-05, -4.261102112152255e-05], [-4.2866124341593966e-05, 0.00012309346699192005, -4.2948905006687425e-05], [-4.261102112152255e-05, -4.2948905006687425e-05, 0.00012284764294760882]]} - #*EXTRAS*# Step: 6 Bead: 11 -{"friction": [[0.00012282264991463675, -4.298678035557154e-05, -4.276871893318173e-05], [-4.298678035557154e-05, 0.00012289102210902726, -4.306271487081847e-05], [-4.276871893318173e-05, -4.306271487081847e-05, 0.00012265925800972037]]} - #*EXTRAS*# Step: 7 Bead: 11 -{"friction": [[0.000122695742333527, -4.3059564289629945e-05, -4.286436340902654e-05], [-4.3059564289629945e-05, 0.00012276297930847354, -4.313051786946066e-05], [-4.286436340902654e-05, -4.313051786946066e-05, 0.00012254061363862887]]} - #*EXTRAS*# Step: 8 Bead: 11 -{"friction": [[0.00012261448766159858, -4.310491272030069e-05, -4.2924061852190495e-05], [-4.310491272030069e-05, 0.0001226807221796435, -4.317239453641315e-05], [-4.2924061852190495e-05, -4.317239453641315e-05, 0.00012246461075579693]]} - #*EXTRAS*# Step: 9 Bead: 11 -{"friction": [[0.00012256160905263074, -4.3133909391350406e-05, -4.2962250112511566e-05], [-4.3133909391350406e-05, 0.00012262706748494855, -4.319901088073911e-05], [-4.2962250112511566e-05, -4.319901088073911e-05, 0.00012241512911120248]]} - #*EXTRAS*# Step: 10 Bead: 11 -{"friction": [[0.00012252689599436746, -4.3152727047498306e-05, -4.298703135321873e-05], [-4.3152727047498306e-05, 0.00012259178972210728, -4.321621343798132e-05], [-4.298703135321873e-05, -4.321621343798132e-05, 0.0001223826359117054]]} - #*EXTRAS*# Step: 11 Bead: 11 -{"friction": [[0.00012250395683968717, -4.3165068397720224e-05, -4.300328088168336e-05], [-4.3165068397720224e-05, 0.0001225684527624527, -4.322746449495209e-05], [-4.300328088168336e-05, -4.322746449495209e-05, 0.00012236115893254023]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 deleted file mode 100644 index 70925dcda..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_12 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 -{"friction": [[0.0001289917032280999, -3.670377679754094e-05, -3.638593541360157e-05], [-3.670377679754094e-05, 0.00012915277647290737, -3.674556669422962e-05], [-3.638593541360157e-05, -3.674556669422962e-05, 0.0001286455046890979]]} - #*EXTRAS*# Step: 1 Bead: 12 -{"friction": [[0.00012665195793878069, -3.9669747200622883e-05, -3.913990676753965e-05], [-3.9669747200622883e-05, 0.00012673893038559495, -3.975316537486622e-05], [-3.913990676753965e-05, -3.975316537486622e-05, 0.00012631161770769217]]} - #*EXTRAS*# Step: 2 Bead: 12 -{"friction": [[0.00012479123031580464, -4.1534812321540836e-05, -4.101347659243908e-05], [-4.1534812321540836e-05, 0.00012485087063073363, -4.163572419670373e-05], [-4.101347659243908e-05, -4.163572419670373e-05, 0.000124510261111306]]} - #*EXTRAS*# Step: 3 Bead: 12 -{"friction": [[0.0001236946820485437, -4.241864213236119e-05, -4.2042319593186064e-05], [-4.241864213236119e-05, 0.0001237610287533441, -4.2515822164381005e-05], [-4.2042319593186064e-05, -4.2515822164381005e-05, 0.0001234747695788012]]} - #*EXTRAS*# Step: 4 Bead: 12 -{"friction": [[0.00012316042903819476, -4.278103751895841e-05, -4.250071928665974e-05], [-4.278103751895841e-05, 0.0001232296568580921, -4.2867737676748985e-05], [-4.250071928665974e-05, -4.2867737676748985e-05, 0.00012297489148755517]]} - #*EXTRAS*# Step: 5 Bead: 12 -{"friction": [[0.00012283713278045074, -4.2978320154446276e-05, -4.27576217716483e-05], [-4.2978320154446276e-05, 0.00012290560320630433, -4.305478953345787e-05], [-4.27576217716483e-05, -4.305478953345787e-05, 0.00012267279426988266]]} - #*EXTRAS*# Step: 6 Bead: 12 -{"friction": [[0.00012264239584141093, -4.3089445900652e-05, -4.29036954360305e-05], [-4.3089445900652e-05, 0.0001227090001158148, -4.315814539096394e-05], [-4.29036954360305e-05, -4.315814539096394e-05, 0.00012249071919843307]]} - #*EXTRAS*# Step: 7 Bead: 12 -{"friction": [[0.00012251956673121504, -4.315667829969557e-05, -4.299223419891966e-05], [-4.315667829969557e-05, 0.00012258433550796455, -4.321981832695115e-05], [-4.299223419891966e-05, -4.321981832695115e-05, 0.00012237577424942128]]} - #*EXTRAS*# Step: 8 Bead: 12 -{"friction": [[0.0001224408410652038, -4.319864406557981e-05, -4.304746620210496e-05], [-4.319864406557981e-05, 0.00012250413857150283, -4.325794510944247e-05], [-4.304746620210496e-05, -4.325794510944247e-05, 0.00012230204517123247]]} - #*EXTRAS*# Step: 9 Bead: 12 -{"friction": [[0.00012238957266676336, -4.3225511502859485e-05, -4.308278565561852e-05], [-4.3225511502859485e-05, 0.0001224517813035304, -4.3282194881450844e-05], [-4.308278565561852e-05, -4.3282194881450844e-05, 0.0001222540029344652]]} - #*EXTRAS*# Step: 10 Bead: 12 -{"friction": [[0.00012235590248029337, -4.324296156254507e-05, -4.310569969033522e-05], [-4.324296156254507e-05, 0.00012241733805664845, -4.329787488904623e-05], [-4.310569969033522e-05, -4.329787488904623e-05, 0.00012222243851486058]]} - #*EXTRAS*# Step: 11 Bead: 12 -{"friction": [[0.00012233364623565895, -4.3254412286209014e-05, -4.3120722539237446e-05], [-4.3254412286209014e-05, 0.00012239454507612698, -4.330813331607712e-05], [-4.3120722539237446e-05, -4.330813331607712e-05, 0.00012220156823806015]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 deleted file mode 100644 index ed4f1acb0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_13 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 -{"friction": [[0.00012845706441002837, -3.745063354531244e-05, -3.70741901275435e-05], [-3.745063354531244e-05, 0.00012859965202404274, -3.75034377235823e-05], [-3.70741901275435e-05, -3.75034377235823e-05, 0.00012810552361980438]]} - #*EXTRAS*# Step: 1 Bead: 13 -{"friction": [[0.0001262271027058798, -4.013230315464137e-05, -3.95837870886085e-05], [-4.013230315464137e-05, 0.00012630402487175663, -4.022122562515816e-05], [-3.95837870886085e-05, -4.022122562515816e-05, 0.00012589575207885725]]} - #*EXTRAS*# Step: 2 Bead: 13 -{"friction": [[0.00012449576835121953, -4.179059448015686e-05, -4.129840952753301e-05], [-4.179059448015686e-05, 0.00012455611338617396, -4.189218684234193e-05], [-4.129840952753301e-05, -4.189218684234193e-05, 0.0001242295000003705]]} - #*EXTRAS*# Step: 3 Bead: 13 -{"friction": [[0.00012345671247295615, -4.2585725412707144e-05, -4.225117511565929e-05], [-4.2585725412707144e-05, 0.0001235247722350038, -4.267913954722775e-05], [-4.225117511565929e-05, -4.267913954722775e-05, 0.00012325191069685452]]} - #*EXTRAS*# Step: 4 Bead: 13 -{"friction": [[0.00012294741939698566, -4.291284516411205e-05, -4.267192834907532e-05], [-4.291284516411205e-05, 0.00012301644325730991, -4.299316727370822e-05], [-4.267192834907532e-05, -4.299316727370822e-05, 0.0001227758567867178]]} - #*EXTRAS*# Step: 5 Bead: 13 -{"friction": [[0.0001226365602128012, -4.3092689398073716e-05, -4.290796607493997e-05], [-4.3092689398073716e-05, 0.00012270308940558696, -4.3161136465297886e-05], [-4.290796607493997e-05, -4.3161136465297886e-05, 0.00012248526026731912]]} - #*EXTRAS*# Step: 6 Bead: 13 -{"friction": [[0.00012244874560659737, -4.319446946550274e-05, -4.30419748669891e-05], [-4.319446946550274e-05, 0.00012251220168642827, -4.325416581287509e-05], [-4.30419748669891e-05, -4.325416581287509e-05, 0.00012230945027908902]]} - #*EXTRAS*# Step: 7 Bead: 13 -{"friction": [[0.0001223300494252409, -4.325625659939129e-05, -4.3123141107067376e-05], [-4.325625659939129e-05, 0.000122390859580582, -4.330978327428848e-05], [-4.3123141107067376e-05, -4.330978327428848e-05, 0.00012219819495481467]]} - #*EXTRAS*# Step: 8 Bead: 13 -{"friction": [[0.000122253894565434, -4.3294903904359764e-05, -4.317374069674106e-05], [-4.3294903904359764e-05, 0.0001223126977418057, -4.334420602269342e-05], [-4.317374069674106e-05, -4.334420602269342e-05, 0.00012212674152514564]]} - #*EXTRAS*# Step: 9 Bead: 13 -{"friction": [[0.00012220426625646682, -4.331968225091323e-05, -4.320608538798865e-05], [-4.331968225091323e-05, 0.00012226162574633954, -4.336611819304311e-05], [-4.320608538798865e-05, -4.336611819304311e-05, 0.00012208014308652608]]} - #*EXTRAS*# Step: 10 Bead: 13 -{"friction": [[0.00012217165975116304, -4.333579036922635e-05, -4.322706357268622e-05], [-4.333579036922635e-05, 0.00012222801089173543, -4.3380294316146807e-05], [-4.322706357268622e-05, -4.3380294316146807e-05, 0.00012204951174641371]]} - #*EXTRAS*# Step: 11 Bead: 13 -{"friction": [[0.00012215010066933093, -4.334636711442955e-05, -4.324081477763576e-05], [-4.334636711442955e-05, 0.0001222057586301239, -4.338957228880028e-05], [-4.324081477763576e-05, -4.338957228880028e-05, 0.00012202925161266956]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 deleted file mode 100644 index 1fe6424a9..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_14 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 -{"friction": [[0.0001278780787535134, -3.82100307641886e-05, -3.7774858450361775e-05], [-3.82100307641886e-05, 0.00012800126167604204, -3.8273806917358165e-05], [-3.7774858450361775e-05, -3.8273806917358165e-05, 0.0001275253587009841]]} - #*EXTRAS*# Step: 1 Bead: 14 -{"friction": [[0.00012578246331836646, -4.059341152208736e-05, -4.0036238382891376e-05], [-4.059341152208736e-05, 0.00012585085738073384, -4.06872452092589e-05], [-4.0036238382891376e-05, -4.06872452092589e-05, 0.0001254632457589615]]} - #*EXTRAS*# Step: 2 Bead: 14 -{"friction": [[0.00012418931039763145, -4.204251499751554e-05, -4.15890169615444e-05], [-4.204251499751554e-05, 0.0001242515520984264, -4.214368559323861e-05], [-4.15890169615444e-05, -4.214368559323861e-05, 0.00012393977019774295]]} - #*EXTRAS*# Step: 3 Bead: 14 -{"friction": [[0.00012320575625420508, -4.275206650693605e-05, -4.246336674785786e-05], [-4.275206650693605e-05, 0.00012327490083350706, -4.283995078908281e-05], [-4.246336674785786e-05, -4.283995078908281e-05, 0.00012301725153761117]]} - #*EXTRAS*# Step: 4 Bead: 14 -{"friction": [[0.0001227210006965545, -4.304526973926057e-05, -4.284555849963817e-05], [-4.304526973926057e-05, 0.00012278850423350817, -4.3117257196333533e-05], [-4.284555849963817e-05, -4.3117257196333533e-05, 0.0001225642326145286]]} - #*EXTRAS*# Step: 5 Bead: 14 -{"friction": [[0.0001224224869903457, -4.320830406661538e-05, -4.306016981507952e-05], [-4.320830406661538e-05, 0.00012248540676616353, -4.326667870544688e-05], [-4.306016981507952e-05, -4.326667870544688e-05, 0.0001222848487138715]]} - #*EXTRAS*# Step: 6 Bead: 14 -{"friction": [[0.00012224160479492024, -4.330106954237184e-05, -4.3181796932756195e-05], [-4.330106954237184e-05, 0.00012230006058893702, -4.3349670235917054e-05], [-4.3181796932756195e-05, -4.3349670235917054e-05, 0.00012211520464433002]]} - #*EXTRAS*# Step: 7 Bead: 14 -{"friction": [[0.00012212706883186822, -4.335760213904237e-05, -4.325540004361911e-05], [-4.335760213904237e-05, 0.0001221819627156497, -4.339940099254343e-05], [-4.325540004361911e-05, -4.339940099254343e-05, 0.00012200760112498288]]} - #*EXTRAS*# Step: 8 Bead: 14 -{"friction": [[0.0001220535113296791, -4.339304620496759e-05, -4.330124943885356e-05], [-4.339304620496759e-05, 0.00012210579935207461, -4.343022300927331e-05], [-4.330124943885356e-05, -4.343022300927331e-05, 0.00012193840973297636]]} - #*EXTRAS*# Step: 9 Bead: 14 -{"friction": [[0.00012200554391917203, -4.3415807532017956e-05, -4.3330544466172255e-05], [-4.3415807532017956e-05, 0.00012205599412484769, -4.344986273376658e-05], [-4.3330544466172255e-05, -4.344986273376658e-05, 0.0001218932504125687]]} - #*EXTRAS*# Step: 10 Bead: 14 -{"friction": [[0.00012197401631245756, -4.343061978561974e-05, -4.334953841863052e-05], [-4.343061978561974e-05, 0.00012202319786107986, -4.346257688449717e-05], [-4.334953841863052e-05, -4.346257688449717e-05, 0.00012186355091694459]]} - #*EXTRAS*# Step: 11 Bead: 14 -{"friction": [[0.00012195316510467573, -4.3440352462524354e-05, -4.336198634638677e-05], [-4.3440352462524354e-05, 0.00012200148083516266, -4.347090171953936e-05], [-4.336198634638677e-05, -4.347090171953936e-05, 0.00012184390088759481]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 deleted file mode 100644 index ec5aaf637..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_15 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 -{"friction": [[0.00012726027358761464, -3.896940372900226e-05, -3.8480234708173996e-05], [-3.896940372900226e-05, 0.00012736412762627062, -3.9043725441288e-05], [-3.8480234708173996e-05, -3.9043725441288e-05, 0.00012691129785582055]]} - #*EXTRAS*# Step: 1 Bead: 15 -{"friction": [[0.00012532374853239491, -4.104428662184295e-05, -4.049272120305384e-05], [-4.104428662184295e-05, 0.00012538603933726745, -4.1142140091990166e-05], [-4.049272120305384e-05, -4.1142140091990166e-05, 0.0001250201774848244]]} - #*EXTRAS*# Step: 2 Bead: 15 -{"friction": [[0.00012387257592657113, -4.228780976666489e-05, -4.1881968130470805e-05], [-4.228780976666489e-05, 0.00012393743148223153, -4.238697067699562e-05], [-4.1881968130470805e-05, -4.238697067699562e-05, 0.0001236416880526651]]} - #*EXTRAS*# Step: 3 Bead: 15 -{"friction": [[0.00012294185777681589, -4.291619175755203e-05, -4.267629936031752e-05], [-4.291619175755203e-05, 0.00012301086164234008, -4.299632878874585e-05], [-4.267629936031752e-05, -4.299632878874585e-05, 0.00012277065996541735]]} - #*EXTRAS*# Step: 4 Bead: 15 -{"friction": [[0.00012248103095928578, -4.317732859583495e-05, -4.3019419811348176e-05], [-4.317732859583495e-05, 0.00012254510936925055, -4.323861665018421e-05], [-4.3019419811348176e-05, -4.323861665018421e-05, 0.00012233969039986793]]} - #*EXTRAS*# Step: 5 Bead: 15 -{"friction": [[0.0001221946938609292, -4.3324425170868924e-05, -4.3212266510874424e-05], [-4.3324425170868924e-05, 0.00012225176229110112, -4.337029795808152e-05], [-4.3212266510874424e-05, -4.337029795808152e-05, 0.00012207115184934312]]} - #*EXTRAS*# Step: 6 Bead: 15 -{"friction": [[0.00012202072169296155, -4.3408635037250346e-05, -4.3321326701368724e-05], [-4.3408635037250346e-05, 0.00012207176540496816, -4.3443687170979784e-05], [-4.3321326701368724e-05, -4.3443687170979784e-05, 0.00012190754309742539]]} - #*EXTRAS*# Step: 7 Bead: 15 -{"friction": [[0.0001219103575391437, -4.346017719972109e-05, -4.3387256907824e-05], [-4.346017719972109e-05, 0.00012195682821020236, -4.348778561460905e-05], [-4.3387256907824e-05, -4.348778561460905e-05, 0.00012180353921987073]]} - #*EXTRAS*# Step: 8 Bead: 15 -{"friction": [[0.00012183941580338053, -4.349257738995842e-05, -4.3428289408522766e-05], [-4.349257738995842e-05, 0.00012188262589594939, -4.351516234413921e-05], [-4.3428289408522766e-05, -4.351516234413921e-05, 0.00012173658928011548]]} - #*EXTRAS*# Step: 9 Bead: 15 -{"friction": [[0.00012179312554758328, -4.3513421321194995e-05, -4.345449276775801e-05], [-4.3513421321194995e-05, 0.00012183406940355936, -4.353262758497828e-05], [-4.345449276775801e-05, -4.353262758497828e-05, 0.00012169286072035449]]} - #*EXTRAS*# Step: 10 Bead: 15 -{"friction": [[0.0001217626893860185, -4.352700137634921e-05, -4.3471475562486856e-05], [-4.352700137634921e-05, 0.0001218020826636864, -4.3543942735527616e-05], [-4.3471475562486856e-05, -4.3543942735527616e-05, 0.00012166408978763266]]} - #*EXTRAS*# Step: 11 Bead: 15 -{"friction": [[0.0001217425551325182, -4.353593130392902e-05, -4.3482602693597565e-05], [-4.353593130392902e-05, 0.00012178089605365459, -4.355135545973759e-05], [-4.3482602693597565e-05, -4.355135545973759e-05, 0.00012164504862631244]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 deleted file mode 100644 index c47846f62..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_16 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 16 -{"friction": [[0.00012661143308844656, -3.971479929521334e-05, -3.9182795101576245e-05], [-3.971479929521334e-05, 0.00012669737778386712, -3.979877417067022e-05], [-3.9182795101576245e-05, -3.979877417067022e-05, 0.00012627184388542937]]} - #*EXTRAS*# Step: 1 Bead: 16 -{"friction": [[0.00012485779285589202, -4.147551960731289e-05, -4.0948815471506864e-05], [-4.147551960731289e-05, 0.00012491747138266817, -4.157616122914629e-05], [-4.0948815471506864e-05, -4.157616122914629e-05, 0.00012457372023348448]]} - #*EXTRAS*# Step: 2 Bead: 16 -{"friction": [[0.00012354579417121362, -4.252424610685229e-05, -4.217380541720183e-05], [-4.252424610685229e-05, 0.00012361326978017884, -4.261922892320737e-05], [-4.217380541720183e-05, -4.261922892320737e-05, 0.00012333528704243385]]} - #*EXTRAS*# Step: 3 Bead: 16 -{"friction": [[0.0001226647439240126, -4.3076978625894126e-05, -4.2887282218615385e-05], [-4.3076978625894126e-05, 0.00012273162494002326, -4.314663410699337e-05], [-4.2887282218615385e-05, -4.314663410699337e-05, 0.00012251162294685874]]} - #*EXTRAS*# Step: 4 Bead: 16 -{"friction": [[0.00012222713268466773, -4.3308304966741746e-05, -4.3191244528735084e-05], [-4.3308304966741746e-05, 0.00012228517089435208, -4.3356072643850946e-05], [-4.3191244528735084e-05, -4.3356072643850946e-05, 0.00012210161695559905]]} - #*EXTRAS*# Step: 5 Bead: 16 -{"friction": [[0.00012195276629704154, -4.344053812346781e-05, -4.3362223544278977e-05], [-4.344053812346781e-05, 0.00012200106525855596, -4.3471060296492975e-05], [-4.3362223544278977e-05, -4.3471060296492975e-05, 0.00012184352499222377]]} - #*EXTRAS*# Step: 6 Bead: 16 -{"friction": [[0.00012178567172013534, -4.3516756167033884e-05, -4.345866992309634e-05], [-4.3516756167033884e-05, 0.00012182624029939764, -4.3535410937610724e-05], [-4.345866992309634e-05, -4.3535410937610724e-05, 0.00012168581612521065]]} - #*EXTRAS*# Step: 7 Bead: 16 -{"friction": [[0.00012167948855490207, -4.356363165957137e-05, -4.351690240150563e-05], [-4.356363165957137e-05, 0.00012171439472691409, -4.357420606666969e-05], [-4.351690240150563e-05, -4.357420606666969e-05, 0.00012158536117482042]]} - #*EXTRAS*# Step: 8 Bead: 16 -{"friction": [[0.00012161118105668094, -4.359318299385875e-05, -4.355310495040823e-05], [-4.359318299385875e-05, 0.00012164212745857588, -4.359833827928824e-05], [-4.355310495040823e-05, -4.359833827928824e-05, 0.00012152063488480735]]} - #*EXTRAS*# Step: 9 Bead: 16 -{"friction": [[0.00012156658486373061, -4.361223131580249e-05, -4.357620916622884e-05], [-4.361223131580249e-05, 0.0001215948098975108, -4.3613755474880615e-05], [-4.357620916622884e-05, -4.3613755474880615e-05, 0.0001214783312422077]]} - #*EXTRAS*# Step: 10 Bead: 16 -{"friction": [[0.0001215372533837494, -4.362465694462225e-05, -4.359117638981338e-05], [-4.362465694462225e-05, 0.00012156362936073852, -4.36237528581027e-05], [-4.359117638981338e-05, -4.36237528581027e-05, 0.00012145048754327093]]} - #*EXTRAS*# Step: 11 Bead: 16 -{"friction": [[0.0001215178457297046, -4.363283457276851e-05, -4.360098000899406e-05], [-4.363283457276851e-05, 0.00012154297228550594, -4.363030637763299e-05], [-4.360098000899406e-05, -4.363030637763299e-05, 0.00012143205542935452]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 deleted file mode 100644 index b83b8d565..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_17 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 17 -{"friction": [[0.00012594185509922254, -4.0430818480279955e-05, -3.987531491748839e-05], [-4.0430818480279955e-05, 0.0001260130421325445, -4.052299864131734e-05], [-3.987531491748839e-05, -4.052299864131734e-05, 0.00012561795751016416]]} - #*EXTRAS*# Step: 1 Bead: 17 -{"friction": [[0.00012438959864401357, -4.1879451907979675e-05, -4.139975238174502e-05], [-4.1879451907979675e-05, 0.00012445049212081701, -4.198104486218396e-05], [-4.139975238174502e-05, -4.198104486218396e-05, 0.00012412896409157506]]} - #*EXTRAS*# Step: 2 Bead: 17 -{"friction": [[0.00012320865033165957, -4.275020565511822e-05, -4.246097130418611e-05], [-4.275020565511822e-05, 0.00012327778826046055, -4.283816354740649e-05], [-4.246097130418611e-05, -4.283816354740649e-05, 0.0001230199563312979]]} - #*EXTRAS*# Step: 3 Bead: 17 -{"friction": [[0.00012237379645341692, -4.323370686238187e-05, -4.309354999720255e-05], [-4.323370686238187e-05, 0.00012243564866549968, -4.328956592367749e-05], [-4.309354999720255e-05, -4.328956592367749e-05, 0.0001222392147070845]]} - #*EXTRAS*# Step: 4 Bead: 17 -{"friction": [[0.00012195867403475409, -4.343778595839776e-05, -4.335870641051787e-05], [-4.343778595839776e-05, 0.00012200722059935485, -4.346870873672655e-05], [-4.335870641051787e-05, -4.346870873672655e-05, 0.0001218490930804006]]} - #*EXTRAS*# Step: 5 Bead: 17 -{"friction": [[0.00012169608073478002, -4.355638331953843e-05, -4.3507959906463095e-05], [-4.355638331953843e-05, 0.00012173191101000938, -4.3568247953976755e-05], [-4.3507959906463095e-05, -4.3568247953976755e-05, 0.00012160107100297852]]} - #*EXTRAS*# Step: 6 Bead: 17 -{"friction": [[0.00012153584635522432, -4.3625250982375524e-05, -4.3591889807296926e-05], [-4.3625250982375524e-05, 0.0001215621324472966, -4.3624229616322105e-05], [-4.3591889807296926e-05, -4.3624229616322105e-05, 0.00012144915147878073]]} - #*EXTRAS*# Step: 7 Bead: 17 -{"friction": [[0.00012143386577427496, -4.366782714310562e-05, -4.3642488199643905e-05], [-4.366782714310562e-05, 0.00012145334579958563, -4.365811176322798e-05], [-4.3642488199643905e-05, -4.365811176322798e-05, 0.0001213522137684051]]} - #*EXTRAS*# Step: 8 Bead: 17 -{"friction": [[0.00012136822017854234, -4.369475036426348e-05, -4.367390355635056e-05], [-4.369475036426348e-05, 0.0001213830124681712, -4.367923735615852e-05], [-4.367390355635056e-05, -4.367923735615852e-05, 0.00012128970694034944]]} - #*EXTRAS*# Step: 9 Bead: 17 -{"friction": [[0.00012132534139071193, -4.3712140725117625e-05, -4.369393706176951e-05], [-4.3712140725117625e-05, 0.00012133694079897278, -4.369275621844458e-05], [-4.369393706176951e-05, -4.369275621844458e-05, 0.0001212488317468092]]} - #*EXTRAS*# Step: 10 Bead: 17 -{"friction": [[0.00012129713224782773, -4.3723499736472284e-05, -4.370690770312432e-05], [-4.3723499736472284e-05, 0.00012130657439601862, -4.370153196718018e-05], [-4.370690770312432e-05, -4.370153196718018e-05, 0.00012122192033112598]]} - #*EXTRAS*# Step: 11 Bead: 17 -{"friction": [[0.0001212784638381476, -4.373098198701315e-05, -4.3715400480677494e-05], [-4.373098198701315e-05, 0.0001212864535082251, -4.370728887107541e-05], [-4.3715400480677494e-05, -4.370728887107541e-05, 0.00012120410174994968]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 deleted file mode 100644 index dca22809c..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_18 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 18 -{"friction": [[0.00012526486252094083, -4.1100303058221635e-05, -4.0550714905083066e-05], [-4.1100303058221635e-05, 0.00012532660471124878, -4.119858624384984e-05], [-4.0550714905083066e-05, -4.119858624384984e-05, 0.00012496354601260095]]} - #*EXTRAS*# Step: 1 Bead: 18 -{"friction": [[0.0001239188276642438, -4.2252969695188683e-05, -4.183974823014191e-05], [-4.2252969695188683e-05, 0.00012398328684323833, -4.235253913582912e-05], [-4.183974823014191e-05, -4.235253913582912e-05, 0.00012368514027657725]]} - #*EXTRAS*# Step: 2 Bead: 18 -{"friction": [[0.0001228602460114463, -4.296475247559434e-05, -4.273983593574023e-05], [-4.296475247559434e-05, 0.00012292886056593209, -4.304206141594908e-05], [-4.273983593574023e-05, -4.304206141594908e-05, 0.00012269439563349538]]} - #*EXTRAS*# Step: 3 Bead: 18 -{"friction": [[0.00012206803309219933, -4.338610103771562e-05, -4.3292286425981794e-05], [-4.338610103771562e-05, 0.0001221208557713237, -4.342420612349431e-05], [-4.3292286425981794e-05, -4.342420612349431e-05, 0.0001219520751759214]]} - #*EXTRAS*# Step: 4 Bead: 18 -{"friction": [[0.00012167475687090212, -4.356569362280953e-05, -4.35194419282963e-05], [-4.356569362280953e-05, 0.000121709396820621, -4.357589821773643e-05], [-4.35194419282963e-05, -4.357589821773643e-05, 0.00012158088023334547]]} - #*EXTRAS*# Step: 5 Bead: 18 -{"friction": [[0.00012142379664401083, -4.3671980805157275e-05, -4.3647365516341516e-05], [-4.3671980805157275e-05, 0.00012144257331291909, -4.3661386350578335e-05], [-4.3647365516341516e-05, -4.3661386350578335e-05, 0.0001213426316208139]]} - #*EXTRAS*# Step: 6 Bead: 18 -{"friction": [[0.00012127044732088058, -4.3734186540719725e-05, -4.371902520353982e-05], [-4.3734186540719725e-05, 0.00012127780719164214, -4.3709748683593e-05], [-4.371902520353982e-05, -4.3709748683593e-05, 0.00012119644795294669]]} - #*EXTRAS*# Step: 7 Bead: 18 -{"friction": [[0.00012117271936793818, -4.377285615018617e-05, -4.376214442477691e-05], [-4.377285615018617e-05, 0.00012117210657417093, -4.373915424778001e-05], [-4.376214442477691e-05, -4.373915424778001e-05, 0.00012110303379184989]]} - #*EXTRAS*# Step: 8 Bead: 18 -{"friction": [[0.00012110978698251192, -4.3797381344074104e-05, -4.378887442151027e-05], [-4.3797381344074104e-05, 0.00012110375353977132, -4.375753607540866e-05], [-4.378887442151027e-05, -4.375753607540866e-05, 0.00012104277286761216]]} - #*EXTRAS*# Step: 9 Bead: 18 -{"friction": [[0.00012106867527229401, -4.381324471044223e-05, -4.3805907198902106e-05], [-4.381324471044223e-05, 0.0001210589848600004, -4.37693154426202e-05], [-4.3805907198902106e-05, -4.37693154426202e-05, 0.00012100336231749422]]} - #*EXTRAS*# Step: 10 Bead: 18 -{"friction": [[0.00012104163126097949, -4.3823611481724485e-05, -4.3816929914050936e-05], [-4.3823611481724485e-05, 0.00012102948729823076, -4.3776966741329203e-05], [-4.3816929914050936e-05, -4.3776966741329203e-05, 0.00012097741881566642]]} - #*EXTRAS*# Step: 11 Bead: 18 -{"friction": [[0.00012102373565946622, -4.383044145622314e-05, -4.382414545838014e-05], [-4.383044145622314e-05, 0.00012100994777267574, -4.378198763077536e-05], [-4.382414545838014e-05, -4.378198763077536e-05, 0.00012096024347267427]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 deleted file mode 100644 index 6f76db57e..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_19 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 19 -{"friction": [[0.00012459632602131336, -4.170492542491858e-05, -4.120187097266213e-05], [-4.170492542491858e-05, 0.00012465628415804492, -4.1806390624578615e-05], [-4.120187097266213e-05, -4.1806390624578615e-05, 0.00012432488906652224]]} - #*EXTRAS*# Step: 1 Bead: 19 -{"friction": [[0.00012344341606437893, -4.2594792313237465e-05, -4.226263546021848e-05], [-4.2594792313237465e-05, 0.00012351155558679326, -4.2687955260761484e-05], [-4.226263546021848e-05, -4.2687955260761484e-05, 0.00012323947016404854]]} - #*EXTRAS*# Step: 2 Bead: 19 -{"friction": [[0.0001224990773896943, -4.316768398975024e-05, -4.300672431795472e-05], [-4.316768398975024e-05, 0.00012256348613050858, -4.32298457976013e-05], [-4.300672431795472e-05, -4.32298457976013e-05, 0.00012235658999764628]]} - #*EXTRAS*# Step: 3 Bead: 19 -{"friction": [[0.00012174609791396609, -4.353436308218889e-05, -4.3480650988786034e-05], [-4.353436308218889e-05, 0.00012178462554804798, -4.355005529363577e-05], [-4.3480650988786034e-05, -4.355005529363577e-05, 0.00012164839956465362]]} - #*EXTRAS*# Step: 4 Bead: 19 -{"friction": [[0.00012137421260250509, -4.3692307869037394e-05, -4.367107323894586e-05], [-4.3692307869037394e-05, 0.0001213894428461508, -4.367733060110526e-05], [-4.367107323894586e-05, -4.367733060110526e-05, 0.00012129541640312762]]} - #*EXTRAS*# Step: 5 Bead: 19 -{"friction": [[0.00012113485643045337, -4.3787646628226176e-05, -4.377832243325158e-05], [-4.3787646628226176e-05, 0.00012113100855893098, -4.375026470298071e-05], [-4.377832243325158e-05, -4.375026470298071e-05, 0.00012106678800552513]]} - #*EXTRAS*# Step: 6 Bead: 19 -{"friction": [[0.00012098857876750774, -4.384378969877826e-05, -4.383814076658575e-05], [-4.384378969877826e-05, 0.00012097151526909515, -4.379175444989424e-05], [-4.383814076658575e-05, -4.379175444989424e-05, 0.00012092648333040016]]} - #*EXTRAS*# Step: 7 Bead: 19 -{"friction": [[0.00012089540608882924, -4.387871672039968e-05, -4.387409805930765e-05], [-4.387871672039968e-05, 0.00012086937996559985, -4.381702496214579e-05], [-4.387409805930765e-05, -4.381702496214579e-05, 0.00012083689826103156]]} - #*EXTRAS*# Step: 8 Bead: 19 -{"friction": [[0.00012083548205169441, -4.390083377314648e-05, -4.389637471563365e-05], [-4.390083377314648e-05, 0.00012080348850204614, -4.3832814873784745e-05], [-4.389637471563365e-05, -4.3832814873784745e-05, 0.00012077919682483574]]} - #*EXTRAS*# Step: 9 Bead: 19 -{"friction": [[0.00012079636313107244, -4.391512476239298e-05, -4.39105667510141e-05], [-4.391512476239298e-05, 0.00012076039364198491, -4.3842930450409304e-05], [-4.39105667510141e-05, -4.3842930450409304e-05, 0.00012074149417647374]]} - #*EXTRAS*# Step: 10 Bead: 19 -{"friction": [[0.00012077064306673696, -4.392445721663701e-05, -4.3919749224597155e-05], [-4.392445721663701e-05, 0.00012073202634962098, -4.384949941703018e-05], [-4.3919749224597155e-05, -4.384949941703018e-05, 0.00012071669067790518]]} - #*EXTRAS*# Step: 11 Bead: 19 -{"friction": [[0.00012075362873120946, -4.393060299194752e-05, -4.392575946645879e-05], [-4.393060299194752e-05, 0.00012071324679783699, -4.385380946925693e-05], [-4.392575946645879e-05, -4.385380946925693e-05, 0.0001207002763850438]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 deleted file mode 100644 index b6d7a85e0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_20 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 20 -{"friction": [[0.0001239405986518248, -4.2236453288719934e-05, -4.1819804194371584e-05], [-4.2236453288719934e-05, 0.0001240048715323352, -4.2336200609474876e-05], [-4.1819804194371584e-05, -4.2336200609474876e-05, 0.00012370560188273736]]} - #*EXTRAS*# Step: 1 Bead: 20 -{"friction": [[0.00012295984495349003, -4.290535104625566e-05, -4.2662144065700354e-05], [-4.290535104625566e-05, 0.0001230289105766293, -4.298608316206368e-05], [-4.2662144065700354e-05, -4.298608316206368e-05, 0.00012278746720004207]]} - #*EXTRAS*# Step: 2 Bead: 20 -{"friction": [[0.0001221230305038373, -4.335956525671425e-05, -4.325794614403937e-05], [-4.335956525671425e-05, 0.0001221777878931933, -4.3401115523885014e-05], [-4.325794614403937e-05, -4.3401115523885014e-05, 0.00012200380431317677]]} - #*EXTRAS*# Step: 3 Bead: 20 -{"friction": [[0.00012140626289656152, -4.36791927969543e-05, -4.3655807820111423e-05], [-4.36791927969543e-05, 0.00012142380124915721, -4.366705874410578e-05], [-4.3655807820111423e-05, -4.366705874410578e-05, 0.00012132594110624523]]} - #*EXTRAS*# Step: 4 Bead: 20 -{"friction": [[0.00012105563210146888, -4.38182513360711e-05, -4.381124127146911e-05], [-4.38182513360711e-05, 0.00012104476302488789, -4.377301521743328e-05], [-4.381124127146911e-05, -4.377301521743328e-05, 0.00012099085173621321]]} - #*EXTRAS*# Step: 5 Bead: 20 -{"friction": [[0.00012082854503067202, -4.390337651941366e-05, -4.389891143736767e-05], [-4.390337651941366e-05, 0.00012079585094469738, -4.383461969740494e-05], [-4.389891143736767e-05, -4.383461969740494e-05, 0.00012077251292849089]]} - #*EXTRAS*# Step: 6 Bead: 20 -{"friction": [[0.00012069028608537877, -4.3953287521160523e-05, -4.3947691463224126e-05], [-4.3953287521160523e-05, 0.00012064323796382602, -4.386960932220906e-05], [-4.3947691463224126e-05, -4.386960932220906e-05, 0.0001206391244137673]]} - #*EXTRAS*# Step: 7 Bead: 20 -{"friction": [[0.00012060234710547045, -4.398426625409771e-05, -4.39770028188763e-05], [-4.398426625409771e-05, 0.00012054581234529774, -4.3890909826330555e-05], [-4.39770028188763e-05, -4.3890909826330555e-05, 0.00012055411688115091]]} - #*EXTRAS*# Step: 8 Bead: 20 -{"friction": [[0.00012054586162770552, -4.400384681944954e-05, -4.3995149298204463e-05], [-4.400384681944954e-05, 0.00012048310218290587, -4.390420876579431e-05], [-4.3995149298204463e-05, -4.390420876579431e-05, 0.00012049944923572026]]} - #*EXTRAS*# Step: 9 Bead: 20 -{"friction": [[0.00012050901068040135, -4.401648615800542e-05, -4.4006706639780997e-05], [-4.401648615800542e-05, 0.00012044213892242864, -4.391272566863104e-05], [-4.4006706639780997e-05, -4.391272566863104e-05, 0.00012046375759012989]]} - #*EXTRAS*# Step: 10 Bead: 20 -{"friction": [[0.00012048479320915928, -4.402473410054979e-05, -4.4014182389584205e-05], [-4.402473410054979e-05, 0.00012041519794768444, -4.391825484457878e-05], [-4.4014182389584205e-05, -4.391825484457878e-05, 0.00012044029074267317]]} - #*EXTRAS*# Step: 11 Bead: 20 -{"friction": [[0.00012046877729835047, -4.4030163292280214e-05, -4.401907477694183e-05], [-4.4030163292280214e-05, 0.0001203973720374864, -4.3921882067007375e-05], [-4.401907477694183e-05, -4.3921882067007375e-05, 0.00012042476641174526]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 deleted file mode 100644 index 790d1a468..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_21 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 21 -{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} - #*EXTRAS*# Step: 1 Bead: 21 -{"friction": [[0.00012246308505234, -4.318687430765704e-05, -4.303198209536257e-05], [-4.318687430765704e-05, 0.00012252682254249207, -4.32472821375287e-05], [-4.303198209536257e-05, -4.32472821375287e-05, 0.00012232288238727613]]} - #*EXTRAS*# Step: 2 Bead: 21 -{"friction": [[0.00012172939169122137, -4.3541746717750115e-05, -4.348983117499435e-05], [-4.3541746717750115e-05, 0.0001217670330810301, -4.355617081143887e-05], [-4.348983117499435e-05, -4.355617081143887e-05, 0.00012163259612644521]]} - #*EXTRAS*# Step: 3 Bead: 21 -{"friction": [[0.0001210464730957474, -4.382175946205089e-05, -4.38149669713396e-05], [-4.382175946205089e-05, 0.00012103477114590811, -4.377560253298005e-05], [-4.38149669713396e-05, -4.377560253298005e-05, 0.00012098206469008646]]} - #*EXTRAS*# Step: 4 Bead: 21 -{"friction": [[0.00012071850496068567, -4.394321981597958e-05, -4.393800669511929e-05], [-4.394321981597958e-05, 0.00012067444464194389, -4.3862618263766004e-05], [-4.393800669511929e-05, -4.3862618263766004e-05, 0.00012066637569714348]]} - #*EXTRAS*# Step: 5 Bead: 21 -{"friction": [[0.00012050554498062824, -4.401766933926631e-05, -4.4007782257430294e-05], [-4.401766933926631e-05, 0.00012043828447249314, -4.3913520227573155e-05], [-4.4007782257430294e-05, -4.3913520227573155e-05, 0.00012046039985312542]]} - #*EXTRAS*# Step: 6 Bead: 21 -{"friction": [[0.00012037642364680413, -4.406107217807297e-05, -4.404649588006806e-05], [-4.406107217807297e-05, 0.00012029445185690897, -4.394234509684928e-05], [-4.404649588006806e-05, -4.394234509684928e-05, 0.00012033517389078765]]} - #*EXTRAS*# Step: 7 Bead: 21 -{"friction": [[0.00012029439420672766, -4.408795270428611e-05, -4.406974456438949e-05], [-4.408795270428611e-05, 0.00012020286821421504, -4.395988150617115e-05], [-4.406974456438949e-05, -4.395988150617115e-05, 0.00012025549506331134]]} - #*EXTRAS*# Step: 8 Bead: 21 -{"friction": [[0.00012024176891754239, -4.4104911100511086e-05, -4.4084123911558525e-05], [-4.4104911100511086e-05, 0.00012014403909831063, -4.3970819888037813e-05], [-4.4084123911558525e-05, -4.3970819888037813e-05, 0.00012020432916720873]]} - #*EXTRAS*# Step: 9 Bead: 21 -{"friction": [[0.0001202074553747348, -4.411584706086809e-05, -4.40932780938064e-05], [-4.411584706086809e-05, 0.00012010565195146894, -4.3977822149084234e-05], [-4.40932780938064e-05, -4.3977822149084234e-05, 0.0001201709472870358]]} - #*EXTRAS*# Step: 10 Bead: 21 -{"friction": [[0.00012018491528648401, -4.412297829658066e-05, -4.409919716884625e-05], [-4.412297829658066e-05, 0.00012008042450668626, -4.398236638329607e-05], [-4.409919716884625e-05, -4.398236638329607e-05, 0.00012014901079214064]]} - #*EXTRAS*# Step: 11 Bead: 21 -{"friction": [[0.00012017001237899396, -4.4127670372561816e-05, -4.410306998531786e-05], [-4.4127670372561816e-05, 0.00012006374001821727, -4.3985346866267195e-05], [-4.410306998531786e-05, -4.3985346866267195e-05, 0.00012013450334813203]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 deleted file mode 100644 index 6ccd7a0e5..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_22 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 22 -{"friction": [[0.000122630467543474, -4.3096070467800976e-05, -4.2912418060752e-05], [-4.3096070467800976e-05, 0.00012269691709164998, -4.316425275719657e-05], [-4.2912418060752e-05, -4.316425275719657e-05, 0.00012247956068148197]]} - #*EXTRAS*# Step: 1 Bead: 22 -{"friction": [[0.00012194669748663574, -4.3443361139222514e-05, -4.336582897212374e-05], [-4.3443361139222514e-05, 0.00012199474029708691, -4.3473470436813117e-05], [-4.336582897212374e-05, -4.3473470436813117e-05, 0.0001218378045578662]]} - #*EXTRAS*# Step: 2 Bead: 22 -{"friction": [[0.00012131487424833561, -4.37163630266614e-05, -4.369876921378231e-05], [-4.37163630266614e-05, 0.00012132567845787345, -4.369602334073665e-05], [-4.369876921378231e-05, -4.369602334073665e-05, 0.00012123884803271955]]} - #*EXTRAS*# Step: 3 Bead: 22 -{"friction": [[0.00012066593796395938, -4.396192481976961e-05, -4.395593804873556e-05], [-4.396192481976961e-05, 0.00012061628932321865, -4.3875580245758e-05], [-4.395593804873556e-05, -4.3875580245758e-05, 0.00012061560054086454]]} - #*EXTRAS*# Step: 4 Bead: 22 -{"friction": [[0.00012036392554305523, -4.406520269132847e-05, -4.40501045936719e-05], [-4.406520269132847e-05, 0.00012028050779383473, -4.394505551998687e-05], [-4.40501045936719e-05, -4.394505551998687e-05, 0.00012032304001129696]]} - #*EXTRAS*# Step: 5 Bead: 22 -{"friction": [[0.00012016698285011312, -4.4128621964308644e-05, -4.4103853320059356e-05], [-4.4128621964308644e-05, 0.00012006034786902398, -4.3985950416692084e-05], [-4.4103853320059356e-05, -4.3985950416692084e-05, 0.00012013155386104235]]} - #*EXTRAS*# Step: 6 Bead: 22 -{"friction": [[0.00012004807480571842, -4.4165371731788155e-05, -4.4133559065104784e-05], [-4.4165371731788155e-05, 0.00011992709693486659, -4.400902115726393e-05], [-4.4133559065104784e-05, -4.400902115726393e-05, 0.00012001569613072604]]} - #*EXTRAS*# Step: 7 Bead: 22 -{"friction": [[0.00011997260349447188, -4.418808455533306e-05, -4.415138096771235e-05], [-4.418808455533306e-05, 0.00011984242598707372, -4.402304531694719e-05], [-4.415138096771235e-05, -4.402304531694719e-05, 0.0001199420714095638]]} - #*EXTRAS*# Step: 8 Bead: 22 -{"friction": [[0.00011992424241303526, -4.420238588686296e-05, -4.416238910907455e-05], [-4.420238588686296e-05, 0.00011978813817710694, -4.403178241143715e-05], [-4.416238910907455e-05, -4.403178241143715e-05, 0.00011989485851006993]]} - #*EXTRAS*# Step: 9 Bead: 22 -{"friction": [[0.00011989272422391818, -4.4211599408873747e-05, -4.416939270467742e-05], [-4.4211599408873747e-05, 0.00011975274603913486, -4.4037372575406655e-05], [-4.416939270467742e-05, -4.4037372575406655e-05, 0.00011986407424201441]]} - #*EXTRAS*# Step: 10 Bead: 22 -{"friction": [[0.00011987202875243032, -4.4217603034971026e-05, -4.4173918809321174e-05], [-4.4217603034971026e-05, 0.00011972950253295618, -4.404099875873893e-05], [-4.4173918809321174e-05, -4.404099875873893e-05, 0.00011984385460769357]]} - #*EXTRAS*# Step: 11 Bead: 22 -{"friction": [[0.00011985834842902656, -4.422155146077291e-05, -4.4176879293330155e-05], [-4.422155146077291e-05, 0.00011971413615608172, -4.404337649945583e-05], [-4.4176879293330155e-05, -4.404337649945583e-05, 0.00011983048621378702]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 deleted file mode 100644 index af927f9d8..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_23 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 23 -{"friction": [[0.00012194919365104008, -4.3442200516587006e-05, -4.336434695504495e-05], [-4.3442200516587006e-05, 0.0001219973420398065, -4.3472479799487785e-05], [-4.336434695504495e-05, -4.3472479799487785e-05, 0.00012184015749727416]]} - #*EXTRAS*# Step: 1 Bead: 23 -{"friction": [[0.00012140306870047774, -4.3680503790516874e-05, -4.365733885162047e-05], [-4.3680503790516874e-05, 0.00012142037960948291, -4.366808805533885e-05], [-4.365733885162047e-05, -4.366808805533885e-05, 0.00012132289987064997]]} - #*EXTRAS*# Step: 2 Bead: 23 -{"friction": [[0.00012087602834354934, -4.3885898521890074e-05, -4.388137343609205e-05], [-4.3885898521890074e-05, 0.00012084808926681702, -4.382217022019373e-05], [-4.388137343609205e-05, -4.382217022019373e-05, 0.00012081824636522506]]} - #*EXTRAS*# Step: 3 Bead: 23 -{"friction": [[0.00012026618868236042, -4.4097069863936774e-05, -4.4077502929709304e-05], [-4.4097069863936774e-05, 0.0001201713444342548, -4.396577425140728e-05], [-4.4077502929709304e-05, -4.396577425140728e-05, 0.00012022807637008312]]} - #*EXTRAS*# Step: 4 Bead: 23 -{"friction": [[0.0001199933720791207, -4.418188212195927e-05, -4.414655529086958e-05], [-4.418188212195927e-05, 0.00011986573259403375, -4.401923356093502e-05], [-4.414655529086958e-05, -4.401923356093502e-05, 0.00011996233857254168]]} - #*EXTRAS*# Step: 5 Bead: 23 -{"friction": [[0.00011981422392868484, -4.423417701195779e-05, -4.418625889307503e-05], [-4.423417701195779e-05, 0.00011966456508816849, -4.405094150992665e-05], [-4.418625889307503e-05, -4.405094150992665e-05, 0.0001197873538210701]]} - #*EXTRAS*# Step: 6 Bead: 23 -{"friction": [[0.0001197065371053325, -4.4264281203920326e-05, -4.4208081627103034e-05], [-4.4264281203920326e-05, 0.0001195435453875495, -4.406874155192904e-05], [-4.4208081627103034e-05, -4.406874155192904e-05, 0.00011968200101942822]]} - #*EXTRAS*# Step: 7 Bead: 23 -{"friction": [[0.00011963823068311246, -4.4282849656501474e-05, -4.4221153181210326e-05], [-4.4282849656501474e-05, 0.0001194667649172386, -4.407954970692526e-05], [-4.4221153181210326e-05, -4.407954970692526e-05, 0.00011961511324998141]]} - #*EXTRAS*# Step: 8 Bead: 23 -{"friction": [[0.00011959451121760073, -4.4294517383930295e-05, -4.422921144602003e-05], [-4.4294517383930295e-05, 0.00011941761987982661, -4.408627265918653e-05], [-4.422921144602003e-05, -4.408627265918653e-05, 0.00011957227752031245]]} - #*EXTRAS*# Step: 9 Bead: 23 -{"friction": [[0.00011956602914040096, -4.430202683954372e-05, -4.423433331283966e-05], [-4.430202683954372e-05, 0.00011938560380489902, -4.409057114661542e-05], [-4.423433331283966e-05, -4.409057114661542e-05, 0.00011954436122375053]]} - #*EXTRAS*# Step: 10 Bead: 23 -{"friction": [[0.00011954733427817141, -4.430691630523866e-05, -4.42376407336422e-05], [-4.430691630523866e-05, 0.0001193645899625526, -4.4093357793867836e-05], [-4.42376407336422e-05, -4.4093357793867836e-05, 0.00011952603352323464]]} - #*EXTRAS*# Step: 11 Bead: 23 -{"friction": [[0.00011953497871439692, -4.4310130536089405e-05, -4.423980306851748e-05], [-4.4310130536089405e-05, 0.00011935070215339982, -4.4095184420353985e-05], [-4.423980306851748e-05, -4.4095184420353985e-05, 0.00011951391881026372]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 deleted file mode 100644 index e391ebc7c..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_24 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 24 -{"friction": [[0.0001212275207465149, -4.375126119893523e-05, -4.373820812440936e-05], [-4.375126119893523e-05, 0.00012123144588354693, -4.372279618309253e-05], [-4.373820812440936e-05, -4.372279618309253e-05, 0.00012115544091225404]]} - #*EXTRAS*# Step: 1 Bead: 24 -{"friction": [[0.00012082396073671184, -4.390505487040522e-05, -4.390058306325644e-05], [-4.390505487040522e-05, 0.00012079080262449425, -4.38358097942225e-05], [-4.390058306325644e-05, -4.38358097942225e-05, 0.00012076809544127083]]} - #*EXTRAS*# Step: 2 Bead: 24 -{"friction": [[0.00012041306569266984, -4.404889021387063e-05, -4.4035776290729826e-05], [-4.404889021387063e-05, 0.00012033531177908212, -4.393431814702446e-05], [-4.4035776290729826e-05, -4.393431814702446e-05, 0.00012037073525325993]]} - #*EXTRAS*# Step: 3 Bead: 24 -{"friction": [[0.00011984926901622147, -4.4224163095564996e-05, -4.4178830372939526e-05], [-4.4224163095564996e-05, 0.00011970393702232657, -4.404494611606638e-05], [-4.4178830372939526e-05, -4.404494611606638e-05, 0.00011982161268363976]]} - #*EXTRAS*# Step: 4 Bead: 24 -{"friction": [[0.00011960859361100139, -4.4290777697296655e-05, -4.422664185917218e-05], [-4.4290777697296655e-05, 0.00011943344985139849, -4.4084123676925905e-05], [-4.422664185917218e-05, -4.4084123676925905e-05, 0.00011958607728930887]]} - #*EXTRAS*# Step: 5 Bead: 24 -{"friction": [[0.00011944886155197352, -4.433214979378633e-05, -4.425435844759494e-05], [-4.433214979378633e-05, 0.0001192539184728417, -4.410758374623853e-05], [-4.425435844759494e-05, -4.410758374623853e-05, 0.0001194294411714044]]} - #*EXTRAS*# Step: 6 Bead: 24 -{"friction": [[0.00011935331231028884, -4.435578741860952e-05, -4.4269468267305295e-05], [-4.435578741860952e-05, 0.00011914657668446676, -4.412066589494962e-05], [-4.4269468267305295e-05, -4.412066589494962e-05, 0.00011933563347937368]]} - #*EXTRAS*# Step: 7 Bead: 24 -{"friction": [[0.0001192927215479473, -4.437033878343526e-05, -4.4278493864083565e-05], [-4.437033878343526e-05, 0.00011907854132262548, -4.412859656757082e-05], [-4.4278493864083565e-05, -4.412859656757082e-05, 0.00011927610659844549]]} - #*EXTRAS*# Step: 8 Bead: 24 -{"friction": [[0.00011925398575914356, -4.437946148667519e-05, -4.4284041189802117e-05], [-4.437946148667519e-05, 0.00011903506315200893, -4.4133519046184375e-05], [-4.4284041189802117e-05, -4.4133519046184375e-05, 0.00011923803505204551]]} - #*EXTRAS*# Step: 9 Bead: 24 -{"friction": [[0.00011922875782295523, -4.438532692695456e-05, -4.4287561515943576e-05], [-4.438532692695456e-05, 0.00011900675459934558, -4.4136663279016176e-05], [-4.4287561515943576e-05, -4.4136663279016176e-05, 0.00011921323320660534]]} - #*EXTRAS*# Step: 10 Bead: 24 -{"friction": [[0.00011921220474778592, -4.438914275623046e-05, -4.4289831917718994e-05], [-4.438914275623046e-05, 0.0001189881838886159, -4.413869995666427e-05], [-4.4289831917718994e-05, -4.413869995666427e-05, 0.00011919695695409515]]} - #*EXTRAS*# Step: 11 Bead: 24 -{"friction": [[0.00011920126638018202, -4.4391650007737524e-05, -4.429131513619347e-05], [-4.4391650007737524e-05, 0.00011897591392723124, -4.4140034350521716e-05], [-4.429131513619347e-05, -4.4140034350521716e-05, 0.0001191862003271652]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 deleted file mode 100644 index 9aa1699a0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_25 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 25 -{"friction": [[0.00012044952884396826, -4.403666137295798e-05, -4.402490059939584e-05], [-4.403666137295798e-05, 0.00012037593919233641, -4.3926210514548074e-05], [-4.402490059939584e-05, -4.3926210514548074e-05, 0.00012040610370999929]]} - #*EXTRAS*# Step: 1 Bead: 25 -{"friction": [[0.00012020886497248827, -4.411539970860818e-05, -4.409290545749114e-05], [-4.411539970860818e-05, 0.00012010722931354498, -4.397753650665045e-05], [-4.409290545749114e-05, -4.397753650665045e-05, 0.00012017231891747126]]} - #*EXTRAS*# Step: 2 Bead: 25 -{"friction": [[0.00011992892872572898, -4.42010087376678e-05, -4.416133631508996e-05], [-4.42010087376678e-05, 0.00011979339976457563, -4.403094423701325e-05], [-4.416133631508996e-05, -4.403094423701325e-05, 0.00011989943473693642]]} - #*EXTRAS*# Step: 3 Bead: 25 -{"friction": [[0.00011941755074156832, -4.4339988172585734e-05, -4.425942919018159e-05], [-4.4339988172585734e-05, 0.00011921873735756763, -4.4111948607555305e-05], [-4.425942919018159e-05, -4.4111948607555305e-05, 0.00011939870985521936]]} - #*EXTRAS*# Step: 4 Bead: 25 -{"friction": [[0.0001192115909373238, -4.4389283752587377e-05, -4.428991550847317e-05], [-4.4389283752587377e-05, 0.00011898749531957892, -4.41387750779459e-05], [-4.428991550847317e-05, -4.41387750779459e-05, 0.00011919635336697778]]} - #*EXTRAS*# Step: 5 Bead: 25 -{"friction": [[0.00011907270065021501, -4.442026072362427e-05, -4.43077414443862e-05], [-4.442026072362427e-05, 0.00011883180918050381, -4.415503787138325e-05], [-4.43077414443862e-05, -4.415503787138325e-05, 0.00011905970203646759]]} - #*EXTRAS*# Step: 6 Bead: 25 -{"friction": [[0.00011899009128511937, -4.4437798632849395e-05, -4.431733221866311e-05], [-4.4437798632849395e-05, 0.00011873934134613834, -4.416401991884375e-05], [-4.431733221866311e-05, -4.416401991884375e-05, 0.00011897835704853841]]} - #*EXTRAS*# Step: 7 Bead: 25 -{"friction": [[0.00011893769760593897, -4.444857358748443e-05, -4.432303139683909e-05], [-4.444857358748443e-05, 0.00011868075437105062, -4.416945119899113e-05], [-4.432303139683909e-05, -4.416945119899113e-05, 0.00011892674061190132]]} - #*EXTRAS*# Step: 8 Bead: 25 -{"friction": [[0.00011890424397340144, -4.445531067741955e-05, -4.4326516391480475e-05], [-4.445531067741955e-05, 0.00011864337246873536, -4.417281167607884e-05], [-4.4326516391480475e-05, -4.417281167607884e-05, 0.00011889377356782563]]} - #*EXTRAS*# Step: 9 Bead: 25 -{"friction": [[0.00011888246026152235, -4.4459637407553695e-05, -4.432872164816807e-05], [-4.4459637407553695e-05, 0.0001186190423532978, -4.417495496745889e-05], [-4.432872164816807e-05, -4.417495496745889e-05, 0.00011887230273336393]]} - #*EXTRAS*# Step: 10 Bead: 25 -{"friction": [[0.00011886817197196801, -4.4462449485870544e-05, -4.4330140810088684e-05], [-4.4462449485870544e-05, 0.00011860308893275855, -4.4176341568318373e-05], [-4.4330140810088684e-05, -4.4176341568318373e-05, 0.00011885821798867321]]} - #*EXTRAS*# Step: 11 Bead: 25 -{"friction": [[0.00011885873130129654, -4.446429621892357e-05, -4.433106665942791e-05], [-4.446429621892357e-05, 0.00011859255032314837, -4.417724938713289e-05], [-4.433106665942791e-05, -4.417724938713289e-05, 0.00011884891108389906]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 deleted file mode 100644 index fa589dfbe..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_26 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 26 -{"friction": [[0.00011962164781834676, -4.428729526742142e-05, -4.422423780727485e-05], [-4.428729526742142e-05, 0.00011944812410604063, -4.4082117571065435e-05], [-4.422423780727485e-05, -4.4082117571065435e-05, 0.00011959886778569174]]} - #*EXTRAS*# Step: 1 Bead: 26 -{"friction": [[0.00011956420958774032, -4.430250410507531e-05, -4.423465711124019e-05], [-4.430250410507531e-05, 0.00011938355852155563, -4.409084357716244e-05], [-4.423465711124019e-05, -4.409084357716244e-05, 0.00011954257755208874]]} - #*EXTRAS*# Step: 2 Bead: 26 -{"friction": [[0.00011942704637695186, -4.433762051480021e-05, -4.425790374945869e-05], [-4.433762051480021e-05, 0.00011922940619548024, -4.411063292095287e-05], [-4.425790374945869e-05, -4.411063292095287e-05, 0.00011940803066550242]]} - #*EXTRAS*# Step: 3 Bead: 26 -{"friction": [[0.00011897369986408245, -4.444119880700896e-05, -4.431914699935431e-05], [-4.444119880700896e-05, 0.00011872100714445573, -4.4165741203132435e-05], [-4.431914699935431e-05, -4.4165741203132435e-05, 0.00011896221080665896]]} - #*EXTRAS*# Step: 4 Bead: 26 -{"friction": [[0.00011880459115871713, -4.4474712593060996e-05, -4.4336195345046715e-05], [-4.4474712593060996e-05, 0.00011853214963040642, -4.4182327422280245e-05], [-4.4336195345046715e-05, -4.4182327422280245e-05, 0.00011879552714498319]]} - #*EXTRAS*# Step: 5 Bead: 26 -{"friction": [[0.00011868773575170423, -4.449617260932374e-05, -4.434622746209159e-05], [-4.449617260932374e-05, 0.00011840200551266024, -4.419254608982146e-05], [-4.434622746209159e-05, -4.419254608982146e-05, 0.00011868024293753555]]} - #*EXTRAS*# Step: 6 Bead: 26 -{"friction": [[0.00011861873395827795, -4.450817842427834e-05, -4.4351495513239337e-05], [-4.450817842427834e-05, 0.0001183253140265147, -4.419810549076173e-05], [-4.4351495513239337e-05, -4.419810549076173e-05, 0.00011861213178104821]]} - #*EXTRAS*# Step: 7 Bead: 26 -{"friction": [[0.00011857493725671562, -4.451553843459481e-05, -4.435459021320624e-05], [-4.451553843459481e-05, 0.00011827670200952476, -4.420145175475154e-05], [-4.435459021320624e-05, -4.420145175475154e-05, 0.00011856888680365574]]} - #*EXTRAS*# Step: 8 Bead: 26 -{"friction": [[0.00011854701317825116, -4.452012458834187e-05, -4.4356463253255004e-05], [-4.452012458834187e-05, 0.00011824573553493671, -4.420351142815802e-05], [-4.4356463253255004e-05, -4.420351142815802e-05, 0.00011854130916918456]]} - #*EXTRAS*# Step: 9 Bead: 26 -{"friction": [[0.00011852883107900232, -4.452306592903546e-05, -4.435764116865877e-05], [-4.452306592903546e-05, 0.00011822558440611744, -4.420482164333959e-05], [-4.435764116865877e-05, -4.420482164333959e-05, 0.0001185233504665207]]} - #*EXTRAS*# Step: 10 Bead: 26 -{"friction": [[0.00011851690933273039, -4.4524975263019346e-05, -4.4358395733372976e-05], [-4.4524975263019346e-05, 0.00011821237680381056, -4.420566751273579e-05], [-4.4358395733372976e-05, -4.420566751273579e-05, 0.00011851157427706811]]} - #*EXTRAS*# Step: 11 Bead: 26 -{"friction": [[0.0001185090329255519, -4.452622832366421e-05, -4.435888654879616e-05], [-4.452622832366421e-05, 0.00011820365315210676, -4.420622061516671e-05], [-4.435888654879616e-05, -4.420622061516671e-05, 0.00011850379363918162]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 deleted file mode 100644 index 7736313c0..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_27 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 27 -{"friction": [[0.00011875913034376447, -4.4483228394450665e-05, -4.434026563858943e-05], [-4.4483228394450665e-05, 0.00011848148125785116, -4.418642315217651e-05], [-4.434026563858943e-05, -4.418642315217651e-05, 0.0001187506872749722]]} - #*EXTRAS*# Step: 1 Bead: 27 -{"friction": [[0.00011889754303883965, -4.4456646700982576e-05, -4.432720011949088e-05], [-4.4456646700982576e-05, 0.0001186358872430357, -4.417347474909975e-05], [-4.432720011949088e-05, -4.417347474909975e-05, 0.00011888716920890355]]} - #*EXTRAS*# Step: 2 Bead: 27 -{"friction": [[0.00011891124627343716, -4.445390976398518e-05, -4.432579681108149e-05], [-4.445390976398518e-05, 0.00011865119525684976, -4.4172115200751746e-05], [-4.432579681108149e-05, -4.4172115200751746e-05, 0.00011890067463300128]]} - #*EXTRAS*# Step: 3 Bead: 27 -{"friction": [[0.00011852063630896816, -4.452438000901119e-05, -4.435816135188714e-05], [-4.452438000901119e-05, 0.00011821650531754549, -4.4205404201912454e-05], [-4.435816135188714e-05, -4.4205404201912454e-05, 0.00011851525582722269]]} - #*EXTRAS*# Step: 4 Bead: 27 -{"friction": [[0.00011839001607548813, -4.454434282367058e-05, -4.436556264881523e-05], [-4.454434282367058e-05, 0.00011807206488202185, -4.421402249739068e-05], [-4.436556264881523e-05, -4.421402249739068e-05, 0.00011838618681243794]]} - #*EXTRAS*# Step: 5 Bead: 27 -{"friction": [[0.00011829612387727394, -4.45575320587298e-05, -4.436986170150084e-05], [-4.45575320587298e-05, 0.00011796858021705418, -4.421944224516458e-05], [-4.436986170150084e-05, -4.421944224516458e-05, 0.00011829336058556301]]} - #*EXTRAS*# Step: 6 Bead: 27 -{"friction": [[0.00011824124476680616, -4.456478314321945e-05, -4.4371985110537326e-05], [-4.456478314321945e-05, 0.00011790823687257927, -4.422230990345265e-05], [-4.4371985110537326e-05, -4.422230990345265e-05, 0.00011823908691204161]]} - #*EXTRAS*# Step: 7 Bead: 27 -{"friction": [[0.000118206352754207, -4.4569215486619616e-05, -4.4373187281910205e-05], [-4.4569215486619616e-05, 0.0001178699279420633, -4.4224017990701657e-05], [-4.4373187281910205e-05, -4.4224017990701657e-05, 0.00011820457342555049]]} - #*EXTRAS*# Step: 8 Bead: 27 -{"friction": [[0.00011818414799400393, -4.4571963610244567e-05, -4.437389282420149e-05], [-4.4571963610244567e-05, 0.00011784557250768474, -4.422505836706408e-05], [-4.437389282420149e-05, -4.422505836706408e-05, 0.00011818260704496809]]} - #*EXTRAS*# Step: 9 Bead: 27 -{"friction": [[0.00011816968805519664, -4.457372272219616e-05, -4.437432749127666e-05], [-4.457372272219616e-05, 0.00011782972215492802, -4.4225716367651537e-05], [-4.437432749127666e-05, -4.4225716367651537e-05, 0.00011816830131475525]]} - #*EXTRAS*# Step: 10 Bead: 27 -{"friction": [[0.00011816021069794609, -4.45748625932287e-05, -4.4374601799984085e-05], [-4.45748625932287e-05, 0.00011781933786982312, -4.422613928911364e-05], [-4.4374601799984085e-05, -4.422613928911364e-05, 0.00011815892459624705]]} - #*EXTRAS*# Step: 11 Bead: 27 -{"friction": [[0.00011815394944373662, -4.457560995606988e-05, -4.4374778434002464e-05], [-4.457560995606988e-05, 0.00011781247936593324, -4.422641506796233e-05], [-4.4374778434002464e-05, -4.422641506796233e-05, 0.00011815272964316132]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 deleted file mode 100644 index 53db434d5..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_28 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 28 -{"friction": [[0.00011787887860218989, -4.4603875439562205e-05, -4.437898686966099e-05], [-4.4603875439562205e-05, 0.00011751277754076018, -4.4235677964967273e-05], [-4.437898686966099e-05, -4.4235677964967273e-05, 0.00011788043866959533]]} - #*EXTRAS*# Step: 1 Bead: 28 -{"friction": [[0.00011821716815919634, -4.456785647027198e-05, -4.437282688981072e-05], [-4.456785647027198e-05, 0.00011788179763208274, -4.4223498113881176e-05], [-4.437282688981072e-05, -4.4223498113881176e-05, 0.00011821527202003079]]} - #*EXTRAS*# Step: 2 Bead: 28 -{"friction": [[0.00011838569138740155, -4.454497183562904e-05, -4.436577928393003e-05], [-4.454497183562904e-05, 0.00011806729185287206, -4.4214286372228455e-05], [-4.436577928393003e-05, -4.4214286372228455e-05, 0.00011838191209280875]]} - #*EXTRAS*# Step: 3 Bead: 28 -{"friction": [[0.00011806148666091202, -4.458611480001459e-05, -4.437696412294825e-05], [-4.458611480001459e-05, 0.00011771137868652827, -4.423015156027718e-05], [-4.437696412294825e-05, -4.423015156027718e-05, 0.00011806122929420302]]} - #*EXTRAS*# Step: 4 Bead: 28 -{"friction": [[0.00011797044514981993, -4.459547167406276e-05, -4.4378349868520603e-05], [-4.459547167406276e-05, 0.00011761217959256026, -4.4233214813589336e-05], [-4.4378349868520603e-05, -4.4233214813589336e-05, 0.00011797110680819052]]} - #*EXTRAS*# Step: 5 Bead: 28 -{"friction": [[0.00011790015293083769, -4.460201406123035e-05, -4.4378906029532975e-05], [-4.460201406123035e-05, 0.00011753583820886205, -4.4235161024597545e-05], [-4.4378906029532975e-05, -4.4235161024597545e-05, 0.0001179015064396536]]} - #*EXTRAS*# Step: 6 Bead: 28 -{"friction": [[0.00011785974412410197, -4.4605502089579566e-05, -4.437902503330294e-05], [-4.4605502089579566e-05, 0.00011749205445605932, -4.4236114258129916e-05], [-4.437902503330294e-05, -4.4236114258129916e-05, 0.0001178614888993328]]} - #*EXTRAS*# Step: 7 Bead: 28 -{"friction": [[0.00011783396351394781, -4.46076222452649e-05, -4.437902487515595e-05], [-4.46076222452649e-05, 0.00011746416086048637, -4.423665914825199e-05], [-4.437902487515595e-05, -4.423665914825199e-05, 0.00011783595558926046]]} - #*EXTRAS*# Step: 8 Bead: 28 -{"friction": [[0.00011781760479149767, -4.4608924804798216e-05, -4.437899415521877e-05], [-4.4608924804798216e-05, 0.00011744647788888599, -4.423697931407515e-05], [-4.437899415521877e-05, -4.423697931407515e-05, 0.00011781975288148242]]} - #*EXTRAS*# Step: 9 Bead: 28 -{"friction": [[0.00011780694729995558, -4.4609755476478894e-05, -4.437896138291455e-05], [-4.4609755476478894e-05, 0.0001174349646375853, -4.4237177203120094e-05], [-4.437896138291455e-05, -4.4237177203120094e-05, 0.0001178091966619199]]} - #*EXTRAS*# Step: 10 Bead: 28 -{"friction": [[0.00011779996606323877, -4.461029192429088e-05, -4.4378934466950035e-05], [-4.461029192429088e-05, 0.00011742742583315106, -4.423730225504211e-05], [-4.4378934466950035e-05, -4.423730225504211e-05, 0.00011780228160828536]]} - #*EXTRAS*# Step: 11 Bead: 28 -{"friction": [[0.00011779535373799366, -4.4610642997903614e-05, -4.43789143206899e-05], [-4.4610642997903614e-05, 0.00011742244644622176, -4.4237382885828976e-05], [-4.43789143206899e-05, -4.4237382885828976e-05, 0.00011779771294165908]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 deleted file mode 100644 index 9b811c0f4..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_29 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 29 -{"friction": [[0.0001169988017405095, -4.4628706812311107e-05, -4.434812841942771e-05], [-4.4628706812311107e-05, 0.00011658072617402499, -4.422718506529086e-05], [-4.434812841942771e-05, -4.422718506529086e-05, 0.00011700820795224204]]} - #*EXTRAS*# Step: 1 Bead: 29 -{"friction": [[0.00011753189974625173, -4.4626185785848615e-05, -4.4374678762031694e-05], [-4.4626185785848615e-05, 0.00011713984978702145, -4.423935106572228e-05], [-4.4374678762031694e-05, -4.423935106572228e-05, 0.0001175366758387438]]} - #*EXTRAS*# Step: 2 Bead: 29 -{"friction": [[0.00011785480746316499, -4.460591443703884e-05, -4.4379029581375005e-05], [-4.460591443703884e-05, 0.00011748671073803878, -4.423622241511476e-05], [-4.4379029581375005e-05, -4.423622241511476e-05, 0.00011785659973074332]]} - #*EXTRAS*# Step: 3 Bead: 29 -{"friction": [[0.00011759953086947621, -4.462305479111253e-05, -4.437633968264983e-05], [-4.462305479111253e-05, 0.00011721203991483914, -4.4239342201802445e-05], [-4.437633968264983e-05, -4.4239342201802445e-05, 0.00011760369937668614]]} - #*EXTRAS*# Step: 4 Bead: 29 -{"friction": [[0.00011754857393602378, -4.462547003010778e-05, -4.4375124686233114e-05], [-4.462547003010778e-05, 0.00011715762415018113, -4.4239380883758826e-05], [-4.4375124686233114e-05, -4.4239380883758826e-05, 0.00011755320093169063]]} - #*EXTRAS*# Step: 5 Bead: 29 -{"friction": [[0.00011750220634373885, -4.462736866459116e-05, -4.437382585284434e-05], [-4.462736866459116e-05, 0.00011710823649482514, -4.423924599519867e-05], [-4.437382585284434e-05, -4.423924599519867e-05, 0.000117507246891289]]} - #*EXTRAS*# Step: 6 Bead: 29 -{"friction": [[0.00011747643658614995, -4.462829945346136e-05, -4.4373024768115825e-05], [-4.462829945346136e-05, 0.00011708084186528402, -4.4239100768079964e-05], [-4.4373024768115825e-05, -4.4239100768079964e-05, 0.00011748170560821562]]} - #*EXTRAS*# Step: 7 Bead: 29 -{"friction": [[0.00011745986638223633, -4.462885066878213e-05, -4.4372479862216465e-05], [-4.462885066878213e-05, 0.0001170632473995152, -4.423898081370372e-05], [-4.4372479862216465e-05, -4.423898081370372e-05, 0.00011746528183714778]]} - #*EXTRAS*# Step: 8 Bead: 29 -{"friction": [[0.00011744941326375558, -4.462917927445722e-05, -4.437212414001567e-05], [-4.462917927445722e-05, 0.00011705215648754886, -4.4238894429508836e-05], [-4.437212414001567e-05, -4.4238894429508836e-05, 0.00011745492091031024]]} - #*EXTRAS*# Step: 9 Bead: 29 -{"friction": [[0.0001174425956520085, -4.462938560135049e-05, -4.4371887149921774e-05], [-4.462938560135049e-05, 0.0001170449264028491, -4.42388336200355e-05], [-4.4371887149921774e-05, -4.42388336200355e-05, 0.00011744816335248383]]} - #*EXTRAS*# Step: 10 Bead: 29 -{"friction": [[0.00011743813448525062, -4.462951719175473e-05, -4.437172994471009e-05], [-4.462951719175473e-05, 0.00011704019683257886, -4.423879191801523e-05], [-4.437172994471009e-05, -4.423879191801523e-05, 0.00011744374145148282]]} - #*EXTRAS*# Step: 11 Bead: 29 -{"friction": [[0.00011743518666439092, -4.462960265636111e-05, -4.437162514423069e-05], [-4.462960265636111e-05, 0.00011703707231134586, -4.423876353273301e-05], [-4.437162514423069e-05, -4.423876353273301e-05, 0.00011744081956309121]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 deleted file mode 100644 index c4f6066c6..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_30 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 30 -{"friction": [[0.00011613512964090057, -4.4542480960535e-05, -4.4255686347443705e-05], [-4.4542480960535e-05, 0.00011571790314066553, -4.415921694916118e-05], [-4.4255686347443705e-05, -4.415921694916118e-05, 0.00011615221676811073]]} - #*EXTRAS*# Step: 1 Bead: 30 -{"friction": [[0.0001168508521955774, -4.462198079338802e-05, -4.433662780422844e-05], [-4.462198079338802e-05, 0.00011642908619130902, -4.421986823821559e-05], [-4.433662780422844e-05, -4.421986823821559e-05, 0.00011686153884928971]]} - #*EXTRAS*# Step: 2 Bead: 30 -{"friction": [[0.00011732320280343508, -4.463196453028039e-05, -4.436710209384723e-05], [-4.463196453028039e-05, 0.00011691876908673685, -4.423719474814293e-05], [-4.436710209384723e-05, -4.423719474814293e-05, 0.00011732981391897723]]} - #*EXTRAS*# Step: 3 Bead: 30 -{"friction": [[0.00011713814468780041, -4.463199273868092e-05, -4.4357337498689066e-05], [-4.463199273868092e-05, 0.00011672503648143685, -4.4232489528430636e-05], [-4.4357337498689066e-05, -4.4232489528430636e-05, 0.00011714635268094946]]} - #*EXTRAS*# Step: 4 Bead: 30 -{"friction": [[0.00011712716904114754, -4.4631838748797657e-05, -4.435666964536891e-05], [-4.4631838748797657e-05, 0.0001167136192376424, -4.423212698397402e-05], [-4.435666964536891e-05, -4.423212698397402e-05, 0.00011713547137529799]]} - #*EXTRAS*# Step: 5 Bead: 30 -{"friction": [[0.00011710472485968075, -4.463146856013476e-05, -4.4355273228645355e-05], [-4.463146856013476e-05, 0.00011669029836540867, -4.423135629913294e-05], [-4.4355273228645355e-05, -4.423135629913294e-05, 0.00011711322008420053]]} - #*EXTRAS*# Step: 6 Bead: 30 -{"friction": [[0.00011709357650357364, -4.463125696736904e-05, -4.4354564291257306e-05], [-4.463125696736904e-05, 0.00011667872778860107, -4.423095882930775e-05], [-4.4354564291257306e-05, -4.423095882930775e-05, 0.00011710216753577108]]} - #*EXTRAS*# Step: 7 Bead: 30 -{"friction": [[0.00011708620359525206, -4.4631106889663855e-05, -4.4354089861031955e-05], [-4.4631106889663855e-05, 0.00011667108050855097, -4.423069061165197e-05], [-4.4354089861031955e-05, -4.423069061165197e-05, 0.00011709485799143094]]} - #*EXTRAS*# Step: 8 Bead: 30 -{"friction": [[0.00011708164581272938, -4.463101006790052e-05, -4.435379435815152e-05], [-4.463101006790052e-05, 0.00011666635505827255, -4.423052267155863e-05], [-4.435379435815152e-05, -4.423052267155863e-05, 0.00011709033938083567]]} - #*EXTRAS*# Step: 9 Bead: 30 -{"friction": [[0.00011707866097182768, -4.463094498275846e-05, -4.435359991799847e-05], [-4.463094498275846e-05, 0.0001166632612201497, -4.4230411805726484e-05], [-4.435359991799847e-05, -4.4230411805726484e-05, 0.00011708738019406158]]} - #*EXTRAS*# Step: 10 Bead: 30 -{"friction": [[0.00011707671495970156, -4.463090183388839e-05, -4.4353472758388596e-05], [-4.463090183388839e-05, 0.0001166612444899166, -4.42303391482841e-05], [-4.4353472758388596e-05, -4.42303391482841e-05, 0.00011708545090795862]]} - #*EXTRAS*# Step: 11 Bead: 30 -{"friction": [[0.00011707542831335341, -4.463087299474888e-05, -4.4353388514538216e-05], [-4.463087299474888e-05, 0.00011665991123620533, -4.4230290945946367e-05], [-4.4353388514538216e-05, -4.4230290945946367e-05, 0.00011708417532056929]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 deleted file mode 100644 index e085b0737..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_31 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 31 -{"friction": [[0.00011529316548301044, -4.435439121512612e-05, -4.41050010482841e-05], [-4.435439121512612e-05, 0.00011492181793038626, -4.403170578939231e-05], [-4.41050010482841e-05, -4.403170578939231e-05, 0.00011531825069130156]]} - #*EXTRAS*# Step: 1 Bead: 31 -{"friction": [[0.00011618143560430524, -4.454992602515317e-05, -4.4262212197190304e-05], [-4.454992602515317e-05, 0.00011576286740312808, -4.4164436366442505e-05], [-4.4262212197190304e-05, -4.4164436366442505e-05, 0.00011619809791954101]]} - #*EXTRAS*# Step: 2 Bead: 31 -{"friction": [[0.00011679557074895778, -4.461859976467617e-05, -4.4331876407486066e-05], [-4.461859976467617e-05, 0.00011637285338915298, -4.4216683724111655e-05], [-4.4331876407486066e-05, -4.4216683724111655e-05, 0.00011680673943670854]]} - #*EXTRAS*# Step: 3 Bead: 31 -{"friction": [[0.00011668067469725762, -4.4610072617390604e-05, -4.432120616723605e-05], [-4.4610072617390604e-05, 0.00011625670864088914, -4.420927382725791e-05], [-4.432120616723605e-05, -4.420927382725791e-05, 0.00011669285170427029]]} - #*EXTRAS*# Step: 4 Bead: 31 -{"friction": [[0.00011670897606248251, -4.461236036127493e-05, -4.4323934401912875e-05], [-4.461236036127493e-05, 0.00011628522725521543, -4.4211198612397986e-05], [-4.4323934401912875e-05, -4.4211198612397986e-05, 0.00011672090388378314]]} - #*EXTRAS*# Step: 5 Bead: 31 -{"friction": [[0.00011671012240289376, -4.461245045141217e-05, -4.4324043529746896e-05], [-4.461245045141217e-05, 0.00011628638363122736, -4.421127520065163e-05], [-4.4324043529746896e-05, -4.421127520065163e-05, 0.00011672204014224594]]} - #*EXTRAS*# Step: 6 Bead: 31 -{"friction": [[0.00011671338992993012, -4.4612706143352436e-05, -4.4324353998906704e-05], [-4.4612706143352436e-05, 0.0001162896802931441, -4.421149292088838e-05], [-4.4324353998906704e-05, -4.421149292088838e-05, 0.00011672527893651709]]} - #*EXTRAS*# Step: 7 Bead: 31 -{"friction": [[0.00011671508811696076, -4.461283838685081e-05, -4.4324515010642386e-05], [-4.461283838685081e-05, 0.00011629139393174298, -4.421160573059622e-05], [-4.4324515010642386e-05, -4.421160573059622e-05, 0.00011672696219347092]]} - #*EXTRAS*# Step: 8 Bead: 31 -{"friction": [[0.0001167163451180329, -4.461293599009261e-05, -4.432463404023682e-05], [-4.461293599009261e-05, 0.00011629266250658357, -4.421168908145511e-05], [-4.432463404023682e-05, -4.421168908145511e-05, 0.0001167282081445108]]} - #*EXTRAS*# Step: 9 Bead: 31 -{"friction": [[0.00011671714112046479, -4.461299767305991e-05, -4.4324709349663716e-05], [-4.461299767305991e-05, 0.00011629346589822784, -4.4211741797356404e-05], [-4.4324709349663716e-05, -4.4211741797356404e-05, 0.00011672899714999678]]} - #*EXTRAS*# Step: 10 Bead: 31 -{"friction": [[0.00011671767632078693, -4.461303909182102e-05, -4.4324759955653194e-05], [-4.461303909182102e-05, 0.00011629400609295324, -4.421177721245518e-05], [-4.4324759955653194e-05, -4.421177721245518e-05, 0.00011672952764608852]]} - #*EXTRAS*# Step: 11 Bead: 31 -{"friction": [[0.00011671802851105306, -4.4613066323699734e-05, -4.432479324433376e-05], [-4.4613066323699734e-05, 0.00011629436158129287, -4.4211800504764215e-05], [-4.432479324433376e-05, -4.4211800504764215e-05, 0.00011672987674082499]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 deleted file mode 100644 index 1950b59c1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_32 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 32 -{"friction": [[0.00011447442737646712, -4.4082214189905e-05, -4.389842451436581e-05], [-4.4082214189905e-05, 0.00011417821453784439, -4.384566898769395e-05], [-4.389842451436581e-05, -4.384566898769395e-05, 0.0001145078200454766]]} - #*EXTRAS*# Step: 1 Bead: 32 -{"friction": [[0.00011552592376511203, -4.441613809123734e-05, -4.415280344343716e-05], [-4.441613809123734e-05, 0.00011513814426212077, -4.4073247851896053e-05], [-4.415280344343716e-05, -4.4073247851896053e-05, 0.00011554874474127439]]} - #*EXTRAS*# Step: 2 Bead: 32 -{"friction": [[0.00011627546015973217, -4.456408067743581e-05, -4.427490821314602e-05], [-4.456408067743581e-05, 0.00011585459018543612, -4.417447430350005e-05], [-4.427490821314602e-05, -4.417447430350005e-05, 0.00011629126455004889]]} - #*EXTRAS*# Step: 3 Bead: 32 -{"friction": [[0.00011622924232197253, -4.455728463130126e-05, -4.4268760211181105e-05], [-4.455728463130126e-05, 0.00011580943235948906, -4.4169633704368606e-05], [-4.4268760211181105e-05, -4.4169633704368606e-05, 0.00011624546764852702]]} - #*EXTRAS*# Step: 4 Bead: 32 -{"friction": [[0.00011629581905243802, -4.4566974781535756e-05, -4.427755963555833e-05], [-4.4566974781535756e-05, 0.00011587452645299433, -4.417654936810728e-05], [-4.427755963555833e-05, -4.417654936810728e-05, 0.00011631143849577973]]} - #*EXTRAS*# Step: 5 Bead: 32 -{"friction": [[0.00011632000898392532, -4.4570334116205896e-05, -4.428066493784767e-05], [-4.4570334116205896e-05, 0.00011589824976753216, -4.417896953455571e-05], [-4.428066493784767e-05, -4.417896953455571e-05, 0.00011633540905410704]]} - #*EXTRAS*# Step: 6 Bead: 32 -{"friction": [[0.00011633737206515648, -4.457269214403897e-05, -4.428286373857454e-05], [-4.457269214403897e-05, 0.00011591530185143721, -4.4180676358009666e-05], [-4.428286373857454e-05, -4.4180676358009666e-05, 0.00011635261492470085]]} - #*EXTRAS*# Step: 7 Bead: 32 -{"friction": [[0.00011634794511972351, -4.4574106207910194e-05, -4.4284190352205886e-05], [-4.4574106207910194e-05, 0.00011592569537308618, -4.4181703311332177e-05], [-4.4284190352205886e-05, -4.4181703311332177e-05, 0.00011636309235029273]]} - #*EXTRAS*# Step: 8 Bead: 32 -{"friction": [[0.00011635489317975355, -4.457502644967249e-05, -4.4285057058525385e-05], [-4.457502644967249e-05, 0.00011593252952448775, -4.418237306660518e-05], [-4.4285057058525385e-05, -4.418237306660518e-05, 0.00011636997761021585]]} - #*EXTRAS*# Step: 9 Bead: 32 -{"friction": [[0.0001163593905113958, -4.4575618291564234e-05, -4.4285615914194125e-05], [-4.4575618291564234e-05, 0.00011593695485035164, -4.418280442779502e-05], [-4.4285615914194125e-05, -4.418280442779502e-05, 0.00011637443431054037]]} - #*EXTRAS*# Step: 10 Bead: 32 -{"friction": [[0.00011636235513783233, -4.457600679322332e-05, -4.428598338846941e-05], [-4.457600679322332e-05, 0.0001159398727530949, -4.418308785297056e-05], [-4.428598338846941e-05, -4.418308785297056e-05, 0.00011637737216061435]]} - #*EXTRAS*# Step: 11 Bead: 32 -{"friction": [[0.00011636431213710674, -4.457626253600785e-05, -4.428622556318936e-05], [-4.457626253600785e-05, 0.00011594179923274342, -4.4183274543268836e-05], [-4.428622556318936e-05, -4.4183274543268836e-05, 0.00011637931148770446]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 deleted file mode 100644 index 624bc9d81..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_33 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 33 -{"friction": [[0.00011368019507082692, -4.37444711227787e-05, -4.363905558610621e-05], [-4.37444711227787e-05, 0.00011347259446525294, -4.36029403928641e-05], [-4.363905558610621e-05, -4.36029403928641e-05, 0.00011372219122617184]]} - #*EXTRAS*# Step: 1 Bead: 33 -{"friction": [[0.00011488557065104784, -4.4229252911492665e-05, -4.4009723651564715e-05], [-4.4229252911492665e-05, 0.00011454868533191005, -4.394698891570549e-05], [-4.4009723651564715e-05, -4.394698891570549e-05, 0.00011491472330333603]]} - #*EXTRAS*# Step: 2 Bead: 33 -{"friction": [[0.00011576416381858035, -4.447173641787124e-05, -4.419683527688875e-05], [-4.447173641787124e-05, 0.0001153623837463286, -4.4110739881217473e-05], [-4.419683527688875e-05, -4.4110739881217473e-05, 0.00011578470989628958]]} - #*EXTRAS*# Step: 3 Bead: 33 -{"friction": [[0.00011578484216243536, -4.447619208442007e-05, -4.420042552191256e-05], [-4.447619208442007e-05, 0.000115381990907153, -4.411375724972794e-05], [-4.420042552191256e-05, -4.411375724972794e-05, 0.00011580519278670521]]} - #*EXTRAS*# Step: 4 Bead: 33 -{"friction": [[0.00011588863698785958, -4.449765178982637e-05, -4.421789168091407e-05], [-4.449765178982637e-05, 0.00011548077293943289, -4.412833703042674e-05], [-4.421789168091407e-05, -4.412833703042674e-05, 0.00011590801129524293]]} - #*EXTRAS*# Step: 5 Bead: 33 -{"friction": [[0.00011593527522988086, -4.4506799468546096e-05, -4.4225439301514597e-05], [-4.4506799468546096e-05, 0.00011552536058491374, -4.413458229274719e-05], [-4.4225439301514597e-05, -4.413458229274719e-05, 0.00011595421341667227]]} - #*EXTRAS*# Step: 6 Bead: 33 -{"friction": [[0.00011596638376652037, -4.451272942544407e-05, -4.423037046716735e-05], [-4.451272942544407e-05, 0.00011555517240377913, -4.4138643061589455e-05], [-4.423037046716735e-05, -4.4138643061589455e-05, 0.00011598503193279866]]} - #*EXTRAS*# Step: 7 Bead: 33 -{"friction": [[0.00011598561623572341, -4.4516326575025816e-05, -4.4233377849592714e-05], [-4.4516326575025816e-05, 0.00011557363195886409, -4.414111168660611e-05], [-4.4233377849592714e-05, -4.414111168660611e-05, 0.00011600408545127837]]} - #*EXTRAS*# Step: 8 Bead: 33 -{"friction": [[0.00011599811925141648, -4.451863674988514e-05, -4.423531606131457e-05], [-4.451863674988514e-05, 0.00011558564437634655, -4.414269939740096e-05], [-4.423531606131457e-05, -4.414269939740096e-05, 0.00011601647227469133]]} - #*EXTRAS*# Step: 9 Bead: 33 -{"friction": [[0.00011600623030456794, -4.452012347000192e-05, -4.423656632293723e-05], [-4.452012347000192e-05, 0.000115593442190146, -4.414372217435727e-05], [-4.423656632293723e-05, -4.414372217435727e-05, 0.00011602450801105388]]} - #*EXTRAS*# Step: 10 Bead: 33 -{"friction": [[0.00011601156724903985, -4.452109657223465e-05, -4.423738592475621e-05], [-4.452109657223465e-05, 0.00011559857519141815, -4.414439205049982e-05], [-4.423738592475621e-05, -4.414439205049982e-05, 0.00011602979542415938]]} - #*EXTRAS*# Step: 11 Bead: 33 -{"friction": [[0.00011601509150879722, -4.452173692571863e-05, -4.423792582319335e-05], [-4.452173692571863e-05, 0.00011560196572003811, -4.414483305824063e-05], [-4.423792582319335e-05, -4.414483305824063e-05, 0.00011603328698705741]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 deleted file mode 100644 index 14fb9b945..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_34 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 34 -{"friction": [[0.0001129115705507499, -4.335986330177095e-05, -4.33306885948054e-05], [-4.335986330177095e-05, 0.00011279080035366944, -4.3306160132593466e-05], [-4.33306885948054e-05, -4.3306160132593466e-05, 0.00011296244664467974]]} - #*EXTRAS*# Step: 1 Bead: 34 -{"friction": [[0.00011426150772254876, -4.399832285946132e-05, -4.3834685021937484e-05], [-4.399832285946132e-05, 0.00011398810605570284, -4.378676893980419e-05], [-4.3834685021937484e-05, -4.378676893980419e-05, 0.00011429715231755915]]} - #*EXTRAS*# Step: 2 Bead: 34 -{"friction": [[0.00011526264338286579, -4.434576130918476e-05, -4.409837880774723e-05], [-4.434576130918476e-05, 0.00011489363744283414, -4.402589337720955e-05], [-4.409837880774723e-05, -4.402589337720955e-05, 0.00011528802861583142]]} - #*EXTRAS*# Step: 3 Bead: 34 -{"friction": [[0.00011534836302830751, -4.4369686628347246e-05, -4.411676802902943e-05], [-4.4369686628347246e-05, 0.00011497288763174257, -4.4042001353587696e-05], [-4.411676802902943e-05, -4.4042001353587696e-05, 0.00011537290750191765]]} - #*EXTRAS*# Step: 4 Bead: 34 -{"friction": [[0.00011548827852440699, -4.4406643370886556e-05, -4.4145394204292986e-05], [-4.4406643370886556e-05, 0.00011510297961325047, -4.406686059320522e-05], [-4.4145394204292986e-05, -4.406686059320522e-05, 0.00011551146288650336]]} - #*EXTRAS*# Step: 5 Bead: 34 -{"friction": [[0.00011555673708213701, -4.442376682210013e-05, -4.415877597355805e-05], [-4.442376682210013e-05, 0.00011516698007694079, -4.407838138163964e-05], [-4.415877597355805e-05, -4.407838138163964e-05, 0.00011557926142255594]]} - #*EXTRAS*# Step: 6 Bead: 34 -{"friction": [[0.00011560121878781194, -4.443455165335257e-05, -4.4167251958182236e-05], [-4.443455165335257e-05, 0.00011520869247353871, -4.4085642394160214e-05], [-4.4167251958182236e-05, -4.4085642394160214e-05, 0.00011562331617730565]]} - #*EXTRAS*# Step: 7 Bead: 34 -{"friction": [[0.00011562888057639166, -4.444112203691841e-05, -4.417243614823435e-05], [-4.444112203691841e-05, 0.00011523468373871902, -4.409006884789824e-05], [-4.417243614823435e-05, -4.409006884789824e-05, 0.0001156507132114404]]} - #*EXTRAS*# Step: 8 Bead: 34 -{"friction": [[0.0001156467928275793, -4.444532066964563e-05, -4.41757577114203e-05], [-4.444532066964563e-05, 0.00011525153563379555, -4.4092898879145275e-05], [-4.41757577114203e-05, -4.4092898879145275e-05, 0.00011566845432926164]]} - #*EXTRAS*# Step: 9 Bead: 34 -{"friction": [[0.00011565842365222586, -4.444802331617e-05, -4.41778995776946e-05], [-4.444802331617e-05, 0.00011526248701662714, -4.4094721227055774e-05], [-4.41778995776946e-05, -4.4094721227055774e-05, 0.00011567997416215917]]} - #*EXTRAS*# Step: 10 Bead: 34 -{"friction": [[0.00011566607160918241, -4.4449790316441855e-05, -4.4179301593005485e-05], [-4.4449790316441855e-05, 0.00011526969211234302, -4.409591298963699e-05], [-4.4179301593005485e-05, -4.409591298963699e-05, 0.00011568754919072312]]} - #*EXTRAS*# Step: 11 Bead: 34 -{"friction": [[0.00011567112279363183, -4.4450952932775206e-05, -4.418022479251847e-05], [-4.4450952932775206e-05, 0.00011527445251132792, -4.409669726038635e-05], [-4.418022479251847e-05, -4.409669726038635e-05, 0.00011569255223276694]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 deleted file mode 100644 index 64e38053a..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_35 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 35 -{"friction": [[0.00011216920631531552, -4.2946540772708485e-05, -4.2977592964064865e-05], [-4.2946540772708485e-05, 0.00011211926994815254, -4.2958595375337326e-05], [-4.2977592964064865e-05, -4.2958595375337326e-05, 0.0001122292163872923]]} - #*EXTRAS*# Step: 1 Bead: 35 -{"friction": [[0.0001136546357097823, -4.3732527334955156e-05, -4.36297190113692e-05], [-4.3732527334955156e-05, 0.00011344998512729614, -4.359406880400897e-05], [-4.36297190113692e-05, -4.359406880400897e-05, 0.00011369691815731713]]} - #*EXTRAS*# Step: 2 Bead: 35 -{"friction": [[0.00011477177945060752, -4.419059042821466e-05, -4.3980460193950474e-05], [-4.419059042821466e-05, 0.00011444563041758137, -4.3920562977080135e-05], [-4.3980460193950474e-05, -4.3920562977080135e-05, 0.00011480209156060453]]} - #*EXTRAS*# Step: 3 Bead: 35 -{"friction": [[0.00011492062709614939, -4.42408424664992e-05, -4.401850323772993e-05], [-4.42408424664992e-05, 0.00011458052432246342, -4.395488372987467e-05], [-4.401850323772993e-05, -4.395488372987467e-05, 0.00011494942467794017]]} - #*EXTRAS*# Step: 4 Bead: 35 -{"friction": [[0.00011509553462571892, -4.4296364911419025e-05, -4.4060656826133835e-05], [-4.4296364911419025e-05, 0.00011474006240818068, -4.3992553617294235e-05], [-4.4060656826133835e-05, -4.3992553617294235e-05, 0.00011512257548156689]]} - #*EXTRAS*# Step: 5 Bead: 35 -{"friction": [[0.00011518515847088456, -4.4323306500694605e-05, -4.408119656464824e-05], [-4.4323306500694605e-05, 0.00011482228076313524, -4.4010754248877724e-05], [-4.408119656464824e-05, -4.4010754248877724e-05, 0.00011521130864124455]]} - #*EXTRAS*# Step: 6 Bead: 35 -{"friction": [[0.0001152426223086565, -4.434003423675883e-05, -4.409399014926263e-05], [-4.434003423675883e-05, 0.00011487517479454032, -4.402203441061126e-05], [-4.409399014926263e-05, -4.402203441061126e-05, 0.00011526820473958935]]} - #*EXTRAS*# Step: 7 Bead: 35 -{"friction": [[0.0001152784708170027, -4.435025165654924e-05, -4.4101823098831026e-05], [-4.435025165654924e-05, 0.00011490824542940928, -4.4028918071838894e-05], [-4.4101823098831026e-05, -4.4028918071838894e-05, 0.00011530370037937012]]} - #*EXTRAS*# Step: 8 Bead: 35 -{"friction": [[0.0001153016383234253, -4.435676515864481e-05, -4.410682475690998e-05], [-4.435676515864481e-05, 0.00011492964814736439, -4.403330420483617e-05], [-4.410682475690998e-05, -4.403330420483617e-05, 0.00011532664037474344]]} - #*EXTRAS*# Step: 9 Bead: 35 -{"friction": [[0.00011531668950274123, -4.4360958936414204e-05, -4.411004876236915e-05], [-4.4360958936414204e-05, 0.00011494356577302316, -4.4036127484589396e-05], [-4.411004876236915e-05, -4.4036127484589396e-05, 0.00011534154397167577]]} - #*EXTRAS*# Step: 10 Bead: 35 -{"friction": [[0.00011532658354057343, -4.436369948839236e-05, -4.4112157200386606e-05], [-4.436369948839236e-05, 0.00011495272026976636, -4.4037972146706877e-05], [-4.4112157200386606e-05, -4.4037972146706877e-05, 0.00011535134109082609]]} - #*EXTRAS*# Step: 11 Bead: 35 -{"friction": [[0.00011533311890263997, -4.436550263252077e-05, -4.4113545162007574e-05], [-4.436550263252077e-05, 0.00011495876959285213, -4.403918572198884e-05], [-4.4113545162007574e-05, -4.403918572198884e-05, 0.00011535781247639964]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 deleted file mode 100644 index 85b5e1cf1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_36 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 36 -{"friction": [[0.00011145322627121049, -4.2518769308164815e-05, -4.2584527045753256e-05], [-4.2518769308164815e-05, 0.00011144842873098494, -4.2564924963892915e-05], [-4.2584527045753256e-05, -4.2564924963892915e-05, 0.00011152215281971272]]} - #*EXTRAS*# Step: 1 Bead: 36 -{"friction": [[0.00011306563078114409, -4.344090953553081e-05, -4.339710820279744e-05], [-4.344090953553081e-05, 0.00011292807044108663, -4.3370685622427525e-05], [-4.339710820279744e-05, -4.3370685622427525e-05, 0.00011311468129920366]]} - #*EXTRAS*# Step: 2 Bead: 36 -{"friction": [[0.0001142923764596724, -4.401080067793624e-05, -4.384418637177919e-05], [-4.401080067793624e-05, 0.00011401560861421836, -4.3795584152071336e-05], [-4.384418637177919e-05, -4.3795584152071336e-05, 0.00011432769215063264]]} - #*EXTRAS*# Step: 3 Bead: 36 -{"friction": [[0.00011450239290209676, -4.409284940694744e-05, -4.390648502956183e-05], [-4.409284940694744e-05, 0.00011420326118287328, -4.385307600388265e-05], [-4.390648502956183e-05, -4.385307600388265e-05, 0.00011453549268036254]]} - #*EXTRAS*# Step: 4 Bead: 36 -{"friction": [[0.00011471114047469993, -4.416934312795027e-05, -4.3964386101475195e-05], [-4.416934312795027e-05, 0.00011439088621581625, -4.390597850728574e-05], [-4.3964386101475195e-05, -4.390597850728574e-05, 0.00011474207480922138]]} - #*EXTRAS*# Step: 5 Bead: 36 -{"friction": [[0.00011482125269717975, -4.420759477649007e-05, -4.399332717107384e-05], [-4.420759477649007e-05, 0.00011449038217252451, -4.3932202884685816e-05], [-4.399332717107384e-05, -4.3932202884685816e-05, 0.00011485105940274622]]} - #*EXTRAS*# Step: 6 Bead: 36 -{"friction": [[0.00011489129203615494, -4.423115479057045e-05, -4.401116409284453e-05], [-4.423115479057045e-05, 0.00011455387862953963, -4.3948285289705684e-05], [-4.401116409284453e-05, -4.3948285289705684e-05, 0.00011492038667090782]]} - #*EXTRAS*# Step: 7 Bead: 36 -{"friction": [[0.00011493507413673813, -4.4245574168250956e-05, -4.4022089144747485e-05], [-4.4245574168250956e-05, 0.0001145936582646026, -4.395810361504382e-05], [-4.4022089144747485e-05, -4.395810361504382e-05, 0.0001149637256816248]]} - #*EXTRAS*# Step: 8 Bead: 36 -{"friction": [[0.00011496333591687868, -4.4254755159515635e-05, -4.402904969073398e-05], [-4.4254755159515635e-05, 0.00011461937337498437, -4.39643458154026e-05], [-4.402904969073398e-05, -4.39643458154026e-05, 0.00011499170226842742]]} - #*EXTRAS*# Step: 9 Bead: 36 -{"friction": [[0.0001149817033813361, -4.426066831404615e-05, -4.40335348761301e-05], [-4.426066831404615e-05, 0.00011463610161180177, -4.396836252045649e-05], [-4.40335348761301e-05, -4.396836252045649e-05, 0.00011500988473053973]]} - #*EXTRAS*# Step: 10 Bead: 36 -{"friction": [[0.00011499377547445366, -4.426453168590876e-05, -4.4036466278280225e-05], [-4.426453168590876e-05, 0.00011464710321071942, -4.3970985324617776e-05], [-4.4036466278280225e-05, -4.3970985324617776e-05, 0.0001150218353782984]]} - #*EXTRAS*# Step: 11 Bead: 36 -{"friction": [[0.0001150017502061887, -4.426707374149145e-05, -4.403839556425337e-05], [-4.426707374149145e-05, 0.0001146543738069237, -4.397271045682178e-05], [-4.403839556425337e-05, -4.397271045682178e-05, 0.00011502972994855528]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 deleted file mode 100644 index aefeed0dc..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_37 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 37 -{"friction": [[0.00011076333879039023, -4.207916178846279e-05, -4.2157344930675944e-05], [-4.207916178846279e-05, 0.00011078149553564103, -4.213391549981982e-05], [-4.2157344930675944e-05, -4.213391549981982e-05, 0.0001108388141904826]]} - #*EXTRAS*# Step: 1 Bead: 37 -{"friction": [[0.00011249510520123627, -4.3132228951610966e-05, -4.313938726228368e-05], [-4.3132228951610966e-05, 0.00011241659005309463, -4.3118741832230955e-05], [-4.313938726228368e-05, -4.3118741832230955e-05, 0.00011255103545476299]]} - #*EXTRAS*# Step: 2 Bead: 37 -{"friction": [[0.00011382516907134414, -4.381101493885735e-05, -4.3690833891754304e-05], [-4.381101493885735e-05, 0.00011360087282623942, -4.365198980160124e-05], [-4.3690833891754304e-05, -4.365198980160124e-05, 0.00011386555272349105]]} - #*EXTRAS*# Step: 3 Bead: 37 -{"friction": [[0.0001140943587468416, -4.3928947846054306e-05, -4.378169328230424e-05], [-4.3928947846054306e-05, 0.00011383947405285343, -4.373739521468227e-05], [-4.378169328230424e-05, -4.373739521468227e-05, 0.00011413179876360064]]} - #*EXTRAS*# Step: 4 Bead: 37 -{"friction": [[0.00011433577777791734, -4.402816520886982e-05, -4.3857395477162896e-05], [-4.402816520886982e-05, 0.0001140543089283237, -4.380781945673494e-05], [-4.3857395477162896e-05, -4.380781945673494e-05, 0.00011437063242792666]]} - #*EXTRAS*# Step: 5 Bead: 37 -{"friction": [[0.00011446568418166232, -4.407887067105941e-05, -4.389588968030583e-05], [-4.407887067105941e-05, 0.00011417038788107097, -4.384333764470163e-05], [-4.389588968030583e-05, -4.384333764470163e-05, 0.00011449916855702952]]} - #*EXTRAS*# Step: 6 Bead: 37 -{"friction": [[0.00011454787965400728, -4.410995427484038e-05, -4.391944204716221e-05], [-4.410995427484038e-05, 0.00011424404287673417, -4.386496167893767e-05], [-4.391944204716221e-05, -4.386496167893767e-05, 0.00011458050445314908]]} - #*EXTRAS*# Step: 7 Bead: 37 -{"friction": [[0.00011459933349353848, -4.412901170508542e-05, -4.393386988874646e-05], [-4.412901170508542e-05, 0.00011429024076784554, -4.387816537862105e-05], [-4.393386988874646e-05, -4.387816537862105e-05, 0.00011463142310961346]]} - #*EXTRAS*# Step: 8 Bead: 37 -{"friction": [[0.00011463252271719959, -4.41411389362879e-05, -4.3943047614399236e-05], [-4.41411389362879e-05, 0.00011432007871555885, -4.388654676499809e-05], [-4.3943047614399236e-05, -4.388654676499809e-05, 0.00011466426830492323]]} - #*EXTRAS*# Step: 9 Bead: 37 -{"friction": [[0.00011465409849182818, -4.4148952654288014e-05, -4.394895988654351e-05], [-4.4148952654288014e-05, 0.00011433949281595958, -4.389193857680145e-05], [-4.394895988654351e-05, -4.389193857680145e-05, 0.00011468562092692053]]} - #*EXTRAS*# Step: 10 Bead: 37 -{"friction": [[0.00011466827800980202, -4.415405764359672e-05, -4.395282225816139e-05], [-4.415405764359672e-05, 0.00011435225910803007, -4.389545773017858e-05], [-4.395282225816139e-05, -4.389545773017858e-05, 0.00011469965400153468]]} - #*EXTRAS*# Step: 11 Bead: 37 -{"friction": [[0.00011467764556483789, -4.415741704800082e-05, -4.395536382985509e-05], [-4.415741704800082e-05, 0.00011436069630016796, -4.389777205219173e-05], [-4.395536382985509e-05, -4.389777205219173e-05, 0.00011470892490221093]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 deleted file mode 100644 index 266dadb14..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_38 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 38 -{"friction": [[0.0001100992324223387, -4.1627963427024275e-05, -4.170223714900381e-05], [-4.1627963427024275e-05, 0.00011012443903750724, -4.167507154046895e-05], [-4.170223714900381e-05, -4.167507154046895e-05, 0.00011017661577495691]]} - #*EXTRAS*# Step: 1 Bead: 38 -{"friction": [[0.00011194363333834211, -4.2814715023164674e-05, -4.285932844207568e-05], [-4.2814715023164674e-05, 0.00011191051645482177, -4.2840704463731256e-05], [-4.285932844207568e-05, -4.2840704463731256e-05, 0.00011200651946843509]]} - #*EXTRAS*# Step: 2 Bead: 38 -{"friction": [[0.0001133708327200139, -4.359581312965394e-05, -4.35218334272684e-05], [-4.359581312965394e-05, 0.00011319886428033085, -4.349100010359989e-05], [-4.35218334272684e-05, -4.349100010359989e-05, 0.00011341633502409409]]} - #*EXTRAS*# Step: 3 Bead: 38 -{"friction": [[0.0001136971663963983, -4.3752367060687974e-05, -4.3645220546303374e-05], [-4.3752367060687974e-05, 0.00011348760759764768, -4.3608793884598034e-05], [-4.3645220546303374e-05, -4.3608793884598034e-05, 0.00011373897278784109]]} - #*EXTRAS*# Step: 4 Bead: 38 -{"friction": [[0.0001139700773749525, -4.3875430249148906e-05, -4.374059441868975e-05], [-4.3875430249148906e-05, 0.00011372922260780362, -4.36988741893795e-05], [-4.374059441868975e-05, -4.36988741893795e-05, 0.00011400886835468954]]} - #*EXTRAS*# Step: 5 Bead: 38 -{"friction": [[0.00011411907050544158, -4.3939394528734756e-05, -4.378969231863727e-05], [-4.3939394528734756e-05, 0.00011386142026698746, -4.3744870003721734e-05], [-4.378969231863727e-05, -4.3744870003721734e-05, 0.00011415624353503611]]} - #*EXTRAS*# Step: 6 Bead: 38 -{"friction": [[0.00011421299255285906, -4.397849962328956e-05, -4.381957285514968e-05], [-4.397849962328956e-05, 0.0001139449172181694, -4.377272405136132e-05], [-4.381957285514968e-05, -4.377272405136132e-05, 0.00011424915574927427]]} - #*EXTRAS*# Step: 7 Bead: 38 -{"friction": [[0.00011427184917235624, -4.400251485154205e-05, -4.383787797646911e-05], [-4.400251485154205e-05, 0.00011399731775600461, -4.3789732634374456e-05], [-4.383787797646911e-05, -4.3789732634374456e-05, 0.0001143073834878137]]} - #*EXTRAS*# Step: 8 Bead: 38 -{"friction": [[0.00011430979420167188, -4.401779462863303e-05, -4.384950843679059e-05], [-4.401779462863303e-05, 0.00011403113518784377, -4.3800516679241445e-05], [-4.384950843679059e-05, -4.3800516679241445e-05, 0.00011434492467268716]]} - #*EXTRAS*# Step: 9 Bead: 38 -{"friction": [[0.0001143344670829111, -4.4027643892669276e-05, -4.3856999129762237e-05], [-4.4027643892669276e-05, 0.00011405313963769317, -4.3807452671242466e-05], [-4.3856999129762237e-05, -4.3807452671242466e-05, 0.00011436933563224784]]} - #*EXTRAS*# Step: 10 Bead: 38 -{"friction": [[0.00011435068123430704, -4.40340793579039e-05, -4.386189100233078e-05], [-4.40340793579039e-05, 0.00011406760705656692, -4.381197817741783e-05], [-4.386189100233078e-05, -4.381197817741783e-05, 0.00011438537794414508]]} - #*EXTRAS*# Step: 11 Bead: 38 -{"friction": [[0.00011436139362077341, -4.4038314940364235e-05, -4.3865109603655424e-05], [-4.4038314940364235e-05, 0.00011407716846537999, -4.381495393552605e-05], [-4.3865109603655424e-05, -4.381495393552605e-05, 0.00011439597692378767]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 deleted file mode 100644 index aee28f65f..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_39 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 39 -{"friction": [[0.00010946055557351727, -4.116585373381819e-05, -4.12253165138265e-05], [-4.116585373381819e-05, 0.00010948261620819361, -4.119736995851763e-05], [-4.12253165138265e-05, -4.119736995851763e-05, 0.0001095333241093075]]} - #*EXTRAS*# Step: 1 Bead: 39 -{"friction": [[0.00011141159638801519, -4.2493033750126976e-05, -4.2560088914835746e-05], [-4.2493033750126976e-05, 0.00011140871432497702, -4.2540315164077124e-05], [-4.2560088914835746e-05, -4.2540315164077124e-05, 0.0001114810014116761]]} - #*EXTRAS*# Step: 2 Bead: 39 -{"friction": [[0.00011292999421529916, -4.336965081821405e-05, -4.3338754470814793e-05], [-4.336965081821405e-05, 0.00011280724275856742, -4.3314011866908754e-05], [-4.3338754470814793e-05, -4.3314011866908754e-05, 0.0001129806507574064]]} - #*EXTRAS*# Step: 3 Bead: 39 -{"friction": [[0.00011331140497466551, -4.356626803399791e-05, -4.349825801789088e-05], [-4.356626803399791e-05, 0.00011314622335372278, -4.346834882600959e-05], [-4.349825801789088e-05, -4.346834882600959e-05, 0.00011335759114211881]]} - #*EXTRAS*# Step: 4 Bead: 39 -{"friction": [[0.00011361462206565993, -4.371370393907156e-05, -4.361497690093434e-05], [-4.371370393907156e-05, 0.00011341459091107873, -4.358004463654571e-05], [-4.361497690093434e-05, -4.358004463654571e-05, 0.00011365735392300711]]} - #*EXTRAS*# Step: 5 Bead: 39 -{"friction": [[0.0001137819846701434, -4.3791409177305185e-05, -4.3675619607273276e-05], [-4.3791409177305185e-05, 0.0001135626522477285, -4.363760436114409e-05], [-4.3675619607273276e-05, -4.363760436114409e-05, 0.00011382284663834568]]} - #*EXTRAS*# Step: 6 Bead: 39 -{"friction": [[0.00011388719577663617, -4.383884859220974e-05, -4.3712376761074234e-05], [-4.383884859220974e-05, 0.00011365579065055473, -4.367231918343187e-05], [-4.3712376761074234e-05, -4.367231918343187e-05, 0.0001139268953782979]]} - #*EXTRAS*# Step: 7 Bead: 39 -{"friction": [[0.00011395318054620925, -4.386802970241525e-05, -4.3734894436463085e-05], [-4.386802970241525e-05, 0.00011371424695943752, -4.3693516914553645e-05], [-4.3734894436463085e-05, -4.3693516914553645e-05, 0.00011399215626277792]]} - #*EXTRAS*# Step: 8 Bead: 39 -{"friction": [[0.00011399570586264119, -4.388659868164089e-05, -4.3749188541682515e-05], [-4.388659868164089e-05, 0.00011375194286914677, -4.370694490374824e-05], [-4.3749188541682515e-05, -4.370694490374824e-05, 0.00011403421712854468]]} - #*EXTRAS*# Step: 9 Bead: 39 -{"friction": [[0.00011402336202303768, -4.3898573996878015e-05, -4.375839318733072e-05], [-4.3898573996878015e-05, 0.00011377646898687425, -4.371557991114739e-05], [-4.375839318733072e-05, -4.371557991114739e-05, 0.00011406157210326666]]} - #*EXTRAS*# Step: 10 Bead: 39 -{"friction": [[0.00011404153625273443, -4.3906399952986944e-05, -4.3764402816469894e-05], [-4.3906399952986944e-05, 0.00011379259127704848, -4.372121250950688e-05], [-4.3764402816469894e-05, -4.372121250950688e-05, 0.00011407954878028764]]} - #*EXTRAS*# Step: 11 Bead: 39 -{"friction": [[0.00011405354429581377, -4.391155164169097e-05, -4.376835644624532e-05], [-4.391155164169097e-05, 0.00011380324582853161, -4.3724915866887684e-05], [-4.376835644624532e-05, -4.3724915866887684e-05, 0.00011409142645798362]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 deleted file mode 100644 index 29fbd9244..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_40 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 40 -{"friction": [[0.00010884671416050972, -4.069374642795891e-05, -4.0732312774585544e-05], [-4.069374642795891e-05, 0.00010886046575184648, -4.0708913362173936e-05], [-4.0732312774585544e-05, -4.0708913362173936e-05, 0.00010890687369275164]]} - #*EXTRAS*# Step: 1 Bead: 40 -{"friction": [[0.00011089909566692243, -4.216792896085031e-05, -4.224511885169162e-05], [-4.216792896085031e-05, 0.0001109141311362888, -4.222254660426497e-05], [-4.224511885169162e-05, -4.222254660426497e-05, 0.000110973566417452]]} - #*EXTRAS*# Step: 2 Bead: 40 -{"friction": [[0.00011250323854750766, -4.3136784260261586e-05, -4.314328865778931e-05], [-4.3136784260261586e-05, 0.00011242395300991247, -4.31225858047955e-05], [-4.314328865778931e-05, -4.31225858047955e-05, 0.00011255906840103084]]} - #*EXTRAS*# Step: 3 Bead: 40 -{"friction": [[0.00011293761530599875, -4.3373692048372174e-05, -4.3342081202539734e-05], [-4.3373692048372174e-05, 0.00011281404202533606, -4.331724901984381e-05], [-4.3342081202539734e-05, -4.331724901984381e-05, 0.00011298818112737397]]} - #*EXTRAS*# Step: 4 Bead: 40 -{"friction": [[0.00011326994957288292, -4.354547733159545e-05, -4.3481609454229555e-05], [-4.354547733159545e-05, 0.00011310948203986136, -4.3452326700399274e-05], [-4.3481609454229555e-05, -4.3452326700399274e-05, 0.00011331661478731689]]} - #*EXTRAS*# Step: 5 Bead: 40 -{"friction": [[0.00011345495750738493, -4.363710438015204e-05, -4.355462189166924e-05], [-4.363710438015204e-05, 0.00011327333537733923, -4.3522429027447406e-05], [-4.355462189166924e-05, -4.3522429027447406e-05, 0.00011349949748764563]]} - #*EXTRAS*# Step: 6 Bead: 40 -{"friction": [[0.0001135710141222771, -4.369301746423191e-05, -4.359873581377076e-05], [-4.369301746423191e-05, 0.00011337601683920186, -4.356457187082932e-05], [-4.359873581377076e-05, -4.356457187082932e-05, 0.00011361423745210462]]} - #*EXTRAS*# Step: 7 Bead: 40 -{"friction": [[0.00011364384799171142, -4.3727467520558064e-05, -4.362575961592783e-05], [-4.3727467520558064e-05, 0.00011344044273669363, -4.359030417453505e-05], [-4.362575961592783e-05, -4.359030417453505e-05, 0.00011368625145450186]]} - #*EXTRAS*# Step: 8 Bead: 40 -{"friction": [[0.00011369077500922488, -4.3749396717907234e-05, -4.3642902057053646e-05], [-4.3749396717907234e-05, 0.00011348195359460239, -4.36065929475844e-05], [-4.3642902057053646e-05, -4.36065929475844e-05, 0.00011373265283442789]]} - #*EXTRAS*# Step: 9 Bead: 40 -{"friction": [[0.0001137212985299091, -4.376354661236526e-05, -4.365393936885328e-05], [-4.376354661236526e-05, 0.00011350895648467105, -4.3617066116951946e-05], [-4.365393936885328e-05, -4.3617066116951946e-05, 0.00011376283554602615]]} - #*EXTRAS*# Step: 10 Bead: 40 -{"friction": [[0.00011374135686978036, -4.3772795827031106e-05, -4.366114407076693e-05], [-4.3772795827031106e-05, 0.00011352670275218304, -4.362389633891404e-05], [-4.366114407076693e-05, -4.362389633891404e-05, 0.00011378267039167405]]} - #*EXTRAS*# Step: 11 Bead: 40 -{"friction": [[0.00011375461044379085, -4.3778885683923425e-05, -4.366588354584625e-05], [-4.3778885683923425e-05, 0.00011353842941185629, -4.3628386755756025e-05], [-4.366588354584625e-05, -4.3628386755756025e-05, 0.00011379577649407882]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 deleted file mode 100644 index 0dcbc3cc5..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_41 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 41 -{"friction": [[0.00010825727003808276, -4.0213019041528475e-05, -4.022875126678125e-05], [-4.0213019041528475e-05, 0.00010826184840136975, -4.021709341324004e-05], [-4.022875126678125e-05, -4.021709341324004e-05, 0.00010829577020577766]]} - #*EXTRAS*# Step: 1 Bead: 41 -{"friction": [[0.00011040625247218961, -4.1840129505126145e-05, -4.1917903577703516e-05], [-4.1840129505126145e-05, 0.00011042976778296876, -4.189227853829798e-05], [-4.1917903577703516e-05, -4.189227853829798e-05, 0.0001104834514098337]]} - #*EXTRAS*# Step: 2 Bead: 41 -{"friction": [[0.00011209111177315083, -4.290119848267727e-05, -4.293723114306271e-05], [-4.290119848267727e-05, 0.00011204728227433164, -4.291843196524452e-05], [-4.293723114306271e-05, -4.291843196524452e-05, 0.0001121521155816934]]} - #*EXTRAS*# Step: 3 Bead: 41 -{"friction": [[0.00011257629475231057, -4.317751602844343e-05, -4.3178035649156925e-05], [-4.317751602844343e-05, 0.0001124899794579598, -4.3156782918712166e-05], [-4.3178035649156925e-05, -4.3156782918712166e-05, 0.00011263122584100714]]} - #*EXTRAS*# Step: 4 Bead: 41 -{"friction": [[0.00011293655556409973, -4.337313036171858e-05, -4.334161895022815e-05], [-4.337313036171858e-05, 0.00011281309663940101, -4.331679925864623e-05], [-4.334161895022815e-05, -4.331679925864623e-05, 0.00011298713399709048]]} - #*EXTRAS*# Step: 5 Bead: 41 -{"friction": [[0.0001131384801725285, -4.3478585160423066e-05, -4.342770460388564e-05], [-4.3478585160423066e-05, 0.0001129928238082936, -4.3400306526684566e-05], [-4.342770460388564e-05, -4.3400306526684566e-05, 0.0001131866755645502]]} - #*EXTRAS*# Step: 6 Bead: 41 -{"friction": [[0.00011326493433405845, -4.354295213353791e-05, -4.3479584001287794e-05], [-4.354295213353791e-05, 0.00011310503584554575, -4.345037600456423e-05], [-4.3479584001287794e-05, -4.345037600456423e-05, 0.00011331165761501973]]} - #*EXTRAS*# Step: 7 Bead: 41 -{"friction": [[0.00011334433490410115, -4.358267748749164e-05, -4.3511363847851754e-05], [-4.358267748749164e-05, 0.0001131753964620428, -4.3480946342953935e-05], [-4.3511363847851754e-05, -4.3480946342953935e-05, 0.00011339014171491427]]} - #*EXTRAS*# Step: 8 Bead: 41 -{"friction": [[0.0001133954826710941, -4.360797732562427e-05, -4.353151185616141e-05], [-4.360797732562427e-05, 0.00011322069051261455, -4.350028633128355e-05], [-4.353151185616141e-05, -4.350028633128355e-05, 0.0001134407023034787]]} - #*EXTRAS*# Step: 9 Bead: 41 -{"friction": [[0.00011342875600348206, -4.362431151246092e-05, -4.35444829268315e-05], [-4.362431151246092e-05, 0.00011325014548892111, -4.3512719861044315e-05], [-4.35444829268315e-05, -4.3512719861044315e-05, 0.00011347359499047108]]} - #*EXTRAS*# Step: 10 Bead: 41 -{"friction": [[0.00011345062137730059, -4.36349915314057e-05, -4.3552948553552395e-05], [-4.36349915314057e-05, 0.00011326949790887406, -4.3520827210292035e-05], [-4.3552948553552395e-05, -4.3520827210292035e-05, 0.00011349521079590209]]} - #*EXTRAS*# Step: 11 Bead: 41 -{"friction": [[0.00011346506960783513, -4.3642025068023354e-05, -4.355851716295946e-05], [-4.3642025068023354e-05, 0.0001132822841914115, -4.352615690525228e-05], [-4.355851716295946e-05, -4.352615690525228e-05, 0.00011350949436400676]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 deleted file mode 100644 index 1a63d95c6..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_42 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 42 -{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} - #*EXTRAS*# Step: 1 Bead: 42 -{"friction": [[0.00010993324022054, -4.1510606123928054e-05, -4.158192119432386e-05], [-4.1510606123928054e-05, 0.00010995839913419749, -4.1554170665025e-05], [-4.158192119432386e-05, -4.1554170665025e-05, 0.0001100101287696102]]} - #*EXTRAS*# Step: 2 Bead: 42 -{"friction": [[0.00011169409557077084, -4.266576691444841e-05, -4.272251905166439e-05], [-4.266576691444841e-05, 0.00011167674727532415, -4.270366298541051e-05], [-4.272251905166439e-05, -4.270366298541051e-05, 0.00011176012685035594]]} - #*EXTRAS*# Step: 3 Bead: 42 -{"friction": [[0.00011222790196517527, -4.2980415014047385e-05, -4.300752283128825e-05], [-4.2980415014047385e-05, 0.00011217317540199615, -4.2988325249378214e-05], [-4.300752283128825e-05, -4.2988325249378214e-05, 0.00011228716898775013]]} - #*EXTRAS*# Step: 4 Bead: 42 -{"friction": [[0.000112614896664197, -4.319890063184607e-05, -4.319618030214452e-05], [-4.319890063184607e-05, 0.0001125247902299898, -4.3174612569470535e-05], [-4.319618030214452e-05, -4.3174612569470535e-05, 0.00011266935507219712]]} - #*EXTRAS*# Step: 5 Bead: 42 -{"friction": [[0.00011283300666341234, -4.331784444640506e-05, -4.329591740968143e-05], [-4.331784444640506e-05, 0.00011272059375373359, -4.327226335276752e-05], [-4.329591740968143e-05, -4.327226335276752e-05, 0.00011288482278697955]]} - #*EXTRAS*# Step: 6 Bead: 42 -{"friction": [[0.00011296940733866869, -4.339050298382681e-05, -4.335589725499729e-05], [-4.339050298382681e-05, 0.00011284239189440307, -4.333068513247618e-05], [-4.335589725499729e-05, -4.333068513247618e-05, 0.0001130195953318484]]} - #*EXTRAS*# Step: 7 Bead: 42 -{"friction": [[0.00011305508976122487, -4.3435422935141966e-05, -4.339263797920654e-05], [-4.3435422935141966e-05, 0.0001129186932703127, -4.3366352376612127e-05], [-4.339263797920654e-05, -4.3366352376612127e-05, 0.00011310426444253478]]} - #*EXTRAS*# Step: 8 Bead: 42 -{"friction": [[0.00011311027555584516, -4.346404913652198e-05, -4.341592041478201e-05], [-4.346404913652198e-05, 0.00011296776419240363, -4.3388905951867174e-05], [-4.341592041478201e-05, -4.3388905951867174e-05, 0.0001131588014066439]]} - #*EXTRAS*# Step: 9 Bead: 42 -{"friction": [[0.00011314617991533306, -4.348254221761609e-05, -4.34309081247133e-05], [-4.348254221761609e-05, 0.00011299966279453225, -4.3403404031532404e-05], [-4.34309081247133e-05, -4.3403404031532404e-05, 0.00011319428522809608]]} - #*EXTRAS*# Step: 10 Bead: 42 -{"friction": [[0.00011316977439961201, -4.349463774127436e-05, -4.344068867630582e-05], [-4.349463774127436e-05, 0.00011302061405453579, -4.3412856293390893e-05], [-4.344068867630582e-05, -4.3412856293390893e-05, 0.00011321760403943933]]} - #*EXTRAS*# Step: 11 Bead: 42 -{"friction": [[0.00011318536583682293, -4.3502605464990886e-05, -4.3447121925214546e-05], [-4.3502605464990886e-05, 0.00011303445436029258, -4.3419069789775554e-05], [-4.3447121925214546e-05, -4.3419069789775554e-05, 0.00011323301360608451]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 deleted file mode 100644 index 7e5f61bf6..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_43 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 43 -{"friction": [[0.00010715217792801399, -3.923464312552263e-05, -3.921096682771662e-05], [-3.923464312552263e-05, 0.00010714750227249788, -3.92473297219389e-05], [-3.921096682771662e-05, -3.92473297219389e-05, 0.00010711974146902487]]} - #*EXTRAS*# Step: 1 Bead: 43 -{"friction": [[0.00010948025470431537, -4.118054066676035e-05, -4.124058528015529e-05], [-4.118054066676035e-05, 0.00010950251734778074, -4.1212593281823386e-05], [-4.124058528015529e-05, -4.1212593281823386e-05, 0.0001095532834096008]]} - #*EXTRAS*# Step: 2 Bead: 43 -{"friction": [[0.0001113125816801122, -4.2431425110308745e-05, -4.2501269026520284e-05], [-4.2431425110308745e-05, 0.00011131396573999718, -4.248104440444911e-05], [-4.2501269026520284e-05, -4.248104440444911e-05, 0.00011138309191497685]]} - #*EXTRAS*# Step: 3 Bead: 43 -{"friction": [[0.00011189285520231655, -4.278467499741953e-05, -4.283199771331931e-05], [-4.278467499741953e-05, 0.00011186318356606287, -4.2813377530400325e-05], [-4.283199771331931e-05, -4.2813377530400325e-05, 0.00011195638782515919]]} - #*EXTRAS*# Step: 4 Bead: 43 -{"friction": [[0.0001123053936830362, -4.302485797551433e-05, -4.304650438206026e-05], [-4.302485797551433e-05, 0.00011224409017596692, -4.3026976375147295e-05], [-4.304650438206026e-05, -4.3026976375147295e-05, 0.00011236368529888479]]} - #*EXTRAS*# Step: 5 Bead: 43 -{"friction": [[0.00011253895631141721, -4.315674035219836e-05, -4.316034338139598e-05], [-4.315674035219836e-05, 0.00011245625821964694, -4.313937931735147e-05], [-4.316034338139598e-05, -4.313937931735147e-05, 0.00011259434606480611]]} - #*EXTRAS*# Step: 6 Bead: 43 -{"friction": [[0.00011268485047286811, -4.323740385147962e-05, -4.322868345207957e-05], [-4.323740385147962e-05, 0.00011258774696480869, -4.320650263156654e-05], [-4.322868345207957e-05, -4.320650263156654e-05, 0.00011273845617563499]]} - #*EXTRAS*# Step: 7 Bead: 43 -{"friction": [[0.00011277652819105508, -4.3287361337701094e-05, -4.327054388163123e-05], [-4.3287361337701094e-05, 0.0001126700249517739, -4.324747893799289e-05], [-4.327054388163123e-05, -4.324747893799289e-05, 0.00011282902390733458]]} - #*EXTRAS*# Step: 8 Bead: 43 -{"friction": [[0.00011283556801626963, -4.3319221464131874e-05, -4.329706064134774e-05], [-4.3319221464131874e-05, 0.00011272288508207029, -4.3273379077922844e-05], [-4.329706064134774e-05, -4.3273379077922844e-05, 0.00011288735339555057]]} - #*EXTRAS*# Step: 9 Bead: 43 -{"friction": [[0.00011287398371179234, -4.333981704873077e-05, -4.3314129271872164e-05], [-4.333981704873077e-05, 0.00011275723081100484, -4.3290027030892404e-05], [-4.3314129271872164e-05, -4.3290027030892404e-05, 0.00011292530876957146]]} - #*EXTRAS*# Step: 10 Bead: 43 -{"friction": [[0.0001128992287549963, -4.3353292579015936e-05, -4.332526664179543e-05], [-4.3353292579015936e-05, 0.00011277978137202653, -4.3300879714012006e-05], [-4.332526664179543e-05, -4.3300879714012006e-05, 0.00011295025211289417]]} - #*EXTRAS*# Step: 11 Bead: 43 -{"friction": [[0.00011291591151958682, -4.336217171669909e-05, -4.333259208289634e-05], [-4.336217171669909e-05, 0.0001127946752036013, -4.330801347276635e-05], [-4.333259208289634e-05, -4.330801347276635e-05, 0.00011296673585251566]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 deleted file mode 100644 index 4af0b356b..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_44 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 44 -{"friction": [[0.00010664017028987908, -3.874471502576407e-05, -3.8706267883039e-05], [-3.874471502576407e-05, 0.00010663532824109419, -3.87745976441682e-05], [-3.8706267883039e-05, -3.87745976441682e-05, 0.00010656312142689027]]} - #*EXTRAS*# Step: 1 Bead: 44 -{"friction": [[0.00010904737738839252, -4.085120170975111e-05, -4.0897096206283396e-05], [-4.085120170975111e-05, 0.00010906417370562769, -4.087147447821876e-05], [-4.0897096206283396e-05, -4.087147447821876e-05, 0.00010911267385246929]]} - #*EXTRAS*# Step: 2 Bead: 44 -{"friction": [[0.00011094693640705304, -4.219894036793211e-05, -4.227561954073473e-05], [-4.219894036793211e-05, 0.00011096071872304386, -4.225334439227173e-05], [-4.227561954073473e-05, -4.225334439227173e-05, 0.00011102101389672582]]} - #*EXTRAS*# Step: 3 Bead: 44 -{"friction": [[0.00011157150557892233, -4.259135599678139e-05, -4.265301501561713e-05], [-4.259135599678139e-05, 0.00011156086234360825, -4.263383542704127e-05], [-4.265301501561713e-05, -4.263383542704127e-05, 0.00011163903445492691]]} - #*EXTRAS*# Step: 4 Bead: 44 -{"friction": [[0.00011200843399025782, -4.2852854156760386e-05, -4.2893828720818075e-05], [-4.2852854156760386e-05, 0.00011197074061968918, -4.2875158705624006e-05], [-4.2893828720818075e-05, -4.2875158705624006e-05, 0.00011207049315576282]]} - #*EXTRAS*# Step: 5 Bead: 44 -{"friction": [[0.00011225671624411899, -4.299697829896951e-05, -4.3022088347372464e-05], [-4.299697829896951e-05, 0.00011219957694884776, -4.300277664689704e-05], [-4.3022088347372464e-05, -4.300277664689704e-05, 0.00011231561983366092]]} - #*EXTRAS*# Step: 6 Bead: 44 -{"friction": [[0.00011241164966193397, -4.308525524765625e-05, -4.3098972534271776e-05], [-4.308525524765625e-05, 0.00011234089010457118, -4.307887161468411e-05], [-4.3098972534271776e-05, -4.307887161468411e-05, 0.0001124686140726275]]} - #*EXTRAS*# Step: 7 Bead: 44 -{"friction": [[0.00011250903500309559, -4.3140028233207395e-05, -4.314606505603423e-05], [-4.3140028233207395e-05, 0.000112429198897059, -4.312532081162802e-05], [-4.314606505603423e-05, -4.312532081162802e-05, 0.00011256479334548633]]} - #*EXTRAS*# Step: 8 Bead: 44 -{"friction": [[0.00011257174398923852, -4.317498866916781e-05, -4.317588678733464e-05], [-4.317498866916781e-05, 0.00011248587221726391, -4.315467008641508e-05], [-4.317588678733464e-05, -4.315467008641508e-05, 0.00011262673090274341]]} - #*EXTRAS*# Step: 9 Bead: 44 -{"friction": [[0.00011261255069344947, -4.3197603779472884e-05, -4.319508183025607e-05], [-4.3197603779472884e-05, 0.00011252267611733422, -4.317353371825003e-05], [-4.319508183025607e-05, -4.317353371825003e-05, 0.00011266703778432683]]} - #*EXTRAS*# Step: 10 Bead: 44 -{"friction": [[0.00011263936729658601, -4.3212406454093194e-05, -4.320760567839105e-05], [-4.3212406454093194e-05, 0.00011254683137361447, -4.3185829629857584e-05], [-4.320760567839105e-05, -4.3185829629857584e-05, 0.00011269352685115272]]} - #*EXTRAS*# Step: 11 Bead: 44 -{"friction": [[0.00011265708920044922, -4.3222162799328774e-05, -4.32158428270747e-05], [-4.3222162799328774e-05, 0.00011256278148570468, -4.3193911770208594e-05], [-4.32158428270747e-05, -4.3193911770208594e-05, 0.00011271103270363154]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 deleted file mode 100644 index 190789347..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_45 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 45 -{"friction": [[0.00010615791386994777, -3.8259948801847704e-05, -3.820990102880373e-05], [-3.8259948801847704e-05, 0.0001061542815691971, -3.831149517488624e-05], [-3.820990102880373e-05, -3.831149517488624e-05, 0.000106034172149726]]} - #*EXTRAS*# Step: 1 Bead: 45 -{"friction": [[0.00010863469602018364, -4.052399813395291e-05, -4.055448700123146e-05], [-4.052399813395291e-05, 0.00010864509081510968, -4.05343510809212e-05], [-4.055448700123146e-05, -4.05343510809212e-05, 0.00010868824489182309]]} - #*EXTRAS*# Step: 2 Bead: 45 -{"friction": [[0.00011059750715570393, -4.196916716171967e-05, -4.204768466388029e-05], [-4.196916716171967e-05, 0.00011061864402767053, -4.2023208820699584e-05], [-4.204768466388029e-05, -4.2023208820699584e-05, 0.00011067396209392366]]} - #*EXTRAS*# Step: 3 Bead: 45 -{"friction": [[0.0001112641688837344, -4.24010960550294e-05, -4.247215373462893e-05], [-4.24010960550294e-05, 0.00011126749310831239, -4.245168891995276e-05], [-4.247215373462893e-05, -4.245168891995276e-05, 0.00011133520091907473]]} - #*EXTRAS*# Step: 4 Bead: 45 -{"friction": [[0.00011172435580959319, -4.268400770341092e-05, -4.273944323230246e-05], [-4.268400770341092e-05, 0.00011170524875038996, -4.272064725443229e-05], [-4.273944323230246e-05, -4.272064725443229e-05, 0.00011179001133822722]]} - #*EXTRAS*# Step: 5 Bead: 45 -{"friction": [[0.00011198664235724837, -4.28400529230893e-05, -4.2882274027017454e-05], [-4.28400529230893e-05, 0.00011195051066232454, -4.2863624771099615e-05], [-4.2882274027017454e-05, -4.2863624771099615e-05, 0.00011204897975709736]]} - #*EXTRAS*# Step: 6 Bead: 45 -{"friction": [[0.00011215016152124495, -4.293551184641547e-05, -4.2967806857432826e-05], [-4.293551184641547e-05, 0.00011210174255055643, -4.294886471572819e-05], [-4.2967806857432826e-05, -4.294886471572819e-05, 0.00011221041346661001]]} - #*EXTRAS*# Step: 7 Bead: 45 -{"friction": [[0.00011225296614996207, -4.299482513787121e-05, -4.30201974310676e-05], [-4.299482513787121e-05, 0.0001121961430951405, -4.300090117197603e-05], [-4.30201974310676e-05, -4.300090117197603e-05, 0.00011231191698952628]]} - #*EXTRAS*# Step: 8 Bead: 45 -{"friction": [[0.00011231915887350306, -4.3032718317650015e-05, -4.30533655344622e-05], [-4.3032718317650015e-05, 0.00011225665817841294, -4.303377104961898e-05], [-4.30533655344622e-05, -4.303377104961898e-05, 0.0001123772778858554]]} - #*EXTRAS*# Step: 9 Bead: 45 -{"friction": [[0.00011236223583898793, -4.305724795473915e-05, -4.307471368708211e-05], [-4.305724795473915e-05, 0.00011229593438914257, -4.305489620094858e-05], [-4.307471368708211e-05, -4.305489620094858e-05, 0.00011241981598934233]]} - #*EXTRAS*# Step: 10 Bead: 45 -{"friction": [[0.00011239054470102075, -4.307331048744947e-05, -4.3088641433501954e-05], [-4.307331048744947e-05, 0.00011232170180686712, -4.3068665155153757e-05], [-4.3088641433501954e-05, -4.3068665155153757e-05, 0.00011244777178607453]]} - #*EXTRAS*# Step: 11 Bead: 45 -{"friction": [[0.0001124092533447522, -4.308390031806745e-05, -4.30978017623542e-05], [-4.308390031806745e-05, 0.00011233871234142084, -4.307771526258414e-05], [-4.30978017623542e-05, -4.307771526258414e-05, 0.00011246624755686012]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 deleted file mode 100644 index 5f3303c46..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_46 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 46 -{"friction": [[0.00010570677276922272, -3.778420803142114e-05, -3.7725549753719546e-05], [-3.778420803142114e-05, 0.0001057047887977086, -3.7859417660977375e-05], [-3.7725549753719546e-05, -3.7859417660977375e-05, 0.00010553660403377729]]} - #*EXTRAS*# Step: 1 Bead: 46 -{"friction": [[0.00010824233242971631, -4.0200475562310954e-05, -4.0215623482820447e-05], [-4.0200475562310954e-05, 0.00010824669528540214, -4.020437836892297e-05], [-4.0215623482820447e-05, -4.020437836892297e-05, 0.00010828014508954347]]} - #*EXTRAS*# Step: 2 Bead: 46 -{"friction": [[0.00011026462014657351, -4.174303422146751e-05, -4.181952937569787e-05], [-4.174303422146751e-05, 0.00011028922221048206, -4.1793133448417936e-05], [-4.181952937569787e-05, -4.1793133448417936e-05, 0.00011034207011276024]]} - #*EXTRAS*# Step: 3 Bead: 46 -{"friction": [[0.00011097114489146206, -4.2214579690599524e-05, -4.229096778242044e-05], [-4.2214579690599524e-05, 0.00011098426184669523, -4.2268841391150894e-05], [-4.229096778242044e-05, -4.2268841391150894e-05, 0.00011104501609383273]]} - #*EXTRAS*# Step: 4 Bead: 46 -{"friction": [[0.0001114534578977028, -4.251891222437449e-05, -4.258466253376924e-05], [-4.251891222437449e-05, 0.00011144864949534345, -4.256506137534343e-05], [-4.258466253376924e-05, -4.256506137534343e-05, 0.00011152238176292117]]} - #*EXTRAS*# Step: 5 Bead: 46 -{"friction": [[0.00011172904665970957, -4.2686830873687415e-05, -4.274205852575965e-05], [-4.2686830873687415e-05, 0.00011170966323768848, -4.2723271124024345e-05], [-4.274205852575965e-05, -4.2723271124024345e-05, 0.00011179464375741968]]} - #*EXTRAS*# Step: 6 Bead: 46 -{"friction": [[0.00011190071030750553, -4.2789330925817436e-05, -4.283624263432756e-05], [-4.2789330925817436e-05, 0.00011187051373963898, -4.281762366778519e-05], [-4.283624263432756e-05, -4.281762366778519e-05, 0.00011196414305280242]]} - #*EXTRAS*# Step: 7 Bead: 46 -{"friction": [[0.00011200864949655341, -4.2852980629950976e-05, -4.2893942750402515e-05], [-4.2852980629950976e-05, 0.00011197094056671673, -4.287527250277649e-05], [-4.2893942750402515e-05, -4.287527250277649e-05, 0.00011207070591016548]]} - #*EXTRAS*# Step: 8 Bead: 46 -{"friction": [[0.00011207814111548145, -4.289363743411503e-05, -4.293046776688013e-05], [-4.289363743411503e-05, 0.00011203529650948634, -4.291169424226401e-05], [-4.293046776688013e-05, -4.291169424226401e-05, 0.00011213931036372298]]} - #*EXTRAS*# Step: 9 Bead: 46 -{"friction": [[0.00011212336752035216, -4.291996410945537e-05, -4.295397673201995e-05], [-4.291996410945537e-05, 0.00011207705258158327, -4.293510483331291e-05], [-4.295397673201995e-05, -4.293510483331291e-05, 0.00011218396031317572]]} - #*EXTRAS*# Step: 10 Bead: 46 -{"friction": [[0.00011215308917756725, -4.293720846251329e-05, -4.29693136108016e-05], [-4.293720846251329e-05, 0.00011210443813053993, -4.2950363245731e-05], [-4.29693136108016e-05, -4.2950363245731e-05, 0.00011221330391794694]]} - #*EXTRAS*# Step: 11 Bead: 46 -{"friction": [[0.00011217273202854153, -4.2948580512310046e-05, -4.2979400615524976e-05], [-4.2948580512310046e-05, 0.00011212251274861597, -4.296039225366435e-05], [-4.2979400615524976e-05, -4.296039225366435e-05, 0.00011223269736382091]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 deleted file mode 100644 index c975cc3e7..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_47 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 47 -{"friction": [[0.00010528762108165504, -3.73210662070218e-05, -3.725656530783905e-05], [-3.73210662070218e-05, 0.0001052870117955876, -3.741999059478165e-05], [-3.725656530783905e-05, -3.741999059478165e-05, 0.00010507311718896647]]} - #*EXTRAS*# Step: 1 Bead: 47 -{"friction": [[0.0001078704511116357, -3.9882300210906057e-05, -3.9883198943246924e-05], [-3.9882300210906057e-05, 0.00010787013901492297, -3.988433822695942e-05], [-3.9883198943246924e-05, -3.988433822695942e-05, 0.00010788872237563123]]} - #*EXTRAS*# Step: 2 Bead: 47 -{"friction": [[0.00010994857898437897, -4.152153006976962e-05, -4.159314746922519e-05], [-4.152153006976962e-05, 0.00010997376793619955, -4.156544179976334e-05], [-4.159314746922519e-05, -4.156544179976334e-05, 0.0001100255323165689]]} - #*EXTRAS*# Step: 3 Bead: 47 -{"friction": [[0.0001106927191699658, -4.2032532420192095e-05, -4.2110973217978145e-05], [-4.2032532420192095e-05, 0.00011071225375081056, -4.208709576241603e-05], [-4.2110973217978145e-05, -4.208709576241603e-05, 0.00011076864695074036]]} - #*EXTRAS*# Step: 4 Bead: 47 -{"friction": [[0.00011119602073174465, -4.235817201253699e-05, -4.2430774754559896e-05], [-4.235817201253699e-05, 0.00011120191738594266, -4.24099525204161e-05], [-4.2430774754559896e-05, -4.24099525204161e-05, 0.00011126776433184093]]} - #*EXTRAS*# Step: 5 Bead: 47 -{"friction": [[0.0001114842101255233, -4.253785976719452e-05, -4.260260316119028e-05], [-4.253785976719452e-05, 0.00011147793935938565, -4.258312138168878e-05], [-4.260260316119028e-05, -4.258312138168878e-05, 0.00011155277575944616]]} - #*EXTRAS*# Step: 6 Bead: 47 -{"friction": [[0.00011166358075739829, -4.2647322034618075e-05, -4.270535930470349e-05], [-4.2647322034618075e-05, 0.00011164796412219416, -4.268643446700857e-05], [-4.270535930470349e-05, -4.268643446700857e-05, 0.0001117299887252038]]} - #*EXTRAS*# Step: 7 Bead: 47 -{"friction": [[0.00011177637590557875, -4.2715249086544054e-05, -4.2768322211692875e-05], [-4.2715249086544054e-05, 0.00011175414774983026, -4.2749609955092125e-05], [-4.2768322211692875e-05, -4.2749609955092125e-05, 0.00011184138095541767]]} - #*EXTRAS*# Step: 8 Bead: 47 -{"friction": [[0.00011184898614342392, -4.275861246819041e-05, -4.280817636836665e-05], [-4.275861246819041e-05, 0.00011182219248969327, -4.2789537557981594e-05], [-4.280817636836665e-05, -4.2789537557981594e-05, 0.00011191307541446234]]} - #*EXTRAS*# Step: 9 Bead: 47 -{"friction": [[0.00011189624383936546, -4.2786683932543513e-05, -4.283382970546871e-05], [-4.2786683932543513e-05, 0.00011186634611045422, -4.281521012723448e-05], [-4.283382970546871e-05, -4.281521012723448e-05, 0.00011195973338251051]]} - #*EXTRAS*# Step: 10 Bead: 47 -{"friction": [[0.00011192730030011488, -4.280506732624384e-05, -4.285056575450533e-05], [-4.280506732624384e-05, 0.00011189530502285922, -4.283194602735919e-05], [-4.285056575450533e-05, -4.283194602735919e-05, 0.0001119903945788839]]} - #*EXTRAS*# Step: 11 Bead: 47 -{"friction": [[0.0001119478256290553, -4.281718908956797e-05, -4.2861573268018635e-05], [-4.281718908956797e-05, 0.00011191441879469995, -4.284294772835962e-05], [-4.2861573268018635e-05, -4.284294772835962e-05, 0.00011201065830746748]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 deleted file mode 100644 index a46e8f448..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_48 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 48 -{"friction": [[0.00010490062451440705, -3.687350091212312e-05, -3.6805665261342465e-05], [-3.687350091212312e-05, 0.00010490061033065456, -3.69947368229772e-05], [-3.6805665261342465e-05, -3.69947368229772e-05, 0.0001046451982602587]]} - #*EXTRAS*# Step: 1 Bead: 48 -{"friction": [[0.00010751933279627845, -3.9571281514985224e-05, -3.9559630751252144e-05], [-3.9571281514985224e-05, 0.00010751616596963181, -3.9576303756615484e-05], [-3.9559630751252144e-05, -3.9576303756615484e-05, 0.00010751479334275887]]} - #*EXTRAS*# Step: 2 Bead: 48 -{"friction": [[0.00010964966386135679, -4.1305687465597434e-05, -4.137044257821771e-05], [-4.1305687465597434e-05, 0.00010967342652668003, -4.1342269128064986e-05], [-4.137044257821771e-05, -4.1342269128064986e-05, 0.00010972459857508748]]} - #*EXTRAS*# Step: 3 Bead: 48 -{"friction": [[0.00011042916436843229, -4.185571283636858e-05, -4.193363695482147e-05], [-4.185571283636858e-05, 0.00011045245147070559, -4.190814412951436e-05], [-4.193363695482147e-05, -4.190814412951436e-05, 0.00011050629779866348]]} - #*EXTRAS*# Step: 4 Bead: 48 -{"friction": [[0.00011095230853856884, -4.220241398292837e-05, -4.227903046645702e-05], [-4.220241398292837e-05, 0.00011096594502782647, -4.225678842939314e-05], [-4.227903046645702e-05, -4.225678842939314e-05, 0.00011102634066625348]]} - #*EXTRAS*# Step: 5 Bead: 48 -{"friction": [[0.00011125239613991877, -4.2393700223781755e-05, -4.246503840071435e-05], [-4.2393700223781755e-05, 0.00011125617792842779, -4.2444513392334635e-05], [-4.246503840071435e-05, -4.2444513392334635e-05, 0.00011132355306983547]]} - #*EXTRAS*# Step: 6 Bead: 48 -{"friction": [[0.00011143903608994259, -4.251000800497215e-05, -4.257621638820006e-05], [-4.251000800497215e-05, 0.00011143489967095269, -4.255655705572104e-05], [-4.257621638820006e-05, -4.255655705572104e-05, 0.00011150812658752761]]} - #*EXTRAS*# Step: 7 Bead: 48 -{"friction": [[0.00011155640872001583, -4.258213484429366e-05, -4.264435138713613e-05], [-4.258213484429366e-05, 0.00011154654528857232, -4.262512358659337e-05], [-4.264435138713613e-05, -4.262512358659337e-05, 0.00011162411884896791]]} - #*EXTRAS*# Step: 8 Bead: 48 -{"friction": [[0.00011163195799102799, -4.2628153542826036e-05, -4.268747783497091e-05], [-4.2628153542826036e-05, 0.00011161809184408185, -4.266847333013431e-05], [-4.268747783497091e-05, -4.266847333013431e-05, 0.00011169875373965129]]} - #*EXTRAS*# Step: 9 Bead: 48 -{"friction": [[0.00011168112978389636, -4.265793588533556e-05, -4.2715239281155884e-05], [-4.265793588533556e-05, 0.00011166452239525116, -4.2696354982770866e-05], [-4.2715239281155884e-05, -4.2696354982770866e-05, 0.00011174732140402385]]} - #*EXTRAS*# Step: 10 Bead: 48 -{"friction": [[0.00011171344396853811, -4.26774358251897e-05, -4.2733350985311486e-05], [-4.26774358251897e-05, 0.00011169497590957938, -4.2714534285888316e-05], [-4.2733350985311486e-05, -4.2714534285888316e-05, 0.00011177923523292904]]} - #*EXTRAS*# Step: 11 Bead: 48 -{"friction": [[0.00011173480079233538, -4.2690292344457025e-05, -4.274526360999068e-05], [-4.2690292344457025e-05, 0.00011171507699385572, -4.272648645404588e-05], [-4.274526360999068e-05, -4.272648645404588e-05, 0.0001118003261504056]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 deleted file mode 100644 index 3bd1a51d7..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_49 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 49 -{"friction": [[0.00010454547171753977, -3.6444056165635773e-05, -3.637510960233212e-05], [-3.6444056165635773e-05, 0.00010454494879362924, -3.658517988655125e-05], [-3.637510960233212e-05, -3.658517988655125e-05, 0.00010425342130998133]]} - #*EXTRAS*# Step: 1 Bead: 49 -{"friction": [[0.00010718972227491339, -3.9269616442606175e-05, -3.924711656540057e-05], [-3.9269616442606175e-05, 0.00010718514048158849, -3.928132516899051e-05], [-3.924711656540057e-05, -3.928132516899051e-05, 0.00010716031004237312]]} - #*EXTRAS*# Step: 2 Bead: 49 -{"friction": [[0.00010936813232911244, -4.1096568060181137e-05, -4.115321350227058e-05], [-4.1096568060181137e-05, 0.00010938917643809587, -4.112555334101409e-05], [-4.115321350227058e-05, -4.112555334101409e-05, 0.00010943956856354979]]} - #*EXTRAS*# Step: 3 Bead: 49 -{"friction": [[0.00011018074088021696, -4.168490371317932e-05, -4.1760366755337695e-05], [-4.168490371317932e-05, 0.00011020573518179522, -4.1733560177609555e-05], [-4.1760366755337695e-05, -4.1733560177609555e-05, 0.00011025820775565387]]} - #*EXTRAS*# Step: 4 Bead: 49 -{"friction": [[0.00011072257036036972, -4.2052280995570795e-05, -4.2130634064617134e-05], [-4.2052280995570795e-05, 0.00011074154256000285, -4.210694581061294e-05], [-4.2130634064617134e-05, -4.210694581061294e-05, 0.00011079831308265448]]} - #*EXTRAS*# Step: 5 Bead: 49 -{"friction": [[0.00011103385172111439, -4.225492493035832e-05, -4.233045555750098e-05], [-4.225492493035832e-05, 0.00011104514597036944, -4.230870835427604e-05], [-4.233045555750098e-05, -4.230870835427604e-05, 0.00011110716681259907]]} - #*EXTRAS*# Step: 6 Bead: 49 -{"friction": [[0.00011122732268778896, -4.237792171574066e-05, -4.244983832822908e-05], [-4.237792171574066e-05, 0.00011123206059573108, -4.2429182915318095e-05], [-4.244983832822908e-05, -4.2429182915318095e-05, 0.00011129874291264384]]} - #*EXTRAS*# Step: 7 Bead: 49 -{"friction": [[0.00011134899409147604, -4.245414698653464e-05, -4.252301354335068e-05], [-4.245414698653464e-05, 0.00011134885623864095, -4.2502961331310564e-05], [-4.252301354335068e-05, -4.2502961331310564e-05, 0.00011141910357010713]]} - #*EXTRAS*# Step: 8 Bead: 49 -{"friction": [[0.00011142730268450619, -4.2502754935544865e-05, -4.256932937428298e-05], [-4.2502754935544865e-05, 0.0001114237065088634, -4.2549621707374074e-05], [-4.256932937428298e-05, -4.2549621707374074e-05, 0.00011149652808577145]]} - #*EXTRAS*# Step: 9 Bead: 49 -{"friction": [[0.00011147827129729228, -4.253420480424595e-05, -4.2599145860553944e-05], [-4.253420480424595e-05, 0.00011147228607805608, -4.257964153068416e-05], [-4.2599145860553944e-05, -4.257964153068416e-05, 0.0001115469064139975]]} - #*EXTRAS*# Step: 10 Bead: 49 -{"friction": [[0.00011151176606799609, -4.255479267540448e-05, -4.2618598732686786e-05], [-4.255479267540448e-05, 0.00011150415061784592, -4.259921834855598e-05], [-4.2618598732686786e-05, -4.259921834855598e-05, 0.00011158000748449947]]} - #*EXTRAS*# Step: 11 Bead: 49 -{"friction": [[0.00011153390336263999, -4.256836498331526e-05, -4.263139384856813e-05], [-4.256836498331526e-05, 0.0001115251839797575, -4.2612090970459306e-05], [-4.263139384856813e-05, -4.2612090970459306e-05, 0.00011160188222604244]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 deleted file mode 100644 index 252e7bea8..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_50 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 50 -{"friction": [[0.00010422157793290393, -3.6035021611147086e-05, -3.5966888494172815e-05], [-3.6035021611147086e-05, 0.00010421927471690661, -3.619295965410192e-05], [-3.5966888494172815e-05, -3.619295965410192e-05, 0.00010389772288898436]]} - #*EXTRAS*# Step: 1 Bead: 50 -{"friction": [[0.00010688226525661363, -3.897942834033022e-05, -3.8947664518042906e-05], [-3.897942834033022e-05, 0.0001068772645223112, -3.900032845297986e-05], [-3.8947664518042906e-05, -3.900032845297986e-05, 0.00010682705015776695]]} - #*EXTRAS*# Step: 2 Bead: 50 -{"friction": [[0.0001091042228457379, -4.0895248920428554e-05, -4.094314518969592e-05], [-4.0895248920428554e-05, 0.00010912183848657076, -4.091703380455052e-05], [-4.094314518969592e-05, -4.091703380455052e-05, 0.0001091707872657307]]} - #*EXTRAS*# Step: 3 Bead: 50 -{"friction": [[0.00010994769659753867, -4.152090209304113e-05, -4.15925022556862e-05], [-4.152090209304113e-05, 0.0001099728839578621, -4.156479395136362e-05], [-4.15925022556862e-05, -4.156479395136362e-05, 0.00011002464631106863]]} - #*EXTRAS*# Step: 4 Bead: 50 -{"friction": [[0.00011050704081943693, -4.1908424699192846e-05, -4.198673626199791e-05], [-4.1908424699192846e-05, 0.0001105294385242952, -4.1961705153029155e-05], [-4.198673626199791e-05, -4.1961705153029155e-05, 0.0001105839025039089]]} - #*EXTRAS*# Step: 5 Bead: 50 -{"friction": [[0.0001108288083312415, -4.212211256295431e-05, -4.219989978294769e-05], [-4.212211256295431e-05, 0.00011084553886792053, -4.217688544393612e-05], [-4.219989978294769e-05, -4.217688544393612e-05, 0.00011090382053479518]]} - #*EXTRAS*# Step: 6 Bead: 50 -{"friction": [[0.00011102867090044044, -4.225160060857412e-05, -4.232720778643653e-05], [-4.225160060857412e-05, 0.00011104012122110064, -4.2305429629705166e-05], [-4.232720778643653e-05, -4.2305429629705166e-05, 0.00011110203309474452]]} - #*EXTRAS*# Step: 7 Bead: 50 -{"friction": [[0.00011115436191735961, -4.2331798356731695e-05, -4.2405252817913006e-05], [-4.2331798356731695e-05, 0.00011116174125842683, -4.2384202105818835e-05], [-4.2405252817913006e-05, -4.2384202105818835e-05, 0.00011122652631873643]]} - #*EXTRAS*# Step: 8 Bead: 50 -{"friction": [[0.00011123524988312174, -4.2382914202604164e-05, -4.2454650720194915e-05], [-4.2382914202604164e-05, 0.00011123968820345596, -4.2434036854054145e-05], [-4.2454650720194915e-05, -4.2434036854054145e-05, 0.00011130658726798664]]} - #*EXTRAS*# Step: 9 Bead: 50 -{"friction": [[0.0001112878978940052, -4.2415978503685e-05, -4.248645342692199e-05], [-4.2415978503685e-05, 0.00011129028297772307, -4.246610784802755e-05], [-4.248645342692199e-05, -4.246610784802755e-05, 0.0001113586757951835]]} - #*EXTRAS*# Step: 10 Bead: 50 -{"friction": [[0.00011132249601873564, -4.24376193784944e-05, -4.2507202691430194e-05], [-4.24376193784944e-05, 0.00011132347105566937, -4.248702573797676e-05], [-4.2507202691430194e-05, -4.248702573797676e-05, 0.0001113928978216412]]} - #*EXTRAS*# Step: 11 Bead: 50 -{"friction": [[0.0001113453626974834, -4.245188437280933e-05, -4.252085090360856e-05], [-4.245188437280933e-05, 0.0001113453790596462, -4.250078182989472e-05], [-4.252085090360856e-05, -4.250078182989472e-05, 0.00011141551245044024]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 deleted file mode 100644 index 89e4768b1..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_51 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 51 -{"friction": [[0.00010392810737404057, -3.564841585082599e-05, -3.5582711172999606e-05], [-3.564841585082599e-05, 0.0001039227172200635, -3.581976330672245e-05], [-3.5582711172999606e-05, -3.581976330672245e-05, 0.00010357747568088037]]} - #*EXTRAS*# Step: 1 Bead: 51 -{"friction": [[0.00010659738920046837, -3.87026521400088e-05, -3.8663082009413894e-05], [-3.87026521400088e-05, 0.00010659261223789722, -3.87342657679597e-05], [-3.8663082009413894e-05, -3.87342657679597e-05, 0.00010651635869829663]]} - #*EXTRAS*# Step: 2 Bead: 51 -{"friction": [[0.00010885815780103535, -4.070280912408581e-05, -4.074180295934311e-05], [-4.070280912408581e-05, 0.00010887208789185322, -4.071825509031117e-05], [-4.074180295934311e-05, -4.071825509031117e-05, 0.00010891863881567782]]} - #*EXTRAS*# Step: 3 Bead: 51 -{"friction": [[0.00010973026642054414, -4.136450895870238e-05, -4.143130738960599e-05], [-4.136450895870238e-05, 0.00010975457884155222, -4.1403169161820155e-05], [-4.143130738960599e-05, -4.1403169161820155e-05, 0.00010980590779731617]]} - #*EXTRAS*# Step: 4 Bead: 51 -{"friction": [[0.00011030594060479529, -4.1771498043873867e-05, -4.184842767574959e-05], [-4.1771498043873867e-05, 0.00011033028197926537, -4.1822247505509544e-05], [-4.184842767574959e-05, -4.1822247505509544e-05, 0.00011038334545006209]]} - #*EXTRAS*# Step: 5 Bead: 51 -{"friction": [[0.00011063748246108206, -4.199584142658615e-05, -4.2074363990955145e-05], [-4.199584142658615e-05, 0.0001106579816669476, -4.205013812514188e-05], [-4.2074363990955145e-05, -4.205013812514188e-05, 0.00011071372803504835]]} - #*EXTRAS*# Step: 6 Bead: 51 -{"friction": [[0.00011084329564996089, -4.213158094578883e-05, -4.220925977432778e-05], [-4.213158094578883e-05, 0.00011085969083919635, -4.218633696450145e-05], [-4.220925977432778e-05, -4.218633696450145e-05, 0.00011091819990393749]]} - #*EXTRAS*# Step: 7 Bead: 51 -{"friction": [[0.00011097272644766295, -4.22156001792611e-05, -4.229196848509937e-05], [-4.22156001792611e-05, 0.00011098579919729196, -4.2269851770361327e-05], [-4.229196848509937e-05, -4.2269851770361327e-05, 0.00011104658400682763]]} - #*EXTRAS*# Step: 8 Bead: 51 -{"friction": [[0.00011105601348272115, -4.226912702286552e-05, -4.234431848664201e-05], [-4.226912702286552e-05, 0.00011106662885798345, -4.2322702846666086e-05], [-4.234431848664201e-05, -4.2322702846666086e-05, 0.00011112912480202128]]} - #*EXTRAS*# Step: 9 Bead: 51 -{"friction": [[0.00011111022325952321, -4.2303742761092796e-05, -4.237802395733137e-05], [-4.2303742761092796e-05, 0.00011111910041682936, -4.235672381742277e-05], [-4.237802395733137e-05, -4.235672381742277e-05, 0.00011118282099533963]]} - #*EXTRAS*# Step: 10 Bead: 51 -{"friction": [[0.00011114584737309008, -4.232639529769034e-05, -4.240001527243073e-05], [-4.232639529769034e-05, 0.00011115352147461868, -4.237891700912842e-05], [-4.240001527243073e-05, -4.237891700912842e-05, 0.00011121809638953061]]} - #*EXTRAS*# Step: 11 Bead: 51 -{"friction": [[0.00011116939226247045, -4.234132567559808e-05, -4.241448088425314e-05], [-4.234132567559808e-05, 0.00011117624443519128, -4.239351342034503e-05], [-4.241448088425314e-05, -4.239351342034503e-05, 0.00011124140613133703]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 deleted file mode 100644 index 36c5dff68..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_52 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 52 -{"friction": [[0.00010366394327696455, -3.5285887569447394e-05, -3.522391444163986e-05], [-3.5285887569447394e-05, 0.00010365423205589712, -3.546717661556058e-05], [-3.522391444163986e-05, -3.546717661556058e-05, 0.00010329150520581095]]} - #*EXTRAS*# Step: 1 Bead: 52 -{"friction": [[0.00010633529483262444, -3.84409999687275e-05, -3.839494416313572e-05], [-3.84409999687275e-05, 0.00010633111189352298, -3.848406180840241e-05], [-3.839494416313572e-05, -3.848406180840241e-05, 0.00010622915768290394]]} - #*EXTRAS*# Step: 2 Bead: 52 -{"friction": [[0.00010863014551742617, -4.0520316283984664e-05, -4.0550629116795764e-05], [-4.0520316283984664e-05, 0.0001086404678881989, -4.0530574346712984e-05], [-4.0550629116795764e-05, -4.0530574346712984e-05, 0.00010868353854298102]]} - #*EXTRAS*# Step: 3 Bead: 52 -{"friction": [[0.00010952867169385479, -4.12165188087269e-05, -4.127796428052876e-05], [-4.12165188087269e-05, 0.00010955140750574472, -4.1249882888814735e-05], [-4.127796428052876e-05, -4.1249882888814735e-05, 0.00010960230512537791]]} - #*EXTRAS*# Step: 4 Bead: 52 -{"friction": [[0.0001101194767097989, -4.164214761038742e-05, -4.17167334593018e-05], [-4.164214761038742e-05, 0.00011014464567331005, -4.1689653022112195e-05], [-4.17167334593018e-05, -4.1689653022112195e-05, 0.00011019689026788544]]} - #*EXTRAS*# Step: 5 Bead: 52 -{"friction": [[0.00011046007600826995, -4.1876682935204065e-05, -4.195478368167024e-05], [-4.1876682935204065e-05, 0.00011048303130395, -4.192947198122667e-05], [-4.195478368167024e-05, -4.192947198122667e-05, 0.00011053711054109131]]} - #*EXTRAS*# Step: 6 Bead: 52 -{"friction": [[0.00011067139685442698, -4.2018391919222346e-05, -4.2096876598199625e-05], [-4.2018391919222346e-05, 0.00011069131540531362, -4.2072864328219056e-05], [-4.2096876598199625e-05, -4.2072864328219056e-05, 0.00011074745115197221]]} - #*EXTRAS*# Step: 7 Bead: 52 -{"friction": [[0.00011080428672376668, -4.2106056537063517e-05, -4.218400998219951e-05], [-4.2106056537063517e-05, 0.00011082156847871106, -4.216084038632012e-05], [-4.218400998219951e-05, -4.216084038632012e-05, 0.00011087947719794702]]} - #*EXTRAS*# Step: 8 Bead: 52 -{"friction": [[0.00011088979205998749, -4.2161881902089115e-05, -4.223916124884156e-05], [-4.2161881902089115e-05, 0.0001109050618055459, -4.2216530813007675e-05], [-4.223916124884156e-05, -4.2216530813007675e-05, 0.00011096433700701134]]} - #*EXTRAS*# Step: 9 Bead: 52 -{"friction": [[0.00011094544569655772, -4.2197976164666226e-05, -4.2274672541037186e-05], [-4.2197976164666226e-05, 0.00011095926829410107, -4.225238819477053e-05], [-4.2274672541037186e-05, -4.225238819477053e-05, 0.00011101953573134598]]} - #*EXTRAS*# Step: 10 Bead: 52 -{"friction": [[0.0001109820182623048, -4.222159259809246e-05, -4.229784274604936e-05], [-4.222159259809246e-05, 0.00011099482946544186, -4.227578277250922e-05], [-4.229784274604936e-05, -4.227578277250922e-05, 0.00011105579525902599]]} - #*EXTRAS*# Step: 11 Bead: 52 -{"friction": [[0.00011100619007828505, -4.223715685099646e-05, -4.2313084249124014e-05], [-4.223715685099646e-05, 0.0001110183061482042, -4.2291170960268984e-05], [-4.2313084249124014e-05, -4.2291170960268984e-05, 0.00011107975427839271]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 deleted file mode 100644 index a9e36f273..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_53 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 53 -{"friction": [[0.00010342777205096691, -3.4948757364551355e-05, -3.48915119324289e-05], [-3.4948757364551355e-05, 0.00010341266127600232, -3.513667008856002e-05], [-3.48915119324289e-05, -3.513667008856002e-05, 0.0001030382318154365]]} - #*EXTRAS*# Step: 1 Bead: 53 -{"friction": [[0.00010609599691303195, -3.819597322211792e-05, -3.81446102538467e-05], [-3.819597322211792e-05, 0.00010609257661209749, -3.825060395285669e-05], [-3.81446102538467e-05, -3.825060395285669e-05, 0.0001059660103422631]]} - #*EXTRAS*# Step: 2 Bead: 53 -{"friction": [[0.00010842038144812837, -4.034881331496071e-05, -4.037094161657163e-05], [-4.034881331496071e-05, 0.0001084274044080589, -4.035517150651024e-05], [-4.037094161657163e-05, -4.035517150651024e-05, 0.0001084659237797132]]} - #*EXTRAS*# Step: 3 Bead: 53 -{"friction": [[0.00010934311960735249, -4.1077709356246505e-05, -4.1133568542785985e-05], [-4.1077709356246505e-05, 0.00010936387023376427, -4.110600739328421e-05], [-4.1133568542785985e-05, -4.110600739328421e-05, 0.00010941416301194454]]} - #*EXTRAS*# Step: 4 Bead: 53 -{"friction": [[0.00010994784245418986, -4.152100589995588e-05, -4.1592608913119075e-05], [-4.152100589995588e-05, 0.00010997303007873796, -4.1564901043879487e-05], [-4.1592608913119075e-05, -4.1564901043879487e-05, 0.00011002479276678453]]} - #*EXTRAS*# Step: 5 Bead: 53 -{"friction": [[0.0001102967764728108, -4.176519505159984e-05, -4.18420326143446e-05], [-4.176519505159984e-05, 0.00011032117959137537, -4.1815803886408767e-05], [-4.18420326143446e-05, -4.1815803886408767e-05, 0.0001103741933708584]]} - #*EXTRAS*# Step: 6 Bead: 53 -{"friction": [[0.000110513159688305, -4.1912549717315214e-05, -4.199088357709438e-05], [-4.1912549717315214e-05, 0.00011053547993273332, -4.196588945827663e-05], [-4.199088357709438e-05, -4.196588945827663e-05, 0.00011058999688590044]]} - #*EXTRAS*# Step: 7 Bead: 53 -{"friction": [[0.00011064922686583983, -4.200365880606488e-05, -4.208217266214199e-05], [-4.200365880606488e-05, 0.0001106695291467517, -4.205802062855221e-05], [-4.208217266214199e-05, -4.205802062855221e-05, 0.00011072540760139091]]} - #*EXTRAS*# Step: 8 Bead: 53 -{"friction": [[0.00011073676917255757, -4.2061654833051176e-05, -4.2139955321469756e-05], [-4.2061654833051176e-05, 0.00011075546361518265, -4.211635718221711e-05], [-4.2139955321469756e-05, -4.211635718221711e-05, 0.00011081242067964347]]} - #*EXTRAS*# Step: 9 Bead: 53 -{"friction": [[0.00011079374843170799, -4.209914491633419e-05, -4.217716317596078e-05], [-4.209914491633419e-05, 0.0001108112607829503, -4.21539267595911e-05], [-4.217716317596078e-05, -4.21539267595911e-05, 0.00011086901377529946]]} - #*EXTRAS*# Step: 10 Bead: 53 -{"friction": [[0.00011083119170682856, -4.212367114181219e-05, -4.220144105138178e-05], [-4.212367114181219e-05, 0.00011084786757029157, -4.2178441781560744e-05], [-4.220144105138178e-05, -4.2178441781560744e-05, 0.000110906186284153]]} - #*EXTRAS*# Step: 11 Bead: 53 -{"friction": [[0.00011085593903310046, -4.2139833610318514e-05, -4.221741162438055e-05], [-4.2139833610318514e-05, 0.00011087203563670366, -4.219456854556681e-05], [-4.221741162438055e-05, -4.219456854556681e-05, 0.00011093074750693787]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 deleted file mode 100644 index 0f156953b..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_54 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 54 -{"friction": [[0.00010321820672526034, -3.463813479007007e-05, -3.4586315531130965e-05], [-3.463813479007007e-05, 0.00010319683609987853, -3.482966366715975e-05], [-3.4586315531130965e-05, -3.482966366715975e-05, 0.00010281585060269033]]} - #*EXTRAS*# Step: 1 Bead: 54 -{"friction": [[0.00010587938648071665, -3.796890114537215e-05, -3.7913266677567196e-05], [-3.796890114537215e-05, 0.00010587675610782059, -3.803475647524443e-05], [-3.7913266677567196e-05, -3.803475647524443e-05, 0.00010572721017266073]]} - #*EXTRAS*# Step: 2 Bead: 54 -{"friction": [[0.00010822904871973259, -4.018930566833102e-05, -4.020393438010497e-05], [-4.018930566833102e-05, 0.00010823322132307501, -4.019306154146698e-05], [-4.020393438010497e-05, -4.019306154146698e-05, 0.00010826624387855552]]} - #*EXTRAS*# Step: 3 Bead: 54 -{"friction": [[0.00010917380258737363, -4.094883154395565e-05, -4.099912588563783e-05], [-4.094883154395565e-05, 0.00010919238691573272, -4.09724937013694e-05], [-4.099912588563783e-05, -4.09724937013694e-05, 0.00010924181091614152]]} - #*EXTRAS*# Step: 4 Bead: 54 -{"friction": [[0.00010979121732685517, -4.1408683720930764e-05, -4.147693599058431e-05], [-4.1408683720930764e-05, 0.00010981586808200854, -4.144887146872218e-05], [-4.147693599058431e-05, -4.144887146872218e-05, 0.00010986731143173133]]} - #*EXTRAS*# Step: 5 Bead: 54 -{"friction": [[0.00011014775699662489, -4.1661915801868875e-05, -4.173691926448433e-05], [-4.1661915801868875e-05, 0.00011017285679065683, -4.170996231546591e-05], [-4.173691926448433e-05, -4.170996231546591e-05, 0.00011022520221547483]]} - #*EXTRAS*# Step: 6 Bead: 54 -{"friction": [[0.00011036875470171303, -4.1814551653449256e-05, -4.189204548015638e-05], [-4.1814551653449256e-05, 0.00011039261143666444, -4.1866208158066496e-05], [-4.189204548015638e-05, -4.1866208158066496e-05, 0.00011044604623062921]]} - #*EXTRAS*# Step: 7 Bead: 54 -{"friction": [[0.00011050771622821612, -4.190888014268581e-05, -4.1987194225555015e-05], [-4.190888014268581e-05, 0.00011053010543779985, -4.196216719500818e-05], [-4.1987194225555015e-05, -4.196216719500818e-05, 0.00011058457523180933]]} - #*EXTRAS*# Step: 8 Bead: 54 -{"friction": [[0.00011059711353281078, -4.1968904003692625e-05, -4.204742119105575e-05], [-4.1968904003692625e-05, 0.00011061825643487608, -4.2022942898067e-05], [-4.204742119105575e-05, -4.2022942898067e-05, 0.00011067357044430695]]} - #*EXTRAS*# Step: 9 Bead: 54 -{"friction": [[0.00011065529979946061, -4.2007697679593364e-05, -4.208620520318973e-05], [-4.2007697679593364e-05, 0.00011067549853019927, -4.206209140669799e-05], [-4.208620520318973e-05, -4.206209140669799e-05, 0.00011073144642344597]]} - #*EXTRAS*# Step: 10 Bead: 54 -{"friction": [[0.00011069353580632324, -4.20330734259487e-05, -4.211151223299558e-05], [-4.20330734259487e-05, 0.00011071305538868232, -4.208763994711919e-05], [-4.211151223299558e-05, -4.208763994711919e-05, 0.00011076945864689924]]} - #*EXTRAS*# Step: 11 Bead: 54 -{"friction": [[0.00011071880707627625, -4.204979441374409e-05, -4.212816024232781e-05], [-4.204979441374409e-05, 0.00011073785178045527, -4.21044481141756e-05], [-4.212816024232781e-05, -4.21044481141756e-05, 0.00011079457363198546]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 deleted file mode 100644 index ed70dbf7e..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_55 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 55 -{"friction": [[0.0001030336955245592, -3.435497053307799e-05, -3.430893758166685e-05], [-3.435497053307799e-05, 0.00010300555227581691, -3.4547622358950575e-05], [-3.430893758166685e-05, -3.4547622358950575e-05, 0.00010262224478354004]]} - #*EXTRAS*# Step: 1 Bead: 55 -{"friction": [[0.00010568527053064547, -3.7760961772199965e-05, -3.770195122035504e-05], [-3.7760961772199965e-05, 0.00010568336598957213, -3.7837357817431626e-05], [-3.770195122035504e-05, -3.7837357817431626e-05, 0.00010551284542658475]]} - #*EXTRAS*# Step: 2 Bead: 55 -{"friction": [[0.00010805631812484309, -4.004274919114014e-05, -4.005067886697458e-05], [-4.004274919114014e-05, 0.00010805815574732738, -4.004510800760899e-05], [-4.005067886697458e-05, -4.004510800760899e-05, 0.00010808494981191354]]} - #*EXTRAS*# Step: 3 Bead: 55 -{"friction": [[0.00010902089769672644, -4.0830600038885e-05, -4.087554987674827e-05], [-4.0830600038885e-05, 0.0001090373047441396, -4.085017658855083e-05], [-4.087554987674827e-05, -4.085017658855083e-05, 0.00010908557588979122]]} - #*EXTRAS*# Step: 4 Bead: 55 -{"friction": [[0.00010964976668667094, -4.130576279925025e-05, -4.1370520603282006e-05], [-4.130576279925025e-05, 0.00010967353012443889, -4.1342347150740044e-05], [-4.1370520603282006e-05, -4.1342347150740044e-05, 0.00010972470238199631]]} - #*EXTRAS*# Step: 5 Bead: 55 -{"friction": [[0.00011001317627539949, -4.156735697168856e-05, -4.164018398962453e-05], [-4.156735697168856e-05, 0.00011003843560122355, -4.1612688580600166e-05], [-4.164018398962453e-05, -4.1612688580600166e-05, 0.00011009035918223477]]} - #*EXTRAS*# Step: 6 Bead: 55 -{"friction": [[0.00011023833782219693, -4.172487045249428e-05, -4.1801063619613784e-05], [-4.172487045249428e-05, 0.00011026308227496954, -4.1774534901132106e-05], [-4.1801063619613784e-05, -4.1774534901132106e-05, 0.00011031580400185701]]} - #*EXTRAS*# Step: 7 Bead: 55 -{"friction": [[0.0001103799094437924, -4.182217011542601e-05, -4.189975177567129e-05], [-4.182217011542601e-05, 0.00011040366873687404, -4.187397704591758e-05], [-4.189975177567129e-05, -4.187397704591758e-05, 0.00011045717534616317]]} - #*EXTRAS*# Step: 8 Bead: 55 -{"friction": [[0.00011047097907485705, -4.188406464063633e-05, -4.196222055045534e-05], [-4.188406464063633e-05, 0.00011049381071119826, -4.193697343783128e-05], [-4.196222055045534e-05, -4.193697343783128e-05, 0.00011054797588521862]]} - #*EXTRAS*# Step: 9 Bead: 55 -{"friction": [[0.00011053025332210125, -4.192406055722852e-05, -4.200245033017237e-05], [-4.192406055722852e-05, 0.00011055235122620279, -4.197756002786641e-05], [-4.200245033017237e-05, -4.197756002786641e-05, 0.00011060701975019464]]} - #*EXTRAS*# Step: 10 Bead: 55 -{"friction": [[0.00011056920382736851, -4.1950219646933315e-05, -4.202870145763412e-05], [-4.1950219646933315e-05, 0.0001105907620513734, -4.200405013165232e-05], [-4.202870145763412e-05, -4.200405013165232e-05, 0.00011064579618917533]]} - #*EXTRAS*# Step: 11 Bead: 55 -{"friction": [[0.00011059494731092463, -4.196745559126683e-05, -4.2045970954250854e-05], [-4.196745559126683e-05, 0.00011061612331212563, -4.202147918371152e-05], [-4.2045970954250854e-05, -4.202147918371152e-05, 0.00011067141505080317]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 deleted file mode 100644 index 6aa8a14ce..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_56 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 56 -{"friction": [[0.00010287248283727404, -3.41000175745236e-05, -3.4059743381936934e-05], [-3.41000175745236e-05, 0.00010283753372188608, -3.4291999923335146e-05], [-3.4059743381936934e-05, -3.4291999923335146e-05, 0.00010245497440254835]]} - #*EXTRAS*# Step: 1 Bead: 56 -{"friction": [[0.00010551338152019661, -3.757317297080601e-05, -3.751154664211382e-05], [-3.757317297080601e-05, 0.00010551208747260516, -3.76591904443821e-05], [-3.751154664211382e-05, -3.76591904443821e-05, 0.00010532282944900653]]} - #*EXTRAS*# Step: 2 Bead: 56 -{"friction": [[0.00010790234770645254, -3.991003876806969e-05, -3.9912126560933974e-05], [-3.991003876806969e-05, 0.0001079023730119228, -3.991203723344638e-05], [-3.9912126560933974e-05, -3.991203723344638e-05, 0.0001079224837223884]]} - #*EXTRAS*# Step: 3 Bead: 56 -{"friction": [[0.00010888456606022351, -4.0723684343475974e-05, -4.0763660698731716e-05], [-4.0723684343475974e-05, 0.00010889890629591815, -4.073978057987642e-05], [-4.0763660698731716e-05, -4.073978057987642e-05, 0.00010894577553168974]]} - #*EXTRAS*# Step: 4 Bead: 56 -{"friction": [[0.00010952364135854918, -4.1212788728038696e-05, -4.127409062198184e-05], [-4.1212788728038696e-05, 0.00010954632959185874, -4.1246017068110866e-05], [-4.127409062198184e-05, -4.1246017068110866e-05, 0.0001095972142383212]]} - #*EXTRAS*# Step: 5 Bead: 56 -{"friction": [[0.00010989317837141276, -4.1481998082769866e-05, -4.1552496820752654e-05], [-4.1481998082769866e-05, 0.00010991823539637821, -4.152463878101612e-05], [-4.1552496820752654e-05, -4.152463878101612e-05, 0.0001099698787317994]]} - #*EXTRAS*# Step: 6 Bead: 56 -{"friction": [[0.00011012205026325673, -4.164394878498173e-05, -4.171857352858452e-05], [-4.164394878498173e-05, 0.00011014721373497907, -4.169150411439326e-05], [-4.171857352858452e-05, -4.169150411439326e-05, 0.0001101994672081787]]} - #*EXTRAS*# Step: 7 Bead: 56 -{"friction": [[0.00011026594637922502, -4.174394956478799e-05, -4.1820459432655924e-05], [-4.174394956478799e-05, 0.00011029054077892647, -4.179407030030076e-05], [-4.1820459432655924e-05, -4.179407030030076e-05, 0.00011034339526781115]]} - #*EXTRAS*# Step: 8 Bead: 56 -{"friction": [[0.0001103585049350248, -4.1807544069176005e-05, -4.188495387656098e-05], [-4.1807544069176005e-05, 0.00011038244815289338, -4.185905947427962e-05], [-4.188495387656098e-05, -4.185905947427962e-05, 0.00011043581856480895]]} - #*EXTRAS*# Step: 9 Bead: 56 -{"friction": [[0.00011041874770492986, -4.184863227802106e-05, -4.192649018667254e-05], [-4.184863227802106e-05, 0.00011044214041805985, -4.1900937027270956e-05], [-4.192649018667254e-05, -4.1900937027270956e-05, 0.00011049591174802914]]} - #*EXTRAS*# Step: 10 Bead: 56 -{"friction": [[0.0001104583342076689, -4.1875502969051744e-05, -4.1953594556826755e-05], [-4.1875502969051744e-05, 0.00011048130893671071, -4.192827257107027e-05], [-4.1953594556826755e-05, -4.192827257107027e-05, 0.00011053537463051823]]} - #*EXTRAS*# Step: 11 Bead: 56 -{"friction": [[0.00011048449800378008, -4.1893206664688265e-05, -4.197142576463895e-05], [-4.1893206664688265e-05, 0.00011050717147044749, -4.1946259212570714e-05], [-4.197142576463895e-05, -4.1946259212570714e-05, 0.00011056144601116417]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 deleted file mode 100644 index e467f6e4d..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_57 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 57 -{"friction": [[0.00010273307889993032, -3.387387660981356e-05, -3.383904253920663e-05], [-3.387387660981356e-05, 0.00010269165843199864, -3.406401214784578e-05], [-3.383904253920663e-05, -3.406401214784578e-05, 0.00010231189325852699]]} - #*EXTRAS*# Step: 1 Bead: 57 -{"friction": [[0.00010536340689656752, -3.7406405851485144e-05, -3.734279685029382e-05], [-3.7406405851485144e-05, 0.00010536258765219391, -3.750097330746608e-05], [-3.734279685029382e-05, -3.750097330746608e-05, 0.0001051569518497606]]} - #*EXTRAS*# Step: 2 Bead: 57 -{"friction": [[0.0001077672899467541, -3.979200408389626e-05, -3.978911239809217e-05], [-3.979200408389626e-05, 0.00010776597932267155, -3.979444212774247e-05], [-3.978911239809217e-05, -3.979444212774247e-05, 0.00010777928592300358]]} - #*EXTRAS*# Step: 3 Bead: 57 -{"friction": [[0.0001087649523324993, -4.0628700634069755e-05, -4.066418472077692e-05], [-4.0628700634069755e-05, 0.00010877741770462994, -4.064192658711429e-05], [-4.066418472077692e-05, -4.064192658711429e-05, 0.00010882271122082538]]} - #*EXTRAS*# Step: 4 Bead: 57 -{"friction": [[0.00010941297716055378, -4.113026435924637e-05, -4.118829446586204e-05], [-4.113026435924637e-05, 0.0001094345282604382, -4.116048000380276e-05], [-4.118829446586204e-05, -4.116048000380276e-05, 0.00010948508305179779]]} - #*EXTRAS*# Step: 5 Bead: 57 -{"friction": [[0.00010978789245555794, -4.1406280738047924e-05, -4.147445579266751e-05], [-4.1406280738047924e-05, 0.00010981252654353268, -4.144638625364133e-05], [-4.147445579266751e-05, -4.144638625364133e-05, 0.00010986396363720996]]} - #*EXTRAS*# Step: 6 Bead: 57 -{"friction": [[0.00011002001836375603, -4.157219412992952e-05, -4.1645143149069345e-05], [-4.157219412992952e-05, 0.00011004527972096271, -4.161767195391058e-05], [-4.1645143149069345e-05, -4.161767195391058e-05, 0.00011009722155591035]]} - #*EXTRAS*# Step: 7 Bead: 57 -{"friction": [[0.00011016595202276082, -4.167460576822622e-05, -4.174986644005414e-05], [-4.167460576822622e-05, 0.00011019099695999457, -4.172299161834093e-05], [-4.174986644005414e-05, -4.172299161834093e-05, 0.00011024341120308603]]} - #*EXTRAS*# Step: 8 Bead: 57 -{"friction": [[0.00011025981536631939, -4.1739717063769264e-05, -4.181615848851476e-05], [-4.1739717063769264e-05, 0.00011028444480968353, -4.178973801867443e-05], [-4.181615848851476e-05, -4.178973801867443e-05, 0.00011033726902870968]]} - #*EXTRAS*# Step: 9 Bead: 57 -{"friction": [[0.0001103209067663942, -4.1781779664792057e-05, -4.185885435365232e-05], [-4.1781779664792057e-05, 0.00011034514244129577, -4.1832754314504246e-05], [-4.185885435365232e-05, -4.1832754314504246e-05, 0.00011039828945047845]]} - #*EXTRAS*# Step: 10 Bead: 57 -{"friction": [[0.00011036105049583356, -4.1809285068399454e-05, -4.188671603744782e-05], [-4.1809285068399454e-05, 0.00011038497250746309, -4.1860835771759115e-05], [-4.188671603744782e-05, -4.1860835771759115e-05, 0.00011043835876664947]]} - #*EXTRAS*# Step: 11 Bead: 57 -{"friction": [[0.00011038758253108684, -4.1827405941199015e-05, -4.1905045830065985e-05], [-4.1827405941199015e-05, 0.00011041127277516824, -4.187931443464574e-05], [-4.1905045830065985e-05, -4.187931443464574e-05, 0.00011046482985904919]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 deleted file mode 100644 index 8a0b14d89..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_58 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 58 -{"friction": [[0.00010261428366339391, -3.367703313457375e-05, -3.3647121432587244e-05], [-3.367703313457375e-05, 0.00010256698019056102, -3.3864653594504656e-05], [-3.3647121432587244e-05, -3.3864653594504656e-05, 0.00010219119996151315]]} - #*EXTRAS*# Step: 1 Bead: 58 -{"friction": [[0.0001052350179684757, -3.7261400315599e-05, -3.719632488166249e-05], [-3.7261400315599e-05, 0.00010523453987101449, -3.7363357930734816e-05], [-3.719632488166249e-05, -3.7363357930734816e-05, 0.0001050149275339326]]} - #*EXTRAS*# Step: 2 Bead: 58 -{"friction": [[0.00010765130340315402, -3.9689410025850775e-05, -3.968235868597892e-05], [-3.9689410025850775e-05, 0.00010764903244530955, -3.969277934457391e-05], [-3.968235868597892e-05, -3.969277934457391e-05, 0.00010765581254918402]]} - #*EXTRAS*# Step: 3 Bead: 58 -{"friction": [[0.00010866218424880969, -4.054620443346167e-05, -4.057775472510992e-05], [-4.054620443346167e-05, 0.00010867301667475944, -4.0557138841220643e-05], [-4.057775472510992e-05, -4.0557138841220643e-05, 0.00010871666181012876]]} - #*EXTRAS*# Step: 4 Bead: 58 -{"friction": [[0.00010931789438123606, -4.105864371625966e-05, -4.1113700161084415e-05], [-4.105864371625966e-05, 0.00010933834160357464, -4.1086248483347904e-05], [-4.1113700161084415e-05, -4.1086248483347904e-05, 0.00010938852742091382]]} - #*EXTRAS*# Step: 5 Bead: 58 -{"friction": [[0.00010969743250532752, -4.134060341369331e-05, -4.1406585725889926e-05], [-4.134060341369331e-05, 0.00010972153465585688, -4.137842432157714e-05], [-4.1406585725889926e-05, -4.137842432157714e-05, 0.00010977280108308987]]} - #*EXTRAS*# Step: 6 Bead: 58 -{"friction": [[0.00010993235338128733, -4.150997403822779e-05, -4.15812714544102e-05], [-4.150997403822779e-05, 0.00010995751040483094, -4.155351839302731e-05], [-4.15812714544102e-05, -4.155351839302731e-05, 0.00011000923806253775]]} - #*EXTRAS*# Step: 7 Bead: 58 -{"friction": [[0.00011008003632569763, -4.16144879784933e-05, -4.168845569472884e-05], [-4.16144879784933e-05, 0.0001101052696301386, -4.166121190343459e-05], [-4.168845569472884e-05, -4.166121190343459e-05, 0.0001101573851489705]]} - #*EXTRAS*# Step: 8 Bead: 58 -{"friction": [[0.00011017501960659655, -4.168092155523587e-05, -4.175630702221574e-05], [-4.168092155523587e-05, 0.00011020003414407904, -4.1729473887282815e-05], [-4.175630702221574e-05, -4.1729473887282815e-05, 0.00011025248389147027]]} - #*EXTRAS*# Step: 9 Bead: 58 -{"friction": [[0.00011023683932210806, -4.172383344860166e-05, -4.180000880369074e-05], [-4.172383344860166e-05, 0.00011026159135153239, -4.177347262322645e-05], [-4.180000880369074e-05, -4.177347262322645e-05, 0.00011031430612943409]]} - #*EXTRAS*# Step: 10 Bead: 58 -{"friction": [[0.00011027746124519757, -4.17518920161995e-05, -4.182852750065361e-05], [-4.17518920161995e-05, 0.00011030198715209597, -4.180219773447237e-05], [-4.182852750065361e-05, -4.180219773447237e-05, 0.00011035489973834276]]} - #*EXTRAS*# Step: 11 Bead: 58 -{"friction": [[0.00011030430927864885, -4.177037644188916e-05, -4.184728986434607e-05], [-4.177037644188916e-05, 0.00011032866180931211, -4.182110102163738e-05], [-4.184728986434607e-05, -4.182110102163738e-05, 0.00011038171635405511]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 deleted file mode 100644 index 9f2b42a41..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_59 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 59 -{"friction": [[0.00010251514085647045, -3.350986950112593e-05, -3.3484233397662335e-05], [-3.350986950112593e-05, 0.0001024627094050115, -3.369472217637789e-05], [-3.3484233397662335e-05, -3.369472217637789e-05, 0.00010209140079979171]]} - #*EXTRAS*# Step: 1 Bead: 59 -{"friction": [[0.00010512788961161465, -3.71387729731769e-05, -3.7072642833027904e-05], [-3.71387729731769e-05, 0.00010512763581882635, -3.724691914570833e-05], [-3.7072642833027904e-05, -3.724691914570833e-05, 0.00010489643388892816]]} - #*EXTRAS*# Step: 2 Bead: 59 -{"friction": [[0.00010755451041822721, -3.960291575373603e-05, -3.9592476967194964e-05], [-3.960291575373603e-05, 0.00010755156267742175, -3.960743732596367e-05], [-3.9592476967194964e-05, -3.960743732596367e-05, 0.00010755243649046094]]} - #*EXTRAS*# Step: 3 Bead: 59 -{"friction": [[0.00010857637231398265, -4.0476684216099065e-05, -4.05049106472146e-05], [-4.0476684216099065e-05, 0.00010858584013436002, -4.0485851819446464e-05], [-4.05049106472146e-05, -4.0485851819446464e-05, 0.00010862787795858954]]} - #*EXTRAS*# Step: 4 Bead: 59 -{"friction": [[0.00010923849721524898, -4.0998326486522296e-05, -4.105079474597055e-05], [-4.0998326486522296e-05, 0.00010925794377160113, -4.1023752723423126e-05], [-4.105079474597055e-05, -4.1023752723423126e-05, 0.00010930774390070632]]} - #*EXTRAS*# Step: 5 Bead: 59 -{"friction": [[0.00010962189698362254, -4.128531676556566e-05, -4.1349337375174327e-05], [-4.128531676556566e-05, 0.00010964544463478689, -4.1321169149820804e-05], [-4.1349337375174327e-05, -4.1321169149820804e-05, 0.0001096965590126182]]} - #*EXTRAS*# Step: 6 Bead: 59 -{"friction": [[0.00010985915126110704, -4.145761185929922e-05, -4.152738743221311e-05], [-4.145761185929922e-05, 0.00010988409571330159, -4.149944945349963e-05], [-4.152738743221311e-05, -4.149944945349963e-05, 0.00010993566987552648]]} - #*EXTRAS*# Step: 7 Bead: 59 -{"friction": [[0.00011000829401724617, -4.156390339529413e-05, -4.1636642632954926e-05], [-4.156390339529413e-05, 0.00011003355124973123, -4.160913016722292e-05], [-4.1636642632954926e-05, -4.160913016722292e-05, 0.00011008546198226062]]} - #*EXTRAS*# Step: 8 Bead: 59 -{"friction": [[0.00011010421171911968, -4.163145475285745e-05, -4.1705806257958496e-05], [-4.163145475285745e-05, 0.00011012940998297533, -4.167866134262013e-05], [-4.1705806257958496e-05, -4.167866134262013e-05, 0.00011018160308948388]]} - #*EXTRAS*# Step: 9 Bead: 59 -{"friction": [[0.00011016663904073194, -4.167508448620823e-05, -4.175035469243272e-05], [-4.167508448620823e-05, 0.00011019168174626674, -4.172348301170962e-05], [-4.175035469243272e-05, -4.172348301170962e-05, 0.00011024409865081321]]} - #*EXTRAS*# Step: 10 Bead: 59 -{"friction": [[0.0001102076598792176, -4.170361055787318e-05, -4.177942641040984e-05], [-4.170361055787318e-05, 0.00011023254792276632, -4.1752747364611484e-05], [-4.177942641040984e-05, -4.1752747364611484e-05, 0.00011028513245299239]]} - #*EXTRAS*# Step: 11 Bead: 59 -{"friction": [[0.00011023477151328872, -4.1722402221112785e-05, -4.179855289230215e-05], [-4.1722402221112785e-05, 0.00011025953390246373, -4.177200643463401e-05], [-4.179855289230215e-05, -4.177200643463401e-05, 0.00011031223913385279]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 deleted file mode 100644 index bbb66c535..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_60 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 60 -{"friction": [[0.00010243489413890537, -3.337266793205423e-05, -3.3350583183048474e-05], [-3.337266793205423e-05, 0.00010237819197671717, -3.355483283288116e-05], [-3.3350583183048474e-05, -3.355483283288116e-05, 0.00010201127331709875]]} - #*EXTRAS*# Step: 1 Bead: 60 -{"friction": [[0.00010504171525898483, -3.703902177562985e-05, -3.697215820465263e-05], [-3.703902177562985e-05, 0.00010504159386926141, -3.715214478383926e-05], [-3.697215820465263e-05, -3.715214478383926e-05, 0.00010480114085988345]]} - #*EXTRAS*# Step: 2 Bead: 60 -{"friction": [[0.00010747699575359396, -3.953306711412285e-05, -3.951997134586765e-05], [-3.953306711412285e-05, 0.00010747358365077813, -3.953874851522914e-05], [-3.951997134586765e-05, -3.953874851522914e-05, 0.0001074694386068857]]} - #*EXTRAS*# Step: 3 Bead: 60 -{"friction": [[0.0001085076094704989, -4.042055585190487e-05, -4.044610051763782e-05], [-4.042055585190487e-05, 0.00010851599113750501, -4.0428416722827415e-05], [-4.044610051763782e-05, -4.0428416722827415e-05, 0.00010855657703823011]]} - #*EXTRAS*# Step: 4 Bead: 60 -{"friction": [[0.00010917487325976849, -4.094965321539262e-05, -4.0999983984558606e-05], [-4.094965321539262e-05, 0.00010919347217277586, -4.097334444339943e-05], [-4.0999983984558606e-05, -4.097334444339943e-05, 0.00010924290289239569]]} - #*EXTRAS*# Step: 5 Bead: 60 -{"friction": [[0.00010956136852074872, -4.124071950738956e-05, -4.1303086864651574e-05], [-4.124071950738956e-05, 0.00010958440437717394, -4.1274962534541497e-05], [-4.1303086864651574e-05, -4.1274962534541497e-05, 0.00010963538281766172]]} - #*EXTRAS*# Step: 6 Bead: 60 -{"friction": [[0.0001098004924002042, -4.141538298453672e-05, -4.148384935776913e-05], [-4.141538298453672e-05, 0.00010982518853729445, -4.145579942454147e-05], [-4.148384935776913e-05, -4.145579942454147e-05, 0.0001098766493826682]]} - #*EXTRAS*# Step: 7 Bead: 60 -{"friction": [[0.00010995080441076994, -4.152311362160652e-05, -4.159477440880391e-05], [-4.152311362160652e-05, 0.00010997599730210928, -4.1567075413781526e-05], [-4.159477440880391e-05, -4.1567075413781526e-05, 0.00011002776681098711]]} - #*EXTRAS*# Step: 8 Bead: 60 -{"friction": [[0.00011004747042252092, -4.1591569731421995e-05, -4.166499624115483e-05], [-4.1591569731421995e-05, 0.00011007272924659043, -4.163762577262774e-05], [-4.166499624115483e-05, -4.163762577262774e-05, 0.0001101247473785609]]} - #*EXTRAS*# Step: 9 Bead: 60 -{"friction": [[0.00011011038428813566, -4.1635780429990154e-05, -4.1710227443457736e-05], [-4.1635780429990154e-05, 0.00011013557137722407, -4.1683108412967094e-05], [-4.1710227443457736e-05, -4.1683108412967094e-05, 0.00011018778506388565]]} - #*EXTRAS*# Step: 10 Bead: 60 -{"friction": [[0.0001101517245444789, -4.166468483652233e-05, -4.1739745155579874e-05], [-4.166468483652233e-05, 0.0001101768130724035, -4.171280593949865e-05], [-4.1739745155579874e-05, -4.171280593949865e-05, 0.00011022917323283132]]} - #*EXTRAS*# Step: 11 Bead: 60 -{"friction": [[0.00011017904724149928, -4.168372512500324e-05, -4.175916529714994e-05], [-4.168372512500324e-05, 0.00011020404761867768, -4.1732350837467645e-05], [-4.175916529714994e-05, -4.1732350837467645e-05, 0.00011025651340074062]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 deleted file mode 100644 index c81aa6d8a..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_61 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 61 -{"friction": [[0.00010237295826707656, -3.326562672264948e-05, -3.3246327268270765e-05], [-3.326562672264948e-05, 0.00010231289990664679, -3.3445442976744176e-05], [-3.3246327268270765e-05, -3.3445442976744176e-05, 0.0001019498435873969]]} - #*EXTRAS*# Step: 1 Bead: 61 -{"friction": [[0.00010497622350492327, -3.696253465527045e-05, -3.6895184002999406e-05], [-3.696253465527045e-05, 0.0001049761700279079, -3.7079431383619136e-05], [-3.6895184002999406e-05, -3.7079431383619136e-05, 0.00010472874078958076]]} - #*EXTRAS*# Step: 2 Bead: 61 -{"friction": [[0.00010741881640390687, -3.948029896129552e-05, -3.946524193977612e-05], [-3.948029896129552e-05, 0.00010741509919581306, -3.948698521976394e-05], [-3.946524193977612e-05, -3.948698521976394e-05, 0.00010740702430699702]]} - #*EXTRAS*# Step: 3 Bead: 61 -{"friction": [[0.00010845597074566795, -4.0378157902783e-05, -4.040168143887436e-05], [-4.0378157902783e-05, 0.00010846354482416401, -4.038510722770884e-05], [-4.040168143887436e-05, -4.038510722770884e-05, 0.00010850293869586134]]} - #*EXTRAS*# Step: 4 Bead: 61 -{"friction": [[0.00010912709309522245, -4.091290125601393e-05, -4.096159230280928e-05], [-4.091290125601393e-05, 0.00010914503152720644, -4.093530035955948e-05], [-4.096159230280928e-05, -4.093530035955948e-05, 0.00010919414511008921]]} - #*EXTRAS*# Step: 5 Bead: 61 -{"friction": [[0.00010951591361911851, -4.120705490803478e-05, -4.1268135336905526e-05], [-4.120705490803478e-05, 0.0001095385280367727, -4.12400744720793e-05], [-4.1268135336905526e-05, -4.12400744720793e-05, 0.00010958939245441774]]} - #*EXTRAS*# Step: 6 Bead: 61 -{"friction": [[0.00010975644142369795, -4.138351165211073e-05, -4.145094429416002e-05], [-4.138351165211073e-05, 0.00010978090756342167, -4.1422832932032534e-05], [-4.145094429416002e-05, -4.1422832932032534e-05, 0.0001098322856887074]]} - #*EXTRAS*# Step: 7 Bead: 61 -{"friction": [[0.00010990763121726532, -4.149233164767918e-05, -4.156312930641954e-05], [-4.149233164767918e-05, 0.00010993272886860607, -4.15353084149259e-05], [-4.156312930641954e-05, -4.15353084149259e-05, 0.00010998440265835843]]} - #*EXTRAS*# Step: 8 Bead: 61 -{"friction": [[0.00011000485892522482, -4.156147252525685e-05, -4.1634149641135395e-05], [-4.156147252525685e-05, 0.00011003011436462694, -4.1606625285818845e-05], [-4.1634149641135395e-05, -4.1606625285818845e-05, 0.00011008201614364663]]} - #*EXTRAS*# Step: 9 Bead: 61 -{"friction": [[0.00011006813797439846, -4.16061228917534e-05, -4.167989607373449e-05], [-4.16061228917534e-05, 0.00011009338346565017, -4.165260511638784e-05], [-4.167989607373449e-05, -4.165260511638784e-05, 0.00011014546248999789]]} - #*EXTRAS*# Step: 10 Bead: 61 -{"friction": [[0.00011010971796554216, -4.1635313601837346e-05, -4.170975035414365e-05], [-4.1635313601837346e-05, 0.00011013490630485031, -4.1682628517081335e-05], [-4.170975035414365e-05, -4.1682628517081335e-05, 0.00011018711775438423]]} - #*EXTRAS*# Step: 11 Bead: 61 -{"friction": [[0.00011013719906930738, -4.165454202988721e-05, -4.172939211098937e-05], [-4.165454202988721e-05, 0.00011016232696405186, -4.1702388457941515e-05], [-4.172939211098937e-05, -4.1702388457941515e-05, 0.00011021463389413222]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 deleted file mode 100644 index 3a8bdd729..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_62 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 62 -{"friction": [[0.00010232890466352831, -3.318888996525138e-05, -3.3171590289423344e-05], [-3.318888996525138e-05, 0.00010226643313891227, -3.33668903313071e-05], [-3.3171590289423344e-05, -3.33668903313071e-05, 0.00010190637620575303]]} - #*EXTRAS*# Step: 1 Bead: 62 -{"friction": [[0.00010493119610870736, -3.690960222648608e-05, -3.68419526225159e-05], [-3.690960222648608e-05, 0.00010493117133566126, -3.702908608317043e-05], [-3.68419526225159e-05, -3.702908608317043e-05, 0.00010467897768247295]]} - #*EXTRAS*# Step: 2 Bead: 62 -{"friction": [[0.0001073800096357312, -3.9444937165909055e-05, -3.942858780610902e-05], [-3.9444937165909055e-05, 0.00010737610893022676, -3.945235623979784e-05], [-3.942858780610902e-05, -3.945235623979784e-05, 0.00010736533720958268]]} - #*EXTRAS*# Step: 3 Bead: 62 -{"friction": [[0.00010842151291922681, -4.034974781250241e-05, -4.037192049143732e-05], [-4.034974781250241e-05, 0.0001084285533218993, -4.035612431593316e-05], [-4.037192049143732e-05, -4.035612431593316e-05, 0.00010846710117630905]]} - #*EXTRAS*# Step: 4 Bead: 62 -{"friction": [[0.00010909520995018607, -4.088828150263538e-05, -4.093586285564525e-05], [-4.088828150263538e-05, 0.00010911269726537385, -4.090982519163474e-05], [-4.093586285564525e-05, -4.090982519163474e-05, 0.00010916157868434374]]} - #*EXTRAS*# Step: 5 Bead: 62 -{"friction": [[0.00010948558239711153, -4.118450794598396e-05, -4.124470875251072e-05], [-4.118450794598396e-05, 0.00010950789874685311, -4.121670537621751e-05], [-4.124470875251072e-05, -4.121670537621751e-05, 0.00010955868005340166]]} - #*EXTRAS*# Step: 6 Bead: 62 -{"friction": [[0.00010972704698816182, -4.1362168349263066e-05, -4.142888776319552e-05], [-4.1362168349263066e-05, 0.00010975133964274408, -4.140074673987314e-05], [-4.142888776319552e-05, -4.140074673987314e-05, 0.00010980266252099715]]} - #*EXTRAS*# Step: 7 Bead: 62 -{"friction": [[0.00010987882237959801, -4.1471719397705736e-05, -4.154191633496635e-05], [-4.1471719397705736e-05, 0.00010990383478619501, -4.1514023266728234e-05], [-4.154191633496635e-05, -4.1514023266728234e-05, 0.00010995544853837047]]} - #*EXTRAS*# Step: 8 Bead: 62 -{"friction": [[0.00010997642477719597, -4.154131976356126e-05, -4.161347129972085e-05], [-4.154131976356126e-05, 0.00011000165530307113, -4.1585852117568044e-05], [-4.161347129972085e-05, -4.1585852117568044e-05, 0.00011005348557759603]]} - #*EXTRAS*# Step: 9 Bead: 62 -{"friction": [[0.00011003994741609463, -4.158626513429387e-05, -4.165956271321123e-05], [-4.158626513429387e-05, 0.00011006520864600165, -4.163216407930532e-05], [-4.165956271321123e-05, -4.163216407930532e-05, 0.00011011720536618256]]} - #*EXTRAS*# Step: 10 Bead: 62 -{"friction": [[0.00011008168731381539, -4.161564793801208e-05, -4.1689642354305476e-05], [-4.161564793801208e-05, 0.00011010691866485967, -4.166240518661445e-05], [-4.1689642354305476e-05, -4.166240518661445e-05, 0.00011015903933372153]]} - #*EXTRAS*# Step: 11 Bead: 62 -{"friction": [[0.00011010927407535976, -4.163500259398473e-05, -4.170943250394984e-05], [-4.163500259398473e-05, 0.00011013446324163322, -4.168230879885966e-05], [-4.170943250394984e-05, -4.168230879885966e-05, 0.00011018667320293423]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 deleted file mode 100644 index 7a829d3fe..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst.raw_63 +++ /dev/null @@ -1,24 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 63 -{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} - #*EXTRAS*# Step: 1 Bead: 63 -{"friction": [[0.00010490646196707843, -3.688040445238592e-05, -3.681260326094125e-05], [-3.688040445238592e-05, 0.00010490644633441923, -3.700130613295973e-05], [-3.681260326094125e-05, -3.700130613295973e-05, 0.00010465164772604607]]} - #*EXTRAS*# Step: 2 Bead: 63 -{"friction": [[0.00010736059912417344, -3.942720019368981e-05, -3.941020921641274e-05], [-3.942720019368981e-05, 0.0001073566125073179, -3.943500429453144e-05], [-3.941020921641274e-05, -3.943500429453144e-05, 0.00010734446961473918]]} - #*EXTRAS*# Step: 3 Bead: 63 -{"friction": [[0.00010840427424357551, -4.033549902001546e-05, -4.035699548366669e-05], [-4.033549902001546e-05, 0.00010841104949806518, -4.0341600028322654e-05], [-4.035699548366669e-05, -4.0341600028322654e-05, 0.00010844915849013377]]} - #*EXTRAS*# Step: 4 Bead: 63 -{"friction": [[0.00010907925945021144, -4.087593592646039e-05, -4.092295764769355e-05], [-4.087593592646039e-05, 0.00010909651816779468, -4.0897054042152546e-05], [-4.092295764769355e-05, -4.0897054042152546e-05, 0.0001091452769495408]]} - #*EXTRAS*# Step: 5 Bead: 63 -{"friction": [[0.00010947040838536123, -4.117320315043954e-05, -4.1232957787394115e-05], [-4.117320315043954e-05, 0.0001094925707286398, -4.120498783657466e-05], [-4.1232957787394115e-05, -4.120498783657466e-05, 0.00010954330807887231]]} - #*EXTRAS*# Step: 6 Bead: 63 -{"friction": [[0.00010971234162371044, -4.135146784021359e-05, -4.1417823540771805e-05], [-4.135146784021359e-05, 0.00010973654162811998, -4.138967118707266e-05], [-4.1417823540771805e-05, -4.138967118707266e-05, 0.00010978783661459619]]} - #*EXTRAS*# Step: 7 Bead: 63 -{"friction": [[0.00010986440993848807, -4.146138586654531e-05, -4.153127496362318e-05], [-4.146138586654531e-05, 0.00010988937332306589, -4.150334863731693e-05], [-4.153127496362318e-05, -4.150334863731693e-05, 0.00010994095797070902]]} - #*EXTRAS*# Step: 8 Bead: 63 -{"friction": [[0.00010996219974949212, -4.153121687394696e-05, -4.1603097929312325e-05], [-4.153121687394696e-05, 0.00010998741113946761, -4.157543376168608e-05], [-4.1603097929312325e-05, -4.157543376168608e-05, 0.00011003920727490534]]} - #*EXTRAS*# Step: 9 Bead: 63 -{"friction": [[0.00011002584422402483, -4.157631031732261e-05, -4.1649362279812446e-05], [-4.157631031732261e-05, 0.00011005110647749188, -4.162191198525026e-05], [-4.1649362279812446e-05, -4.162191198525026e-05, 0.00011010306408844832]]} - #*EXTRAS*# Step: 10 Bead: 63 -{"friction": [[0.00011006766410040153, -4.16057895370744e-05, -4.1679554894746565e-05], [-4.16057895370744e-05, 0.00011009291000845757, -4.165226207976316e-05], [-4.1679554894746565e-05, -4.165226207976316e-05, 0.00011014498760158926]]} - #*EXTRAS*# Step: 11 Bead: 63 -{"friction": [[0.00011009530370704743, -4.162520754867345e-05, -4.1699419434893625e-05], [-4.162520754867345e-05, 0.00011012051649486337, -4.167223761841634e-05], [-4.1699419434893625e-05, -4.167223761841634e-05, 0.00011017268046141867]]} diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat b/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat deleted file mode 100644 index f58744441..000000000 --- a/drivers/py/pes/friction/frictionD/test_friction_80K_D/inst1D.dat +++ /dev/null @@ -1,64 +0,0 @@ -2.3727731017022706 0.13344076815778944 -2.373211152535036 0.13350597554029547 -2.374086336849262 0.13363575948820305 -2.3753968183111454 0.1338288632110306 -2.377139838420972 0.134083413638433 -2.37931171193371 0.13439693597364508 -2.381907821115009 0.13476637311767872 -2.3849226091344726 0.13518810997043584 -2.3883495729623347 0.13565800260347652 -2.3921812561951343 0.13617141228015153 -2.3964092422848546 0.13672324427064092 -2.401024148687287 0.13730799137215854 -2.4060156224757043 0.13791978199771937 -2.411372337984157 0.13855243264065165 -2.4170819970525947 0.13919950445753013 -2.4231313324387553 0.13985436364001252 -2.4295061149433943 0.14051024516837346 -2.4361911647625227 0.1411603194579342 -2.4431703675355485 0.14179775445635487 -2.4504266958110636 0.14241568519506387 -2.4579422413457497 0.14300728328348783 -2.465698258604672 0.14356589508503978 -2.473675216355156 0.1440851172115186 -2.481852857235644 0.14455886944443586 -2.490210265066654 0.14498146573989762 -2.4987259394908965 0.14534768216272217 -2.5073778773600814 0.1456528205872441 -2.5161436601187166 0.1458927670262171 -2.5250005462861926 0.14606404350729021 -2.5339255680037502 0.14616385250803637 -2.542895630503215 0.14619011308405766 -2.5518876132687565 0.1461415902639429 -2.5608784706097456 0.14601937534911896 -2.569845316057347 0.1458265254311242 -2.578765492870325 0.145566805530133 -2.58761664169884 0.14524457610961072 -2.596376765285668 0.14486470916780467 -2.6050242898107223 0.14443250216916687 -2.6135381225336554 0.14395359154023069 -2.6218977054462664 0.1434338673450423 -2.6300830647037903 0.14287939061258836 -2.6380748556678935 0.14229631461851475 -2.6458544034562985 0.14169081123268026 -2.6534037389585743 0.1410690032391952 -2.660705630338084 0.14043690332361008 -2.6677436101028182 0.1398003602086623 -2.674501997880584 0.1391650122122337 -2.6809659190822788 0.13853604243049505 -2.687121320810235 0.13791761692261295 -2.6929549884902007 0.13731369340396973 -2.6984545585902553 0.13672823296400757 -2.7036085265029537 0.13616515878196916 -2.7084062501095665 0.13562831507462428 -2.7128379495945523 0.13512142682802297 -2.716894704112094 0.13464806082706757 -2.720568445925636 0.13421158845277156 -2.7238519526475953 0.13381515066910485 -2.726738838193951 0.13346162557208227 -2.729223543049307 0.13315359882371663 -2.7313013244007887 0.13289333724556276 -2.7329682466547207 0.13268276580079472 -2.734221172794841 0.13252344815140743 -2.735057756976749 0.13241657093852707 -2.735476438682034 0.1323629318989296 diff --git a/drivers/py/pes/friction/frictionH/060K/MEP.dat b/drivers/py/pes/friction/frictionH/060K/MEP.dat deleted file mode 100644 index e69de29bb..000000000 diff --git a/drivers/py/pes/friction/frictionH/060K/RESTART b/drivers/py/pes/friction/frictionH/060K/RESTART deleted file mode 100644 index 1c516a07f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/RESTART +++ /dev/null @@ -1,1063 +0,0 @@ - - - [ step, potential{electronvolt} ] - extras - extras - - 16 - 30 - - - - - - [ friction ] - - - - 1.90008912e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 1.53942804e-03, 1.53982849e-03, 1.54064652e-03, 1.54191721e-03, 1.54369533e-03, - 1.54605802e-03, 1.54910860e-03, 1.55298158e-03, 1.55784924e-03, 1.56392988e-03, - 1.57149821e-03, 1.58089806e-03, 1.59255794e-03, 1.60700960e-03, 1.62491007e-03, - 1.64706700e-03, 1.67446721e-03, 1.70830774e-03, 1.75002760e-03, 1.80133767e-03, - 1.86424405e-03, 1.94105823e-03, 2.03438418e-03, 2.14706908e-03, 2.28210033e-03, - 2.44242787e-03, 2.63068841e-03, 2.84880926e-03, 3.09747653e-03, 3.37546744e-03, - 3.67845832e-03, 3.99748069e-03, 4.31874982e-03, 4.62348251e-03, 4.89031385e-03, - 5.10635288e-03, 5.26305752e-03, 5.35283931e-03, 5.36943053e-03, 5.31335664e-03, - 5.19769209e-03, 5.03816021e-03, 4.84349175e-03, 4.61499986e-03, 4.35543233e-03, - 4.07492841e-03, 3.78764349e-03, 3.50491204e-03, 3.23514178e-03, 2.98354922e-03, - 2.75263267e-03, 2.54360073e-03, 2.35672829e-03, 2.19160155e-03, 2.04732860e-03, - 1.92258846e-03, 1.81578669e-03, 1.72546973e-03, 1.65037070e-03, 1.58941113e-03, - 1.54169962e-03, 1.50652891e-03, 1.48337242e-03, 1.47188112e-03 ] - - - [ -5.01050817e-04, 2.88014170e-06, 2.65947398e-06, -5.05731985e-04, 2.91650062e-06, - 2.69358374e-06, -5.15146470e-04, 2.98978934e-06, 2.76237418e-06, -5.29398865e-04, - 3.10113582e-06, 2.86697659e-06, -5.48646713e-04, 3.25219652e-06, 3.00906014e-06, - -5.73101137e-04, 3.44511160e-06, 3.19079639e-06, -6.03027371e-04, 3.68244157e-06, - 3.41480862e-06, -6.38744923e-04, 3.96708229e-06, 3.68410282e-06, -6.80626989e-04, - 4.30215440e-06, 4.00197624e-06, -7.29098600e-04, 4.69086239e-06, 4.37189854e-06, - -7.84632826e-04, 5.13631759e-06, 4.79735900e-06, -8.47744159e-04, 5.64131920e-06, - 5.28167292e-06, -9.18977959e-04, 6.20808691e-06, 5.82773844e-06, -9.98894519e-04, - 6.83793911e-06, 6.43773514e-06, -1.08804594e-03, 7.53091183e-06, 7.11275481e-06, - -1.18694360e-03, 8.28531529e-06, 7.85235574e-06, -1.29601336e-03, 9.09722864e-06, - 8.65403327e-06, -1.41553531e-03, 9.95993804e-06, 9.51260298e-06, -1.54556398e-03, - 1.08633299e-05, 1.04194986e-05, -1.68582453e-03, 1.17932600e-05, 1.13619957e-05, - -1.83557991e-03, 1.27309331e-05, 1.23223882e-05, -1.99346385e-03, 1.36523538e-05, - 1.32771650e-05, -2.15727482e-03, 1.45278751e-05, 1.41962497e-05, -2.32372773e-03, - 1.53219243e-05, 1.50424064e-05, -2.48816268e-03, 1.59929800e-05, 1.57709454e-05, - -2.64421569e-03, 1.64938647e-05, 1.63299007e-05, -2.78346492e-03, 1.67723718e-05, - 1.66608702e-05, -2.89507907e-03, 1.67722270e-05, 1.67007277e-05, -2.96551390e-03, - 1.64343033e-05, 1.63843859e-05, -2.97834866e-03, 1.56978180e-05, 1.56486992e-05, - -2.91808012e-03, 1.45010850e-05, 1.44374315e-05, -2.77746412e-03, 1.27859597e-05, - 1.27064470e-05, -2.55491091e-03, 1.05118758e-05, 1.04294035e-05, -2.25514834e-03, - 7.67222390e-06, 7.60580392e-06, -1.88843065e-03, 4.30858677e-06, 4.27001613e-06, - -1.46256029e-03, 5.09294924e-07, 4.95322034e-07, -9.86852373e-04, -3.61947376e-06, - -3.61511684e-06, -4.78936857e-04, -7.96380218e-06, -7.93946859e-06, 3.53047744e-05, - -1.23851601e-05, -1.23433534e-05, 5.32585726e-04, -1.67302133e-05, -1.66891421e-05, - 1.00042511e-03, -2.08726378e-05, -2.08513840e-05, 1.42921428e-03, -2.47279207e-05, - -2.47286318e-05, 1.80715244e-03, -2.82396438e-05, -2.82485381e-05, 2.12104464e-03, - -3.13649784e-05, -3.13678016e-05, 2.36248330e-03, -3.40774542e-05, -3.40687399e-05, - 2.53503932e-03, -3.63698507e-05, -3.63525426e-05, 2.65020279e-03, -3.82535981e-05, - -3.82346032e-05, 2.71890103e-03, -3.97549062e-05, -3.97421270e-05, 2.75092380e-03, - -4.09107915e-05, -4.09108151e-05, 2.75455211e-03, -4.17655827e-05, -4.17811242e-05, - 2.73658568e-03, -4.23668145e-05, -4.23948365e-05, 2.70284448e-03, -4.27608264e-05, - -4.27928135e-05, 2.65825963e-03, -4.29901999e-05, -4.30137067e-05, 2.60695308e-03, - -4.30924651e-05, -4.30932789e-05, 2.55232998e-03, -4.30994977e-05, -4.30640780e-05, - 2.49726097e-03, -4.30371606e-05, -4.29552853e-05, 2.44416434e-03, -4.29263162e-05, - -4.27928694e-05, 2.39488132e-03, -4.27851675e-05, -4.25999328e-05, 2.35077787e-03, - -4.26301969e-05, -4.23967768e-05, 2.31285091e-03, -4.24762787e-05, -4.22008548e-05, - 2.28181378e-03, -4.23364577e-05, -4.20267180e-05, 2.25816333e-03, -4.22216340e-05, - -4.18859881e-05, 2.24223050e-03, -4.21402625e-05, -4.17873565e-05, 2.23421661e-03, - -4.20981141e-05, -4.17365999e-05 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] - - True - - [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, - 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, - 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, - 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, - 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, - 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, - 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, - 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, - 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, - 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, - 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, - 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, - 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, - 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, - 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, - 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, - 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, - 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, - 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, - 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, - 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, - 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, - 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, - 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, - 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, - 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, - 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, - 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, - 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, - 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, - 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, - 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, - 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, - 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, - 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, - 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, - 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, - 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, - 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, - 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, - 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, - 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, - 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, - 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, - 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, - 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, - 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, - 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, - 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, - 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, - 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, - 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, - 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, - 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, - 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, - 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, - 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, - 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, - 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, - 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, - 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, - 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, - 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, - 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, - 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, - 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, - 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, - 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, - 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, - 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, - 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, - 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, - 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, - 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, - 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, - 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, - 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, - 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, - 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, - 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, - 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, - 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, - 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, - 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, - 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, - 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, - 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, - 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, - 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, - 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, - 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, - 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, - 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, - 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, - 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, - 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, - 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, - 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, - 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, - 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, - 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, - 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, - 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, - 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, - 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, - 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, - 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, - 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, - 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, - 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, - 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, - 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, - 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, - 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, - 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, - 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, - 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, - 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, - 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, - 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, - 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, - 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, - 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, - 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, - 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, - 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, - 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, - 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, - 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, - 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, - 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, - 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, - 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, - 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, - 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, - 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, - 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, - 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, - 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, - 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, - 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, - 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, - 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, - 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, - 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, - 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, - 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, - 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, - 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, - 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, - 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, - 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, - 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, - 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, - 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, - 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, - 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, - 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, - 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, - 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, - 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, - 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, - 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, - 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, - 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, - 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, - 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, - 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, - 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, - 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, - 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, - 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, - 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, - 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, - 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, - 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, - 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, - 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, - 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, - 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, - 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, - 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, - 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, - 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, - 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, - 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, - 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, - 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, - 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, - 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, - 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, - 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, - 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, - 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, - 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, - 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, - 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, - 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, - 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, - 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, - 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, - 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, - 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, - 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, - 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, - 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, - 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, - 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, - 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, - 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, - 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, - 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, - 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, - 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, - 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, - 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, - 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, - 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, - 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, - 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, - 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, - 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, - 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, - 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, - 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, - 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, - 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, - 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, - 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, - 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, - 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, - 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, - 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, - 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, - 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, - 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, - 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, - 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, - 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, - 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, - 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, - 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, - 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, - 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, - 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, - 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, - 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, - 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, - 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, - 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, - 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, - 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, - 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, - 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, - 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, - 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, - 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, - 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, - 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, - 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, - 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, - 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, - 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, - 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, - 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, - 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, - 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, - 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, - 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, - 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, - 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, - 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, - 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, - 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, - 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, - 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, - 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, - 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, - 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, - 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, - 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, - 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, - 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, - 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, - 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, - 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, - 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, - 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, - 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, - 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, - 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, - 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, - 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, - 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, - 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, - 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, - 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, - 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, - 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, - 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, - 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, - 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, - 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, - 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, - 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, - 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, - 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, - 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, - 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, - 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, - 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, - 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, - 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, - 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, - 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, - 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, - 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, - 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, - 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, - 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, - 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, - 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, - 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, - 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, - 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, - 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, - 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, - 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, - 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, - 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, - 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, - 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, - 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, - 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, - 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, - 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, - 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, - 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, - 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, - 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, - 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, - 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, - 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, - 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, - 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, - 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, - 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, - 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, - 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, - 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, - 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, - 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, - 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, - 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, - 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, - 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, - 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, - 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, - 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, - 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, - 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, - 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, - 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, - 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, - 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, - 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, - 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, - 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, - 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, - 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, - 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, - 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, - 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, - 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, - 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, - 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, - 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, - 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, - 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, - 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, - 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, - 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, - 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, - 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, - 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, - 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, - 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, - 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, - 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, - 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, - 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, - 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, - 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, - 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, - 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, - 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, - 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, - 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, - 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, - 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] - - - [ 1.72738330e-02, 9.87604599e-05, 9.30137216e-05, 1.72596504e-02, 9.90329642e-05, - 9.32978576e-05, 1.72310601e-02, 9.95676147e-05, 9.38571021e-05, 1.71876080e-02, - 1.00343891e-04, 9.46735532e-05, 1.71286019e-02, 1.01331504e-04, 9.57207378e-05, - 1.70530984e-02, 1.02490969e-04, 9.69640571e-05, 1.69598851e-02, 1.03774376e-04, - 9.83613646e-05, 1.68474573e-02, 1.05126315e-04, 9.98636645e-05, 1.67139901e-02, - 1.06484976e-04, 1.01415914e-04, 1.65573040e-02, 1.07783395e-04, 1.02957913e-04, - 1.63748245e-02, 1.08950836e-04, 1.04425267e-04, 1.61635352e-02, 1.09914305e-04, - 1.05750397e-04, 1.59199231e-02, 1.10600175e-04, 1.06863596e-04, 1.56399152e-02, - 1.10935917e-04, 1.07694112e-04, 1.53188080e-02, 1.10851929e-04, 1.08171252e-04, - 1.49511860e-02, 1.10283451e-04, 1.08225524e-04, 1.45308318e-02, 1.09172554e-04, - 1.07789825e-04, 1.40506261e-02, 1.07470200e-04, 1.06800712e-04, 1.35024396e-02, - 1.05138344e-04, 1.05199822e-04, 1.28770171e-02, 1.02152066e-04, 1.02935493e-04, - 1.21638597e-02, 9.85016825e-05, 9.99647001e-05, 1.13511076e-02, 9.41947686e-05, - 9.62554064e-05, 1.04254371e-02, 8.92579942e-05, 9.17894368e-05, 9.37198199e-03, - 8.37386066e-05, 8.65659662e-05, 8.17430412e-03, 7.77053309e-05, 8.06056515e-05, - 6.81444039e-03, 7.12483565e-05, 7.39553374e-05, 5.27306924e-03, 6.44779547e-05, - 6.66930979e-05, 3.52985049e-03, 5.75211266e-05, 5.89331438e-05, 1.56400850e-03, - 5.05154881e-05, 5.08298199e-05, -6.36095804e-04, 4.35754163e-05, 4.25835058e-05, - -2.83031034e-03, 3.61709787e-05, 3.44850237e-05, -4.84421458e-03, 2.81676941e-05, - 2.66524887e-05, -6.59406142e-03, 1.99052840e-05, 1.91865102e-05, -7.99307885e-03, - 1.20398544e-05, 1.23387812e-05, -9.08777482e-03, 6.21904917e-06, 6.80304919e-06, - -1.00074258e-02, 3.11045233e-06, 3.20054222e-06, -1.06993457e-02, 1.27416438e-06, - 1.40808345e-06, -1.09694249e-02, 6.82140844e-07, 1.31457077e-06, -1.07679196e-02, - 3.05190775e-06, 3.12995572e-06, -1.03076140e-02, 7.85374760e-06, 6.73607583e-06, - -9.71063987e-03, 1.31854170e-05, 1.16369865e-05, -8.96664729e-03, 1.79285028e-05, - 1.73236592e-05, -7.93427567e-03, 2.30667278e-05, 2.34314022e-05, -6.61833645e-03, - 2.88255368e-05, 2.95954446e-05, -5.12047906e-03, 3.50576133e-05, 3.55835888e-05, - -3.75312991e-03, 4.13459883e-05, 4.15335955e-05, -2.54820805e-03, 4.74663366e-05, - 4.73143517e-05, -1.49351279e-03, 5.32635812e-05, 5.27714327e-05, -5.74491015e-04, - 5.86033693e-05, 5.77880655e-05, 2.36533668e-04, 6.32216630e-05, 6.23458538e-05, - 9.52898044e-04, 6.71037525e-05, 6.64861707e-05, 1.58292340e-03, 7.03239923e-05, - 7.02519558e-05, 2.13454114e-03, 7.29637456e-05, 7.36814853e-05, 2.61514548e-03, - 7.51035538e-05, 7.68044869e-05, 3.03092873e-03, 7.68398876e-05, 7.96451741e-05, - 3.37777405e-03, 7.86164664e-05, 8.22765951e-05, 3.66123611e-03, 8.04964160e-05, - 8.46865292e-05, 3.89056709e-03, 8.23691705e-05, 8.68388385e-05, 4.07357188e-03, - 8.41400313e-05, 8.87086933e-05, 4.21671284e-03, 8.57299966e-05, 9.02800131e-05, - 4.32520908e-03, 8.70751755e-05, 9.15431483e-05, 4.40312452e-03, 8.81259591e-05, - 9.24928714e-05, 4.45344111e-03, 8.88461271e-05, 9.31267282e-05, 4.47811513e-03, - 8.92120407e-05, 9.34437847e-05, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 2.11758237e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.11758237e-19, - 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, - 4.23516474e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 1.27054942e-18, 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, - 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -8.47032947e-19, 5.51152161e-01, - 0.00000000e+00, -8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, - 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, - -4.23516474e-19, 5.51152161e-01, 0.00000000e+00, -2.11758237e-19, 5.51152161e-01, - 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, -1.69406589e-18, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, - 5.51152161e-01, 0.00000000e+00, 6.77626358e-18, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 6.77626358e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, - 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, - 6.77626358e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 1.01643954e-17, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, - 5.51152161e-01 ] - - - [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] - - True - - - - - [ 1.89462714e+00, -5.22567433e-06, -4.82529901e-06, 1.89489911e+00, -5.29164327e-06, - -4.88718712e-06, 1.89544678e+00, -5.42461692e-06, -5.01199918e-06, 1.89627766e+00, - -5.62664186e-06, -5.20178780e-06, 1.89740320e+00, -5.90072351e-06, -5.45958149e-06, - 1.89883897e+00, -6.25074497e-06, -5.78932029e-06, 1.90060493e+00, -6.68135196e-06, - -6.19576382e-06, 1.90272572e+00, -7.19779866e-06, -6.68436609e-06, 1.90523112e+00, - -7.80574714e-06, -7.26110959e-06, 1.90815645e+00, -8.51101151e-06, -7.93228957e-06, - 1.91154308e+00, -9.31923695e-06, -8.70423695e-06, 1.91543902e+00, -1.02355023e-05, - -9.58296690e-06, 1.91989947e+00, -1.12638348e-05, -1.05737378e-05, 1.92498751e+00, - -1.24066267e-05, -1.16805042e-05, 1.93077470e+00, -1.36639432e-05, -1.29052471e-05, - 1.93734175e+00, -1.50327185e-05, -1.42471649e-05, 1.94477909e+00, -1.65058387e-05, - -1.57017134e-05, 1.95318739e+00, -1.80711222e-05, -1.72594860e-05, 1.96267790e+00, - -1.97102193e-05, -1.89049401e-05, 1.97337263e+00, -2.13974666e-05, -2.06149890e-05, - 1.98540414e+00, -2.30987629e-05, -2.23575069e-05, 1.99891499e+00, -2.47705712e-05, - -2.40898356e-05, 2.01405644e+00, -2.63591004e-05, -2.57574055e-05, 2.03098653e+00, - -2.77998081e-05, -2.72926561e-05, 2.04986708e+00, -2.90173588e-05, -2.86145035e-05, - 2.07085933e+00, -2.99261544e-05, -2.96286612e-05, 2.09411813e+00, -3.04314725e-05, - -3.02291660e-05, 2.11978414e+00, -3.04312097e-05, -3.03014827e-05, 2.14797378e+00, - -2.98180874e-05, -2.97275182e-05, 2.17876671e+00, -2.84818225e-05, -2.83927022e-05, - 2.21219061e+00, -2.63104928e-05, -2.61950012e-05, 2.24820677e+00, -2.31986022e-05, - -2.30543358e-05, 2.28670319e+00, -1.90725475e-05, -1.89229113e-05, 2.32749291e+00, - -1.39203371e-05, -1.37998260e-05, 2.37031812e+00, -7.81741791e-06, -7.74743606e-06, - 2.41485941e+00, -9.24055024e-07, -8.98702879e-07, 2.46074292e+00, 6.56710437e-06, - 6.55919925e-06, 2.50754873e+00, 1.44493712e-05, 1.44052208e-05, 2.55482700e+00, - 2.24713989e-05, 2.23955457e-05, 2.60212169e+00, 3.03549808e-05, 3.02804621e-05, - 2.64899196e+00, 3.78709172e-05, 3.78323546e-05, 2.69502364e+00, 4.48658691e-05, - 4.48671593e-05, 2.73983807e+00, 5.12374727e-05, 5.12536103e-05, 2.78310284e+00, - 5.69080204e-05, 5.69131427e-05, 2.82454395e+00, 6.18294848e-05, 6.18136739e-05, - 2.86395346e+00, 6.59887655e-05, 6.59573619e-05, 2.90118616e+00, 6.94066010e-05, - 6.93721370e-05, 2.93614904e+00, 7.21305458e-05, 7.21073595e-05, 2.96879114e+00, - 7.42277622e-05, 7.42278049e-05, 2.99909461e+00, 7.57786790e-05, 7.58068772e-05, - 3.02706701e+00, 7.68695425e-05, 7.69203851e-05, 3.05273502e+00, 7.75844302e-05, - 7.76424669e-05, 3.07613907e+00, 7.80006012e-05, 7.80432515e-05, 3.09732877e+00, - 7.81861492e-05, 7.81876257e-05, 3.11635910e+00, 7.81989091e-05, 7.81346442e-05, - 3.13328730e+00, 7.80858058e-05, 7.79372529e-05, 3.14817022e+00, 7.78846917e-05, - 7.76425685e-05, 3.16106217e+00, 7.76285942e-05, 7.72925080e-05, 3.17201320e+00, - 7.73474186e-05, 7.69239057e-05, 3.18106789e+00, 7.70681523e-05, 7.65684284e-05, - 3.18826445e+00, 7.68144637e-05, 7.62524779e-05, 3.19363408e+00, 7.66061299e-05, - 7.59971404e-05, 3.19720051e+00, 7.64584910e-05, 7.58181850e-05, 3.19897971e+00, - 7.63820177e-05, 7.57260931e-05 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/frictionH/060K/clean.sh b/drivers/py/pes/friction/frictionH/060K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/frictionH/060K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/frictionH/060K/get1D.sh b/drivers/py/pes/friction/frictionH/060K/get1D.sh deleted file mode 100755 index 5cd175503..000000000 --- a/drivers/py/pes/friction/frictionH/060K/get1D.sh +++ /dev/null @@ -1,6 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 -xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/frictionH/060K/init.xyz b/drivers/py/pes/friction/frictionH/060K/init.xyz deleted file mode 100644 index cf8e637e3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/init.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1448613 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1460477 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1477077 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1498430 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1524556 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1555471 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1591193 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1631742 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1677134 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1727363 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1782411 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1842257 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1906879 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1976222 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2050185 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2128665 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2211559 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2298731 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2389979 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2485087 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2686011 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2791254 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2899215 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3009534 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3121847 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3235746 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3350802 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3466586 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3582672 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3698644 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3814100 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3928638 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4041854 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4153390 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4262942 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4370210 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4474895 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4576725 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4675494 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4771003 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4951464 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5036114 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5116899 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5193718 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5266471 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5335107 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5399597 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5459909 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5516014 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5567903 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5615583 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5659063 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5698349 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5733452 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5764386 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5791165 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5813803 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5832315 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5846716 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5857018 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0000000 0.0000000 diff --git a/drivers/py/pes/friction/frictionH/060K/input.xml b/drivers/py/pes/friction/frictionH/060K/input.xml deleted file mode 100644 index 1b68adbe5..000000000 --- a/drivers/py/pes/friction/frictionH/060K/input.xml +++ /dev/null @@ -1,45 +0,0 @@ - - - [ step, potential{electronvolt}] - extras - extras - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - ['friction'] - - - - 60 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - - z_friction.dat - true - true - none - 0.1 - - - -
diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_00 b/drivers/py/pes/friction/frictionH/060K/inst.fric_00 deleted file mode 100644 index c08d1136a..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_00 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 - 0.00013194 -0.00003135 -0.00003130 - -0.00003135 0.00013218 -0.00003131 - -0.00003130 -0.00003131 0.00013173 - #*EXTRAS*# Step: 1 Bead: 0 - 0.00013424 -0.00002349 -0.00002325 - -0.00002349 0.00013444 -0.00002337 - -0.00002325 -0.00002337 0.00013439 - #*EXTRAS*# Step: 2 Bead: 0 - 0.00013575 -0.00001519 -0.00001469 - -0.00001519 0.00013585 -0.00001505 - -0.00001469 -0.00001505 0.00013627 - #*EXTRAS*# Step: 3 Bead: 0 - 0.00013715 -0.00000761 -0.00000716 - -0.00000761 0.00013718 -0.00000751 - -0.00000716 -0.00000751 0.00013787 - #*EXTRAS*# Step: 4 Bead: 0 - 0.00013769 -0.00000503 -0.00000467 - -0.00000503 0.00013771 -0.00000495 - -0.00000467 -0.00000495 0.00013846 - #*EXTRAS*# Step: 5 Bead: 0 - 0.00013771 -0.00000496 -0.00000461 - -0.00000496 0.00013772 -0.00000488 - -0.00000461 -0.00000488 0.00013847 - #*EXTRAS*# Step: 6 Bead: 0 - 0.00013784 -0.00000437 -0.00000404 - -0.00000437 0.00013786 -0.00000429 - -0.00000404 -0.00000429 0.00013861 - #*EXTRAS*# Step: 7 Bead: 0 - 0.00013788 -0.00000418 -0.00000387 - -0.00000418 0.00013790 -0.00000411 - -0.00000387 -0.00000411 0.00013866 - #*EXTRAS*# Step: 8 Bead: 0 - 0.00013792 -0.00000402 -0.00000371 - -0.00000402 0.00013793 -0.00000395 - -0.00000371 -0.00000395 0.00013869 - #*EXTRAS*# Step: 9 Bead: 0 - 0.00013794 -0.00000393 -0.00000363 - -0.00000393 0.00013795 -0.00000386 - -0.00000363 -0.00000386 0.00013872 - #*EXTRAS*# Step: 10 Bead: 0 - 0.00013795 -0.00000386 -0.00000357 - -0.00000386 0.00013797 -0.00000380 - -0.00000357 -0.00000380 0.00013873 - #*EXTRAS*# Step: 11 Bead: 0 - 0.00013796 -0.00000383 -0.00000353 - -0.00000383 0.00013798 -0.00000376 - -0.00000353 -0.00000376 0.00013874 - #*EXTRAS*# Step: 12 Bead: 0 - 0.00013797 -0.00000380 -0.00000351 - -0.00000380 0.00013798 -0.00000373 - -0.00000351 -0.00000373 0.00013875 - #*EXTRAS*# Step: 13 Bead: 0 - 0.00013797 -0.00000379 -0.00000350 - -0.00000379 0.00013799 -0.00000372 - -0.00000350 -0.00000372 0.00013875 - #*EXTRAS*# Step: 14 Bead: 0 - 0.00013797 -0.00000378 -0.00000349 - -0.00000378 0.00013799 -0.00000371 - -0.00000349 -0.00000371 0.00013875 - #*EXTRAS*# Step: 15 Bead: 0 - 0.00013797 -0.00000377 -0.00000348 - -0.00000377 0.00013799 -0.00000370 - -0.00000348 -0.00000370 0.00013875 - #*EXTRAS*# Step: 16 Bead: 0 - 0.00013797 -0.00000376 -0.00000348 - -0.00000376 0.00013799 -0.00000370 - -0.00000348 -0.00000370 0.00013875 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_01 b/drivers/py/pes/friction/frictionH/060K/inst.fric_01 deleted file mode 100644 index e9ad4a64a..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_01 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 - 0.00013190 -0.00003145 -0.00003140 - -0.00003145 0.00013214 -0.00003142 - -0.00003140 -0.00003142 0.00013168 - #*EXTRAS*# Step: 1 Bead: 1 - 0.00013421 -0.00002361 -0.00002337 - -0.00002361 0.00013442 -0.00002349 - -0.00002337 -0.00002349 0.00013436 - #*EXTRAS*# Step: 2 Bead: 1 - 0.00013573 -0.00001531 -0.00001481 - -0.00001531 0.00013583 -0.00001517 - -0.00001481 -0.00001517 0.00013624 - #*EXTRAS*# Step: 3 Bead: 1 - 0.00013713 -0.00000770 -0.00000724 - -0.00000770 0.00013716 -0.00000760 - -0.00000724 -0.00000760 0.00013785 - #*EXTRAS*# Step: 4 Bead: 1 - 0.00013768 -0.00000509 -0.00000473 - -0.00000509 0.00013770 -0.00000500 - -0.00000473 -0.00000500 0.00013844 - #*EXTRAS*# Step: 5 Bead: 1 - 0.00013770 -0.00000501 -0.00000466 - -0.00000501 0.00013771 -0.00000493 - -0.00000466 -0.00000493 0.00013846 - #*EXTRAS*# Step: 6 Bead: 1 - 0.00013783 -0.00000441 -0.00000409 - -0.00000441 0.00013785 -0.00000433 - -0.00000409 -0.00000433 0.00013860 - #*EXTRAS*# Step: 7 Bead: 1 - 0.00013787 -0.00000422 -0.00000391 - -0.00000422 0.00013789 -0.00000415 - -0.00000391 -0.00000415 0.00013865 - #*EXTRAS*# Step: 8 Bead: 1 - 0.00013791 -0.00000406 -0.00000375 - -0.00000406 0.00013793 -0.00000398 - -0.00000375 -0.00000398 0.00013868 - #*EXTRAS*# Step: 9 Bead: 1 - 0.00013793 -0.00000396 -0.00000366 - -0.00000396 0.00013795 -0.00000389 - -0.00000366 -0.00000389 0.00013871 - #*EXTRAS*# Step: 10 Bead: 1 - 0.00013794 -0.00000390 -0.00000361 - -0.00000390 0.00013796 -0.00000383 - -0.00000361 -0.00000383 0.00013872 - #*EXTRAS*# Step: 11 Bead: 1 - 0.00013795 -0.00000386 -0.00000357 - -0.00000386 0.00013797 -0.00000379 - -0.00000357 -0.00000379 0.00013873 - #*EXTRAS*# Step: 12 Bead: 1 - 0.00013796 -0.00000384 -0.00000355 - -0.00000384 0.00013797 -0.00000377 - -0.00000355 -0.00000377 0.00013874 - #*EXTRAS*# Step: 13 Bead: 1 - 0.00013796 -0.00000382 -0.00000353 - -0.00000382 0.00013798 -0.00000375 - -0.00000353 -0.00000375 0.00013874 - #*EXTRAS*# Step: 14 Bead: 1 - 0.00013796 -0.00000381 -0.00000352 - -0.00000381 0.00013798 -0.00000374 - -0.00000352 -0.00000374 0.00013874 - #*EXTRAS*# Step: 15 Bead: 1 - 0.00013797 -0.00000380 -0.00000351 - -0.00000380 0.00013798 -0.00000374 - -0.00000351 -0.00000374 0.00013874 - #*EXTRAS*# Step: 16 Bead: 1 - 0.00013797 -0.00000380 -0.00000351 - -0.00000380 0.00013798 -0.00000373 - -0.00000351 -0.00000373 0.00013875 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_02 b/drivers/py/pes/friction/frictionH/060K/inst.fric_02 deleted file mode 100644 index 86a73b0d5..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_02 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 - 0.00013182 -0.00003163 -0.00003158 - -0.00003163 0.00013207 -0.00003160 - -0.00003158 -0.00003160 0.00013160 - #*EXTRAS*# Step: 1 Bead: 2 - 0.00013417 -0.00002381 -0.00002358 - -0.00002381 0.00013437 -0.00002370 - -0.00002358 -0.00002370 0.00013431 - #*EXTRAS*# Step: 2 Bead: 2 - 0.00013570 -0.00001552 -0.00001502 - -0.00001552 0.00013580 -0.00001538 - -0.00001502 -0.00001538 0.00013620 - #*EXTRAS*# Step: 3 Bead: 2 - 0.00013710 -0.00000787 -0.00000740 - -0.00000787 0.00013713 -0.00000776 - -0.00000740 -0.00000776 0.00013782 - #*EXTRAS*# Step: 4 Bead: 2 - 0.00013765 -0.00000520 -0.00000484 - -0.00000520 0.00013767 -0.00000512 - -0.00000484 -0.00000512 0.00013842 - #*EXTRAS*# Step: 5 Bead: 2 - 0.00013767 -0.00000511 -0.00000475 - -0.00000511 0.00013769 -0.00000503 - -0.00000475 -0.00000503 0.00013844 - #*EXTRAS*# Step: 6 Bead: 2 - 0.00013781 -0.00000450 -0.00000417 - -0.00000450 0.00013783 -0.00000442 - -0.00000417 -0.00000442 0.00013858 - #*EXTRAS*# Step: 7 Bead: 2 - 0.00013785 -0.00000430 -0.00000399 - -0.00000430 0.00013787 -0.00000423 - -0.00000399 -0.00000423 0.00013863 - #*EXTRAS*# Step: 8 Bead: 2 - 0.00013789 -0.00000413 -0.00000382 - -0.00000413 0.00013791 -0.00000406 - -0.00000382 -0.00000406 0.00013867 - #*EXTRAS*# Step: 9 Bead: 2 - 0.00013791 -0.00000404 -0.00000374 - -0.00000404 0.00013793 -0.00000397 - -0.00000374 -0.00000397 0.00013869 - #*EXTRAS*# Step: 10 Bead: 2 - 0.00013793 -0.00000398 -0.00000368 - -0.00000398 0.00013794 -0.00000391 - -0.00000368 -0.00000391 0.00013870 - #*EXTRAS*# Step: 11 Bead: 2 - 0.00013794 -0.00000394 -0.00000364 - -0.00000394 0.00013795 -0.00000387 - -0.00000364 -0.00000387 0.00013871 - #*EXTRAS*# Step: 12 Bead: 2 - 0.00013794 -0.00000391 -0.00000361 - -0.00000391 0.00013796 -0.00000384 - -0.00000361 -0.00000384 0.00013872 - #*EXTRAS*# Step: 13 Bead: 2 - 0.00013795 -0.00000389 -0.00000360 - -0.00000389 0.00013796 -0.00000382 - -0.00000360 -0.00000382 0.00013872 - #*EXTRAS*# Step: 14 Bead: 2 - 0.00013795 -0.00000388 -0.00000359 - -0.00000388 0.00013796 -0.00000381 - -0.00000359 -0.00000381 0.00013873 - #*EXTRAS*# Step: 15 Bead: 2 - 0.00013795 -0.00000388 -0.00000358 - -0.00000388 0.00013797 -0.00000381 - -0.00000358 -0.00000381 0.00013873 - #*EXTRAS*# Step: 16 Bead: 2 - 0.00013795 -0.00000387 -0.00000358 - -0.00000387 0.00013797 -0.00000380 - -0.00000358 -0.00000380 0.00013873 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_03 b/drivers/py/pes/friction/frictionH/060K/inst.fric_03 deleted file mode 100644 index b8fce7c34..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_03 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 - 0.00013172 -0.00003187 -0.00003181 - -0.00003187 0.00013196 -0.00003184 - -0.00003181 -0.00003184 0.00013149 - #*EXTRAS*# Step: 1 Bead: 3 - 0.00013411 -0.00002409 -0.00002388 - -0.00002409 0.00013432 -0.00002398 - -0.00002388 -0.00002398 0.00013423 - #*EXTRAS*# Step: 2 Bead: 3 - 0.00013565 -0.00001581 -0.00001532 - -0.00001581 0.00013575 -0.00001567 - -0.00001532 -0.00001567 0.00013614 - #*EXTRAS*# Step: 3 Bead: 3 - 0.00013705 -0.00000810 -0.00000763 - -0.00000810 0.00013708 -0.00000799 - -0.00000763 -0.00000799 0.00013777 - #*EXTRAS*# Step: 4 Bead: 3 - 0.00013762 -0.00000537 -0.00000500 - -0.00000537 0.00013764 -0.00000529 - -0.00000500 -0.00000529 0.00013838 - #*EXTRAS*# Step: 5 Bead: 3 - 0.00013764 -0.00000526 -0.00000489 - -0.00000526 0.00013766 -0.00000518 - -0.00000489 -0.00000518 0.00013840 - #*EXTRAS*# Step: 6 Bead: 3 - 0.00013778 -0.00000463 -0.00000429 - -0.00000463 0.00013780 -0.00000455 - -0.00000429 -0.00000455 0.00013855 - #*EXTRAS*# Step: 7 Bead: 3 - 0.00013782 -0.00000443 -0.00000410 - -0.00000443 0.00013784 -0.00000435 - -0.00000410 -0.00000435 0.00013860 - #*EXTRAS*# Step: 8 Bead: 3 - 0.00013786 -0.00000425 -0.00000394 - -0.00000425 0.00013788 -0.00000418 - -0.00000394 -0.00000418 0.00013864 - #*EXTRAS*# Step: 9 Bead: 3 - 0.00013789 -0.00000415 -0.00000384 - -0.00000415 0.00013790 -0.00000408 - -0.00000384 -0.00000408 0.00013866 - #*EXTRAS*# Step: 10 Bead: 3 - 0.00013790 -0.00000409 -0.00000378 - -0.00000409 0.00013792 -0.00000402 - -0.00000378 -0.00000402 0.00013868 - #*EXTRAS*# Step: 11 Bead: 3 - 0.00013791 -0.00000405 -0.00000374 - -0.00000405 0.00013793 -0.00000398 - -0.00000374 -0.00000398 0.00013869 - #*EXTRAS*# Step: 12 Bead: 3 - 0.00013792 -0.00000402 -0.00000372 - -0.00000402 0.00013793 -0.00000395 - -0.00000372 -0.00000395 0.00013869 - #*EXTRAS*# Step: 13 Bead: 3 - 0.00013792 -0.00000400 -0.00000370 - -0.00000400 0.00013794 -0.00000393 - -0.00000370 -0.00000393 0.00013870 - #*EXTRAS*# Step: 14 Bead: 3 - 0.00013792 -0.00000399 -0.00000369 - -0.00000399 0.00013794 -0.00000392 - -0.00000369 -0.00000392 0.00013870 - #*EXTRAS*# Step: 15 Bead: 3 - 0.00013792 -0.00000398 -0.00000368 - -0.00000398 0.00013794 -0.00000391 - -0.00000368 -0.00000391 0.00013870 - #*EXTRAS*# Step: 16 Bead: 3 - 0.00013793 -0.00000398 -0.00000368 - -0.00000398 0.00013794 -0.00000391 - -0.00000368 -0.00000391 0.00013870 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_04 b/drivers/py/pes/friction/frictionH/060K/inst.fric_04 deleted file mode 100644 index 032511633..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_04 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 - 0.00013158 -0.00003218 -0.00003211 - -0.00003218 0.00013182 -0.00003215 - -0.00003211 -0.00003215 0.00013134 - #*EXTRAS*# Step: 1 Bead: 4 - 0.00013403 -0.00002446 -0.00002426 - -0.00002446 0.00013424 -0.00002435 - -0.00002426 -0.00002435 0.00013413 - #*EXTRAS*# Step: 2 Bead: 4 - 0.00013558 -0.00001619 -0.00001571 - -0.00001619 0.00013569 -0.00001605 - -0.00001571 -0.00001605 0.00013606 - #*EXTRAS*# Step: 3 Bead: 4 - 0.00013699 -0.00000841 -0.00000793 - -0.00000841 0.00013702 -0.00000830 - -0.00000793 -0.00000830 0.00013770 - #*EXTRAS*# Step: 4 Bead: 4 - 0.00013757 -0.00000560 -0.00000522 - -0.00000560 0.00013759 -0.00000551 - -0.00000522 -0.00000551 0.00013833 - #*EXTRAS*# Step: 5 Bead: 4 - 0.00013760 -0.00000546 -0.00000509 - -0.00000546 0.00013762 -0.00000538 - -0.00000509 -0.00000538 0.00013836 - #*EXTRAS*# Step: 6 Bead: 4 - 0.00013774 -0.00000481 -0.00000446 - -0.00000481 0.00013776 -0.00000473 - -0.00000446 -0.00000473 0.00013851 - #*EXTRAS*# Step: 7 Bead: 4 - 0.00013779 -0.00000460 -0.00000426 - -0.00000460 0.00013780 -0.00000452 - -0.00000426 -0.00000452 0.00013856 - #*EXTRAS*# Step: 8 Bead: 4 - 0.00013783 -0.00000441 -0.00000409 - -0.00000441 0.00013785 -0.00000434 - -0.00000409 -0.00000434 0.00013860 - #*EXTRAS*# Step: 9 Bead: 4 - 0.00013785 -0.00000431 -0.00000399 - -0.00000431 0.00013787 -0.00000423 - -0.00000399 -0.00000423 0.00013863 - #*EXTRAS*# Step: 10 Bead: 4 - 0.00013787 -0.00000424 -0.00000392 - -0.00000424 0.00013788 -0.00000417 - -0.00000392 -0.00000417 0.00013864 - #*EXTRAS*# Step: 11 Bead: 4 - 0.00013788 -0.00000420 -0.00000388 - -0.00000420 0.00013789 -0.00000412 - -0.00000388 -0.00000412 0.00013865 - #*EXTRAS*# Step: 12 Bead: 4 - 0.00013788 -0.00000417 -0.00000386 - -0.00000417 0.00013790 -0.00000410 - -0.00000386 -0.00000410 0.00013866 - #*EXTRAS*# Step: 13 Bead: 4 - 0.00013789 -0.00000415 -0.00000384 - -0.00000415 0.00013790 -0.00000408 - -0.00000384 -0.00000408 0.00013866 - #*EXTRAS*# Step: 14 Bead: 4 - 0.00013789 -0.00000414 -0.00000383 - -0.00000414 0.00013791 -0.00000407 - -0.00000383 -0.00000407 0.00013867 - #*EXTRAS*# Step: 15 Bead: 4 - 0.00013789 -0.00000413 -0.00000382 - -0.00000413 0.00013791 -0.00000406 - -0.00000382 -0.00000406 0.00013867 - #*EXTRAS*# Step: 16 Bead: 4 - 0.00013789 -0.00000413 -0.00000382 - -0.00000413 0.00013791 -0.00000406 - -0.00000382 -0.00000406 0.00013867 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_05 b/drivers/py/pes/friction/frictionH/060K/inst.fric_05 deleted file mode 100644 index fbcf08c6d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_05 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 - 0.00013141 -0.00003255 -0.00003248 - -0.00003255 0.00013164 -0.00003253 - -0.00003248 -0.00003253 0.00013115 - #*EXTRAS*# Step: 1 Bead: 5 - 0.00013392 -0.00002491 -0.00002473 - -0.00002491 0.00013414 -0.00002481 - -0.00002473 -0.00002481 0.00013401 - #*EXTRAS*# Step: 2 Bead: 5 - 0.00013550 -0.00001667 -0.00001619 - -0.00001667 0.00013561 -0.00001653 - -0.00001619 -0.00001653 0.00013596 - #*EXTRAS*# Step: 3 Bead: 5 - 0.00013691 -0.00000880 -0.00000831 - -0.00000880 0.00013695 -0.00000869 - -0.00000831 -0.00000869 0.00013761 - #*EXTRAS*# Step: 4 Bead: 5 - 0.00013750 -0.00000589 -0.00000550 - -0.00000589 0.00013752 -0.00000581 - -0.00000550 -0.00000581 0.00013826 - #*EXTRAS*# Step: 5 Bead: 5 - 0.00013754 -0.00000572 -0.00000533 - -0.00000572 0.00013756 -0.00000563 - -0.00000533 -0.00000563 0.00013830 - #*EXTRAS*# Step: 6 Bead: 5 - 0.00013769 -0.00000504 -0.00000468 - -0.00000504 0.00013771 -0.00000495 - -0.00000468 -0.00000495 0.00013846 - #*EXTRAS*# Step: 7 Bead: 5 - 0.00013774 -0.00000481 -0.00000446 - -0.00000481 0.00013776 -0.00000473 - -0.00000446 -0.00000473 0.00013851 - #*EXTRAS*# Step: 8 Bead: 5 - 0.00013778 -0.00000461 -0.00000428 - -0.00000461 0.00013780 -0.00000454 - -0.00000428 -0.00000454 0.00013855 - #*EXTRAS*# Step: 9 Bead: 5 - 0.00013781 -0.00000451 -0.00000418 - -0.00000451 0.00013782 -0.00000443 - -0.00000418 -0.00000443 0.00013858 - #*EXTRAS*# Step: 10 Bead: 5 - 0.00013782 -0.00000443 -0.00000411 - -0.00000443 0.00013784 -0.00000436 - -0.00000411 -0.00000436 0.00013860 - #*EXTRAS*# Step: 11 Bead: 5 - 0.00013783 -0.00000439 -0.00000406 - -0.00000439 0.00013785 -0.00000431 - -0.00000406 -0.00000431 0.00013861 - #*EXTRAS*# Step: 12 Bead: 5 - 0.00013784 -0.00000436 -0.00000404 - -0.00000436 0.00013786 -0.00000428 - -0.00000404 -0.00000428 0.00013861 - #*EXTRAS*# Step: 13 Bead: 5 - 0.00013784 -0.00000434 -0.00000402 - -0.00000434 0.00013786 -0.00000426 - -0.00000402 -0.00000426 0.00013862 - #*EXTRAS*# Step: 14 Bead: 5 - 0.00013785 -0.00000433 -0.00000401 - -0.00000433 0.00013786 -0.00000425 - -0.00000401 -0.00000425 0.00013862 - #*EXTRAS*# Step: 15 Bead: 5 - 0.00013785 -0.00000432 -0.00000400 - -0.00000432 0.00013787 -0.00000425 - -0.00000400 -0.00000425 0.00013862 - #*EXTRAS*# Step: 16 Bead: 5 - 0.00013785 -0.00000431 -0.00000400 - -0.00000431 0.00013787 -0.00000424 - -0.00000400 -0.00000424 0.00013862 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_06 b/drivers/py/pes/friction/frictionH/060K/inst.fric_06 deleted file mode 100644 index d49232d63..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_06 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 - 0.00013120 -0.00003298 -0.00003290 - -0.00003298 0.00013143 -0.00003297 - -0.00003290 -0.00003297 0.00013093 - #*EXTRAS*# Step: 1 Bead: 6 - 0.00013380 -0.00002544 -0.00002528 - -0.00002544 0.00013402 -0.00002534 - -0.00002528 -0.00002534 0.00013385 - #*EXTRAS*# Step: 2 Bead: 6 - 0.00013540 -0.00001724 -0.00001678 - -0.00001724 0.00013552 -0.00001710 - -0.00001678 -0.00001710 0.00013584 - #*EXTRAS*# Step: 3 Bead: 6 - 0.00013682 -0.00000928 -0.00000878 - -0.00000928 0.00013686 -0.00000917 - -0.00000878 -0.00000917 0.00013751 - #*EXTRAS*# Step: 4 Bead: 6 - 0.00013743 -0.00000626 -0.00000585 - -0.00000626 0.00013745 -0.00000616 - -0.00000585 -0.00000616 0.00013818 - #*EXTRAS*# Step: 5 Bead: 6 - 0.00013747 -0.00000604 -0.00000563 - -0.00000604 0.00013750 -0.00000595 - -0.00000563 -0.00000595 0.00013823 - #*EXTRAS*# Step: 6 Bead: 6 - 0.00013763 -0.00000531 -0.00000494 - -0.00000531 0.00013765 -0.00000523 - -0.00000494 -0.00000523 0.00013839 - #*EXTRAS*# Step: 7 Bead: 6 - 0.00013768 -0.00000507 -0.00000471 - -0.00000507 0.00013770 -0.00000499 - -0.00000471 -0.00000499 0.00013845 - #*EXTRAS*# Step: 8 Bead: 6 - 0.00013773 -0.00000486 -0.00000452 - -0.00000486 0.00013775 -0.00000478 - -0.00000452 -0.00000478 0.00013850 - #*EXTRAS*# Step: 9 Bead: 6 - 0.00013775 -0.00000475 -0.00000441 - -0.00000475 0.00013777 -0.00000467 - -0.00000441 -0.00000467 0.00013852 - #*EXTRAS*# Step: 10 Bead: 6 - 0.00013777 -0.00000467 -0.00000433 - -0.00000467 0.00013779 -0.00000459 - -0.00000433 -0.00000459 0.00013854 - #*EXTRAS*# Step: 11 Bead: 6 - 0.00013778 -0.00000462 -0.00000429 - -0.00000462 0.00013780 -0.00000454 - -0.00000429 -0.00000454 0.00013855 - #*EXTRAS*# Step: 12 Bead: 6 - 0.00013779 -0.00000459 -0.00000426 - -0.00000459 0.00013781 -0.00000451 - -0.00000426 -0.00000451 0.00013856 - #*EXTRAS*# Step: 13 Bead: 6 - 0.00013779 -0.00000457 -0.00000424 - -0.00000457 0.00013781 -0.00000449 - -0.00000424 -0.00000449 0.00013856 - #*EXTRAS*# Step: 14 Bead: 6 - 0.00013780 -0.00000456 -0.00000423 - -0.00000456 0.00013781 -0.00000448 - -0.00000423 -0.00000448 0.00013857 - #*EXTRAS*# Step: 15 Bead: 6 - 0.00013780 -0.00000455 -0.00000422 - -0.00000455 0.00013782 -0.00000447 - -0.00000422 -0.00000447 0.00013857 - #*EXTRAS*# Step: 16 Bead: 6 - 0.00013780 -0.00000454 -0.00000421 - -0.00000454 0.00013782 -0.00000447 - -0.00000421 -0.00000447 0.00013857 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_07 b/drivers/py/pes/friction/frictionH/060K/inst.fric_07 deleted file mode 100644 index f5cd051a9..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_07 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 - 0.00013094 -0.00003348 -0.00003337 - -0.00003348 0.00013117 -0.00003348 - -0.00003337 -0.00003348 0.00013066 - #*EXTRAS*# Step: 1 Bead: 7 - 0.00013365 -0.00002606 -0.00002592 - -0.00002606 0.00013387 -0.00002597 - -0.00002592 -0.00002597 0.00013367 - #*EXTRAS*# Step: 2 Bead: 7 - 0.00013528 -0.00001791 -0.00001747 - -0.00001791 0.00013541 -0.00001777 - -0.00001747 -0.00001777 0.00013569 - #*EXTRAS*# Step: 3 Bead: 7 - 0.00013671 -0.00000986 -0.00000935 - -0.00000986 0.00013675 -0.00000974 - -0.00000935 -0.00000974 0.00013739 - #*EXTRAS*# Step: 4 Bead: 7 - 0.00013734 -0.00000669 -0.00000626 - -0.00000669 0.00013736 -0.00000659 - -0.00000626 -0.00000659 0.00013808 - #*EXTRAS*# Step: 5 Bead: 7 - 0.00013739 -0.00000641 -0.00000600 - -0.00000641 0.00013742 -0.00000632 - -0.00000600 -0.00000632 0.00013814 - #*EXTRAS*# Step: 6 Bead: 7 - 0.00013756 -0.00000565 -0.00000526 - -0.00000565 0.00013758 -0.00000556 - -0.00000526 -0.00000556 0.00013832 - #*EXTRAS*# Step: 7 Bead: 7 - 0.00013761 -0.00000538 -0.00000501 - -0.00000538 0.00013763 -0.00000530 - -0.00000501 -0.00000530 0.00013838 - #*EXTRAS*# Step: 8 Bead: 7 - 0.00013766 -0.00000516 -0.00000480 - -0.00000516 0.00013768 -0.00000508 - -0.00000480 -0.00000508 0.00013843 - #*EXTRAS*# Step: 9 Bead: 7 - 0.00013769 -0.00000504 -0.00000468 - -0.00000504 0.00013771 -0.00000496 - -0.00000468 -0.00000496 0.00013846 - #*EXTRAS*# Step: 10 Bead: 7 - 0.00013771 -0.00000495 -0.00000460 - -0.00000495 0.00013773 -0.00000487 - -0.00000460 -0.00000487 0.00013847 - #*EXTRAS*# Step: 11 Bead: 7 - 0.00013772 -0.00000490 -0.00000455 - -0.00000490 0.00013774 -0.00000482 - -0.00000455 -0.00000482 0.00013849 - #*EXTRAS*# Step: 12 Bead: 7 - 0.00013773 -0.00000487 -0.00000452 - -0.00000487 0.00013774 -0.00000479 - -0.00000452 -0.00000479 0.00013849 - #*EXTRAS*# Step: 13 Bead: 7 - 0.00013773 -0.00000485 -0.00000450 - -0.00000485 0.00013775 -0.00000477 - -0.00000450 -0.00000477 0.00013850 - #*EXTRAS*# Step: 14 Bead: 7 - 0.00013773 -0.00000483 -0.00000449 - -0.00000483 0.00013775 -0.00000475 - -0.00000449 -0.00000475 0.00013850 - #*EXTRAS*# Step: 15 Bead: 7 - 0.00013774 -0.00000482 -0.00000448 - -0.00000482 0.00013775 -0.00000474 - -0.00000448 -0.00000474 0.00013851 - #*EXTRAS*# Step: 16 Bead: 7 - 0.00013774 -0.00000482 -0.00000447 - -0.00000482 0.00013776 -0.00000474 - -0.00000447 -0.00000474 0.00013851 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_08 b/drivers/py/pes/friction/frictionH/060K/inst.fric_08 deleted file mode 100644 index 7989a9c5b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_08 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 - 0.00013065 -0.00003403 -0.00003390 - -0.00003403 0.00013086 -0.00003404 - -0.00003390 -0.00003404 0.00013035 - #*EXTRAS*# Step: 1 Bead: 8 - 0.00013346 -0.00002676 -0.00002665 - -0.00002676 0.00013370 -0.00002668 - -0.00002665 -0.00002668 0.00013346 - #*EXTRAS*# Step: 2 Bead: 8 - 0.00013515 -0.00001868 -0.00001827 - -0.00001868 0.00013529 -0.00001855 - -0.00001827 -0.00001855 0.00013552 - #*EXTRAS*# Step: 3 Bead: 8 - 0.00013658 -0.00001053 -0.00001001 - -0.00001053 0.00013663 -0.00001041 - -0.00001001 -0.00001041 0.00013724 - #*EXTRAS*# Step: 4 Bead: 8 - 0.00013723 -0.00000720 -0.00000676 - -0.00000720 0.00013726 -0.00000710 - -0.00000676 -0.00000710 0.00013796 - #*EXTRAS*# Step: 5 Bead: 8 - 0.00013730 -0.00000686 -0.00000643 - -0.00000686 0.00013733 -0.00000676 - -0.00000643 -0.00000676 0.00013804 - #*EXTRAS*# Step: 6 Bead: 8 - 0.00013747 -0.00000604 -0.00000564 - -0.00000604 0.00013749 -0.00000595 - -0.00000564 -0.00000595 0.00013823 - #*EXTRAS*# Step: 7 Bead: 8 - 0.00013753 -0.00000575 -0.00000536 - -0.00000575 0.00013755 -0.00000566 - -0.00000536 -0.00000566 0.00013829 - #*EXTRAS*# Step: 8 Bead: 8 - 0.00013759 -0.00000551 -0.00000514 - -0.00000551 0.00013761 -0.00000543 - -0.00000514 -0.00000543 0.00013835 - #*EXTRAS*# Step: 9 Bead: 8 - 0.00013761 -0.00000538 -0.00000501 - -0.00000538 0.00013763 -0.00000529 - -0.00000501 -0.00000529 0.00013838 - #*EXTRAS*# Step: 10 Bead: 8 - 0.00013763 -0.00000529 -0.00000492 - -0.00000529 0.00013765 -0.00000520 - -0.00000492 -0.00000520 0.00013840 - #*EXTRAS*# Step: 11 Bead: 8 - 0.00013765 -0.00000523 -0.00000487 - -0.00000523 0.00013767 -0.00000515 - -0.00000487 -0.00000515 0.00013841 - #*EXTRAS*# Step: 12 Bead: 8 - 0.00013765 -0.00000519 -0.00000483 - -0.00000519 0.00013767 -0.00000511 - -0.00000483 -0.00000511 0.00013842 - #*EXTRAS*# Step: 13 Bead: 8 - 0.00013766 -0.00000517 -0.00000481 - -0.00000517 0.00013768 -0.00000509 - -0.00000481 -0.00000509 0.00013842 - #*EXTRAS*# Step: 14 Bead: 8 - 0.00013766 -0.00000516 -0.00000479 - -0.00000516 0.00013768 -0.00000507 - -0.00000479 -0.00000507 0.00013843 - #*EXTRAS*# Step: 15 Bead: 8 - 0.00013767 -0.00000515 -0.00000479 - -0.00000515 0.00013768 -0.00000506 - -0.00000479 -0.00000506 0.00013843 - #*EXTRAS*# Step: 16 Bead: 8 - 0.00013767 -0.00000514 -0.00000478 - -0.00000514 0.00013769 -0.00000506 - -0.00000478 -0.00000506 0.00013843 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_09 b/drivers/py/pes/friction/frictionH/060K/inst.fric_09 deleted file mode 100644 index 6176a97e0..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_09 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 - 0.00013031 -0.00003464 -0.00003447 - -0.00003464 0.00013051 -0.00003465 - -0.00003447 -0.00003465 0.00012999 - #*EXTRAS*# Step: 1 Bead: 9 - 0.00013325 -0.00002755 -0.00002746 - -0.00002755 0.00013349 -0.00002747 - -0.00002746 -0.00002747 0.00013320 - #*EXTRAS*# Step: 2 Bead: 9 - 0.00013499 -0.00001956 -0.00001918 - -0.00001956 0.00013514 -0.00001943 - -0.00001918 -0.00001943 0.00013533 - #*EXTRAS*# Step: 3 Bead: 9 - 0.00013644 -0.00001132 -0.00001079 - -0.00001132 0.00013649 -0.00001119 - -0.00001079 -0.00001119 0.00013708 - #*EXTRAS*# Step: 4 Bead: 9 - 0.00013711 -0.00000780 -0.00000734 - -0.00000780 0.00013714 -0.00000770 - -0.00000734 -0.00000770 0.00013783 - #*EXTRAS*# Step: 5 Bead: 9 - 0.00013719 -0.00000738 -0.00000693 - -0.00000738 0.00013722 -0.00000727 - -0.00000693 -0.00000727 0.00013793 - #*EXTRAS*# Step: 6 Bead: 9 - 0.00013738 -0.00000650 -0.00000608 - -0.00000650 0.00013740 -0.00000640 - -0.00000608 -0.00000640 0.00013812 - #*EXTRAS*# Step: 7 Bead: 9 - 0.00013744 -0.00000618 -0.00000577 - -0.00000618 0.00013747 -0.00000609 - -0.00000577 -0.00000609 0.00013819 - #*EXTRAS*# Step: 8 Bead: 9 - 0.00013750 -0.00000592 -0.00000553 - -0.00000592 0.00013752 -0.00000583 - -0.00000553 -0.00000583 0.00013825 - #*EXTRAS*# Step: 9 Bead: 9 - 0.00013753 -0.00000577 -0.00000538 - -0.00000577 0.00013755 -0.00000569 - -0.00000538 -0.00000569 0.00013829 - #*EXTRAS*# Step: 10 Bead: 9 - 0.00013755 -0.00000568 -0.00000529 - -0.00000568 0.00013757 -0.00000559 - -0.00000529 -0.00000559 0.00013831 - #*EXTRAS*# Step: 11 Bead: 9 - 0.00013756 -0.00000561 -0.00000523 - -0.00000561 0.00013758 -0.00000553 - -0.00000523 -0.00000553 0.00013832 - #*EXTRAS*# Step: 12 Bead: 9 - 0.00013757 -0.00000557 -0.00000519 - -0.00000557 0.00013759 -0.00000549 - -0.00000519 -0.00000549 0.00013833 - #*EXTRAS*# Step: 13 Bead: 9 - 0.00013758 -0.00000555 -0.00000517 - -0.00000555 0.00013760 -0.00000546 - -0.00000517 -0.00000546 0.00013834 - #*EXTRAS*# Step: 14 Bead: 9 - 0.00013758 -0.00000553 -0.00000515 - -0.00000553 0.00013760 -0.00000545 - -0.00000515 -0.00000545 0.00013834 - #*EXTRAS*# Step: 15 Bead: 9 - 0.00013758 -0.00000552 -0.00000514 - -0.00000552 0.00013760 -0.00000544 - -0.00000514 -0.00000544 0.00013834 - #*EXTRAS*# Step: 16 Bead: 9 - 0.00013758 -0.00000552 -0.00000514 - -0.00000552 0.00013761 -0.00000543 - -0.00000514 -0.00000543 0.00013835 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_10 b/drivers/py/pes/friction/frictionH/060K/inst.fric_10 deleted file mode 100644 index 167c2ba31..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_10 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 - 0.00012992 -0.00003529 -0.00003508 - -0.00003529 0.00013011 -0.00003531 - -0.00003508 -0.00003531 0.00012959 - #*EXTRAS*# Step: 1 Bead: 10 - 0.00013299 -0.00002841 -0.00002834 - -0.00002841 0.00013324 -0.00002834 - -0.00002834 -0.00002834 0.00013290 - #*EXTRAS*# Step: 2 Bead: 10 - 0.00013481 -0.00002056 -0.00002021 - -0.00002056 0.00013498 -0.00002043 - -0.00002021 -0.00002043 0.00013510 - #*EXTRAS*# Step: 3 Bead: 10 - 0.00013627 -0.00001222 -0.00001169 - -0.00001222 0.00013634 -0.00001209 - -0.00001169 -0.00001209 0.00013689 - #*EXTRAS*# Step: 4 Bead: 10 - 0.00013697 -0.00000850 -0.00000801 - -0.00000850 0.00013700 -0.00000838 - -0.00000801 -0.00000838 0.00013768 - #*EXTRAS*# Step: 5 Bead: 10 - 0.00013707 -0.00000797 -0.00000750 - -0.00000797 0.00013711 -0.00000786 - -0.00000750 -0.00000786 0.00013780 - #*EXTRAS*# Step: 6 Bead: 10 - 0.00013727 -0.00000702 -0.00000658 - -0.00000702 0.00013729 -0.00000692 - -0.00000658 -0.00000692 0.00013800 - #*EXTRAS*# Step: 7 Bead: 10 - 0.00013734 -0.00000667 -0.00000625 - -0.00000667 0.00013736 -0.00000658 - -0.00000625 -0.00000658 0.00013808 - #*EXTRAS*# Step: 8 Bead: 10 - 0.00013740 -0.00000639 -0.00000598 - -0.00000639 0.00013742 -0.00000630 - -0.00000598 -0.00000630 0.00013815 - #*EXTRAS*# Step: 9 Bead: 10 - 0.00013743 -0.00000623 -0.00000582 - -0.00000623 0.00013746 -0.00000614 - -0.00000582 -0.00000614 0.00013818 - #*EXTRAS*# Step: 10 Bead: 10 - 0.00013745 -0.00000612 -0.00000572 - -0.00000612 0.00013748 -0.00000603 - -0.00000572 -0.00000603 0.00013821 - #*EXTRAS*# Step: 11 Bead: 10 - 0.00013747 -0.00000606 -0.00000565 - -0.00000606 0.00013749 -0.00000596 - -0.00000565 -0.00000596 0.00013822 - #*EXTRAS*# Step: 12 Bead: 10 - 0.00013748 -0.00000601 -0.00000561 - -0.00000601 0.00013750 -0.00000592 - -0.00000561 -0.00000592 0.00013823 - #*EXTRAS*# Step: 13 Bead: 10 - 0.00013748 -0.00000598 -0.00000558 - -0.00000598 0.00013751 -0.00000589 - -0.00000558 -0.00000589 0.00013824 - #*EXTRAS*# Step: 14 Bead: 10 - 0.00013749 -0.00000597 -0.00000557 - -0.00000597 0.00013751 -0.00000588 - -0.00000557 -0.00000588 0.00013824 - #*EXTRAS*# Step: 15 Bead: 10 - 0.00013749 -0.00000596 -0.00000556 - -0.00000596 0.00013751 -0.00000586 - -0.00000556 -0.00000586 0.00013825 - #*EXTRAS*# Step: 16 Bead: 10 - 0.00013749 -0.00000595 -0.00000555 - -0.00000595 0.00013751 -0.00000586 - -0.00000555 -0.00000586 0.00013825 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_11 b/drivers/py/pes/friction/frictionH/060K/inst.fric_11 deleted file mode 100644 index ed5581bb1..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_11 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 - 0.00012948 -0.00003598 -0.00003572 - -0.00003598 0.00012966 -0.00003601 - -0.00003572 -0.00003601 0.00012914 - #*EXTRAS*# Step: 1 Bead: 11 - 0.00013269 -0.00002936 -0.00002931 - -0.00002936 0.00013293 -0.00002930 - -0.00002931 -0.00002930 0.00013256 - #*EXTRAS*# Step: 2 Bead: 11 - 0.00013460 -0.00002166 -0.00002136 - -0.00002166 0.00013478 -0.00002154 - -0.00002136 -0.00002154 0.00013484 - #*EXTRAS*# Step: 3 Bead: 11 - 0.00013609 -0.00001325 -0.00001273 - -0.00001325 0.00013616 -0.00001312 - -0.00001273 -0.00001312 0.00013667 - #*EXTRAS*# Step: 4 Bead: 11 - 0.00013682 -0.00000929 -0.00000879 - -0.00000929 0.00013686 -0.00000917 - -0.00000879 -0.00000917 0.00013751 - #*EXTRAS*# Step: 5 Bead: 11 - 0.00013694 -0.00000865 -0.00000816 - -0.00000865 0.00013698 -0.00000854 - -0.00000816 -0.00000854 0.00013765 - #*EXTRAS*# Step: 6 Bead: 11 - 0.00013714 -0.00000762 -0.00000717 - -0.00000762 0.00013717 -0.00000752 - -0.00000717 -0.00000752 0.00013787 - #*EXTRAS*# Step: 7 Bead: 11 - 0.00013722 -0.00000724 -0.00000679 - -0.00000724 0.00013725 -0.00000714 - -0.00000679 -0.00000714 0.00013796 - #*EXTRAS*# Step: 8 Bead: 11 - 0.00013729 -0.00000693 -0.00000649 - -0.00000693 0.00013731 -0.00000683 - -0.00000649 -0.00000683 0.00013803 - #*EXTRAS*# Step: 9 Bead: 11 - 0.00013732 -0.00000675 -0.00000632 - -0.00000675 0.00013735 -0.00000665 - -0.00000632 -0.00000665 0.00013807 - #*EXTRAS*# Step: 10 Bead: 11 - 0.00013735 -0.00000663 -0.00000621 - -0.00000663 0.00013737 -0.00000654 - -0.00000621 -0.00000654 0.00013809 - #*EXTRAS*# Step: 11 Bead: 11 - 0.00013736 -0.00000656 -0.00000614 - -0.00000656 0.00013739 -0.00000646 - -0.00000614 -0.00000646 0.00013811 - #*EXTRAS*# Step: 12 Bead: 11 - 0.00013737 -0.00000651 -0.00000609 - -0.00000651 0.00013740 -0.00000642 - -0.00000609 -0.00000642 0.00013812 - #*EXTRAS*# Step: 13 Bead: 11 - 0.00013738 -0.00000648 -0.00000606 - -0.00000648 0.00013740 -0.00000639 - -0.00000606 -0.00000639 0.00013813 - #*EXTRAS*# Step: 14 Bead: 11 - 0.00013738 -0.00000646 -0.00000604 - -0.00000646 0.00013741 -0.00000637 - -0.00000604 -0.00000637 0.00013813 - #*EXTRAS*# Step: 15 Bead: 11 - 0.00013739 -0.00000645 -0.00000603 - -0.00000645 0.00013741 -0.00000635 - -0.00000603 -0.00000635 0.00013813 - #*EXTRAS*# Step: 16 Bead: 11 - 0.00013739 -0.00000644 -0.00000602 - -0.00000644 0.00013741 -0.00000635 - -0.00000602 -0.00000635 0.00013814 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_12 b/drivers/py/pes/friction/frictionH/060K/inst.fric_12 deleted file mode 100644 index b4f3a7a94..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_12 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 - 0.00012899 -0.00003670 -0.00003639 - -0.00003670 0.00012915 -0.00003675 - -0.00003639 -0.00003675 0.00012865 - #*EXTRAS*# Step: 1 Bead: 12 - 0.00013232 -0.00003038 -0.00003033 - -0.00003038 0.00013257 -0.00003033 - -0.00003033 -0.00003033 0.00013215 - #*EXTRAS*# Step: 2 Bead: 12 - 0.00013436 -0.00002288 -0.00002262 - -0.00002288 0.00013456 -0.00002277 - -0.00002262 -0.00002277 0.00013454 - #*EXTRAS*# Step: 3 Bead: 12 - 0.00013589 -0.00001442 -0.00001391 - -0.00001442 0.00013597 -0.00001428 - -0.00001391 -0.00001428 0.00013643 - #*EXTRAS*# Step: 4 Bead: 12 - 0.00013664 -0.00001020 -0.00000968 - -0.00001020 0.00013669 -0.00001007 - -0.00000968 -0.00001007 0.00013731 - #*EXTRAS*# Step: 5 Bead: 12 - 0.00013679 -0.00000942 -0.00000891 - -0.00000942 0.00013683 -0.00000930 - -0.00000891 -0.00000930 0.00013748 - #*EXTRAS*# Step: 6 Bead: 12 - 0.00013701 -0.00000831 -0.00000783 - -0.00000831 0.00013704 -0.00000820 - -0.00000783 -0.00000820 0.00013772 - #*EXTRAS*# Step: 7 Bead: 12 - 0.00013709 -0.00000788 -0.00000741 - -0.00000788 0.00013712 -0.00000777 - -0.00000741 -0.00000777 0.00013782 - #*EXTRAS*# Step: 8 Bead: 12 - 0.00013716 -0.00000754 -0.00000708 - -0.00000754 0.00013719 -0.00000744 - -0.00000708 -0.00000744 0.00013789 - #*EXTRAS*# Step: 9 Bead: 12 - 0.00013720 -0.00000734 -0.00000689 - -0.00000734 0.00013723 -0.00000724 - -0.00000689 -0.00000724 0.00013793 - #*EXTRAS*# Step: 10 Bead: 12 - 0.00013723 -0.00000721 -0.00000677 - -0.00000721 0.00013725 -0.00000711 - -0.00000677 -0.00000711 0.00013796 - #*EXTRAS*# Step: 11 Bead: 12 - 0.00013724 -0.00000713 -0.00000669 - -0.00000713 0.00013727 -0.00000703 - -0.00000669 -0.00000703 0.00013798 - #*EXTRAS*# Step: 12 Bead: 12 - 0.00013726 -0.00000708 -0.00000664 - -0.00000708 0.00013728 -0.00000698 - -0.00000664 -0.00000698 0.00013799 - #*EXTRAS*# Step: 13 Bead: 12 - 0.00013726 -0.00000705 -0.00000661 - -0.00000705 0.00013729 -0.00000695 - -0.00000661 -0.00000695 0.00013800 - #*EXTRAS*# Step: 14 Bead: 12 - 0.00013727 -0.00000703 -0.00000659 - -0.00000703 0.00013729 -0.00000693 - -0.00000659 -0.00000693 0.00013800 - #*EXTRAS*# Step: 15 Bead: 12 - 0.00013727 -0.00000701 -0.00000657 - -0.00000701 0.00013730 -0.00000691 - -0.00000657 -0.00000691 0.00013801 - #*EXTRAS*# Step: 16 Bead: 12 - 0.00013727 -0.00000700 -0.00000656 - -0.00000700 0.00013730 -0.00000690 - -0.00000656 -0.00000690 0.00013801 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_13 b/drivers/py/pes/friction/frictionH/060K/inst.fric_13 deleted file mode 100644 index 372da34cb..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_13 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 - 0.00012846 -0.00003745 -0.00003707 - -0.00003745 0.00012860 -0.00003750 - -0.00003707 -0.00003750 0.00012811 - #*EXTRAS*# Step: 1 Bead: 13 - 0.00013189 -0.00003147 -0.00003142 - -0.00003147 0.00013213 -0.00003144 - -0.00003142 -0.00003144 0.00013167 - #*EXTRAS*# Step: 2 Bead: 13 - 0.00013408 -0.00002422 -0.00002401 - -0.00002422 0.00013429 -0.00002411 - -0.00002401 -0.00002411 0.00013420 - #*EXTRAS*# Step: 3 Bead: 13 - 0.00013566 -0.00001573 -0.00001524 - -0.00001573 0.00013576 -0.00001559 - -0.00001524 -0.00001559 0.00013616 - #*EXTRAS*# Step: 4 Bead: 13 - 0.00013645 -0.00001122 -0.00001070 - -0.00001122 0.00013651 -0.00001110 - -0.00001070 -0.00001110 0.00013710 - #*EXTRAS*# Step: 5 Bead: 13 - 0.00013663 -0.00001028 -0.00000977 - -0.00001028 0.00013667 -0.00001016 - -0.00000977 -0.00001016 0.00013730 - #*EXTRAS*# Step: 6 Bead: 13 - 0.00013686 -0.00000908 -0.00000858 - -0.00000908 0.00013690 -0.00000896 - -0.00000858 -0.00000896 0.00013755 - #*EXTRAS*# Step: 7 Bead: 13 - 0.00013695 -0.00000860 -0.00000811 - -0.00000860 0.00013699 -0.00000849 - -0.00000811 -0.00000849 0.00013766 - #*EXTRAS*# Step: 8 Bead: 13 - 0.00013702 -0.00000823 -0.00000775 - -0.00000823 0.00013706 -0.00000812 - -0.00000775 -0.00000812 0.00013774 - #*EXTRAS*# Step: 9 Bead: 13 - 0.00013707 -0.00000801 -0.00000754 - -0.00000801 0.00013710 -0.00000790 - -0.00000754 -0.00000790 0.00013779 - #*EXTRAS*# Step: 10 Bead: 13 - 0.00013709 -0.00000787 -0.00000740 - -0.00000787 0.00013713 -0.00000776 - -0.00000740 -0.00000776 0.00013782 - #*EXTRAS*# Step: 11 Bead: 13 - 0.00013711 -0.00000778 -0.00000732 - -0.00000778 0.00013714 -0.00000767 - -0.00000732 -0.00000767 0.00013784 - #*EXTRAS*# Step: 12 Bead: 13 - 0.00013712 -0.00000772 -0.00000726 - -0.00000772 0.00013715 -0.00000762 - -0.00000726 -0.00000762 0.00013785 - #*EXTRAS*# Step: 13 Bead: 13 - 0.00013713 -0.00000769 -0.00000722 - -0.00000769 0.00013716 -0.00000758 - -0.00000722 -0.00000758 0.00013786 - #*EXTRAS*# Step: 14 Bead: 13 - 0.00013714 -0.00000766 -0.00000720 - -0.00000766 0.00013717 -0.00000756 - -0.00000720 -0.00000756 0.00013786 - #*EXTRAS*# Step: 15 Bead: 13 - 0.00013714 -0.00000765 -0.00000719 - -0.00000765 0.00013717 -0.00000754 - -0.00000719 -0.00000754 0.00013787 - #*EXTRAS*# Step: 16 Bead: 13 - 0.00013714 -0.00000764 -0.00000718 - -0.00000764 0.00013717 -0.00000753 - -0.00000718 -0.00000753 0.00013787 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_14 b/drivers/py/pes/friction/frictionH/060K/inst.fric_14 deleted file mode 100644 index c2717e151..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_14 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 - 0.00012788 -0.00003821 -0.00003777 - -0.00003821 0.00012800 -0.00003827 - -0.00003777 -0.00003827 0.00012753 - #*EXTRAS*# Step: 1 Bead: 14 - 0.00013137 -0.00003262 -0.00003255 - -0.00003262 0.00013161 -0.00003261 - -0.00003255 -0.00003261 0.00013111 - #*EXTRAS*# Step: 2 Bead: 14 - 0.00013374 -0.00002566 -0.00002551 - -0.00002566 0.00013397 -0.00002556 - -0.00002551 -0.00002556 0.00013379 - #*EXTRAS*# Step: 3 Bead: 14 - 0.00013541 -0.00001719 -0.00001673 - -0.00001719 0.00013553 -0.00001705 - -0.00001673 -0.00001705 0.00013585 - #*EXTRAS*# Step: 4 Bead: 14 - 0.00013624 -0.00001238 -0.00001185 - -0.00001238 0.00013631 -0.00001225 - -0.00001185 -0.00001225 0.00013685 - #*EXTRAS*# Step: 5 Bead: 14 - 0.00013645 -0.00001126 -0.00001073 - -0.00001126 0.00013650 -0.00001113 - -0.00001073 -0.00001113 0.00013709 - #*EXTRAS*# Step: 6 Bead: 14 - 0.00013669 -0.00000994 -0.00000943 - -0.00000994 0.00013674 -0.00000982 - -0.00000943 -0.00000982 0.00013737 - #*EXTRAS*# Step: 7 Bead: 14 - 0.00013679 -0.00000941 -0.00000891 - -0.00000941 0.00013683 -0.00000929 - -0.00000891 -0.00000929 0.00013748 - #*EXTRAS*# Step: 8 Bead: 14 - 0.00013687 -0.00000900 -0.00000851 - -0.00000900 0.00013691 -0.00000889 - -0.00000851 -0.00000889 0.00013757 - #*EXTRAS*# Step: 9 Bead: 14 - 0.00013692 -0.00000877 -0.00000828 - -0.00000877 0.00013695 -0.00000865 - -0.00000828 -0.00000865 0.00013762 - #*EXTRAS*# Step: 10 Bead: 14 - 0.00013695 -0.00000861 -0.00000812 - -0.00000861 0.00013698 -0.00000850 - -0.00000812 -0.00000850 0.00013766 - #*EXTRAS*# Step: 11 Bead: 14 - 0.00013697 -0.00000851 -0.00000803 - -0.00000851 0.00013700 -0.00000840 - -0.00000803 -0.00000840 0.00013768 - #*EXTRAS*# Step: 12 Bead: 14 - 0.00013698 -0.00000845 -0.00000796 - -0.00000845 0.00013701 -0.00000834 - -0.00000796 -0.00000834 0.00013769 - #*EXTRAS*# Step: 13 Bead: 14 - 0.00013699 -0.00000841 -0.00000792 - -0.00000841 0.00013702 -0.00000830 - -0.00000792 -0.00000830 0.00013770 - #*EXTRAS*# Step: 14 Bead: 14 - 0.00013699 -0.00000838 -0.00000790 - -0.00000838 0.00013703 -0.00000827 - -0.00000790 -0.00000827 0.00013771 - #*EXTRAS*# Step: 15 Bead: 14 - 0.00013700 -0.00000836 -0.00000788 - -0.00000836 0.00013703 -0.00000825 - -0.00000788 -0.00000825 0.00013771 - #*EXTRAS*# Step: 16 Bead: 14 - 0.00013700 -0.00000835 -0.00000787 - -0.00000835 0.00013703 -0.00000824 - -0.00000787 -0.00000824 0.00013771 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_15 b/drivers/py/pes/friction/frictionH/060K/inst.fric_15 deleted file mode 100644 index 15af13159..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_15 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 - 0.00012726 -0.00003897 -0.00003848 - -0.00003897 0.00012736 -0.00003904 - -0.00003848 -0.00003904 0.00012691 - #*EXTRAS*# Step: 1 Bead: 15 - 0.00013076 -0.00003384 -0.00003371 - -0.00003384 0.00013097 -0.00003383 - -0.00003371 -0.00003383 0.00013046 - #*EXTRAS*# Step: 2 Bead: 15 - 0.00013334 -0.00002721 -0.00002711 - -0.00002721 0.00013358 -0.00002712 - -0.00002711 -0.00002712 0.00013331 - #*EXTRAS*# Step: 3 Bead: 15 - 0.00013513 -0.00001880 -0.00001839 - -0.00001880 0.00013527 -0.00001867 - -0.00001839 -0.00001867 0.00013550 - #*EXTRAS*# Step: 4 Bead: 15 - 0.00013601 -0.00001368 -0.00001316 - -0.00001368 0.00013609 -0.00001354 - -0.00001316 -0.00001354 0.00013658 - #*EXTRAS*# Step: 5 Bead: 15 - 0.00013625 -0.00001234 -0.00001181 - -0.00001234 0.00013632 -0.00001221 - -0.00001181 -0.00001221 0.00013686 - #*EXTRAS*# Step: 6 Bead: 15 - 0.00013651 -0.00001091 -0.00001039 - -0.00001091 0.00013656 -0.00001079 - -0.00001039 -0.00001079 0.00013716 - #*EXTRAS*# Step: 7 Bead: 15 - 0.00013662 -0.00001032 -0.00000980 - -0.00001032 0.00013667 -0.00001020 - -0.00000980 -0.00001020 0.00013729 - #*EXTRAS*# Step: 8 Bead: 15 - 0.00013670 -0.00000987 -0.00000936 - -0.00000987 0.00013675 -0.00000975 - -0.00000936 -0.00000975 0.00013738 - #*EXTRAS*# Step: 9 Bead: 15 - 0.00013675 -0.00000961 -0.00000911 - -0.00000961 0.00013680 -0.00000949 - -0.00000911 -0.00000949 0.00013744 - #*EXTRAS*# Step: 10 Bead: 15 - 0.00013679 -0.00000944 -0.00000893 - -0.00000944 0.00013683 -0.00000932 - -0.00000893 -0.00000932 0.00013748 - #*EXTRAS*# Step: 11 Bead: 15 - 0.00013681 -0.00000933 -0.00000883 - -0.00000933 0.00013685 -0.00000921 - -0.00000883 -0.00000921 0.00013750 - #*EXTRAS*# Step: 12 Bead: 15 - 0.00013682 -0.00000926 -0.00000876 - -0.00000926 0.00013686 -0.00000914 - -0.00000876 -0.00000914 0.00013752 - #*EXTRAS*# Step: 13 Bead: 15 - 0.00013683 -0.00000921 -0.00000871 - -0.00000921 0.00013687 -0.00000910 - -0.00000871 -0.00000910 0.00013753 - #*EXTRAS*# Step: 14 Bead: 15 - 0.00013684 -0.00000918 -0.00000869 - -0.00000918 0.00013688 -0.00000907 - -0.00000869 -0.00000907 0.00013753 - #*EXTRAS*# Step: 15 Bead: 15 - 0.00013684 -0.00000917 -0.00000867 - -0.00000917 0.00013688 -0.00000905 - -0.00000867 -0.00000905 0.00013754 - #*EXTRAS*# Step: 16 Bead: 15 - 0.00013684 -0.00000915 -0.00000866 - -0.00000915 0.00013688 -0.00000904 - -0.00000866 -0.00000904 0.00013754 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_16 b/drivers/py/pes/friction/frictionH/060K/inst.fric_16 deleted file mode 100644 index 0f2a9344b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_16 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 16 - 0.00012661 -0.00003971 -0.00003918 - -0.00003971 0.00012670 -0.00003980 - -0.00003918 -0.00003980 0.00012627 - #*EXTRAS*# Step: 1 Bead: 16 - 0.00013004 -0.00003508 -0.00003488 - -0.00003508 0.00013024 -0.00003510 - -0.00003488 -0.00003510 0.00012972 - #*EXTRAS*# Step: 2 Bead: 16 - 0.00013285 -0.00002885 -0.00002879 - -0.00002885 0.00013310 -0.00002878 - -0.00002879 -0.00002878 0.00013275 - #*EXTRAS*# Step: 3 Bead: 16 - 0.00013481 -0.00002057 -0.00002022 - -0.00002057 0.00013497 -0.00002044 - -0.00002022 -0.00002044 0.00013510 - #*EXTRAS*# Step: 4 Bead: 16 - 0.00013576 -0.00001513 -0.00001462 - -0.00001513 0.00013586 -0.00001499 - -0.00001462 -0.00001499 0.00013628 - #*EXTRAS*# Step: 5 Bead: 16 - 0.00013604 -0.00001355 -0.00001303 - -0.00001355 0.00013612 -0.00001342 - -0.00001303 -0.00001342 0.00013661 - #*EXTRAS*# Step: 6 Bead: 16 - 0.00013631 -0.00001200 -0.00001147 - -0.00001200 0.00013638 -0.00001186 - -0.00001147 -0.00001186 0.00013694 - #*EXTRAS*# Step: 7 Bead: 16 - 0.00013643 -0.00001134 -0.00001081 - -0.00001134 0.00013649 -0.00001121 - -0.00001081 -0.00001121 0.00013707 - #*EXTRAS*# Step: 8 Bead: 16 - 0.00013652 -0.00001085 -0.00001032 - -0.00001085 0.00013657 -0.00001072 - -0.00001032 -0.00001072 0.00013718 - #*EXTRAS*# Step: 9 Bead: 16 - 0.00013658 -0.00001056 -0.00001004 - -0.00001056 0.00013663 -0.00001043 - -0.00001004 -0.00001043 0.00013724 - #*EXTRAS*# Step: 10 Bead: 16 - 0.00013661 -0.00001036 -0.00000985 - -0.00001036 0.00013666 -0.00001024 - -0.00000985 -0.00001024 0.00013728 - #*EXTRAS*# Step: 11 Bead: 16 - 0.00013663 -0.00001024 -0.00000973 - -0.00001024 0.00013668 -0.00001012 - -0.00000973 -0.00001012 0.00013730 - #*EXTRAS*# Step: 12 Bead: 16 - 0.00013665 -0.00001017 -0.00000965 - -0.00001017 0.00013670 -0.00001004 - -0.00000965 -0.00001004 0.00013732 - #*EXTRAS*# Step: 13 Bead: 16 - 0.00013666 -0.00001012 -0.00000960 - -0.00001012 0.00013670 -0.00001000 - -0.00000960 -0.00001000 0.00013733 - #*EXTRAS*# Step: 14 Bead: 16 - 0.00013666 -0.00001009 -0.00000957 - -0.00001009 0.00013671 -0.00000996 - -0.00000957 -0.00000996 0.00013734 - #*EXTRAS*# Step: 15 Bead: 16 - 0.00013667 -0.00001007 -0.00000955 - -0.00001007 0.00013671 -0.00000994 - -0.00000955 -0.00000994 0.00013734 - #*EXTRAS*# Step: 16 Bead: 16 - 0.00013667 -0.00001005 -0.00000954 - -0.00001005 0.00013672 -0.00000993 - -0.00000954 -0.00000993 0.00013735 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_17 b/drivers/py/pes/friction/frictionH/060K/inst.fric_17 deleted file mode 100644 index 72a93a760..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_17 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 17 - 0.00012594 -0.00004043 -0.00003988 - -0.00004043 0.00012601 -0.00004052 - -0.00003988 -0.00004052 0.00012562 - #*EXTRAS*# Step: 1 Bead: 17 - 0.00012923 -0.00003635 -0.00003606 - -0.00003635 0.00012940 -0.00003639 - -0.00003606 -0.00003639 0.00012889 - #*EXTRAS*# Step: 2 Bead: 17 - 0.00013225 -0.00003057 -0.00003053 - -0.00003057 0.00013250 -0.00003052 - -0.00003053 -0.00003052 0.00013207 - #*EXTRAS*# Step: 3 Bead: 17 - 0.00013444 -0.00002249 -0.00002221 - -0.00002249 0.00013463 -0.00002237 - -0.00002221 -0.00002237 0.00013464 - #*EXTRAS*# Step: 4 Bead: 17 - 0.00013549 -0.00001673 -0.00001626 - -0.00001673 0.00013560 -0.00001659 - -0.00001626 -0.00001659 0.00013594 - #*EXTRAS*# Step: 5 Bead: 17 - 0.00013580 -0.00001489 -0.00001438 - -0.00001489 0.00013590 -0.00001475 - -0.00001438 -0.00001475 0.00013633 - #*EXTRAS*# Step: 6 Bead: 17 - 0.00013610 -0.00001320 -0.00001267 - -0.00001320 0.00013617 -0.00001306 - -0.00001267 -0.00001306 0.00013668 - #*EXTRAS*# Step: 7 Bead: 17 - 0.00013623 -0.00001247 -0.00001194 - -0.00001247 0.00013630 -0.00001233 - -0.00001194 -0.00001233 0.00013684 - #*EXTRAS*# Step: 8 Bead: 17 - 0.00013632 -0.00001193 -0.00001140 - -0.00001193 0.00013639 -0.00001180 - -0.00001140 -0.00001180 0.00013695 - #*EXTRAS*# Step: 9 Bead: 17 - 0.00013638 -0.00001161 -0.00001108 - -0.00001161 0.00013644 -0.00001148 - -0.00001108 -0.00001148 0.00013702 - #*EXTRAS*# Step: 10 Bead: 17 - 0.00013642 -0.00001140 -0.00001087 - -0.00001140 0.00013648 -0.00001127 - -0.00001087 -0.00001127 0.00013706 - #*EXTRAS*# Step: 11 Bead: 17 - 0.00013645 -0.00001126 -0.00001074 - -0.00001126 0.00013650 -0.00001114 - -0.00001074 -0.00001114 0.00013709 - #*EXTRAS*# Step: 12 Bead: 17 - 0.00013646 -0.00001118 -0.00001065 - -0.00001118 0.00013652 -0.00001105 - -0.00001065 -0.00001105 0.00013711 - #*EXTRAS*# Step: 13 Bead: 17 - 0.00013647 -0.00001112 -0.00001060 - -0.00001112 0.00013653 -0.00001100 - -0.00001060 -0.00001100 0.00013712 - #*EXTRAS*# Step: 14 Bead: 17 - 0.00013648 -0.00001109 -0.00001057 - -0.00001109 0.00013653 -0.00001096 - -0.00001057 -0.00001096 0.00013713 - #*EXTRAS*# Step: 15 Bead: 17 - 0.00013648 -0.00001107 -0.00001054 - -0.00001107 0.00013654 -0.00001094 - -0.00001054 -0.00001094 0.00013713 - #*EXTRAS*# Step: 16 Bead: 17 - 0.00013648 -0.00001105 -0.00001053 - -0.00001105 0.00013654 -0.00001093 - -0.00001053 -0.00001093 0.00013713 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_18 b/drivers/py/pes/friction/frictionH/060K/inst.fric_18 deleted file mode 100644 index a3f684fc7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_18 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 18 - 0.00012526 -0.00004110 -0.00004055 - -0.00004110 0.00012533 -0.00004120 - -0.00004055 -0.00004120 0.00012496 - #*EXTRAS*# Step: 1 Bead: 18 - 0.00012834 -0.00003761 -0.00003722 - -0.00003761 0.00012848 -0.00003767 - -0.00003722 -0.00003767 0.00012799 - #*EXTRAS*# Step: 2 Bead: 18 - 0.00013150 -0.00003236 -0.00003229 - -0.00003236 0.00013173 -0.00003234 - -0.00003229 -0.00003234 0.00013125 - #*EXTRAS*# Step: 3 Bead: 18 - 0.00013401 -0.00002455 -0.00002435 - -0.00002455 0.00013422 -0.00002444 - -0.00002435 -0.00002444 0.00013411 - #*EXTRAS*# Step: 4 Bead: 18 - 0.00013518 -0.00001850 -0.00001808 - -0.00001850 0.00013532 -0.00001837 - -0.00001808 -0.00001837 0.00013556 - #*EXTRAS*# Step: 5 Bead: 18 - 0.00013555 -0.00001636 -0.00001588 - -0.00001636 0.00013566 -0.00001623 - -0.00001588 -0.00001623 0.00013602 - #*EXTRAS*# Step: 6 Bead: 18 - 0.00013587 -0.00001453 -0.00001401 - -0.00001453 0.00013596 -0.00001439 - -0.00001401 -0.00001439 0.00013641 - #*EXTRAS*# Step: 7 Bead: 18 - 0.00013601 -0.00001372 -0.00001320 - -0.00001372 0.00013609 -0.00001358 - -0.00001320 -0.00001358 0.00013658 - #*EXTRAS*# Step: 8 Bead: 18 - 0.00013611 -0.00001313 -0.00001260 - -0.00001313 0.00013619 -0.00001299 - -0.00001260 -0.00001299 0.00013670 - #*EXTRAS*# Step: 9 Bead: 18 - 0.00013617 -0.00001277 -0.00001225 - -0.00001277 0.00013624 -0.00001264 - -0.00001225 -0.00001264 0.00013677 - #*EXTRAS*# Step: 10 Bead: 18 - 0.00013622 -0.00001254 -0.00001201 - -0.00001254 0.00013628 -0.00001241 - -0.00001201 -0.00001241 0.00013682 - #*EXTRAS*# Step: 11 Bead: 18 - 0.00013624 -0.00001240 -0.00001187 - -0.00001240 0.00013631 -0.00001226 - -0.00001187 -0.00001226 0.00013685 - #*EXTRAS*# Step: 12 Bead: 18 - 0.00013626 -0.00001230 -0.00001177 - -0.00001230 0.00013632 -0.00001217 - -0.00001177 -0.00001217 0.00013687 - #*EXTRAS*# Step: 13 Bead: 18 - 0.00013627 -0.00001224 -0.00001171 - -0.00001224 0.00013633 -0.00001211 - -0.00001171 -0.00001211 0.00013688 - #*EXTRAS*# Step: 14 Bead: 18 - 0.00013628 -0.00001220 -0.00001168 - -0.00001220 0.00013634 -0.00001207 - -0.00001168 -0.00001207 0.00013689 - #*EXTRAS*# Step: 15 Bead: 18 - 0.00013628 -0.00001218 -0.00001165 - -0.00001218 0.00013634 -0.00001205 - -0.00001165 -0.00001205 0.00013690 - #*EXTRAS*# Step: 16 Bead: 18 - 0.00013628 -0.00001216 -0.00001163 - -0.00001216 0.00013635 -0.00001203 - -0.00001163 -0.00001203 0.00013690 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_19 b/drivers/py/pes/friction/frictionH/060K/inst.fric_19 deleted file mode 100644 index 8c8abd912..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_19 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 19 - 0.00012460 -0.00004170 -0.00004120 - -0.00004170 0.00012466 -0.00004181 - -0.00004120 -0.00004181 0.00012432 - #*EXTRAS*# Step: 1 Bead: 19 - 0.00012738 -0.00003883 -0.00003835 - -0.00003883 0.00012748 -0.00003890 - -0.00003835 -0.00003890 0.00012703 - #*EXTRAS*# Step: 2 Bead: 19 - 0.00013056 -0.00003419 -0.00003404 - -0.00003419 0.00013078 -0.00003419 - -0.00003404 -0.00003419 0.00013026 - #*EXTRAS*# Step: 3 Bead: 19 - 0.00013347 -0.00002673 -0.00002662 - -0.00002673 0.00013371 -0.00002664 - -0.00002662 -0.00002664 0.00013347 - #*EXTRAS*# Step: 4 Bead: 19 - 0.00013483 -0.00002044 -0.00002008 - -0.00002044 0.00013500 -0.00002031 - -0.00002008 -0.00002031 0.00013513 - #*EXTRAS*# Step: 5 Bead: 19 - 0.00013527 -0.00001798 -0.00001754 - -0.00001798 0.00013540 -0.00001784 - -0.00001754 -0.00001784 0.00013568 - #*EXTRAS*# Step: 6 Bead: 19 - 0.00013562 -0.00001599 -0.00001550 - -0.00001599 0.00013572 -0.00001585 - -0.00001550 -0.00001585 0.00013610 - #*EXTRAS*# Step: 7 Bead: 19 - 0.00013577 -0.00001509 -0.00001459 - -0.00001509 0.00013586 -0.00001496 - -0.00001459 -0.00001496 0.00013629 - #*EXTRAS*# Step: 8 Bead: 19 - 0.00013588 -0.00001445 -0.00001394 - -0.00001445 0.00013597 -0.00001431 - -0.00001394 -0.00001431 0.00013642 - #*EXTRAS*# Step: 9 Bead: 19 - 0.00013595 -0.00001406 -0.00001354 - -0.00001406 0.00013603 -0.00001392 - -0.00001354 -0.00001392 0.00013650 - #*EXTRAS*# Step: 10 Bead: 19 - 0.00013599 -0.00001381 -0.00001329 - -0.00001381 0.00013607 -0.00001367 - -0.00001329 -0.00001367 0.00013656 - #*EXTRAS*# Step: 11 Bead: 19 - 0.00013602 -0.00001365 -0.00001312 - -0.00001365 0.00013610 -0.00001351 - -0.00001312 -0.00001351 0.00013659 - #*EXTRAS*# Step: 12 Bead: 19 - 0.00013604 -0.00001354 -0.00001302 - -0.00001354 0.00013612 -0.00001341 - -0.00001302 -0.00001341 0.00013661 - #*EXTRAS*# Step: 13 Bead: 19 - 0.00013605 -0.00001348 -0.00001295 - -0.00001348 0.00013613 -0.00001334 - -0.00001295 -0.00001334 0.00013663 - #*EXTRAS*# Step: 14 Bead: 19 - 0.00013606 -0.00001344 -0.00001291 - -0.00001344 0.00013613 -0.00001330 - -0.00001291 -0.00001330 0.00013663 - #*EXTRAS*# Step: 15 Bead: 19 - 0.00013606 -0.00001341 -0.00001288 - -0.00001341 0.00013614 -0.00001327 - -0.00001288 -0.00001327 0.00013664 - #*EXTRAS*# Step: 16 Bead: 19 - 0.00013606 -0.00001339 -0.00001287 - -0.00001339 0.00013614 -0.00001326 - -0.00001287 -0.00001326 0.00013664 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_20 b/drivers/py/pes/friction/frictionH/060K/inst.fric_20 deleted file mode 100644 index 648f45995..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_20 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 20 - 0.00012394 -0.00004224 -0.00004182 - -0.00004224 0.00012400 -0.00004234 - -0.00004182 -0.00004234 0.00012371 - #*EXTRAS*# Step: 1 Bead: 20 - 0.00012637 -0.00003998 -0.00003944 - -0.00003998 0.00012645 -0.00004007 - -0.00003944 -0.00004007 0.00012604 - #*EXTRAS*# Step: 2 Bead: 20 - 0.00012946 -0.00003601 -0.00003575 - -0.00003601 0.00012964 -0.00003604 - -0.00003575 -0.00003604 0.00012912 - #*EXTRAS*# Step: 3 Bead: 20 - 0.00013280 -0.00002902 -0.00002896 - -0.00002902 0.00013304 -0.00002896 - -0.00002896 -0.00002896 0.00013268 - #*EXTRAS*# Step: 4 Bead: 20 - 0.00013443 -0.00002254 -0.00002226 - -0.00002254 0.00013462 -0.00002242 - -0.00002226 -0.00002242 0.00013463 - #*EXTRAS*# Step: 5 Bead: 20 - 0.00013496 -0.00001974 -0.00001936 - -0.00001974 0.00013511 -0.00001961 - -0.00001936 -0.00001961 0.00013529 - #*EXTRAS*# Step: 6 Bead: 20 - 0.00013534 -0.00001759 -0.00001714 - -0.00001759 0.00013547 -0.00001745 - -0.00001714 -0.00001745 0.00013576 - #*EXTRAS*# Step: 7 Bead: 20 - 0.00013551 -0.00001661 -0.00001613 - -0.00001661 0.00013562 -0.00001647 - -0.00001613 -0.00001647 0.00013597 - #*EXTRAS*# Step: 8 Bead: 20 - 0.00013563 -0.00001590 -0.00001541 - -0.00001590 0.00013574 -0.00001576 - -0.00001541 -0.00001576 0.00013612 - #*EXTRAS*# Step: 9 Bead: 20 - 0.00013570 -0.00001548 -0.00001498 - -0.00001548 0.00013580 -0.00001534 - -0.00001498 -0.00001534 0.00013621 - #*EXTRAS*# Step: 10 Bead: 20 - 0.00013575 -0.00001520 -0.00001470 - -0.00001520 0.00013585 -0.00001506 - -0.00001470 -0.00001506 0.00013627 - #*EXTRAS*# Step: 11 Bead: 20 - 0.00013578 -0.00001502 -0.00001452 - -0.00001502 0.00013588 -0.00001489 - -0.00001452 -0.00001489 0.00013630 - #*EXTRAS*# Step: 12 Bead: 20 - 0.00013580 -0.00001491 -0.00001440 - -0.00001491 0.00013589 -0.00001477 - -0.00001440 -0.00001477 0.00013633 - #*EXTRAS*# Step: 13 Bead: 20 - 0.00013581 -0.00001484 -0.00001433 - -0.00001484 0.00013591 -0.00001470 - -0.00001433 -0.00001470 0.00013634 - #*EXTRAS*# Step: 14 Bead: 20 - 0.00013582 -0.00001479 -0.00001428 - -0.00001479 0.00013591 -0.00001466 - -0.00001428 -0.00001466 0.00013635 - #*EXTRAS*# Step: 15 Bead: 20 - 0.00013583 -0.00001476 -0.00001425 - -0.00001476 0.00013592 -0.00001463 - -0.00001425 -0.00001463 0.00013636 - #*EXTRAS*# Step: 16 Bead: 20 - 0.00013583 -0.00001474 -0.00001424 - -0.00001474 0.00013592 -0.00001461 - -0.00001424 -0.00001461 0.00013636 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_21 b/drivers/py/pes/friction/frictionH/060K/inst.fric_21 deleted file mode 100644 index 47e1d1937..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_21 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 21 - 0.00012329 -0.00004270 -0.00004239 - -0.00004270 0.00012336 -0.00004279 - -0.00004239 -0.00004279 0.00012310 - #*EXTRAS*# Step: 1 Bead: 21 - 0.00012536 -0.00004101 -0.00004046 - -0.00004101 0.00012542 -0.00004111 - -0.00004046 -0.00004111 0.00012505 - #*EXTRAS*# Step: 2 Bead: 21 - 0.00012821 -0.00003778 -0.00003738 - -0.00003778 0.00012834 -0.00003784 - -0.00003738 -0.00003784 0.00012786 - #*EXTRAS*# Step: 3 Bead: 21 - 0.00013192 -0.00003139 -0.00003134 - -0.00003139 0.00013217 -0.00003135 - -0.00003134 -0.00003135 0.00013171 - #*EXTRAS*# Step: 4 Bead: 21 - 0.00013395 -0.00002479 -0.00002461 - -0.00002479 0.00013417 -0.00002469 - -0.00002461 -0.00002469 0.00013404 - #*EXTRAS*# Step: 5 Bead: 21 - 0.00013461 -0.00002165 -0.00002134 - -0.00002165 0.00013479 -0.00002153 - -0.00002134 -0.00002153 0.00013485 - #*EXTRAS*# Step: 6 Bead: 21 - 0.00013503 -0.00001933 -0.00001893 - -0.00001933 0.00013518 -0.00001920 - -0.00001893 -0.00001920 0.00013538 - #*EXTRAS*# Step: 7 Bead: 21 - 0.00013522 -0.00001825 -0.00001782 - -0.00001825 0.00013536 -0.00001812 - -0.00001782 -0.00001812 0.00013562 - #*EXTRAS*# Step: 8 Bead: 21 - 0.00013536 -0.00001749 -0.00001704 - -0.00001749 0.00013548 -0.00001735 - -0.00001704 -0.00001735 0.00013578 - #*EXTRAS*# Step: 9 Bead: 21 - 0.00013544 -0.00001703 -0.00001656 - -0.00001703 0.00013556 -0.00001689 - -0.00001656 -0.00001689 0.00013588 - #*EXTRAS*# Step: 10 Bead: 21 - 0.00013549 -0.00001673 -0.00001625 - -0.00001673 0.00013560 -0.00001659 - -0.00001625 -0.00001659 0.00013595 - #*EXTRAS*# Step: 11 Bead: 21 - 0.00013552 -0.00001653 -0.00001606 - -0.00001653 0.00013563 -0.00001639 - -0.00001606 -0.00001639 0.00013599 - #*EXTRAS*# Step: 12 Bead: 21 - 0.00013554 -0.00001641 -0.00001593 - -0.00001641 0.00013565 -0.00001627 - -0.00001593 -0.00001627 0.00013601 - #*EXTRAS*# Step: 13 Bead: 21 - 0.00013556 -0.00001633 -0.00001585 - -0.00001633 0.00013567 -0.00001619 - -0.00001585 -0.00001619 0.00013603 - #*EXTRAS*# Step: 14 Bead: 21 - 0.00013556 -0.00001628 -0.00001580 - -0.00001628 0.00013567 -0.00001614 - -0.00001580 -0.00001614 0.00013604 - #*EXTRAS*# Step: 15 Bead: 21 - 0.00013557 -0.00001625 -0.00001577 - -0.00001625 0.00013568 -0.00001611 - -0.00001577 -0.00001611 0.00013605 - #*EXTRAS*# Step: 16 Bead: 21 - 0.00013557 -0.00001623 -0.00001575 - -0.00001623 0.00013568 -0.00001609 - -0.00001575 -0.00001609 0.00013605 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_22 b/drivers/py/pes/friction/frictionH/060K/inst.fric_22 deleted file mode 100644 index d263221c5..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_22 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 22 - 0.00012263 -0.00004310 -0.00004291 - -0.00004310 0.00012270 -0.00004316 - -0.00004291 -0.00004316 0.00012248 - #*EXTRAS*# Step: 1 Bead: 22 - 0.00012438 -0.00004189 -0.00004141 - -0.00004189 0.00012444 -0.00004199 - -0.00004141 -0.00004199 0.00012412 - #*EXTRAS*# Step: 2 Bead: 22 - 0.00012687 -0.00003943 -0.00003891 - -0.00003943 0.00012696 -0.00003951 - -0.00003891 -0.00003951 0.00012653 - #*EXTRAS*# Step: 3 Bead: 22 - 0.00013078 -0.00003379 -0.00003367 - -0.00003379 0.00013100 -0.00003379 - -0.00003367 -0.00003379 0.00013049 - #*EXTRAS*# Step: 4 Bead: 22 - 0.00013335 -0.00002719 -0.00002708 - -0.00002719 0.00013359 -0.00002710 - -0.00002708 -0.00002710 0.00013332 - #*EXTRAS*# Step: 5 Bead: 22 - 0.00013419 -0.00002370 -0.00002347 - -0.00002370 0.00013440 -0.00002359 - -0.00002347 -0.00002359 0.00013433 - #*EXTRAS*# Step: 6 Bead: 22 - 0.00013469 -0.00002121 -0.00002089 - -0.00002121 0.00013486 -0.00002109 - -0.00002089 -0.00002109 0.00013495 - #*EXTRAS*# Step: 7 Bead: 22 - 0.00013491 -0.00002004 -0.00001967 - -0.00002004 0.00013507 -0.00001991 - -0.00001967 -0.00001991 0.00013522 - #*EXTRAS*# Step: 8 Bead: 22 - 0.00013505 -0.00001922 -0.00001882 - -0.00001922 0.00013520 -0.00001908 - -0.00001882 -0.00001908 0.00013541 - #*EXTRAS*# Step: 9 Bead: 22 - 0.00013514 -0.00001871 -0.00001830 - -0.00001871 0.00013528 -0.00001858 - -0.00001830 -0.00001858 0.00013552 - #*EXTRAS*# Step: 10 Bead: 22 - 0.00013520 -0.00001839 -0.00001796 - -0.00001839 0.00013534 -0.00001825 - -0.00001796 -0.00001825 0.00013559 - #*EXTRAS*# Step: 11 Bead: 22 - 0.00013524 -0.00001818 -0.00001775 - -0.00001818 0.00013537 -0.00001804 - -0.00001775 -0.00001804 0.00013563 - #*EXTRAS*# Step: 12 Bead: 22 - 0.00013526 -0.00001804 -0.00001761 - -0.00001804 0.00013539 -0.00001791 - -0.00001761 -0.00001791 0.00013566 - #*EXTRAS*# Step: 13 Bead: 22 - 0.00013528 -0.00001796 -0.00001752 - -0.00001796 0.00013541 -0.00001782 - -0.00001752 -0.00001782 0.00013568 - #*EXTRAS*# Step: 14 Bead: 22 - 0.00013528 -0.00001790 -0.00001746 - -0.00001790 0.00013542 -0.00001777 - -0.00001746 -0.00001777 0.00013569 - #*EXTRAS*# Step: 15 Bead: 22 - 0.00013529 -0.00001787 -0.00001743 - -0.00001787 0.00013542 -0.00001773 - -0.00001743 -0.00001773 0.00013570 - #*EXTRAS*# Step: 16 Bead: 22 - 0.00013529 -0.00001785 -0.00001741 - -0.00001785 0.00013542 -0.00001771 - -0.00001741 -0.00001771 0.00013571 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_23 b/drivers/py/pes/friction/frictionH/060K/inst.fric_23 deleted file mode 100644 index 220de4dcd..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_23 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 23 - 0.00012195 -0.00004344 -0.00004336 - -0.00004344 0.00012200 -0.00004347 - -0.00004336 -0.00004347 0.00012184 - #*EXTRAS*# Step: 1 Bead: 23 - 0.00012344 -0.00004260 -0.00004226 - -0.00004260 0.00012351 -0.00004269 - -0.00004226 -0.00004269 0.00012324 - #*EXTRAS*# Step: 2 Bead: 23 - 0.00012551 -0.00004086 -0.00004031 - -0.00004086 0.00012557 -0.00004096 - -0.00004031 -0.00004096 0.00012520 - #*EXTRAS*# Step: 3 Bead: 23 - 0.00012936 -0.00003616 -0.00003588 - -0.00003616 0.00012953 -0.00003619 - -0.00003588 -0.00003619 0.00012902 - #*EXTRAS*# Step: 4 Bead: 23 - 0.00013257 -0.00002969 -0.00002964 - -0.00002969 0.00013282 -0.00002964 - -0.00002964 -0.00002964 0.00013243 - #*EXTRAS*# Step: 5 Bead: 23 - 0.00013369 -0.00002589 -0.00002574 - -0.00002589 0.00013392 -0.00002579 - -0.00002574 -0.00002579 0.00013372 - #*EXTRAS*# Step: 6 Bead: 23 - 0.00013429 -0.00002324 -0.00002299 - -0.00002324 0.00013449 -0.00002312 - -0.00002299 -0.00002312 0.00013445 - #*EXTRAS*# Step: 7 Bead: 23 - 0.00013455 -0.00002196 -0.00002167 - -0.00002196 0.00013473 -0.00002184 - -0.00002167 -0.00002184 0.00013477 - #*EXTRAS*# Step: 8 Bead: 23 - 0.00013472 -0.00002108 -0.00002075 - -0.00002108 0.00013489 -0.00002095 - -0.00002075 -0.00002095 0.00013498 - #*EXTRAS*# Step: 9 Bead: 23 - 0.00013482 -0.00002054 -0.00002018 - -0.00002054 0.00013498 -0.00002041 - -0.00002018 -0.00002041 0.00013511 - #*EXTRAS*# Step: 10 Bead: 23 - 0.00013488 -0.00002018 -0.00001982 - -0.00002018 0.00013504 -0.00002005 - -0.00001982 -0.00002005 0.00013519 - #*EXTRAS*# Step: 11 Bead: 23 - 0.00013492 -0.00001996 -0.00001959 - -0.00001996 0.00013508 -0.00001983 - -0.00001959 -0.00001983 0.00013524 - #*EXTRAS*# Step: 12 Bead: 23 - 0.00013495 -0.00001982 -0.00001944 - -0.00001982 0.00013510 -0.00001968 - -0.00001944 -0.00001968 0.00013527 - #*EXTRAS*# Step: 13 Bead: 23 - 0.00013496 -0.00001972 -0.00001934 - -0.00001972 0.00013512 -0.00001959 - -0.00001934 -0.00001959 0.00013529 - #*EXTRAS*# Step: 14 Bead: 23 - 0.00013497 -0.00001966 -0.00001928 - -0.00001966 0.00013513 -0.00001953 - -0.00001928 -0.00001953 0.00013531 - #*EXTRAS*# Step: 15 Bead: 23 - 0.00013498 -0.00001963 -0.00001924 - -0.00001963 0.00013513 -0.00001949 - -0.00001924 -0.00001949 0.00013532 - #*EXTRAS*# Step: 16 Bead: 23 - 0.00013499 -0.00001960 -0.00001922 - -0.00001960 0.00013514 -0.00001947 - -0.00001922 -0.00001947 0.00013532 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_24 b/drivers/py/pes/friction/frictionH/060K/inst.fric_24 deleted file mode 100644 index 80b168f64..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_24 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 24 - 0.00012123 -0.00004375 -0.00004374 - -0.00004375 0.00012123 -0.00004372 - -0.00004374 -0.00004372 0.00012116 - #*EXTRAS*# Step: 1 Bead: 24 - 0.00012251 -0.00004316 -0.00004300 - -0.00004316 0.00012257 -0.00004322 - -0.00004300 -0.00004322 0.00012237 - #*EXTRAS*# Step: 2 Bead: 24 - 0.00012422 -0.00004202 -0.00004156 - -0.00004202 0.00012428 -0.00004212 - -0.00004156 -0.00004212 0.00012397 - #*EXTRAS*# Step: 3 Bead: 24 - 0.00012774 -0.00003839 -0.00003794 - -0.00003839 0.00012786 -0.00003845 - -0.00003794 -0.00003845 0.00012738 - #*EXTRAS*# Step: 4 Bead: 24 - 0.00013154 -0.00003227 -0.00003221 - -0.00003227 0.00013177 -0.00003225 - -0.00003221 -0.00003225 0.00013129 - #*EXTRAS*# Step: 5 Bead: 24 - 0.00013306 -0.00002819 -0.00002812 - -0.00002819 0.00013330 -0.00002812 - -0.00002812 -0.00002812 0.00013298 - #*EXTRAS*# Step: 6 Bead: 24 - 0.00013381 -0.00002539 -0.00002523 - -0.00002539 0.00013403 -0.00002529 - -0.00002523 -0.00002529 0.00013387 - #*EXTRAS*# Step: 7 Bead: 24 - 0.00013412 -0.00002402 -0.00002380 - -0.00002402 0.00013433 -0.00002391 - -0.00002380 -0.00002391 0.00013425 - #*EXTRAS*# Step: 8 Bead: 24 - 0.00013432 -0.00002307 -0.00002282 - -0.00002307 0.00013452 -0.00002296 - -0.00002282 -0.00002296 0.00013450 - #*EXTRAS*# Step: 9 Bead: 24 - 0.00013444 -0.00002249 -0.00002222 - -0.00002249 0.00013463 -0.00002237 - -0.00002222 -0.00002237 0.00013464 - #*EXTRAS*# Step: 10 Bead: 24 - 0.00013452 -0.00002212 -0.00002182 - -0.00002212 0.00013470 -0.00002199 - -0.00002182 -0.00002199 0.00013473 - #*EXTRAS*# Step: 11 Bead: 24 - 0.00013456 -0.00002188 -0.00002158 - -0.00002188 0.00013474 -0.00002175 - -0.00002158 -0.00002175 0.00013479 - #*EXTRAS*# Step: 12 Bead: 24 - 0.00013459 -0.00002172 -0.00002141 - -0.00002172 0.00013477 -0.00002160 - -0.00002141 -0.00002160 0.00013483 - #*EXTRAS*# Step: 13 Bead: 24 - 0.00013461 -0.00002162 -0.00002131 - -0.00002162 0.00013479 -0.00002150 - -0.00002131 -0.00002150 0.00013485 - #*EXTRAS*# Step: 14 Bead: 24 - 0.00013462 -0.00002156 -0.00002125 - -0.00002156 0.00013480 -0.00002143 - -0.00002125 -0.00002143 0.00013487 - #*EXTRAS*# Step: 15 Bead: 24 - 0.00013463 -0.00002152 -0.00002120 - -0.00002152 0.00013481 -0.00002139 - -0.00002120 -0.00002139 0.00013488 - #*EXTRAS*# Step: 16 Bead: 24 - 0.00013464 -0.00002149 -0.00002118 - -0.00002149 0.00013481 -0.00002137 - -0.00002118 -0.00002137 0.00013488 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_25 b/drivers/py/pes/friction/frictionH/060K/inst.fric_25 deleted file mode 100644 index 02a98e002..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_25 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 25 - 0.00012045 -0.00004404 -0.00004402 - -0.00004404 0.00012038 -0.00004393 - -0.00004402 -0.00004393 0.00012041 - #*EXTRAS*# Step: 1 Bead: 25 - 0.00012154 -0.00004362 -0.00004359 - -0.00004362 0.00012156 -0.00004362 - -0.00004359 -0.00004362 0.00012145 - #*EXTRAS*# Step: 2 Bead: 25 - 0.00012300 -0.00004288 -0.00004263 - -0.00004288 0.00012307 -0.00004296 - -0.00004263 -0.00004296 0.00012283 - #*EXTRAS*# Step: 3 Bead: 25 - 0.00012602 -0.00004035 -0.00003979 - -0.00004035 0.00012610 -0.00004044 - -0.00003979 -0.00004044 0.00012570 - #*EXTRAS*# Step: 4 Bead: 25 - 0.00013017 -0.00003488 -0.00003469 - -0.00003488 0.00013037 -0.00003489 - -0.00003469 -0.00003489 0.00012985 - #*EXTRAS*# Step: 5 Bead: 25 - 0.00013224 -0.00003060 -0.00003056 - -0.00003060 0.00013249 -0.00003055 - -0.00003056 -0.00003055 0.00013206 - #*EXTRAS*# Step: 6 Bead: 25 - 0.00013322 -0.00002766 -0.00002757 - -0.00002766 0.00013346 -0.00002758 - -0.00002757 -0.00002758 0.00013316 - #*EXTRAS*# Step: 7 Bead: 25 - 0.00013361 -0.00002619 -0.00002606 - -0.00002619 0.00013384 -0.00002610 - -0.00002606 -0.00002610 0.00013363 - #*EXTRAS*# Step: 8 Bead: 25 - 0.00013386 -0.00002519 -0.00002502 - -0.00002519 0.00013408 -0.00002509 - -0.00002502 -0.00002509 0.00013393 - #*EXTRAS*# Step: 9 Bead: 25 - 0.00013400 -0.00002458 -0.00002438 - -0.00002458 0.00013421 -0.00002447 - -0.00002438 -0.00002447 0.00013410 - #*EXTRAS*# Step: 10 Bead: 25 - 0.00013409 -0.00002418 -0.00002397 - -0.00002418 0.00013430 -0.00002407 - -0.00002397 -0.00002407 0.00013421 - #*EXTRAS*# Step: 11 Bead: 25 - 0.00013414 -0.00002392 -0.00002370 - -0.00002392 0.00013435 -0.00002381 - -0.00002370 -0.00002381 0.00013428 - #*EXTRAS*# Step: 12 Bead: 25 - 0.00013418 -0.00002376 -0.00002353 - -0.00002376 0.00013438 -0.00002364 - -0.00002353 -0.00002364 0.00013432 - #*EXTRAS*# Step: 13 Bead: 25 - 0.00013420 -0.00002365 -0.00002342 - -0.00002365 0.00013441 -0.00002354 - -0.00002342 -0.00002354 0.00013435 - #*EXTRAS*# Step: 14 Bead: 25 - 0.00013422 -0.00002358 -0.00002335 - -0.00002358 0.00013442 -0.00002347 - -0.00002335 -0.00002347 0.00013436 - #*EXTRAS*# Step: 15 Bead: 25 - 0.00013423 -0.00002354 -0.00002331 - -0.00002354 0.00013443 -0.00002343 - -0.00002331 -0.00002343 0.00013438 - #*EXTRAS*# Step: 16 Bead: 25 - 0.00013423 -0.00002351 -0.00002328 - -0.00002351 0.00013443 -0.00002340 - -0.00002328 -0.00002340 0.00013438 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_26 b/drivers/py/pes/friction/frictionH/060K/inst.fric_26 deleted file mode 100644 index f99d1947e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_26 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 26 - 0.00011962 -0.00004429 -0.00004422 - -0.00004429 0.00011945 -0.00004408 - -0.00004422 -0.00004408 0.00011960 - #*EXTRAS*# Step: 1 Bead: 26 - 0.00012048 -0.00004403 -0.00004402 - -0.00004403 0.00012041 -0.00004392 - -0.00004402 -0.00004392 0.00012043 - #*EXTRAS*# Step: 2 Bead: 26 - 0.00012177 -0.00004352 -0.00004347 - -0.00004352 0.00012181 -0.00004354 - -0.00004347 -0.00004354 0.00012167 - #*EXTRAS*# Step: 3 Bead: 26 - 0.00012438 -0.00004188 -0.00004141 - -0.00004188 0.00012444 -0.00004199 - -0.00004141 -0.00004199 0.00012412 - #*EXTRAS*# Step: 4 Bead: 26 - 0.00012851 -0.00003738 -0.00003701 - -0.00003738 0.00012865 -0.00003744 - -0.00003701 -0.00003744 0.00012815 - #*EXTRAS*# Step: 5 Bead: 26 - 0.00013115 -0.00003307 -0.00003298 - -0.00003307 0.00013138 -0.00003306 - -0.00003298 -0.00003306 0.00013088 - #*EXTRAS*# Step: 6 Bead: 26 - 0.00013245 -0.00003002 -0.00002998 - -0.00003002 0.00013270 -0.00002997 - -0.00002998 -0.00002997 0.00013230 - #*EXTRAS*# Step: 7 Bead: 26 - 0.00013297 -0.00002847 -0.00002840 - -0.00002847 0.00013322 -0.00002840 - -0.00002840 -0.00002840 0.00013288 - #*EXTRAS*# Step: 8 Bead: 26 - 0.00013328 -0.00002742 -0.00002733 - -0.00002742 0.00013352 -0.00002734 - -0.00002733 -0.00002734 0.00013324 - #*EXTRAS*# Step: 9 Bead: 26 - 0.00013346 -0.00002678 -0.00002666 - -0.00002678 0.00013369 -0.00002669 - -0.00002666 -0.00002669 0.00013345 - #*EXTRAS*# Step: 10 Bead: 26 - 0.00013357 -0.00002635 -0.00002623 - -0.00002635 0.00013380 -0.00002626 - -0.00002623 -0.00002626 0.00013358 - #*EXTRAS*# Step: 11 Bead: 26 - 0.00013364 -0.00002608 -0.00002595 - -0.00002608 0.00013387 -0.00002599 - -0.00002595 -0.00002599 0.00013366 - #*EXTRAS*# Step: 12 Bead: 26 - 0.00013368 -0.00002591 -0.00002577 - -0.00002591 0.00013391 -0.00002581 - -0.00002577 -0.00002581 0.00013372 - #*EXTRAS*# Step: 13 Bead: 26 - 0.00013371 -0.00002580 -0.00002565 - -0.00002580 0.00013394 -0.00002570 - -0.00002565 -0.00002570 0.00013375 - #*EXTRAS*# Step: 14 Bead: 26 - 0.00013373 -0.00002573 -0.00002558 - -0.00002573 0.00013395 -0.00002563 - -0.00002558 -0.00002563 0.00013377 - #*EXTRAS*# Step: 15 Bead: 26 - 0.00013374 -0.00002568 -0.00002553 - -0.00002568 0.00013396 -0.00002559 - -0.00002553 -0.00002559 0.00013378 - #*EXTRAS*# Step: 16 Bead: 26 - 0.00013375 -0.00002565 -0.00002550 - -0.00002565 0.00013397 -0.00002556 - -0.00002550 -0.00002556 0.00013379 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_27 b/drivers/py/pes/friction/frictionH/060K/inst.fric_27 deleted file mode 100644 index 20de3802f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_27 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 27 - 0.00011876 -0.00004448 -0.00004434 - -0.00004448 0.00011848 -0.00004419 - -0.00004434 -0.00004419 0.00011875 - #*EXTRAS*# Step: 1 Bead: 27 - 0.00011933 -0.00004436 -0.00004427 - -0.00004436 0.00011912 -0.00004412 - -0.00004427 -0.00004412 0.00011931 - #*EXTRAS*# Step: 2 Bead: 27 - 0.00012042 -0.00004405 -0.00004403 - -0.00004405 0.00012035 -0.00004393 - -0.00004403 -0.00004393 0.00012038 - #*EXTRAS*# Step: 3 Bead: 27 - 0.00012287 -0.00004296 -0.00004273 - -0.00004296 0.00012294 -0.00004304 - -0.00004273 -0.00004304 0.00012271 - #*EXTRAS*# Step: 4 Bead: 27 - 0.00012667 -0.00003965 -0.00003912 - -0.00003965 0.00012676 -0.00003973 - -0.00003912 -0.00003973 0.00012633 - #*EXTRAS*# Step: 5 Bead: 27 - 0.00012975 -0.00003555 -0.00003532 - -0.00003555 0.00012994 -0.00003558 - -0.00003532 -0.00003558 0.00012942 - #*EXTRAS*# Step: 6 Bead: 27 - 0.00013145 -0.00003246 -0.00003239 - -0.00003246 0.00013169 -0.00003244 - -0.00003239 -0.00003244 0.00013120 - #*EXTRAS*# Step: 7 Bead: 27 - 0.00013215 -0.00003083 -0.00003079 - -0.00003083 0.00013239 -0.00003079 - -0.00003079 -0.00003079 0.00013196 - #*EXTRAS*# Step: 8 Bead: 27 - 0.00013255 -0.00002975 -0.00002970 - -0.00002975 0.00013280 -0.00002969 - -0.00002970 -0.00002969 0.00013240 - #*EXTRAS*# Step: 9 Bead: 27 - 0.00013278 -0.00002907 -0.00002902 - -0.00002907 0.00013303 -0.00002901 - -0.00002902 -0.00002901 0.00013266 - #*EXTRAS*# Step: 10 Bead: 27 - 0.00013292 -0.00002863 -0.00002857 - -0.00002863 0.00013317 -0.00002856 - -0.00002857 -0.00002856 0.00013283 - #*EXTRAS*# Step: 11 Bead: 27 - 0.00013301 -0.00002835 -0.00002828 - -0.00002835 0.00013325 -0.00002828 - -0.00002828 -0.00002828 0.00013293 - #*EXTRAS*# Step: 12 Bead: 27 - 0.00013307 -0.00002817 -0.00002809 - -0.00002817 0.00013331 -0.00002810 - -0.00002809 -0.00002810 0.00013299 - #*EXTRAS*# Step: 13 Bead: 27 - 0.00013310 -0.00002805 -0.00002798 - -0.00002805 0.00013334 -0.00002798 - -0.00002798 -0.00002798 0.00013303 - #*EXTRAS*# Step: 14 Bead: 27 - 0.00013312 -0.00002798 -0.00002790 - -0.00002798 0.00013336 -0.00002790 - -0.00002790 -0.00002790 0.00013306 - #*EXTRAS*# Step: 15 Bead: 27 - 0.00013314 -0.00002793 -0.00002785 - -0.00002793 0.00013338 -0.00002785 - -0.00002785 -0.00002785 0.00013307 - #*EXTRAS*# Step: 16 Bead: 27 - 0.00013315 -0.00002790 -0.00002782 - -0.00002790 0.00013339 -0.00002782 - -0.00002782 -0.00002782 0.00013308 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_28 b/drivers/py/pes/friction/frictionH/060K/inst.fric_28 deleted file mode 100644 index 78161dbe4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_28 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 28 - 0.00011788 -0.00004460 -0.00004438 - -0.00004460 0.00011751 -0.00004424 - -0.00004438 -0.00004424 0.00011788 - #*EXTRAS*# Step: 1 Bead: 28 - 0.00011813 -0.00004458 -0.00004438 - -0.00004458 0.00011779 -0.00004423 - -0.00004438 -0.00004423 0.00011813 - #*EXTRAS*# Step: 2 Bead: 28 - 0.00011894 -0.00004445 -0.00004432 - -0.00004445 0.00011869 -0.00004417 - -0.00004432 -0.00004417 0.00011893 - #*EXTRAS*# Step: 3 Bead: 28 - 0.00012133 -0.00004371 -0.00004369 - -0.00004371 0.00012134 -0.00004369 - -0.00004369 -0.00004369 0.00012125 - #*EXTRAS*# Step: 4 Bead: 28 - 0.00012485 -0.00004149 -0.00004096 - -0.00004149 0.00012491 -0.00004159 - -0.00004096 -0.00004159 0.00012456 - #*EXTRAS*# Step: 5 Bead: 28 - 0.00012810 -0.00003792 -0.00003751 - -0.00003792 0.00012823 -0.00003798 - -0.00003751 -0.00003798 0.00012775 - #*EXTRAS*# Step: 6 Bead: 28 - 0.00013014 -0.00003491 -0.00003472 - -0.00003491 0.00013035 -0.00003493 - -0.00003472 -0.00003493 0.00012983 - #*EXTRAS*# Step: 7 Bead: 28 - 0.00013106 -0.00003325 -0.00003315 - -0.00003325 0.00013129 -0.00003324 - -0.00003315 -0.00003324 0.00013079 - #*EXTRAS*# Step: 8 Bead: 28 - 0.00013160 -0.00003213 -0.00003207 - -0.00003213 0.00013184 -0.00003211 - -0.00003207 -0.00003211 0.00013136 - #*EXTRAS*# Step: 9 Bead: 28 - 0.00013190 -0.00003144 -0.00003139 - -0.00003144 0.00013215 -0.00003141 - -0.00003139 -0.00003141 0.00013169 - #*EXTRAS*# Step: 10 Bead: 28 - 0.00013209 -0.00003099 -0.00003094 - -0.00003099 0.00013233 -0.00003095 - -0.00003094 -0.00003095 0.00013189 - #*EXTRAS*# Step: 11 Bead: 28 - 0.00013220 -0.00003070 -0.00003065 - -0.00003070 0.00013245 -0.00003065 - -0.00003065 -0.00003065 0.00013201 - #*EXTRAS*# Step: 12 Bead: 28 - 0.00013227 -0.00003051 -0.00003047 - -0.00003051 0.00013252 -0.00003046 - -0.00003047 -0.00003046 0.00013209 - #*EXTRAS*# Step: 13 Bead: 28 - 0.00013232 -0.00003039 -0.00003035 - -0.00003039 0.00013257 -0.00003034 - -0.00003035 -0.00003034 0.00013214 - #*EXTRAS*# Step: 14 Bead: 28 - 0.00013235 -0.00003031 -0.00003027 - -0.00003031 0.00013260 -0.00003026 - -0.00003027 -0.00003026 0.00013218 - #*EXTRAS*# Step: 15 Bead: 28 - 0.00013237 -0.00003026 -0.00003022 - -0.00003026 0.00013261 -0.00003021 - -0.00003022 -0.00003021 0.00013220 - #*EXTRAS*# Step: 16 Bead: 28 - 0.00013238 -0.00003023 -0.00003019 - -0.00003023 0.00013263 -0.00003018 - -0.00003019 -0.00003018 0.00013221 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_29 b/drivers/py/pes/friction/frictionH/060K/inst.fric_29 deleted file mode 100644 index 9429b69e8..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_29 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 29 - 0.00011700 -0.00004463 -0.00004435 - -0.00004463 0.00011658 -0.00004423 - -0.00004435 -0.00004423 0.00011701 - #*EXTRAS*# Step: 1 Bead: 29 - 0.00011693 -0.00004463 -0.00004434 - -0.00004463 0.00011651 -0.00004422 - -0.00004434 -0.00004422 0.00011694 - #*EXTRAS*# Step: 2 Bead: 29 - 0.00011741 -0.00004463 -0.00004437 - -0.00004463 0.00011701 -0.00004424 - -0.00004437 -0.00004424 0.00011742 - #*EXTRAS*# Step: 3 Bead: 29 - 0.00011959 -0.00004430 -0.00004423 - -0.00004430 0.00011941 -0.00004409 - -0.00004423 -0.00004409 0.00011957 - #*EXTRAS*# Step: 4 Bead: 29 - 0.00012318 -0.00004277 -0.00004248 - -0.00004277 0.00012325 -0.00004286 - -0.00004248 -0.00004286 0.00012299 - #*EXTRAS*# Step: 5 Bead: 29 - 0.00012631 -0.00004004 -0.00003950 - -0.00004004 0.00012639 -0.00004013 - -0.00003950 -0.00004013 0.00012598 - #*EXTRAS*# Step: 6 Bead: 29 - 0.00012857 -0.00003729 -0.00003693 - -0.00003729 0.00012872 -0.00003735 - -0.00003693 -0.00003735 0.00012822 - #*EXTRAS*# Step: 7 Bead: 29 - 0.00012969 -0.00003566 -0.00003542 - -0.00003566 0.00012987 -0.00003568 - -0.00003542 -0.00003568 0.00012935 - #*EXTRAS*# Step: 8 Bead: 29 - 0.00013036 -0.00003455 -0.00003438 - -0.00003455 0.00013057 -0.00003456 - -0.00003438 -0.00003456 0.00013005 - #*EXTRAS*# Step: 9 Bead: 29 - 0.00013075 -0.00003385 -0.00003372 - -0.00003385 0.00013097 -0.00003385 - -0.00003372 -0.00003385 0.00013046 - #*EXTRAS*# Step: 10 Bead: 29 - 0.00013099 -0.00003339 -0.00003328 - -0.00003339 0.00013122 -0.00003338 - -0.00003328 -0.00003338 0.00013071 - #*EXTRAS*# Step: 11 Bead: 29 - 0.00013114 -0.00003309 -0.00003300 - -0.00003309 0.00013137 -0.00003308 - -0.00003300 -0.00003308 0.00013087 - #*EXTRAS*# Step: 12 Bead: 29 - 0.00013124 -0.00003290 -0.00003282 - -0.00003290 0.00013147 -0.00003289 - -0.00003282 -0.00003289 0.00013097 - #*EXTRAS*# Step: 13 Bead: 29 - 0.00013130 -0.00003278 -0.00003270 - -0.00003278 0.00013153 -0.00003277 - -0.00003270 -0.00003277 0.00013103 - #*EXTRAS*# Step: 14 Bead: 29 - 0.00013133 -0.00003270 -0.00003262 - -0.00003270 0.00013157 -0.00003269 - -0.00003262 -0.00003269 0.00013107 - #*EXTRAS*# Step: 15 Bead: 29 - 0.00013136 -0.00003265 -0.00003258 - -0.00003265 0.00013159 -0.00003263 - -0.00003258 -0.00003263 0.00013110 - #*EXTRAS*# Step: 16 Bead: 29 - 0.00013137 -0.00003262 -0.00003254 - -0.00003262 0.00013161 -0.00003260 - -0.00003254 -0.00003260 0.00013112 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_30 b/drivers/py/pes/friction/frictionH/060K/inst.fric_30 deleted file mode 100644 index 8fded9a4f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_30 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 30 - 0.00011614 -0.00004454 -0.00004426 - -0.00004454 0.00011572 -0.00004416 - -0.00004426 -0.00004416 0.00011615 - #*EXTRAS*# Step: 1 Bead: 30 - 0.00011576 -0.00004447 -0.00004420 - -0.00004447 0.00011536 -0.00004411 - -0.00004420 -0.00004411 0.00011578 - #*EXTRAS*# Step: 2 Bead: 30 - 0.00011591 -0.00004450 -0.00004422 - -0.00004450 0.00011550 -0.00004413 - -0.00004422 -0.00004413 0.00011593 - #*EXTRAS*# Step: 3 Bead: 30 - 0.00011772 -0.00004462 -0.00004438 - -0.00004462 0.00011734 -0.00004424 - -0.00004438 -0.00004424 0.00011772 - #*EXTRAS*# Step: 4 Bead: 30 - 0.00012152 -0.00004363 -0.00004360 - -0.00004363 0.00012155 -0.00004363 - -0.00004360 -0.00004363 0.00012144 - #*EXTRAS*# Step: 5 Bead: 30 - 0.00012456 -0.00004173 -0.00004123 - -0.00004173 0.00012462 -0.00004184 - -0.00004123 -0.00004184 0.00012429 - #*EXTRAS*# Step: 6 Bead: 30 - 0.00012683 -0.00003947 -0.00003895 - -0.00003947 0.00012692 -0.00003955 - -0.00003895 -0.00003955 0.00012648 - #*EXTRAS*# Step: 7 Bead: 30 - 0.00012808 -0.00003796 -0.00003754 - -0.00003796 0.00012821 -0.00003802 - -0.00003754 -0.00003802 0.00012772 - #*EXTRAS*# Step: 8 Bead: 30 - 0.00012885 -0.00003690 -0.00003657 - -0.00003690 0.00012901 -0.00003695 - -0.00003657 -0.00003695 0.00012850 - #*EXTRAS*# Step: 9 Bead: 30 - 0.00012932 -0.00003623 -0.00003594 - -0.00003623 0.00012949 -0.00003626 - -0.00003594 -0.00003626 0.00012898 - #*EXTRAS*# Step: 10 Bead: 30 - 0.00012961 -0.00003578 -0.00003553 - -0.00003578 0.00012979 -0.00003580 - -0.00003553 -0.00003580 0.00012928 - #*EXTRAS*# Step: 11 Bead: 30 - 0.00012979 -0.00003549 -0.00003526 - -0.00003549 0.00012998 -0.00003551 - -0.00003526 -0.00003551 0.00012946 - #*EXTRAS*# Step: 12 Bead: 30 - 0.00012991 -0.00003530 -0.00003509 - -0.00003530 0.00013010 -0.00003532 - -0.00003509 -0.00003532 0.00012958 - #*EXTRAS*# Step: 13 Bead: 30 - 0.00012998 -0.00003518 -0.00003497 - -0.00003518 0.00013018 -0.00003520 - -0.00003497 -0.00003520 0.00012966 - #*EXTRAS*# Step: 14 Bead: 30 - 0.00013003 -0.00003510 -0.00003490 - -0.00003510 0.00013023 -0.00003512 - -0.00003490 -0.00003512 0.00012971 - #*EXTRAS*# Step: 15 Bead: 30 - 0.00013006 -0.00003505 -0.00003485 - -0.00003505 0.00013026 -0.00003507 - -0.00003485 -0.00003507 0.00012974 - #*EXTRAS*# Step: 16 Bead: 30 - 0.00013008 -0.00003502 -0.00003482 - -0.00003502 0.00013028 -0.00003504 - -0.00003482 -0.00003504 0.00012976 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_31 b/drivers/py/pes/friction/frictionH/060K/inst.fric_31 deleted file mode 100644 index 0f5a66aa2..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_31 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 31 - 0.00011529 -0.00004435 -0.00004411 - -0.00004435 0.00011492 -0.00004403 - -0.00004411 -0.00004403 0.00011532 - #*EXTRAS*# Step: 1 Bead: 31 - 0.00011463 -0.00004414 -0.00004394 - -0.00004414 0.00011432 -0.00004389 - -0.00004394 -0.00004389 0.00011466 - #*EXTRAS*# Step: 2 Bead: 31 - 0.00011447 -0.00004408 -0.00004390 - -0.00004408 0.00011418 -0.00004385 - -0.00004390 -0.00004385 0.00011451 - #*EXTRAS*# Step: 3 Bead: 31 - 0.00011588 -0.00004449 -0.00004422 - -0.00004449 0.00011547 -0.00004413 - -0.00004422 -0.00004413 0.00011589 - #*EXTRAS*# Step: 4 Bead: 31 - 0.00011966 -0.00004428 -0.00004422 - -0.00004428 0.00011949 -0.00004408 - -0.00004422 -0.00004408 0.00011963 - #*EXTRAS*# Step: 5 Bead: 31 - 0.00012296 -0.00004291 -0.00004267 - -0.00004291 0.00012302 -0.00004299 - -0.00004267 -0.00004299 0.00012278 - #*EXTRAS*# Step: 6 Bead: 31 - 0.00012507 -0.00004128 -0.00004074 - -0.00004128 0.00012513 -0.00004138 - -0.00004074 -0.00004138 0.00012478 - #*EXTRAS*# Step: 7 Bead: 31 - 0.00012634 -0.00004001 -0.00003947 - -0.00004001 0.00012642 -0.00004010 - -0.00003947 -0.00004010 0.00012601 - #*EXTRAS*# Step: 8 Bead: 31 - 0.00012717 -0.00003908 -0.00003859 - -0.00003908 0.00012727 -0.00003916 - -0.00003859 -0.00003916 0.00012682 - #*EXTRAS*# Step: 9 Bead: 31 - 0.00012768 -0.00003846 -0.00003801 - -0.00003846 0.00012779 -0.00003853 - -0.00003801 -0.00003853 0.00012732 - #*EXTRAS*# Step: 10 Bead: 31 - 0.00012800 -0.00003805 -0.00003763 - -0.00003805 0.00012813 -0.00003811 - -0.00003763 -0.00003811 0.00012765 - #*EXTRAS*# Step: 11 Bead: 31 - 0.00012821 -0.00003778 -0.00003738 - -0.00003778 0.00012835 -0.00003784 - -0.00003738 -0.00003784 0.00012786 - #*EXTRAS*# Step: 12 Bead: 31 - 0.00012834 -0.00003760 -0.00003721 - -0.00003760 0.00012848 -0.00003766 - -0.00003721 -0.00003766 0.00012799 - #*EXTRAS*# Step: 13 Bead: 31 - 0.00012843 -0.00003749 -0.00003711 - -0.00003749 0.00012857 -0.00003754 - -0.00003711 -0.00003754 0.00012808 - #*EXTRAS*# Step: 14 Bead: 31 - 0.00012848 -0.00003742 -0.00003704 - -0.00003742 0.00012863 -0.00003747 - -0.00003704 -0.00003747 0.00012813 - #*EXTRAS*# Step: 15 Bead: 31 - 0.00012852 -0.00003737 -0.00003700 - -0.00003737 0.00012866 -0.00003742 - -0.00003700 -0.00003742 0.00012817 - #*EXTRAS*# Step: 16 Bead: 31 - 0.00012854 -0.00003734 -0.00003697 - -0.00003734 0.00012868 -0.00003739 - -0.00003697 -0.00003739 0.00012819 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_32 b/drivers/py/pes/friction/frictionH/060K/inst.fric_32 deleted file mode 100644 index 283e398a1..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_32 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 32 - 0.00011447 -0.00004408 -0.00004390 - -0.00004408 0.00011418 -0.00004385 - -0.00004390 -0.00004385 0.00011451 - #*EXTRAS*# Step: 1 Bead: 32 - 0.00011355 -0.00004368 -0.00004359 - -0.00004368 0.00011336 -0.00004356 - -0.00004359 -0.00004356 0.00011359 - #*EXTRAS*# Step: 2 Bead: 32 - 0.00011311 -0.00004346 -0.00004341 - -0.00004346 0.00011296 -0.00004339 - -0.00004341 -0.00004339 0.00011316 - #*EXTRAS*# Step: 3 Bead: 32 - 0.00011412 -0.00004394 -0.00004379 - -0.00004394 0.00011386 -0.00004375 - -0.00004379 -0.00004375 0.00011416 - #*EXTRAS*# Step: 4 Bead: 32 - 0.00011763 -0.00004462 -0.00004438 - -0.00004462 0.00011725 -0.00004424 - -0.00004438 -0.00004424 0.00011764 - #*EXTRAS*# Step: 5 Bead: 32 - 0.00012132 -0.00004371 -0.00004370 - -0.00004371 0.00012133 -0.00004369 - -0.00004370 -0.00004369 0.00012124 - #*EXTRAS*# Step: 6 Bead: 32 - 0.00012345 -0.00004259 -0.00004225 - -0.00004259 0.00012352 -0.00004268 - -0.00004225 -0.00004268 0.00012325 - #*EXTRAS*# Step: 7 Bead: 32 - 0.00012464 -0.00004167 -0.00004116 - -0.00004167 0.00012470 -0.00004177 - -0.00004116 -0.00004177 0.00012437 - #*EXTRAS*# Step: 8 Bead: 32 - 0.00012543 -0.00004094 -0.00004038 - -0.00004094 0.00012550 -0.00004104 - -0.00004038 -0.00004104 0.00012513 - #*EXTRAS*# Step: 9 Bead: 32 - 0.00012595 -0.00004043 -0.00003987 - -0.00004043 0.00012602 -0.00004052 - -0.00003987 -0.00004052 0.00012562 - #*EXTRAS*# Step: 10 Bead: 32 - 0.00012628 -0.00004007 -0.00003953 - -0.00004007 0.00012636 -0.00004016 - -0.00003953 -0.00004016 0.00012595 - #*EXTRAS*# Step: 11 Bead: 32 - 0.00012650 -0.00003984 -0.00003930 - -0.00003984 0.00012658 -0.00003993 - -0.00003930 -0.00003993 0.00012616 - #*EXTRAS*# Step: 12 Bead: 32 - 0.00012664 -0.00003969 -0.00003916 - -0.00003969 0.00012672 -0.00003977 - -0.00003916 -0.00003977 0.00012630 - #*EXTRAS*# Step: 13 Bead: 32 - 0.00012672 -0.00003959 -0.00003906 - -0.00003959 0.00012681 -0.00003967 - -0.00003906 -0.00003967 0.00012638 - #*EXTRAS*# Step: 14 Bead: 32 - 0.00012678 -0.00003952 -0.00003900 - -0.00003952 0.00012687 -0.00003961 - -0.00003900 -0.00003961 0.00012644 - #*EXTRAS*# Step: 15 Bead: 32 - 0.00012682 -0.00003948 -0.00003896 - -0.00003948 0.00012691 -0.00003956 - -0.00003896 -0.00003956 0.00012647 - #*EXTRAS*# Step: 16 Bead: 32 - 0.00012684 -0.00003946 -0.00003894 - -0.00003946 0.00012693 -0.00003954 - -0.00003894 -0.00003954 0.00012650 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_33 b/drivers/py/pes/friction/frictionH/060K/inst.fric_33 deleted file mode 100644 index 2e2015433..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_33 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 33 - 0.00011368 -0.00004374 -0.00004364 - -0.00004374 0.00011347 -0.00004360 - -0.00004364 -0.00004360 0.00011372 - #*EXTRAS*# Step: 1 Bead: 33 - 0.00011251 -0.00004314 -0.00004315 - -0.00004314 0.00011243 -0.00004313 - -0.00004315 -0.00004313 0.00011257 - #*EXTRAS*# Step: 2 Bead: 33 - 0.00011181 -0.00004273 -0.00004279 - -0.00004273 0.00011178 -0.00004277 - -0.00004279 -0.00004277 0.00011187 - #*EXTRAS*# Step: 3 Bead: 33 - 0.00011247 -0.00004312 -0.00004313 - -0.00004312 0.00011239 -0.00004311 - -0.00004313 -0.00004311 0.00011252 - #*EXTRAS*# Step: 4 Bead: 33 - 0.00011564 -0.00004444 -0.00004417 - -0.00004444 0.00011524 -0.00004409 - -0.00004417 -0.00004409 0.00011566 - #*EXTRAS*# Step: 5 Bead: 33 - 0.00011947 -0.00004433 -0.00004425 - -0.00004433 0.00011927 -0.00004411 - -0.00004425 -0.00004411 0.00011945 - #*EXTRAS*# Step: 6 Bead: 33 - 0.00012188 -0.00004348 -0.00004341 - -0.00004348 0.00012192 -0.00004350 - -0.00004341 -0.00004350 0.00012177 - #*EXTRAS*# Step: 7 Bead: 33 - 0.00012308 -0.00004283 -0.00004257 - -0.00004283 0.00012315 -0.00004292 - -0.00004257 -0.00004292 0.00012290 - #*EXTRAS*# Step: 8 Bead: 33 - 0.00012382 -0.00004233 -0.00004193 - -0.00004233 0.00012389 -0.00004242 - -0.00004193 -0.00004242 0.00012359 - #*EXTRAS*# Step: 9 Bead: 33 - 0.00012429 -0.00004196 -0.00004149 - -0.00004196 0.00012435 -0.00004206 - -0.00004149 -0.00004206 0.00012404 - #*EXTRAS*# Step: 10 Bead: 33 - 0.00012460 -0.00004170 -0.00004120 - -0.00004170 0.00012466 -0.00004180 - -0.00004120 -0.00004180 0.00012433 - #*EXTRAS*# Step: 11 Bead: 33 - 0.00012480 -0.00004152 -0.00004100 - -0.00004152 0.00012486 -0.00004162 - -0.00004100 -0.00004162 0.00012452 - #*EXTRAS*# Step: 12 Bead: 33 - 0.00012493 -0.00004141 -0.00004087 - -0.00004141 0.00012499 -0.00004151 - -0.00004087 -0.00004151 0.00012465 - #*EXTRAS*# Step: 13 Bead: 33 - 0.00012502 -0.00004133 -0.00004079 - -0.00004133 0.00012508 -0.00004143 - -0.00004079 -0.00004143 0.00012473 - #*EXTRAS*# Step: 14 Bead: 33 - 0.00012507 -0.00004128 -0.00004074 - -0.00004128 0.00012513 -0.00004138 - -0.00004074 -0.00004138 0.00012478 - #*EXTRAS*# Step: 15 Bead: 33 - 0.00012511 -0.00004125 -0.00004070 - -0.00004125 0.00012517 -0.00004135 - -0.00004070 -0.00004135 0.00012481 - #*EXTRAS*# Step: 16 Bead: 33 - 0.00012513 -0.00004123 -0.00004068 - -0.00004123 0.00012519 -0.00004133 - -0.00004068 -0.00004133 0.00012483 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_34 b/drivers/py/pes/friction/frictionH/060K/inst.fric_34 deleted file mode 100644 index da57776c1..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_34 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 34 - 0.00011291 -0.00004336 -0.00004333 - -0.00004336 0.00011279 -0.00004331 - -0.00004333 -0.00004331 0.00011296 - #*EXTRAS*# Step: 1 Bead: 34 - 0.00011152 -0.00004256 -0.00004262 - -0.00004256 0.00011151 -0.00004260 - -0.00004262 -0.00004260 0.00011159 - #*EXTRAS*# Step: 2 Bead: 34 - 0.00011057 -0.00004195 -0.00004203 - -0.00004195 0.00011060 -0.00004201 - -0.00004203 -0.00004201 0.00011065 - #*EXTRAS*# Step: 3 Bead: 34 - 0.00011091 -0.00004217 -0.00004225 - -0.00004217 0.00011092 -0.00004223 - -0.00004225 -0.00004223 0.00011098 - #*EXTRAS*# Step: 4 Bead: 34 - 0.00011376 -0.00004378 -0.00004367 - -0.00004378 0.00011354 -0.00004363 - -0.00004367 -0.00004363 0.00011380 - #*EXTRAS*# Step: 5 Bead: 34 - 0.00011748 -0.00004463 -0.00004437 - -0.00004463 0.00011708 -0.00004424 - -0.00004437 -0.00004424 0.00011748 - #*EXTRAS*# Step: 6 Bead: 34 - 0.00012013 -0.00004414 -0.00004411 - -0.00004414 0.00012002 -0.00004399 - -0.00004411 -0.00004399 0.00012009 - #*EXTRAS*# Step: 7 Bead: 34 - 0.00012151 -0.00004364 -0.00004360 - -0.00004364 0.00012154 -0.00004363 - -0.00004360 -0.00004363 0.00012143 - #*EXTRAS*# Step: 8 Bead: 34 - 0.00012229 -0.00004328 -0.00004315 - -0.00004328 0.00012235 -0.00004333 - -0.00004315 -0.00004333 0.00012216 - #*EXTRAS*# Step: 9 Bead: 34 - 0.00012276 -0.00004302 -0.00004282 - -0.00004302 0.00012283 -0.00004310 - -0.00004282 -0.00004310 0.00012260 - #*EXTRAS*# Step: 10 Bead: 34 - 0.00012306 -0.00004284 -0.00004258 - -0.00004284 0.00012313 -0.00004293 - -0.00004258 -0.00004293 0.00012288 - #*EXTRAS*# Step: 11 Bead: 34 - 0.00012325 -0.00004272 -0.00004243 - -0.00004272 0.00012332 -0.00004281 - -0.00004243 -0.00004281 0.00012306 - #*EXTRAS*# Step: 12 Bead: 34 - 0.00012337 -0.00004264 -0.00004232 - -0.00004264 0.00012344 -0.00004273 - -0.00004232 -0.00004273 0.00012317 - #*EXTRAS*# Step: 13 Bead: 34 - 0.00012345 -0.00004259 -0.00004226 - -0.00004259 0.00012352 -0.00004268 - -0.00004226 -0.00004268 0.00012325 - #*EXTRAS*# Step: 14 Bead: 34 - 0.00012350 -0.00004255 -0.00004221 - -0.00004255 0.00012357 -0.00004265 - -0.00004221 -0.00004265 0.00012329 - #*EXTRAS*# Step: 15 Bead: 34 - 0.00012353 -0.00004253 -0.00004218 - -0.00004253 0.00012360 -0.00004263 - -0.00004218 -0.00004263 0.00012332 - #*EXTRAS*# Step: 16 Bead: 34 - 0.00012355 -0.00004252 -0.00004217 - -0.00004252 0.00012362 -0.00004261 - -0.00004217 -0.00004261 0.00012334 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_35 b/drivers/py/pes/friction/frictionH/060K/inst.fric_35 deleted file mode 100644 index 3c7ab39c0..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_35 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 35 - 0.00011217 -0.00004295 -0.00004298 - -0.00004295 0.00011212 -0.00004296 - -0.00004298 -0.00004296 0.00011223 - #*EXTRAS*# Step: 1 Bead: 35 - 0.00011057 -0.00004195 -0.00004203 - -0.00004195 0.00011059 -0.00004200 - -0.00004203 -0.00004200 0.00011065 - #*EXTRAS*# Step: 2 Bead: 35 - 0.00010940 -0.00004112 -0.00004118 - -0.00004112 0.00010942 -0.00004115 - -0.00004118 -0.00004115 0.00010947 - #*EXTRAS*# Step: 3 Bead: 35 - 0.00010943 -0.00004114 -0.00004120 - -0.00004114 0.00010945 -0.00004118 - -0.00004120 -0.00004118 0.00010950 - #*EXTRAS*# Step: 4 Bead: 35 - 0.00011199 -0.00004284 -0.00004288 - -0.00004284 0.00011195 -0.00004287 - -0.00004288 -0.00004287 0.00011205 - #*EXTRAS*# Step: 5 Bead: 35 - 0.00011553 -0.00004442 -0.00004415 - -0.00004442 0.00011514 -0.00004407 - -0.00004415 -0.00004407 0.00011555 - #*EXTRAS*# Step: 6 Bead: 35 - 0.00011819 -0.00004457 -0.00004437 - -0.00004457 0.00011785 -0.00004422 - -0.00004437 -0.00004422 0.00011819 - #*EXTRAS*# Step: 7 Bead: 35 - 0.00011974 -0.00004425 -0.00004420 - -0.00004425 0.00011959 -0.00004406 - -0.00004420 -0.00004406 0.00011972 - #*EXTRAS*# Step: 8 Bead: 35 - 0.00012065 -0.00004397 -0.00004396 - -0.00004397 0.00012059 -0.00004388 - -0.00004396 -0.00004388 0.00012060 - #*EXTRAS*# Step: 9 Bead: 35 - 0.00012118 -0.00004377 -0.00004376 - -0.00004377 0.00012118 -0.00004374 - -0.00004376 -0.00004374 0.00012111 - #*EXTRAS*# Step: 10 Bead: 35 - 0.00012151 -0.00004364 -0.00004361 - -0.00004364 0.00012153 -0.00004363 - -0.00004361 -0.00004363 0.00012142 - #*EXTRAS*# Step: 11 Bead: 35 - 0.00012171 -0.00004355 -0.00004350 - -0.00004355 0.00012175 -0.00004356 - -0.00004350 -0.00004356 0.00012161 - #*EXTRAS*# Step: 12 Bead: 35 - 0.00012184 -0.00004349 -0.00004343 - -0.00004349 0.00012188 -0.00004351 - -0.00004343 -0.00004351 0.00012174 - #*EXTRAS*# Step: 13 Bead: 35 - 0.00012192 -0.00004345 -0.00004338 - -0.00004345 0.00012197 -0.00004348 - -0.00004338 -0.00004348 0.00012181 - #*EXTRAS*# Step: 14 Bead: 35 - 0.00012198 -0.00004343 -0.00004335 - -0.00004343 0.00012202 -0.00004346 - -0.00004335 -0.00004346 0.00012186 - #*EXTRAS*# Step: 15 Bead: 35 - 0.00012201 -0.00004341 -0.00004333 - -0.00004341 0.00012206 -0.00004345 - -0.00004333 -0.00004345 0.00012190 - #*EXTRAS*# Step: 16 Bead: 35 - 0.00012203 -0.00004340 -0.00004332 - -0.00004340 0.00012208 -0.00004344 - -0.00004332 -0.00004344 0.00012192 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_36 b/drivers/py/pes/friction/frictionH/060K/inst.fric_36 deleted file mode 100644 index a055dde38..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_36 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 36 - 0.00011145 -0.00004252 -0.00004258 - -0.00004252 0.00011145 -0.00004256 - -0.00004258 -0.00004256 0.00011152 - #*EXTRAS*# Step: 1 Bead: 36 - 0.00010967 -0.00004132 -0.00004138 - -0.00004132 0.00010969 -0.00004135 - -0.00004138 -0.00004135 0.00010974 - #*EXTRAS*# Step: 2 Bead: 36 - 0.00010829 -0.00004024 -0.00004025 - -0.00004024 0.00010829 -0.00004024 - -0.00004025 -0.00004024 0.00010833 - #*EXTRAS*# Step: 3 Bead: 36 - 0.00010803 -0.00004002 -0.00004003 - -0.00004002 0.00010804 -0.00004003 - -0.00004003 -0.00004003 0.00010806 - #*EXTRAS*# Step: 4 Bead: 36 - 0.00011033 -0.00004179 -0.00004187 - -0.00004179 0.00011035 -0.00004184 - -0.00004187 -0.00004184 0.00011041 - #*EXTRAS*# Step: 5 Bead: 36 - 0.00011369 -0.00004375 -0.00004364 - -0.00004375 0.00011348 -0.00004361 - -0.00004364 -0.00004361 0.00011373 - #*EXTRAS*# Step: 6 Bead: 36 - 0.00011624 -0.00004456 -0.00004427 - -0.00004456 0.00011582 -0.00004417 - -0.00004427 -0.00004417 0.00011625 - #*EXTRAS*# Step: 7 Bead: 36 - 0.00011782 -0.00004461 -0.00004438 - -0.00004461 0.00011745 -0.00004424 - -0.00004438 -0.00004424 0.00011782 - #*EXTRAS*# Step: 8 Bead: 36 - 0.00011879 -0.00004448 -0.00004434 - -0.00004448 0.00011852 -0.00004418 - -0.00004434 -0.00004418 0.00011878 - #*EXTRAS*# Step: 9 Bead: 36 - 0.00011939 -0.00004435 -0.00004426 - -0.00004435 0.00011918 -0.00004412 - -0.00004426 -0.00004412 0.00011937 - #*EXTRAS*# Step: 10 Bead: 36 - 0.00011976 -0.00004425 -0.00004420 - -0.00004425 0.00011960 -0.00004406 - -0.00004420 -0.00004406 0.00011973 - #*EXTRAS*# Step: 11 Bead: 36 - 0.00011999 -0.00004418 -0.00004415 - -0.00004418 0.00011987 -0.00004402 - -0.00004415 -0.00004402 0.00011996 - #*EXTRAS*# Step: 12 Bead: 36 - 0.00012014 -0.00004414 -0.00004411 - -0.00004414 0.00012003 -0.00004399 - -0.00004411 -0.00004399 0.00012011 - #*EXTRAS*# Step: 13 Bead: 36 - 0.00012024 -0.00004411 -0.00004409 - -0.00004411 0.00012014 -0.00004397 - -0.00004409 -0.00004397 0.00012020 - #*EXTRAS*# Step: 14 Bead: 36 - 0.00012030 -0.00004409 -0.00004407 - -0.00004409 0.00012021 -0.00004396 - -0.00004407 -0.00004396 0.00012026 - #*EXTRAS*# Step: 15 Bead: 36 - 0.00012034 -0.00004407 -0.00004406 - -0.00004407 0.00012025 -0.00004395 - -0.00004406 -0.00004395 0.00012030 - #*EXTRAS*# Step: 16 Bead: 36 - 0.00012036 -0.00004407 -0.00004405 - -0.00004407 0.00012028 -0.00004395 - -0.00004405 -0.00004395 0.00012032 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_37 b/drivers/py/pes/friction/frictionH/060K/inst.fric_37 deleted file mode 100644 index b2372b603..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_37 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 37 - 0.00011076 -0.00004208 -0.00004216 - -0.00004208 0.00011078 -0.00004213 - -0.00004216 -0.00004213 0.00011084 - #*EXTRAS*# Step: 1 Bead: 37 - 0.00010880 -0.00004066 -0.00004070 - -0.00004066 0.00010882 -0.00004067 - -0.00004070 -0.00004067 0.00010886 - #*EXTRAS*# Step: 2 Bead: 37 - 0.00010723 -0.00003930 -0.00003928 - -0.00003930 0.00010722 -0.00003931 - -0.00003928 -0.00003931 0.00010720 - #*EXTRAS*# Step: 3 Bead: 37 - 0.00010671 -0.00003881 -0.00003878 - -0.00003881 0.00010670 -0.00003884 - -0.00003878 -0.00003884 0.00010664 - #*EXTRAS*# Step: 4 Bead: 37 - 0.00010877 -0.00004063 -0.00004067 - -0.00004063 0.00010878 -0.00004064 - -0.00004067 -0.00004064 0.00010882 - #*EXTRAS*# Step: 5 Bead: 37 - 0.00011196 -0.00004282 -0.00004287 - -0.00004282 0.00011193 -0.00004285 - -0.00004287 -0.00004285 0.00011202 - #*EXTRAS*# Step: 6 Bead: 37 - 0.00011438 -0.00004405 -0.00004387 - -0.00004405 0.00011409 -0.00004382 - -0.00004387 -0.00004382 0.00011441 - #*EXTRAS*# Step: 7 Bead: 37 - 0.00011592 -0.00004450 -0.00004422 - -0.00004450 0.00011551 -0.00004413 - -0.00004422 -0.00004413 0.00011593 - #*EXTRAS*# Step: 8 Bead: 37 - 0.00011687 -0.00004462 -0.00004434 - -0.00004462 0.00011645 -0.00004422 - -0.00004434 -0.00004422 0.00011688 - #*EXTRAS*# Step: 9 Bead: 37 - 0.00011748 -0.00004463 -0.00004437 - -0.00004463 0.00011708 -0.00004424 - -0.00004437 -0.00004424 0.00011748 - #*EXTRAS*# Step: 10 Bead: 37 - 0.00011786 -0.00004461 -0.00004438 - -0.00004461 0.00011750 -0.00004424 - -0.00004438 -0.00004424 0.00011786 - #*EXTRAS*# Step: 11 Bead: 37 - 0.00011811 -0.00004458 -0.00004438 - -0.00004458 0.00011776 -0.00004423 - -0.00004438 -0.00004423 0.00011811 - #*EXTRAS*# Step: 12 Bead: 37 - 0.00011827 -0.00004456 -0.00004437 - -0.00004456 0.00011794 -0.00004422 - -0.00004437 -0.00004422 0.00011827 - #*EXTRAS*# Step: 13 Bead: 37 - 0.00011837 -0.00004455 -0.00004437 - -0.00004455 0.00011805 -0.00004422 - -0.00004437 -0.00004422 0.00011837 - #*EXTRAS*# Step: 14 Bead: 37 - 0.00011843 -0.00004454 -0.00004436 - -0.00004454 0.00011812 -0.00004421 - -0.00004436 -0.00004421 0.00011843 - #*EXTRAS*# Step: 15 Bead: 37 - 0.00011848 -0.00004453 -0.00004436 - -0.00004453 0.00011817 -0.00004421 - -0.00004436 -0.00004421 0.00011847 - #*EXTRAS*# Step: 16 Bead: 37 - 0.00011850 -0.00004453 -0.00004436 - -0.00004453 0.00011820 -0.00004421 - -0.00004436 -0.00004421 0.00011850 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_38 b/drivers/py/pes/friction/frictionH/060K/inst.fric_38 deleted file mode 100644 index 358673c0d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_38 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 38 - 0.00011010 -0.00004163 -0.00004170 - -0.00004163 0.00011012 -0.00004168 - -0.00004170 -0.00004168 0.00011018 - #*EXTRAS*# Step: 1 Bead: 38 - 0.00010798 -0.00003998 -0.00003998 - -0.00003998 0.00010798 -0.00003998 - -0.00003998 -0.00003998 0.00010800 - #*EXTRAS*# Step: 2 Bead: 38 - 0.00010623 -0.00003833 -0.00003828 - -0.00003833 0.00010622 -0.00003838 - -0.00003828 -0.00003838 0.00010611 - #*EXTRAS*# Step: 3 Bead: 38 - 0.00010548 -0.00003754 -0.00003748 - -0.00003754 0.00010548 -0.00003763 - -0.00003748 -0.00003763 0.00010529 - #*EXTRAS*# Step: 4 Bead: 38 - 0.00010729 -0.00003936 -0.00003934 - -0.00003936 0.00010728 -0.00003937 - -0.00003934 -0.00003937 0.00010727 - #*EXTRAS*# Step: 5 Bead: 38 - 0.00011034 -0.00004180 -0.00004187 - -0.00004180 0.00011037 -0.00004185 - -0.00004187 -0.00004185 0.00011042 - #*EXTRAS*# Step: 6 Bead: 38 - 0.00011263 -0.00004321 -0.00004320 - -0.00004321 0.00011254 -0.00004318 - -0.00004320 -0.00004318 0.00011268 - #*EXTRAS*# Step: 7 Bead: 38 - 0.00011411 -0.00004393 -0.00004379 - -0.00004393 0.00011385 -0.00004374 - -0.00004379 -0.00004374 0.00011415 - #*EXTRAS*# Step: 8 Bead: 38 - 0.00011502 -0.00004427 -0.00004404 - -0.00004427 0.00011468 -0.00004398 - -0.00004404 -0.00004398 0.00011505 - #*EXTRAS*# Step: 9 Bead: 38 - 0.00011560 -0.00004444 -0.00004417 - -0.00004444 0.00011521 -0.00004409 - -0.00004417 -0.00004409 0.00011563 - #*EXTRAS*# Step: 10 Bead: 38 - 0.00011598 -0.00004451 -0.00004423 - -0.00004451 0.00011557 -0.00004414 - -0.00004423 -0.00004414 0.00011600 - #*EXTRAS*# Step: 11 Bead: 38 - 0.00011622 -0.00004456 -0.00004427 - -0.00004456 0.00011580 -0.00004417 - -0.00004427 -0.00004417 0.00011623 - #*EXTRAS*# Step: 12 Bead: 38 - 0.00011637 -0.00004458 -0.00004429 - -0.00004458 0.00011595 -0.00004418 - -0.00004429 -0.00004418 0.00011639 - #*EXTRAS*# Step: 13 Bead: 38 - 0.00011647 -0.00004459 -0.00004430 - -0.00004459 0.00011605 -0.00004419 - -0.00004430 -0.00004419 0.00011649 - #*EXTRAS*# Step: 14 Bead: 38 - 0.00011654 -0.00004460 -0.00004431 - -0.00004460 0.00011611 -0.00004420 - -0.00004431 -0.00004420 0.00011655 - #*EXTRAS*# Step: 15 Bead: 38 - 0.00011658 -0.00004460 -0.00004431 - -0.00004460 0.00011615 -0.00004420 - -0.00004431 -0.00004420 0.00011659 - #*EXTRAS*# Step: 16 Bead: 38 - 0.00011660 -0.00004460 -0.00004431 - -0.00004460 0.00011618 -0.00004420 - -0.00004431 -0.00004420 0.00011661 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_39 b/drivers/py/pes/friction/frictionH/060K/inst.fric_39 deleted file mode 100644 index afd657b0a..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_39 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 39 - 0.00010946 -0.00004117 -0.00004123 - -0.00004117 0.00010948 -0.00004120 - -0.00004123 -0.00004120 0.00010953 - #*EXTRAS*# Step: 1 Bead: 39 - 0.00010719 -0.00003927 -0.00003925 - -0.00003927 0.00010719 -0.00003928 - -0.00003925 -0.00003928 0.00010716 - #*EXTRAS*# Step: 2 Bead: 39 - 0.00010531 -0.00003735 -0.00003728 - -0.00003735 0.00010531 -0.00003744 - -0.00003728 -0.00003744 0.00010510 - #*EXTRAS*# Step: 3 Bead: 39 - 0.00010438 -0.00003624 -0.00003617 - -0.00003624 0.00010438 -0.00003639 - -0.00003617 -0.00003639 0.00010407 - #*EXTRAS*# Step: 4 Bead: 39 - 0.00010591 -0.00003800 -0.00003794 - -0.00003800 0.00010590 -0.00003806 - -0.00003794 -0.00003806 0.00010576 - #*EXTRAS*# Step: 5 Bead: 39 - 0.00010882 -0.00004067 -0.00004071 - -0.00004067 0.00010883 -0.00004069 - -0.00004071 -0.00004069 0.00010888 - #*EXTRAS*# Step: 6 Bead: 39 - 0.00011099 -0.00004223 -0.00004230 - -0.00004223 0.00011100 -0.00004228 - -0.00004230 -0.00004228 0.00011106 - #*EXTRAS*# Step: 7 Bead: 39 - 0.00011241 -0.00004308 -0.00004310 - -0.00004308 0.00011234 -0.00004308 - -0.00004310 -0.00004308 0.00011246 - #*EXTRAS*# Step: 8 Bead: 39 - 0.00011328 -0.00004355 -0.00004349 - -0.00004355 0.00011312 -0.00004346 - -0.00004349 -0.00004346 0.00011333 - #*EXTRAS*# Step: 9 Bead: 39 - 0.00011383 -0.00004381 -0.00004369 - -0.00004381 0.00011361 -0.00004365 - -0.00004369 -0.00004365 0.00011387 - #*EXTRAS*# Step: 10 Bead: 39 - 0.00011419 -0.00004397 -0.00004381 - -0.00004397 0.00011392 -0.00004377 - -0.00004381 -0.00004377 0.00011423 - #*EXTRAS*# Step: 11 Bead: 39 - 0.00011442 -0.00004406 -0.00004388 - -0.00004406 0.00011413 -0.00004383 - -0.00004388 -0.00004383 0.00011445 - #*EXTRAS*# Step: 12 Bead: 39 - 0.00011457 -0.00004412 -0.00004392 - -0.00004412 0.00011426 -0.00004387 - -0.00004392 -0.00004387 0.00011460 - #*EXTRAS*# Step: 13 Bead: 39 - 0.00011466 -0.00004415 -0.00004395 - -0.00004415 0.00011435 -0.00004389 - -0.00004395 -0.00004389 0.00011469 - #*EXTRAS*# Step: 14 Bead: 39 - 0.00011472 -0.00004417 -0.00004397 - -0.00004417 0.00011440 -0.00004391 - -0.00004397 -0.00004391 0.00011475 - #*EXTRAS*# Step: 15 Bead: 39 - 0.00011476 -0.00004419 -0.00004398 - -0.00004419 0.00011444 -0.00004392 - -0.00004398 -0.00004392 0.00011479 - #*EXTRAS*# Step: 16 Bead: 39 - 0.00011479 -0.00004420 -0.00004398 - -0.00004420 0.00011446 -0.00004392 - -0.00004398 -0.00004392 0.00011482 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_40 b/drivers/py/pes/friction/frictionH/060K/inst.fric_40 deleted file mode 100644 index 226fc8748..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_40 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 40 - 0.00010885 -0.00004069 -0.00004073 - -0.00004069 0.00010886 -0.00004071 - -0.00004073 -0.00004071 0.00010891 - #*EXTRAS*# Step: 1 Bead: 40 - 0.00010645 -0.00003856 -0.00003852 - -0.00003856 0.00010645 -0.00003860 - -0.00003852 -0.00003860 0.00010636 - #*EXTRAS*# Step: 2 Bead: 40 - 0.00010448 -0.00003636 -0.00003629 - -0.00003636 0.00010448 -0.00003650 - -0.00003629 -0.00003650 0.00010418 - #*EXTRAS*# Step: 3 Bead: 40 - 0.00010342 -0.00003494 -0.00003488 - -0.00003494 0.00010341 -0.00003513 - -0.00003488 -0.00003513 0.00010303 - #*EXTRAS*# Step: 4 Bead: 40 - 0.00010466 -0.00003658 -0.00003651 - -0.00003658 0.00010466 -0.00003672 - -0.00003651 -0.00003672 0.00010438 - #*EXTRAS*# Step: 5 Bead: 40 - 0.00010738 -0.00003945 -0.00003943 - -0.00003945 0.00010738 -0.00003945 - -0.00003943 -0.00003945 0.00010737 - #*EXTRAS*# Step: 6 Bead: 40 - 0.00010945 -0.00004116 -0.00004121 - -0.00004116 0.00010947 -0.00004119 - -0.00004121 -0.00004119 0.00010952 - #*EXTRAS*# Step: 7 Bead: 40 - 0.00011081 -0.00004211 -0.00004218 - -0.00004211 0.00011082 -0.00004216 - -0.00004218 -0.00004216 0.00011088 - #*EXTRAS*# Step: 8 Bead: 40 - 0.00011164 -0.00004263 -0.00004269 - -0.00004263 0.00011163 -0.00004267 - -0.00004269 -0.00004267 0.00011171 - #*EXTRAS*# Step: 9 Bead: 40 - 0.00011217 -0.00004295 -0.00004298 - -0.00004295 0.00011212 -0.00004296 - -0.00004298 -0.00004296 0.00011223 - #*EXTRAS*# Step: 10 Bead: 40 - 0.00011251 -0.00004314 -0.00004314 - -0.00004314 0.00011243 -0.00004312 - -0.00004314 -0.00004312 0.00011256 - #*EXTRAS*# Step: 11 Bead: 40 - 0.00011272 -0.00004326 -0.00004325 - -0.00004326 0.00011262 -0.00004322 - -0.00004325 -0.00004322 0.00011278 - #*EXTRAS*# Step: 12 Bead: 40 - 0.00011286 -0.00004333 -0.00004331 - -0.00004333 0.00011275 -0.00004329 - -0.00004331 -0.00004329 0.00011292 - #*EXTRAS*# Step: 13 Bead: 40 - 0.00011295 -0.00004338 -0.00004335 - -0.00004338 0.00011283 -0.00004332 - -0.00004335 -0.00004332 0.00011301 - #*EXTRAS*# Step: 14 Bead: 40 - 0.00011301 -0.00004341 -0.00004337 - -0.00004341 0.00011288 -0.00004335 - -0.00004337 -0.00004335 0.00011306 - #*EXTRAS*# Step: 15 Bead: 40 - 0.00011305 -0.00004343 -0.00004339 - -0.00004343 0.00011291 -0.00004336 - -0.00004339 -0.00004336 0.00011310 - #*EXTRAS*# Step: 16 Bead: 40 - 0.00011307 -0.00004344 -0.00004340 - -0.00004344 0.00011293 -0.00004337 - -0.00004340 -0.00004337 0.00011312 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_41 b/drivers/py/pes/friction/frictionH/060K/inst.fric_41 deleted file mode 100644 index 9ae4df75c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_41 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 41 - 0.00010826 -0.00004021 -0.00004023 - -0.00004021 0.00010826 -0.00004022 - -0.00004023 -0.00004022 0.00010830 - #*EXTRAS*# Step: 1 Bead: 41 - 0.00010576 -0.00003784 -0.00003779 - -0.00003784 0.00010576 -0.00003792 - -0.00003779 -0.00003792 0.00010560 - #*EXTRAS*# Step: 2 Bead: 41 - 0.00010374 -0.00003539 -0.00003532 - -0.00003539 0.00010373 -0.00003557 - -0.00003532 -0.00003557 0.00010337 - #*EXTRAS*# Step: 3 Bead: 41 - 0.00010261 -0.00003366 -0.00003364 - -0.00003366 0.00010256 -0.00003385 - -0.00003364 -0.00003385 0.00010218 - #*EXTRAS*# Step: 4 Bead: 41 - 0.00010357 -0.00003516 -0.00003510 - -0.00003516 0.00010356 -0.00003534 - -0.00003510 -0.00003534 0.00010319 - #*EXTRAS*# Step: 5 Bead: 41 - 0.00010604 -0.00003814 -0.00003809 - -0.00003814 0.00010604 -0.00003820 - -0.00003809 -0.00003820 0.00010590 - #*EXTRAS*# Step: 6 Bead: 41 - 0.00010799 -0.00003999 -0.00003999 - -0.00003999 0.00010799 -0.00003999 - -0.00003999 -0.00003999 0.00010802 - #*EXTRAS*# Step: 7 Bead: 41 - 0.00010930 -0.00004105 -0.00004110 - -0.00004105 0.00010932 -0.00004107 - -0.00004110 -0.00004107 0.00010937 - #*EXTRAS*# Step: 8 Bead: 41 - 0.00011010 -0.00004163 -0.00004170 - -0.00004163 0.00011012 -0.00004167 - -0.00004170 -0.00004167 0.00011017 - #*EXTRAS*# Step: 9 Bead: 41 - 0.00011060 -0.00004197 -0.00004205 - -0.00004197 0.00011062 -0.00004203 - -0.00004205 -0.00004203 0.00011068 - #*EXTRAS*# Step: 10 Bead: 41 - 0.00011092 -0.00004218 -0.00004226 - -0.00004218 0.00011094 -0.00004224 - -0.00004226 -0.00004224 0.00011100 - #*EXTRAS*# Step: 11 Bead: 41 - 0.00011113 -0.00004232 -0.00004239 - -0.00004232 0.00011114 -0.00004237 - -0.00004239 -0.00004237 0.00011120 - #*EXTRAS*# Step: 12 Bead: 41 - 0.00011127 -0.00004240 -0.00004247 - -0.00004240 0.00011127 -0.00004245 - -0.00004247 -0.00004245 0.00011134 - #*EXTRAS*# Step: 13 Bead: 41 - 0.00011135 -0.00004246 -0.00004252 - -0.00004246 0.00011135 -0.00004250 - -0.00004252 -0.00004250 0.00011142 - #*EXTRAS*# Step: 14 Bead: 41 - 0.00011141 -0.00004249 -0.00004256 - -0.00004249 0.00011140 -0.00004254 - -0.00004256 -0.00004254 0.00011147 - #*EXTRAS*# Step: 15 Bead: 41 - 0.00011144 -0.00004251 -0.00004258 - -0.00004251 0.00011144 -0.00004256 - -0.00004258 -0.00004256 0.00011151 - #*EXTRAS*# Step: 16 Bead: 41 - 0.00011146 -0.00004252 -0.00004259 - -0.00004252 0.00011146 -0.00004257 - -0.00004259 -0.00004257 0.00011153 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_42 b/drivers/py/pes/friction/frictionH/060K/inst.fric_42 deleted file mode 100644 index 9532cafc9..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_42 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 42 - 0.00010769 -0.00003973 -0.00003972 - -0.00003973 0.00010769 -0.00003973 - -0.00003972 -0.00003973 0.00010770 - #*EXTRAS*# Step: 1 Bead: 42 - 0.00010513 -0.00003714 -0.00003707 - -0.00003714 0.00010513 -0.00003724 - -0.00003707 -0.00003724 0.00010489 - #*EXTRAS*# Step: 2 Bead: 42 - 0.00010309 -0.00003444 -0.00003439 - -0.00003444 0.00010306 -0.00003463 - -0.00003439 -0.00003463 0.00010268 - #*EXTRAS*# Step: 3 Bead: 42 - 0.00010191 -0.00003243 -0.00003243 - -0.00003243 0.00010182 -0.00003258 - -0.00003243 -0.00003258 0.00010150 - #*EXTRAS*# Step: 4 Bead: 42 - 0.00010266 -0.00003375 -0.00003371 - -0.00003375 0.00010261 -0.00003393 - -0.00003371 -0.00003393 0.00010223 - #*EXTRAS*# Step: 5 Bead: 42 - 0.00010483 -0.00003679 -0.00003672 - -0.00003679 0.00010483 -0.00003691 - -0.00003672 -0.00003691 0.00010456 - #*EXTRAS*# Step: 6 Bead: 42 - 0.00010662 -0.00003873 -0.00003869 - -0.00003873 0.00010662 -0.00003876 - -0.00003869 -0.00003876 0.00010655 - #*EXTRAS*# Step: 7 Bead: 42 - 0.00010788 -0.00003989 -0.00003989 - -0.00003989 0.00010788 -0.00003989 - -0.00003989 -0.00003989 0.00010790 - #*EXTRAS*# Step: 8 Bead: 42 - 0.00010864 -0.00004053 -0.00004056 - -0.00004053 0.00010866 -0.00004054 - -0.00004056 -0.00004054 0.00010870 - #*EXTRAS*# Step: 9 Bead: 42 - 0.00010913 -0.00004091 -0.00004096 - -0.00004091 0.00010915 -0.00004094 - -0.00004096 -0.00004094 0.00010920 - #*EXTRAS*# Step: 10 Bead: 42 - 0.00010944 -0.00004115 -0.00004121 - -0.00004115 0.00010946 -0.00004118 - -0.00004121 -0.00004118 0.00010951 - #*EXTRAS*# Step: 11 Bead: 42 - 0.00010963 -0.00004129 -0.00004136 - -0.00004129 0.00010966 -0.00004133 - -0.00004136 -0.00004133 0.00010971 - #*EXTRAS*# Step: 12 Bead: 42 - 0.00010976 -0.00004139 -0.00004145 - -0.00004139 0.00010979 -0.00004143 - -0.00004145 -0.00004143 0.00010984 - #*EXTRAS*# Step: 13 Bead: 42 - 0.00010984 -0.00004145 -0.00004152 - -0.00004145 0.00010987 -0.00004149 - -0.00004152 -0.00004149 0.00010992 - #*EXTRAS*# Step: 14 Bead: 42 - 0.00010990 -0.00004148 -0.00004155 - -0.00004148 0.00010992 -0.00004153 - -0.00004155 -0.00004153 0.00010997 - #*EXTRAS*# Step: 15 Bead: 42 - 0.00010993 -0.00004151 -0.00004158 - -0.00004151 0.00010995 -0.00004155 - -0.00004158 -0.00004155 0.00011001 - #*EXTRAS*# Step: 16 Bead: 42 - 0.00010995 -0.00004152 -0.00004159 - -0.00004152 0.00010998 -0.00004157 - -0.00004159 -0.00004157 0.00011003 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_43 b/drivers/py/pes/friction/frictionH/060K/inst.fric_43 deleted file mode 100644 index 71cfadacc..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_43 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 43 - 0.00010715 -0.00003923 -0.00003921 - -0.00003923 0.00010715 -0.00003925 - -0.00003921 -0.00003925 0.00010712 - #*EXTRAS*# Step: 1 Bead: 43 - 0.00010454 -0.00003644 -0.00003637 - -0.00003644 0.00010454 -0.00003658 - -0.00003637 -0.00003658 0.00010425 - #*EXTRAS*# Step: 2 Bead: 43 - 0.00010253 -0.00003353 -0.00003350 - -0.00003353 0.00010248 -0.00003372 - -0.00003350 -0.00003372 0.00010210 - #*EXTRAS*# Step: 3 Bead: 43 - 0.00010129 -0.00003125 -0.00003127 - -0.00003125 0.00010117 -0.00003135 - -0.00003127 -0.00003135 0.00010094 - #*EXTRAS*# Step: 4 Bead: 43 - 0.00010188 -0.00003237 -0.00003238 - -0.00003237 0.00010179 -0.00003253 - -0.00003238 -0.00003253 0.00010147 - #*EXTRAS*# Step: 5 Bead: 43 - 0.00010377 -0.00003543 -0.00003536 - -0.00003543 0.00010376 -0.00003560 - -0.00003536 -0.00003560 0.00010340 - #*EXTRAS*# Step: 6 Bead: 43 - 0.00010537 -0.00003741 -0.00003735 - -0.00003741 0.00010537 -0.00003751 - -0.00003735 -0.00003751 0.00010516 - #*EXTRAS*# Step: 7 Bead: 43 - 0.00010654 -0.00003865 -0.00003861 - -0.00003865 0.00010654 -0.00003868 - -0.00003861 -0.00003868 0.00010646 - #*EXTRAS*# Step: 8 Bead: 43 - 0.00010727 -0.00003935 -0.00003933 - -0.00003935 0.00010727 -0.00003936 - -0.00003933 -0.00003936 0.00010725 - #*EXTRAS*# Step: 9 Bead: 43 - 0.00010774 -0.00003977 -0.00003976 - -0.00003977 0.00010774 -0.00003977 - -0.00003976 -0.00003977 0.00010775 - #*EXTRAS*# Step: 10 Bead: 43 - 0.00010803 -0.00004002 -0.00004003 - -0.00004002 0.00010803 -0.00004003 - -0.00004003 -0.00004003 0.00010806 - #*EXTRAS*# Step: 11 Bead: 43 - 0.00010822 -0.00004018 -0.00004020 - -0.00004018 0.00010823 -0.00004019 - -0.00004020 -0.00004019 0.00010826 - #*EXTRAS*# Step: 12 Bead: 43 - 0.00010834 -0.00004029 -0.00004031 - -0.00004029 0.00010835 -0.00004029 - -0.00004031 -0.00004029 0.00010839 - #*EXTRAS*# Step: 13 Bead: 43 - 0.00010842 -0.00004035 -0.00004037 - -0.00004035 0.00010843 -0.00004036 - -0.00004037 -0.00004036 0.00010847 - #*EXTRAS*# Step: 14 Bead: 43 - 0.00010847 -0.00004039 -0.00004042 - -0.00004039 0.00010848 -0.00004040 - -0.00004042 -0.00004040 0.00010852 - #*EXTRAS*# Step: 15 Bead: 43 - 0.00010850 -0.00004042 -0.00004044 - -0.00004042 0.00010851 -0.00004043 - -0.00004044 -0.00004043 0.00010855 - #*EXTRAS*# Step: 16 Bead: 43 - 0.00010853 -0.00004043 -0.00004046 - -0.00004043 0.00010853 -0.00004044 - -0.00004046 -0.00004044 0.00010857 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_44 b/drivers/py/pes/friction/frictionH/060K/inst.fric_44 deleted file mode 100644 index 0e28a7e9d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_44 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 44 - 0.00010664 -0.00003874 -0.00003871 - -0.00003874 0.00010664 -0.00003877 - -0.00003871 -0.00003877 0.00010656 - #*EXTRAS*# Step: 1 Bead: 44 - 0.00010402 -0.00003577 -0.00003570 - -0.00003577 0.00010401 -0.00003593 - -0.00003570 -0.00003593 0.00010367 - #*EXTRAS*# Step: 2 Bead: 44 - 0.00010203 -0.00003266 -0.00003266 - -0.00003266 0.00010195 -0.00003282 - -0.00003266 -0.00003282 0.00010162 - #*EXTRAS*# Step: 3 Bead: 44 - 0.00010072 -0.00003012 -0.00003016 - -0.00003012 0.00010059 -0.00003016 - -0.00003016 -0.00003016 0.00010048 - #*EXTRAS*# Step: 4 Bead: 44 - 0.00010119 -0.00003106 -0.00003109 - -0.00003106 0.00010107 -0.00003115 - -0.00003109 -0.00003115 0.00010086 - #*EXTRAS*# Step: 5 Bead: 44 - 0.00010286 -0.00003409 -0.00003405 - -0.00003409 0.00010283 -0.00003428 - -0.00003405 -0.00003428 0.00010245 - #*EXTRAS*# Step: 6 Bead: 44 - 0.00010425 -0.00003608 -0.00003601 - -0.00003608 0.00010425 -0.00003623 - -0.00003601 -0.00003623 0.00010393 - #*EXTRAS*# Step: 7 Bead: 44 - 0.00010532 -0.00003736 -0.00003729 - -0.00003736 0.00010532 -0.00003746 - -0.00003729 -0.00003746 0.00010511 - #*EXTRAS*# Step: 8 Bead: 44 - 0.00010599 -0.00003809 -0.00003804 - -0.00003809 0.00010599 -0.00003815 - -0.00003804 -0.00003815 0.00010585 - #*EXTRAS*# Step: 9 Bead: 44 - 0.00010643 -0.00003854 -0.00003849 - -0.00003854 0.00010643 -0.00003858 - -0.00003849 -0.00003858 0.00010633 - #*EXTRAS*# Step: 10 Bead: 44 - 0.00010671 -0.00003881 -0.00003878 - -0.00003881 0.00010671 -0.00003884 - -0.00003878 -0.00003884 0.00010664 - #*EXTRAS*# Step: 11 Bead: 44 - 0.00010689 -0.00003899 -0.00003896 - -0.00003899 0.00010689 -0.00003901 - -0.00003896 -0.00003901 0.00010684 - #*EXTRAS*# Step: 12 Bead: 44 - 0.00010701 -0.00003910 -0.00003907 - -0.00003910 0.00010700 -0.00003912 - -0.00003907 -0.00003912 0.00010696 - #*EXTRAS*# Step: 13 Bead: 44 - 0.00010708 -0.00003917 -0.00003914 - -0.00003917 0.00010708 -0.00003918 - -0.00003914 -0.00003918 0.00010704 - #*EXTRAS*# Step: 14 Bead: 44 - 0.00010713 -0.00003921 -0.00003919 - -0.00003921 0.00010713 -0.00003923 - -0.00003919 -0.00003923 0.00010710 - #*EXTRAS*# Step: 15 Bead: 44 - 0.00010716 -0.00003924 -0.00003922 - -0.00003924 0.00010716 -0.00003926 - -0.00003922 -0.00003926 0.00010713 - #*EXTRAS*# Step: 16 Bead: 44 - 0.00010718 -0.00003926 -0.00003924 - -0.00003926 0.00010718 -0.00003927 - -0.00003924 -0.00003927 0.00010715 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_45 b/drivers/py/pes/friction/frictionH/060K/inst.fric_45 deleted file mode 100644 index f63352d2b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_45 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 45 - 0.00010616 -0.00003826 -0.00003821 - -0.00003826 0.00010615 -0.00003831 - -0.00003821 -0.00003831 0.00010603 - #*EXTRAS*# Step: 1 Bead: 45 - 0.00010354 -0.00003511 -0.00003505 - -0.00003511 0.00010353 -0.00003530 - -0.00003505 -0.00003530 0.00010316 - #*EXTRAS*# Step: 2 Bead: 45 - 0.00010159 -0.00003183 -0.00003185 - -0.00003183 0.00010149 -0.00003196 - -0.00003185 -0.00003196 0.00010121 - #*EXTRAS*# Step: 3 Bead: 45 - 0.00010019 -0.00002906 -0.00002909 - -0.00002906 0.00010007 -0.00002903 - -0.00002909 -0.00002903 0.00010008 - #*EXTRAS*# Step: 4 Bead: 45 - 0.00010056 -0.00002981 -0.00002984 - -0.00002981 0.00010044 -0.00002983 - -0.00002984 -0.00002983 0.00010036 - #*EXTRAS*# Step: 5 Bead: 45 - 0.00010210 -0.00003279 -0.00003278 - -0.00003279 0.00010203 -0.00003296 - -0.00003278 -0.00003296 0.00010169 - #*EXTRAS*# Step: 6 Bead: 45 - 0.00010329 -0.00003475 -0.00003470 - -0.00003475 0.00010327 -0.00003494 - -0.00003470 -0.00003494 0.00010289 - #*EXTRAS*# Step: 7 Bead: 45 - 0.00010423 -0.00003605 -0.00003598 - -0.00003605 0.00010423 -0.00003621 - -0.00003598 -0.00003621 0.00010391 - #*EXTRAS*# Step: 8 Bead: 45 - 0.00010484 -0.00003680 -0.00003673 - -0.00003680 0.00010484 -0.00003693 - -0.00003673 -0.00003693 0.00010458 - #*EXTRAS*# Step: 9 Bead: 45 - 0.00010524 -0.00003726 -0.00003720 - -0.00003726 0.00010524 -0.00003737 - -0.00003720 -0.00003737 0.00010502 - #*EXTRAS*# Step: 10 Bead: 45 - 0.00010550 -0.00003755 -0.00003749 - -0.00003755 0.00010549 -0.00003764 - -0.00003749 -0.00003764 0.00010530 - #*EXTRAS*# Step: 11 Bead: 45 - 0.00010566 -0.00003774 -0.00003768 - -0.00003774 0.00010566 -0.00003781 - -0.00003768 -0.00003781 0.00010549 - #*EXTRAS*# Step: 12 Bead: 45 - 0.00010577 -0.00003785 -0.00003780 - -0.00003785 0.00010577 -0.00003792 - -0.00003780 -0.00003792 0.00010561 - #*EXTRAS*# Step: 13 Bead: 45 - 0.00010584 -0.00003793 -0.00003787 - -0.00003793 0.00010584 -0.00003799 - -0.00003787 -0.00003799 0.00010568 - #*EXTRAS*# Step: 14 Bead: 45 - 0.00010588 -0.00003797 -0.00003792 - -0.00003797 0.00010588 -0.00003804 - -0.00003792 -0.00003804 0.00010573 - #*EXTRAS*# Step: 15 Bead: 45 - 0.00010591 -0.00003800 -0.00003795 - -0.00003800 0.00010591 -0.00003807 - -0.00003795 -0.00003807 0.00010576 - #*EXTRAS*# Step: 16 Bead: 45 - 0.00010593 -0.00003802 -0.00003797 - -0.00003802 0.00010593 -0.00003809 - -0.00003797 -0.00003809 0.00010578 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_46 b/drivers/py/pes/friction/frictionH/060K/inst.fric_46 deleted file mode 100644 index ce5fab2ce..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_46 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 46 - 0.00010571 -0.00003778 -0.00003773 - -0.00003778 0.00010570 -0.00003786 - -0.00003773 -0.00003786 0.00010554 - #*EXTRAS*# Step: 1 Bead: 46 - 0.00010312 -0.00003449 -0.00003444 - -0.00003449 0.00010310 -0.00003468 - -0.00003444 -0.00003468 0.00010271 - #*EXTRAS*# Step: 2 Bead: 46 - 0.00010119 -0.00003105 -0.00003108 - -0.00003105 0.00010107 -0.00003115 - -0.00003108 -0.00003115 0.00010086 - #*EXTRAS*# Step: 3 Bead: 46 - 0.00009968 -0.00002808 -0.00002807 - -0.00002808 0.00009961 -0.00002798 - -0.00002807 -0.00002798 0.00009974 - #*EXTRAS*# Step: 4 Bead: 46 - 0.00009997 -0.00002864 -0.00002865 - -0.00002864 0.00009987 -0.00002857 - -0.00002865 -0.00002857 0.00009993 - #*EXTRAS*# Step: 5 Bead: 46 - 0.00010144 -0.00003155 -0.00003157 - -0.00003155 0.00010133 -0.00003166 - -0.00003157 -0.00003166 0.00010108 - #*EXTRAS*# Step: 6 Bead: 46 - 0.00010248 -0.00003346 -0.00003343 - -0.00003346 0.00010243 -0.00003364 - -0.00003343 -0.00003364 0.00010206 - #*EXTRAS*# Step: 7 Bead: 46 - 0.00010330 -0.00003476 -0.00003470 - -0.00003476 0.00010328 -0.00003495 - -0.00003470 -0.00003495 0.00010290 - #*EXTRAS*# Step: 8 Bead: 46 - 0.00010383 -0.00003551 -0.00003545 - -0.00003551 0.00010382 -0.00003569 - -0.00003545 -0.00003569 0.00010347 - #*EXTRAS*# Step: 9 Bead: 46 - 0.00010418 -0.00003598 -0.00003591 - -0.00003598 0.00010418 -0.00003614 - -0.00003591 -0.00003614 0.00010385 - #*EXTRAS*# Step: 10 Bead: 46 - 0.00010441 -0.00003628 -0.00003621 - -0.00003628 0.00010441 -0.00003643 - -0.00003621 -0.00003643 0.00010411 - #*EXTRAS*# Step: 11 Bead: 46 - 0.00010456 -0.00003646 -0.00003640 - -0.00003646 0.00010456 -0.00003660 - -0.00003640 -0.00003660 0.00010427 - #*EXTRAS*# Step: 12 Bead: 46 - 0.00010466 -0.00003658 -0.00003652 - -0.00003658 0.00010466 -0.00003672 - -0.00003652 -0.00003672 0.00010438 - #*EXTRAS*# Step: 13 Bead: 46 - 0.00010472 -0.00003666 -0.00003659 - -0.00003666 0.00010472 -0.00003679 - -0.00003659 -0.00003679 0.00010445 - #*EXTRAS*# Step: 14 Bead: 46 - 0.00010476 -0.00003671 -0.00003664 - -0.00003671 0.00010476 -0.00003684 - -0.00003664 -0.00003684 0.00010449 - #*EXTRAS*# Step: 15 Bead: 46 - 0.00010479 -0.00003674 -0.00003667 - -0.00003674 0.00010479 -0.00003687 - -0.00003667 -0.00003687 0.00010452 - #*EXTRAS*# Step: 16 Bead: 46 - 0.00010480 -0.00003676 -0.00003669 - -0.00003676 0.00010480 -0.00003689 - -0.00003669 -0.00003689 0.00010454 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_47 b/drivers/py/pes/friction/frictionH/060K/inst.fric_47 deleted file mode 100644 index 46dfc1590..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_47 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 47 - 0.00010529 -0.00003732 -0.00003726 - -0.00003732 0.00010529 -0.00003742 - -0.00003726 -0.00003742 0.00010507 - #*EXTRAS*# Step: 1 Bead: 47 - 0.00010275 -0.00003390 -0.00003386 - -0.00003390 0.00010271 -0.00003409 - -0.00003386 -0.00003409 0.00010233 - #*EXTRAS*# Step: 2 Bead: 47 - 0.00010082 -0.00003032 -0.00003036 - -0.00003032 0.00010069 -0.00003037 - -0.00003036 -0.00003037 0.00010056 - #*EXTRAS*# Step: 3 Bead: 47 - 0.00009921 -0.00002716 -0.00002710 - -0.00002716 0.00009919 -0.00002699 - -0.00002710 -0.00002699 0.00009945 - #*EXTRAS*# Step: 4 Bead: 47 - 0.00009940 -0.00002754 -0.00002750 - -0.00002754 0.00009936 -0.00002740 - -0.00002750 -0.00002740 0.00009957 - #*EXTRAS*# Step: 5 Bead: 47 - 0.00010084 -0.00003037 -0.00003041 - -0.00003037 0.00010072 -0.00003042 - -0.00003041 -0.00003042 0.00010058 - #*EXTRAS*# Step: 6 Bead: 47 - 0.00010179 -0.00003222 -0.00003222 - -0.00003222 0.00010170 -0.00003236 - -0.00003222 -0.00003236 0.00010139 - #*EXTRAS*# Step: 7 Bead: 47 - 0.00010251 -0.00003350 -0.00003347 - -0.00003350 0.00010246 -0.00003368 - -0.00003347 -0.00003368 0.00010209 - #*EXTRAS*# Step: 8 Bead: 47 - 0.00010296 -0.00003425 -0.00003420 - -0.00003425 0.00010293 -0.00003444 - -0.00003420 -0.00003444 0.00010255 - #*EXTRAS*# Step: 9 Bead: 47 - 0.00010327 -0.00003472 -0.00003466 - -0.00003472 0.00010325 -0.00003491 - -0.00003466 -0.00003491 0.00010287 - #*EXTRAS*# Step: 10 Bead: 47 - 0.00010347 -0.00003501 -0.00003496 - -0.00003501 0.00010346 -0.00003520 - -0.00003496 -0.00003520 0.00010309 - #*EXTRAS*# Step: 11 Bead: 47 - 0.00010360 -0.00003520 -0.00003514 - -0.00003520 0.00010359 -0.00003539 - -0.00003514 -0.00003539 0.00010323 - #*EXTRAS*# Step: 12 Bead: 47 - 0.00010369 -0.00003532 -0.00003526 - -0.00003532 0.00010368 -0.00003550 - -0.00003526 -0.00003550 0.00010332 - #*EXTRAS*# Step: 13 Bead: 47 - 0.00010375 -0.00003540 -0.00003534 - -0.00003540 0.00010374 -0.00003558 - -0.00003534 -0.00003558 0.00010338 - #*EXTRAS*# Step: 14 Bead: 47 - 0.00010378 -0.00003545 -0.00003538 - -0.00003545 0.00010377 -0.00003563 - -0.00003538 -0.00003563 0.00010342 - #*EXTRAS*# Step: 15 Bead: 47 - 0.00010380 -0.00003548 -0.00003542 - -0.00003548 0.00010380 -0.00003566 - -0.00003542 -0.00003566 0.00010344 - #*EXTRAS*# Step: 16 Bead: 47 - 0.00010382 -0.00003550 -0.00003544 - -0.00003550 0.00010381 -0.00003568 - -0.00003544 -0.00003568 0.00010346 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_48 b/drivers/py/pes/friction/frictionH/060K/inst.fric_48 deleted file mode 100644 index c44ace386..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_48 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 48 - 0.00010490 -0.00003687 -0.00003681 - -0.00003687 0.00010490 -0.00003699 - -0.00003681 -0.00003699 0.00010465 - #*EXTRAS*# Step: 1 Bead: 48 - 0.00010241 -0.00003333 -0.00003331 - -0.00003333 0.00010235 -0.00003351 - -0.00003331 -0.00003351 0.00010199 - #*EXTRAS*# Step: 2 Bead: 48 - 0.00010048 -0.00002964 -0.00002968 - -0.00002964 0.00010036 -0.00002965 - -0.00002968 -0.00002965 0.00010030 - #*EXTRAS*# Step: 3 Bead: 48 - 0.00009877 -0.00002630 -0.00002619 - -0.00002630 0.00009882 -0.00002608 - -0.00002619 -0.00002608 0.00009919 - #*EXTRAS*# Step: 4 Bead: 48 - 0.00009888 -0.00002651 -0.00002642 - -0.00002651 0.00009891 -0.00002631 - -0.00002642 -0.00002631 0.00009925 - #*EXTRAS*# Step: 5 Bead: 48 - 0.00010029 -0.00002927 -0.00002930 - -0.00002927 0.00010017 -0.00002925 - -0.00002930 -0.00002925 0.00010016 - #*EXTRAS*# Step: 6 Bead: 48 - 0.00010118 -0.00003104 -0.00003107 - -0.00003104 0.00010106 -0.00003113 - -0.00003107 -0.00003113 0.00010085 - #*EXTRAS*# Step: 7 Bead: 48 - 0.00010183 -0.00003230 -0.00003230 - -0.00003230 0.00010174 -0.00003245 - -0.00003230 -0.00003245 0.00010143 - #*EXTRAS*# Step: 8 Bead: 48 - 0.00010224 -0.00003303 -0.00003301 - -0.00003303 0.00010217 -0.00003320 - -0.00003301 -0.00003320 0.00010182 - #*EXTRAS*# Step: 9 Bead: 48 - 0.00010251 -0.00003349 -0.00003347 - -0.00003349 0.00010245 -0.00003368 - -0.00003347 -0.00003368 0.00010208 - #*EXTRAS*# Step: 10 Bead: 48 - 0.00010268 -0.00003379 -0.00003375 - -0.00003379 0.00010264 -0.00003398 - -0.00003375 -0.00003398 0.00010226 - #*EXTRAS*# Step: 11 Bead: 48 - 0.00010279 -0.00003397 -0.00003394 - -0.00003397 0.00010276 -0.00003417 - -0.00003394 -0.00003417 0.00010237 - #*EXTRAS*# Step: 12 Bead: 48 - 0.00010287 -0.00003409 -0.00003405 - -0.00003409 0.00010283 -0.00003429 - -0.00003405 -0.00003429 0.00010245 - #*EXTRAS*# Step: 13 Bead: 48 - 0.00010292 -0.00003417 -0.00003413 - -0.00003417 0.00010288 -0.00003436 - -0.00003413 -0.00003436 0.00010250 - #*EXTRAS*# Step: 14 Bead: 48 - 0.00010295 -0.00003422 -0.00003418 - -0.00003422 0.00010292 -0.00003441 - -0.00003418 -0.00003441 0.00010253 - #*EXTRAS*# Step: 15 Bead: 48 - 0.00010297 -0.00003425 -0.00003421 - -0.00003425 0.00010294 -0.00003444 - -0.00003421 -0.00003444 0.00010255 - #*EXTRAS*# Step: 16 Bead: 48 - 0.00010298 -0.00003427 -0.00003423 - -0.00003427 0.00010295 -0.00003446 - -0.00003423 -0.00003446 0.00010257 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_49 b/drivers/py/pes/friction/frictionH/060K/inst.fric_49 deleted file mode 100644 index c89bfdbd6..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_49 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 49 - 0.00010455 -0.00003644 -0.00003638 - -0.00003644 0.00010454 -0.00003659 - -0.00003638 -0.00003659 0.00010425 - #*EXTRAS*# Step: 1 Bead: 49 - 0.00010211 -0.00003281 -0.00003280 - -0.00003281 0.00010204 -0.00003297 - -0.00003280 -0.00003297 0.00010170 - #*EXTRAS*# Step: 2 Bead: 49 - 0.00010016 -0.00002901 -0.00002903 - -0.00002901 0.00010005 -0.00002898 - -0.00002903 -0.00002898 0.00010007 - #*EXTRAS*# Step: 3 Bead: 49 - 0.00009840 -0.00002549 -0.00002533 - -0.00002549 0.00009851 -0.00002523 - -0.00002533 -0.00002523 0.00009897 - #*EXTRAS*# Step: 4 Bead: 49 - 0.00009842 -0.00002555 -0.00002539 - -0.00002555 0.00009853 -0.00002529 - -0.00002539 -0.00002529 0.00009898 - #*EXTRAS*# Step: 5 Bead: 49 - 0.00009977 -0.00002825 -0.00002825 - -0.00002825 0.00009969 -0.00002816 - -0.00002825 -0.00002816 0.00009980 - #*EXTRAS*# Step: 6 Bead: 49 - 0.00010063 -0.00002994 -0.00002997 - -0.00002994 0.00010050 -0.00002996 - -0.00002997 -0.00002996 0.00010041 - #*EXTRAS*# Step: 7 Bead: 49 - 0.00010124 -0.00003116 -0.00003118 - -0.00003116 0.00010112 -0.00003125 - -0.00003118 -0.00003125 0.00010090 - #*EXTRAS*# Step: 8 Bead: 49 - 0.00010161 -0.00003187 -0.00003188 - -0.00003187 0.00010151 -0.00003200 - -0.00003188 -0.00003200 0.00010123 - #*EXTRAS*# Step: 9 Bead: 49 - 0.00010185 -0.00003233 -0.00003233 - -0.00003233 0.00010176 -0.00003248 - -0.00003233 -0.00003248 0.00010145 - #*EXTRAS*# Step: 10 Bead: 49 - 0.00010201 -0.00003261 -0.00003261 - -0.00003261 0.00010193 -0.00003277 - -0.00003261 -0.00003277 0.00010159 - #*EXTRAS*# Step: 11 Bead: 49 - 0.00010211 -0.00003280 -0.00003279 - -0.00003280 0.00010203 -0.00003296 - -0.00003279 -0.00003296 0.00010169 - #*EXTRAS*# Step: 12 Bead: 49 - 0.00010217 -0.00003291 -0.00003290 - -0.00003291 0.00010210 -0.00003309 - -0.00003290 -0.00003309 0.00010175 - #*EXTRAS*# Step: 13 Bead: 49 - 0.00010222 -0.00003299 -0.00003298 - -0.00003299 0.00010215 -0.00003316 - -0.00003298 -0.00003316 0.00010180 - #*EXTRAS*# Step: 14 Bead: 49 - 0.00010224 -0.00003304 -0.00003302 - -0.00003304 0.00010218 -0.00003321 - -0.00003302 -0.00003321 0.00010182 - #*EXTRAS*# Step: 15 Bead: 49 - 0.00010226 -0.00003307 -0.00003305 - -0.00003307 0.00010219 -0.00003324 - -0.00003305 -0.00003324 0.00010184 - #*EXTRAS*# Step: 16 Bead: 49 - 0.00010227 -0.00003309 -0.00003307 - -0.00003309 0.00010221 -0.00003326 - -0.00003307 -0.00003326 0.00010185 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_50 b/drivers/py/pes/friction/frictionH/060K/inst.fric_50 deleted file mode 100644 index 944a43a6c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_50 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 50 - 0.00010422 -0.00003604 -0.00003597 - -0.00003604 0.00010422 -0.00003619 - -0.00003597 -0.00003619 0.00010390 - #*EXTRAS*# Step: 1 Bead: 50 - 0.00010184 -0.00003231 -0.00003232 - -0.00003231 0.00010175 -0.00003246 - -0.00003232 -0.00003246 0.00010144 - #*EXTRAS*# Step: 2 Bead: 50 - 0.00009987 -0.00002843 -0.00002844 - -0.00002843 0.00009977 -0.00002836 - -0.00002844 -0.00002836 0.00009986 - #*EXTRAS*# Step: 3 Bead: 50 - 0.00009808 -0.00002474 -0.00002453 - -0.00002474 0.00009825 -0.00002444 - -0.00002453 -0.00002444 0.00009878 - #*EXTRAS*# Step: 4 Bead: 50 - 0.00009804 -0.00002465 -0.00002443 - -0.00002465 0.00009822 -0.00002434 - -0.00002443 -0.00002434 0.00009876 - #*EXTRAS*# Step: 5 Bead: 50 - 0.00009928 -0.00002730 -0.00002725 - -0.00002730 0.00009925 -0.00002715 - -0.00002725 -0.00002715 0.00009949 - #*EXTRAS*# Step: 6 Bead: 50 - 0.00010011 -0.00002891 -0.00002893 - -0.00002891 0.00010000 -0.00002887 - -0.00002893 -0.00002887 0.00010003 - #*EXTRAS*# Step: 7 Bead: 50 - 0.00010070 -0.00003009 -0.00003013 - -0.00003009 0.00010058 -0.00003013 - -0.00003013 -0.00003013 0.00010047 - #*EXTRAS*# Step: 8 Bead: 50 - 0.00010105 -0.00003078 -0.00003081 - -0.00003078 0.00010093 -0.00003086 - -0.00003081 -0.00003086 0.00010074 - #*EXTRAS*# Step: 9 Bead: 50 - 0.00010128 -0.00003123 -0.00003125 - -0.00003123 0.00010116 -0.00003133 - -0.00003125 -0.00003133 0.00010093 - #*EXTRAS*# Step: 10 Bead: 50 - 0.00010142 -0.00003151 -0.00003153 - -0.00003151 0.00010131 -0.00003162 - -0.00003153 -0.00003162 0.00010106 - #*EXTRAS*# Step: 11 Bead: 50 - 0.00010151 -0.00003169 -0.00003170 - -0.00003169 0.00010141 -0.00003181 - -0.00003170 -0.00003181 0.00010114 - #*EXTRAS*# Step: 12 Bead: 50 - 0.00010157 -0.00003180 -0.00003182 - -0.00003180 0.00010147 -0.00003193 - -0.00003182 -0.00003193 0.00010119 - #*EXTRAS*# Step: 13 Bead: 50 - 0.00010161 -0.00003187 -0.00003189 - -0.00003187 0.00010151 -0.00003200 - -0.00003189 -0.00003200 0.00010123 - #*EXTRAS*# Step: 14 Bead: 50 - 0.00010164 -0.00003192 -0.00003193 - -0.00003192 0.00010154 -0.00003205 - -0.00003193 -0.00003205 0.00010125 - #*EXTRAS*# Step: 15 Bead: 50 - 0.00010165 -0.00003195 -0.00003196 - -0.00003195 0.00010155 -0.00003209 - -0.00003196 -0.00003209 0.00010126 - #*EXTRAS*# Step: 16 Bead: 50 - 0.00010166 -0.00003197 -0.00003198 - -0.00003197 0.00010156 -0.00003211 - -0.00003198 -0.00003211 0.00010127 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_51 b/drivers/py/pes/friction/frictionH/060K/inst.fric_51 deleted file mode 100644 index 6b18adf50..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_51 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 51 - 0.00010393 -0.00003565 -0.00003558 - -0.00003565 0.00010392 -0.00003582 - -0.00003558 -0.00003582 0.00010358 - #*EXTRAS*# Step: 1 Bead: 51 - 0.00010160 -0.00003185 -0.00003187 - -0.00003185 0.00010150 -0.00003198 - -0.00003187 -0.00003198 0.00010122 - #*EXTRAS*# Step: 2 Bead: 51 - 0.00009959 -0.00002790 -0.00002788 - -0.00002790 0.00009952 -0.00002779 - -0.00002788 -0.00002779 0.00009968 - #*EXTRAS*# Step: 3 Bead: 51 - 0.00009782 -0.00002404 -0.00002380 - -0.00002404 0.00009805 -0.00002372 - -0.00002380 -0.00002372 0.00009863 - #*EXTRAS*# Step: 4 Bead: 51 - 0.00009774 -0.00002380 -0.00002354 - -0.00002380 0.00009798 -0.00002347 - -0.00002354 -0.00002347 0.00009858 - #*EXTRAS*# Step: 5 Bead: 51 - 0.00009884 -0.00002643 -0.00002633 - -0.00002643 0.00009888 -0.00002622 - -0.00002633 -0.00002622 0.00009923 - #*EXTRAS*# Step: 6 Bead: 51 - 0.00009963 -0.00002797 -0.00002796 - -0.00002797 0.00009956 -0.00002786 - -0.00002796 -0.00002786 0.00009971 - #*EXTRAS*# Step: 7 Bead: 51 - 0.00010021 -0.00002911 -0.00002913 - -0.00002911 0.00010010 -0.00002908 - -0.00002913 -0.00002908 0.00010010 - #*EXTRAS*# Step: 8 Bead: 51 - 0.00010054 -0.00002977 -0.00002980 - -0.00002977 0.00010042 -0.00002978 - -0.00002980 -0.00002978 0.00010034 - #*EXTRAS*# Step: 9 Bead: 51 - 0.00010076 -0.00003020 -0.00003023 - -0.00003020 0.00010063 -0.00003024 - -0.00003023 -0.00003024 0.00010051 - #*EXTRAS*# Step: 10 Bead: 51 - 0.00010089 -0.00003047 -0.00003051 - -0.00003047 0.00010077 -0.00003053 - -0.00003051 -0.00003053 0.00010062 - #*EXTRAS*# Step: 11 Bead: 51 - 0.00010098 -0.00003065 -0.00003068 - -0.00003065 0.00010086 -0.00003071 - -0.00003068 -0.00003071 0.00010069 - #*EXTRAS*# Step: 12 Bead: 51 - 0.00010104 -0.00003076 -0.00003079 - -0.00003076 0.00010092 -0.00003083 - -0.00003079 -0.00003083 0.00010073 - #*EXTRAS*# Step: 13 Bead: 51 - 0.00010107 -0.00003083 -0.00003086 - -0.00003083 0.00010095 -0.00003091 - -0.00003086 -0.00003091 0.00010076 - #*EXTRAS*# Step: 14 Bead: 51 - 0.00010110 -0.00003087 -0.00003090 - -0.00003087 0.00010098 -0.00003096 - -0.00003090 -0.00003096 0.00010078 - #*EXTRAS*# Step: 15 Bead: 51 - 0.00010111 -0.00003090 -0.00003093 - -0.00003090 0.00010099 -0.00003099 - -0.00003093 -0.00003099 0.00010079 - #*EXTRAS*# Step: 16 Bead: 51 - 0.00010112 -0.00003092 -0.00003095 - -0.00003092 0.00010100 -0.00003101 - -0.00003095 -0.00003101 0.00010080 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_52 b/drivers/py/pes/friction/frictionH/060K/inst.fric_52 deleted file mode 100644 index f80f077bb..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_52 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 52 - 0.00010366 -0.00003529 -0.00003522 - -0.00003529 0.00010365 -0.00003547 - -0.00003522 -0.00003547 0.00010329 - #*EXTRAS*# Step: 1 Bead: 52 - 0.00010138 -0.00003143 -0.00003145 - -0.00003143 0.00010127 -0.00003154 - -0.00003145 -0.00003154 0.00010102 - #*EXTRAS*# Step: 2 Bead: 52 - 0.00009934 -0.00002741 -0.00002737 - -0.00002741 0.00009930 -0.00002726 - -0.00002737 -0.00002726 0.00009953 - #*EXTRAS*# Step: 3 Bead: 52 - 0.00009762 -0.00002340 -0.00002312 - -0.00002340 0.00009788 -0.00002306 - -0.00002312 -0.00002306 0.00009850 - #*EXTRAS*# Step: 4 Bead: 52 - 0.00009751 -0.00002301 -0.00002272 - -0.00002301 0.00009780 -0.00002266 - -0.00002272 -0.00002266 0.00009843 - #*EXTRAS*# Step: 5 Bead: 52 - 0.00009846 -0.00002562 -0.00002547 - -0.00002562 0.00009856 -0.00002536 - -0.00002547 -0.00002536 0.00009900 - #*EXTRAS*# Step: 6 Bead: 52 - 0.00009918 -0.00002711 -0.00002705 - -0.00002711 0.00009916 -0.00002694 - -0.00002705 -0.00002694 0.00009943 - #*EXTRAS*# Step: 7 Bead: 52 - 0.00009975 -0.00002820 -0.00002820 - -0.00002820 0.00009967 -0.00002811 - -0.00002820 -0.00002811 0.00009979 - #*EXTRAS*# Step: 8 Bead: 52 - 0.00010007 -0.00002884 -0.00002886 - -0.00002884 0.00009997 -0.00002879 - -0.00002886 -0.00002879 0.00010000 - #*EXTRAS*# Step: 9 Bead: 52 - 0.00010029 -0.00002926 -0.00002928 - -0.00002926 0.00010017 -0.00002924 - -0.00002928 -0.00002924 0.00010015 - #*EXTRAS*# Step: 10 Bead: 52 - 0.00010042 -0.00002952 -0.00002955 - -0.00002952 0.00010029 -0.00002952 - -0.00002955 -0.00002952 0.00010025 - #*EXTRAS*# Step: 11 Bead: 52 - 0.00010050 -0.00002969 -0.00002972 - -0.00002969 0.00010038 -0.00002970 - -0.00002972 -0.00002970 0.00010031 - #*EXTRAS*# Step: 12 Bead: 52 - 0.00010056 -0.00002979 -0.00002983 - -0.00002979 0.00010043 -0.00002981 - -0.00002983 -0.00002981 0.00010035 - #*EXTRAS*# Step: 13 Bead: 52 - 0.00010059 -0.00002986 -0.00002990 - -0.00002986 0.00010046 -0.00002988 - -0.00002990 -0.00002988 0.00010038 - #*EXTRAS*# Step: 14 Bead: 52 - 0.00010061 -0.00002991 -0.00002994 - -0.00002991 0.00010049 -0.00002993 - -0.00002994 -0.00002993 0.00010040 - #*EXTRAS*# Step: 15 Bead: 52 - 0.00010063 -0.00002994 -0.00002997 - -0.00002994 0.00010050 -0.00002996 - -0.00002997 -0.00002996 0.00010041 - #*EXTRAS*# Step: 16 Bead: 52 - 0.00010064 -0.00002995 -0.00002999 - -0.00002995 0.00010051 -0.00002998 - -0.00002999 -0.00002998 0.00010041 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_53 b/drivers/py/pes/friction/frictionH/060K/inst.fric_53 deleted file mode 100644 index 7da0f7c45..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_53 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 53 - 0.00010343 -0.00003495 -0.00003489 - -0.00003495 0.00010341 -0.00003514 - -0.00003489 -0.00003514 0.00010304 - #*EXTRAS*# Step: 1 Bead: 53 - 0.00010118 -0.00003104 -0.00003107 - -0.00003104 0.00010106 -0.00003113 - -0.00003107 -0.00003113 0.00010085 - #*EXTRAS*# Step: 2 Bead: 53 - 0.00009911 -0.00002697 -0.00002690 - -0.00002697 0.00009910 -0.00002679 - -0.00002690 -0.00002679 0.00009939 - #*EXTRAS*# Step: 3 Bead: 53 - 0.00009746 -0.00002280 -0.00002250 - -0.00002280 0.00009776 -0.00002245 - -0.00002250 -0.00002245 0.00009840 - #*EXTRAS*# Step: 4 Bead: 53 - 0.00009735 -0.00002228 -0.00002197 - -0.00002228 0.00009767 -0.00002193 - -0.00002197 -0.00002193 0.00009831 - #*EXTRAS*# Step: 5 Bead: 53 - 0.00009813 -0.00002488 -0.00002468 - -0.00002488 0.00009830 -0.00002458 - -0.00002468 -0.00002458 0.00009882 - #*EXTRAS*# Step: 6 Bead: 53 - 0.00009878 -0.00002631 -0.00002620 - -0.00002631 0.00009883 -0.00002610 - -0.00002620 -0.00002610 0.00009919 - #*EXTRAS*# Step: 7 Bead: 53 - 0.00009932 -0.00002738 -0.00002734 - -0.00002738 0.00009929 -0.00002723 - -0.00002734 -0.00002723 0.00009952 - #*EXTRAS*# Step: 8 Bead: 53 - 0.00009964 -0.00002799 -0.00002798 - -0.00002799 0.00009957 -0.00002789 - -0.00002798 -0.00002789 0.00009972 - #*EXTRAS*# Step: 9 Bead: 53 - 0.00009985 -0.00002839 -0.00002840 - -0.00002839 0.00009976 -0.00002832 - -0.00002840 -0.00002832 0.00009985 - #*EXTRAS*# Step: 10 Bead: 53 - 0.00009998 -0.00002865 -0.00002866 - -0.00002865 0.00009987 -0.00002859 - -0.00002866 -0.00002859 0.00009994 - #*EXTRAS*# Step: 11 Bead: 53 - 0.00010006 -0.00002881 -0.00002883 - -0.00002881 0.00009995 -0.00002876 - -0.00002883 -0.00002876 0.00009999 - #*EXTRAS*# Step: 12 Bead: 53 - 0.00010011 -0.00002891 -0.00002893 - -0.00002891 0.00010000 -0.00002887 - -0.00002893 -0.00002887 0.00010003 - #*EXTRAS*# Step: 13 Bead: 53 - 0.00010015 -0.00002898 -0.00002900 - -0.00002898 0.00010003 -0.00002894 - -0.00002900 -0.00002894 0.00010005 - #*EXTRAS*# Step: 14 Bead: 53 - 0.00010017 -0.00002902 -0.00002904 - -0.00002902 0.00010005 -0.00002899 - -0.00002904 -0.00002899 0.00010007 - #*EXTRAS*# Step: 15 Bead: 53 - 0.00010018 -0.00002905 -0.00002907 - -0.00002905 0.00010007 -0.00002902 - -0.00002907 -0.00002902 0.00010008 - #*EXTRAS*# Step: 16 Bead: 53 - 0.00010019 -0.00002907 -0.00002909 - -0.00002907 0.00010008 -0.00002904 - -0.00002909 -0.00002904 0.00010009 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_54 b/drivers/py/pes/friction/frictionH/060K/inst.fric_54 deleted file mode 100644 index 4f3e1d596..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_54 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 54 - 0.00010322 -0.00003464 -0.00003459 - -0.00003464 0.00010320 -0.00003483 - -0.00003459 -0.00003483 0.00010282 - #*EXTRAS*# Step: 1 Bead: 54 - 0.00010100 -0.00003069 -0.00003072 - -0.00003069 0.00010088 -0.00003076 - -0.00003072 -0.00003076 0.00010070 - #*EXTRAS*# Step: 2 Bead: 54 - 0.00009891 -0.00002656 -0.00002647 - -0.00002656 0.00009893 -0.00002636 - -0.00002647 -0.00002636 0.00009927 - #*EXTRAS*# Step: 3 Bead: 54 - 0.00009735 -0.00002226 -0.00002195 - -0.00002226 0.00009767 -0.00002191 - -0.00002195 -0.00002191 0.00009831 - #*EXTRAS*# Step: 4 Bead: 54 - 0.00009725 -0.00002160 -0.00002129 - -0.00002160 0.00009759 -0.00002126 - -0.00002129 -0.00002126 0.00009822 - #*EXTRAS*# Step: 5 Bead: 54 - 0.00009788 -0.00002420 -0.00002396 - -0.00002420 0.00009809 -0.00002388 - -0.00002396 -0.00002388 0.00009866 - #*EXTRAS*# Step: 6 Bead: 54 - 0.00009844 -0.00002559 -0.00002544 - -0.00002559 0.00009855 -0.00002533 - -0.00002544 -0.00002533 0.00009899 - #*EXTRAS*# Step: 7 Bead: 54 - 0.00009894 -0.00002663 -0.00002654 - -0.00002663 0.00009896 -0.00002644 - -0.00002654 -0.00002644 0.00009929 - #*EXTRAS*# Step: 8 Bead: 54 - 0.00009924 -0.00002723 -0.00002717 - -0.00002723 0.00009922 -0.00002707 - -0.00002717 -0.00002707 0.00009947 - #*EXTRAS*# Step: 9 Bead: 54 - 0.00009944 -0.00002761 -0.00002758 - -0.00002761 0.00009939 -0.00002748 - -0.00002758 -0.00002748 0.00009959 - #*EXTRAS*# Step: 10 Bead: 54 - 0.00009957 -0.00002786 -0.00002784 - -0.00002786 0.00009951 -0.00002774 - -0.00002784 -0.00002774 0.00009967 - #*EXTRAS*# Step: 11 Bead: 54 - 0.00009965 -0.00002802 -0.00002800 - -0.00002802 0.00009958 -0.00002791 - -0.00002800 -0.00002791 0.00009972 - #*EXTRAS*# Step: 12 Bead: 54 - 0.00009970 -0.00002812 -0.00002811 - -0.00002812 0.00009963 -0.00002802 - -0.00002811 -0.00002802 0.00009976 - #*EXTRAS*# Step: 13 Bead: 54 - 0.00009974 -0.00002818 -0.00002818 - -0.00002818 0.00009966 -0.00002809 - -0.00002818 -0.00002809 0.00009978 - #*EXTRAS*# Step: 14 Bead: 54 - 0.00009976 -0.00002822 -0.00002822 - -0.00002822 0.00009967 -0.00002813 - -0.00002822 -0.00002813 0.00009979 - #*EXTRAS*# Step: 15 Bead: 54 - 0.00009977 -0.00002825 -0.00002825 - -0.00002825 0.00009969 -0.00002816 - -0.00002825 -0.00002816 0.00009980 - #*EXTRAS*# Step: 16 Bead: 54 - 0.00009978 -0.00002827 -0.00002826 - -0.00002827 0.00009970 -0.00002818 - -0.00002826 -0.00002818 0.00009981 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_55 b/drivers/py/pes/friction/frictionH/060K/inst.fric_55 deleted file mode 100644 index 69a83d0b4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_55 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 55 - 0.00010303 -0.00003435 -0.00003431 - -0.00003435 0.00010301 -0.00003455 - -0.00003431 -0.00003455 0.00010262 - #*EXTRAS*# Step: 1 Bead: 55 - 0.00010084 -0.00003037 -0.00003040 - -0.00003037 0.00010072 -0.00003042 - -0.00003040 -0.00003042 0.00010058 - #*EXTRAS*# Step: 2 Bead: 55 - 0.00009873 -0.00002620 -0.00002609 - -0.00002620 0.00009878 -0.00002598 - -0.00002609 -0.00002598 0.00009916 - #*EXTRAS*# Step: 3 Bead: 55 - 0.00009727 -0.00002176 -0.00002145 - -0.00002176 0.00009761 -0.00002142 - -0.00002145 -0.00002142 0.00009824 - #*EXTRAS*# Step: 4 Bead: 55 - 0.00009720 -0.00002099 -0.00002068 - -0.00002099 0.00009755 -0.00002066 - -0.00002068 -0.00002066 0.00009815 - #*EXTRAS*# Step: 5 Bead: 55 - 0.00009767 -0.00002358 -0.00002331 - -0.00002358 0.00009793 -0.00002324 - -0.00002331 -0.00002324 0.00009853 - #*EXTRAS*# Step: 6 Bead: 55 - 0.00009816 -0.00002494 -0.00002474 - -0.00002494 0.00009832 -0.00002465 - -0.00002474 -0.00002465 0.00009883 - #*EXTRAS*# Step: 7 Bead: 55 - 0.00009861 -0.00002596 -0.00002583 - -0.00002596 0.00009869 -0.00002572 - -0.00002583 -0.00002572 0.00009909 - #*EXTRAS*# Step: 8 Bead: 55 - 0.00009889 -0.00002654 -0.00002644 - -0.00002654 0.00009892 -0.00002633 - -0.00002644 -0.00002633 0.00009926 - #*EXTRAS*# Step: 9 Bead: 55 - 0.00009908 -0.00002692 -0.00002684 - -0.00002692 0.00009908 -0.00002674 - -0.00002684 -0.00002674 0.00009937 - #*EXTRAS*# Step: 10 Bead: 55 - 0.00009920 -0.00002715 -0.00002710 - -0.00002715 0.00009919 -0.00002699 - -0.00002710 -0.00002699 0.00009944 - #*EXTRAS*# Step: 11 Bead: 55 - 0.00009928 -0.00002731 -0.00002726 - -0.00002731 0.00009925 -0.00002715 - -0.00002726 -0.00002715 0.00009949 - #*EXTRAS*# Step: 12 Bead: 55 - 0.00009933 -0.00002740 -0.00002736 - -0.00002740 0.00009930 -0.00002726 - -0.00002736 -0.00002726 0.00009952 - #*EXTRAS*# Step: 13 Bead: 55 - 0.00009936 -0.00002747 -0.00002743 - -0.00002747 0.00009933 -0.00002732 - -0.00002743 -0.00002732 0.00009954 - #*EXTRAS*# Step: 14 Bead: 55 - 0.00009939 -0.00002751 -0.00002747 - -0.00002751 0.00009934 -0.00002737 - -0.00002747 -0.00002737 0.00009956 - #*EXTRAS*# Step: 15 Bead: 55 - 0.00009940 -0.00002753 -0.00002750 - -0.00002753 0.00009936 -0.00002739 - -0.00002750 -0.00002739 0.00009956 - #*EXTRAS*# Step: 16 Bead: 55 - 0.00009941 -0.00002755 -0.00002751 - -0.00002755 0.00009936 -0.00002741 - -0.00002751 -0.00002741 0.00009957 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_56 b/drivers/py/pes/friction/frictionH/060K/inst.fric_56 deleted file mode 100644 index 4372cbffd..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_56 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 56 - 0.00010287 -0.00003410 -0.00003406 - -0.00003410 0.00010284 -0.00003429 - -0.00003406 -0.00003429 0.00010245 - #*EXTRAS*# Step: 1 Bead: 56 - 0.00010070 -0.00003009 -0.00003012 - -0.00003009 0.00010058 -0.00003012 - -0.00003012 -0.00003012 0.00010046 - #*EXTRAS*# Step: 2 Bead: 56 - 0.00009858 -0.00002588 -0.00002575 - -0.00002588 0.00009866 -0.00002564 - -0.00002575 -0.00002564 0.00009907 - #*EXTRAS*# Step: 3 Bead: 56 - 0.00009722 -0.00002132 -0.00002101 - -0.00002132 0.00009757 -0.00002099 - -0.00002101 -0.00002099 0.00009819 - #*EXTRAS*# Step: 4 Bead: 56 - 0.00009718 -0.00002044 -0.00002014 - -0.00002044 0.00009753 -0.00002013 - -0.00002014 -0.00002013 0.00009810 - #*EXTRAS*# Step: 5 Bead: 56 - 0.00009752 -0.00002303 -0.00002274 - -0.00002303 0.00009780 -0.00002268 - -0.00002274 -0.00002268 0.00009843 - #*EXTRAS*# Step: 6 Bead: 56 - 0.00009793 -0.00002436 -0.00002412 - -0.00002436 0.00009813 -0.00002404 - -0.00002412 -0.00002404 0.00009870 - #*EXTRAS*# Step: 7 Bead: 56 - 0.00009834 -0.00002536 -0.00002519 - -0.00002536 0.00009846 -0.00002509 - -0.00002519 -0.00002509 0.00009893 - #*EXTRAS*# Step: 8 Bead: 56 - 0.00009859 -0.00002592 -0.00002579 - -0.00002592 0.00009867 -0.00002568 - -0.00002579 -0.00002568 0.00009908 - #*EXTRAS*# Step: 9 Bead: 56 - 0.00009877 -0.00002629 -0.00002618 - -0.00002629 0.00009882 -0.00002607 - -0.00002618 -0.00002607 0.00009919 - #*EXTRAS*# Step: 10 Bead: 56 - 0.00009889 -0.00002653 -0.00002643 - -0.00002653 0.00009892 -0.00002632 - -0.00002643 -0.00002632 0.00009925 - #*EXTRAS*# Step: 11 Bead: 56 - 0.00009896 -0.00002667 -0.00002659 - -0.00002667 0.00009898 -0.00002648 - -0.00002659 -0.00002648 0.00009930 - #*EXTRAS*# Step: 12 Bead: 56 - 0.00009901 -0.00002677 -0.00002669 - -0.00002677 0.00009902 -0.00002658 - -0.00002669 -0.00002658 0.00009933 - #*EXTRAS*# Step: 13 Bead: 56 - 0.00009904 -0.00002683 -0.00002675 - -0.00002683 0.00009904 -0.00002665 - -0.00002675 -0.00002665 0.00009935 - #*EXTRAS*# Step: 14 Bead: 56 - 0.00009906 -0.00002687 -0.00002680 - -0.00002687 0.00009906 -0.00002669 - -0.00002680 -0.00002669 0.00009936 - #*EXTRAS*# Step: 15 Bead: 56 - 0.00009907 -0.00002690 -0.00002682 - -0.00002690 0.00009907 -0.00002671 - -0.00002682 -0.00002671 0.00009937 - #*EXTRAS*# Step: 16 Bead: 56 - 0.00009908 -0.00002691 -0.00002684 - -0.00002691 0.00009908 -0.00002673 - -0.00002684 -0.00002673 0.00009937 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_57 b/drivers/py/pes/friction/frictionH/060K/inst.fric_57 deleted file mode 100644 index 65e442dfc..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_57 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 57 - 0.00010273 -0.00003387 -0.00003384 - -0.00003387 0.00010269 -0.00003406 - -0.00003384 -0.00003406 0.00010231 - #*EXTRAS*# Step: 1 Bead: 57 - 0.00010058 -0.00002984 -0.00002987 - -0.00002984 0.00010045 -0.00002986 - -0.00002987 -0.00002986 0.00010037 - #*EXTRAS*# Step: 2 Bead: 57 - 0.00009845 -0.00002560 -0.00002545 - -0.00002560 0.00009855 -0.00002534 - -0.00002545 -0.00002534 0.00009900 - #*EXTRAS*# Step: 3 Bead: 57 - 0.00009720 -0.00002094 -0.00002063 - -0.00002094 0.00009755 -0.00002061 - -0.00002063 -0.00002061 0.00009815 - #*EXTRAS*# Step: 4 Bead: 57 - 0.00009718 -0.00001996 -0.00001967 - -0.00001996 0.00009753 -0.00001966 - -0.00001967 -0.00001966 0.00009807 - #*EXTRAS*# Step: 5 Bead: 57 - 0.00009740 -0.00002254 -0.00002224 - -0.00002254 0.00009772 -0.00002219 - -0.00002224 -0.00002219 0.00009835 - #*EXTRAS*# Step: 6 Bead: 57 - 0.00009775 -0.00002384 -0.00002358 - -0.00002384 0.00009799 -0.00002351 - -0.00002358 -0.00002351 0.00009859 - #*EXTRAS*# Step: 7 Bead: 57 - 0.00009812 -0.00002483 -0.00002463 - -0.00002483 0.00009828 -0.00002454 - -0.00002463 -0.00002454 0.00009880 - #*EXTRAS*# Step: 8 Bead: 57 - 0.00009835 -0.00002538 -0.00002521 - -0.00002538 0.00009847 -0.00002511 - -0.00002521 -0.00002511 0.00009894 - #*EXTRAS*# Step: 9 Bead: 57 - 0.00009851 -0.00002575 -0.00002560 - -0.00002575 0.00009860 -0.00002550 - -0.00002560 -0.00002550 0.00009904 - #*EXTRAS*# Step: 10 Bead: 57 - 0.00009862 -0.00002597 -0.00002584 - -0.00002597 0.00009869 -0.00002574 - -0.00002584 -0.00002574 0.00009910 - #*EXTRAS*# Step: 11 Bead: 57 - 0.00009869 -0.00002612 -0.00002600 - -0.00002612 0.00009875 -0.00002589 - -0.00002600 -0.00002589 0.00009914 - #*EXTRAS*# Step: 12 Bead: 57 - 0.00009873 -0.00002622 -0.00002610 - -0.00002622 0.00009879 -0.00002599 - -0.00002610 -0.00002599 0.00009917 - #*EXTRAS*# Step: 13 Bead: 57 - 0.00009876 -0.00002627 -0.00002616 - -0.00002627 0.00009881 -0.00002605 - -0.00002616 -0.00002605 0.00009918 - #*EXTRAS*# Step: 14 Bead: 57 - 0.00009878 -0.00002631 -0.00002620 - -0.00002631 0.00009883 -0.00002610 - -0.00002620 -0.00002610 0.00009919 - #*EXTRAS*# Step: 15 Bead: 57 - 0.00009879 -0.00002634 -0.00002623 - -0.00002634 0.00009884 -0.00002612 - -0.00002623 -0.00002612 0.00009920 - #*EXTRAS*# Step: 16 Bead: 57 - 0.00009880 -0.00002635 -0.00002625 - -0.00002635 0.00009884 -0.00002614 - -0.00002625 -0.00002614 0.00009920 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_58 b/drivers/py/pes/friction/frictionH/060K/inst.fric_58 deleted file mode 100644 index 3271af054..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_58 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 58 - 0.00010261 -0.00003368 -0.00003365 - -0.00003368 0.00010257 -0.00003386 - -0.00003365 -0.00003386 0.00010219 - #*EXTRAS*# Step: 1 Bead: 58 - 0.00010047 -0.00002962 -0.00002966 - -0.00002962 0.00010035 -0.00002963 - -0.00002966 -0.00002963 0.00010029 - #*EXTRAS*# Step: 2 Bead: 58 - 0.00009834 -0.00002536 -0.00002519 - -0.00002536 0.00009846 -0.00002509 - -0.00002519 -0.00002509 0.00009893 - #*EXTRAS*# Step: 3 Bead: 58 - 0.00009718 -0.00002060 -0.00002030 - -0.00002060 0.00009753 -0.00002028 - -0.00002030 -0.00002028 0.00009812 - #*EXTRAS*# Step: 4 Bead: 58 - 0.00009720 -0.00001954 -0.00001927 - -0.00001954 0.00009754 -0.00001927 - -0.00001927 -0.00001927 0.00009804 - #*EXTRAS*# Step: 5 Bead: 58 - 0.00009733 -0.00002212 -0.00002181 - -0.00002212 0.00009765 -0.00002177 - -0.00002181 -0.00002177 0.00009829 - #*EXTRAS*# Step: 6 Bead: 58 - 0.00009762 -0.00002340 -0.00002312 - -0.00002340 0.00009788 -0.00002306 - -0.00002312 -0.00002306 0.00009850 - #*EXTRAS*# Step: 7 Bead: 58 - 0.00009794 -0.00002438 -0.00002415 - -0.00002438 0.00009814 -0.00002406 - -0.00002415 -0.00002406 0.00009870 - #*EXTRAS*# Step: 8 Bead: 58 - 0.00009815 -0.00002492 -0.00002472 - -0.00002492 0.00009831 -0.00002463 - -0.00002472 -0.00002463 0.00009882 - #*EXTRAS*# Step: 9 Bead: 58 - 0.00009830 -0.00002528 -0.00002510 - -0.00002528 0.00009843 -0.00002500 - -0.00002510 -0.00002500 0.00009891 - #*EXTRAS*# Step: 10 Bead: 58 - 0.00009840 -0.00002550 -0.00002534 - -0.00002550 0.00009851 -0.00002524 - -0.00002534 -0.00002524 0.00009897 - #*EXTRAS*# Step: 11 Bead: 58 - 0.00009847 -0.00002565 -0.00002549 - -0.00002565 0.00009857 -0.00002539 - -0.00002549 -0.00002539 0.00009901 - #*EXTRAS*# Step: 12 Bead: 58 - 0.00009851 -0.00002574 -0.00002559 - -0.00002574 0.00009860 -0.00002549 - -0.00002559 -0.00002549 0.00009903 - #*EXTRAS*# Step: 13 Bead: 58 - 0.00009854 -0.00002580 -0.00002565 - -0.00002580 0.00009862 -0.00002555 - -0.00002565 -0.00002555 0.00009905 - #*EXTRAS*# Step: 14 Bead: 58 - 0.00009855 -0.00002583 -0.00002569 - -0.00002583 0.00009864 -0.00002559 - -0.00002569 -0.00002559 0.00009906 - #*EXTRAS*# Step: 15 Bead: 58 - 0.00009856 -0.00002586 -0.00002572 - -0.00002586 0.00009865 -0.00002561 - -0.00002572 -0.00002561 0.00009907 - #*EXTRAS*# Step: 16 Bead: 58 - 0.00009857 -0.00002587 -0.00002573 - -0.00002587 0.00009865 -0.00002563 - -0.00002573 -0.00002563 0.00009907 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_59 b/drivers/py/pes/friction/frictionH/060K/inst.fric_59 deleted file mode 100644 index 2c4520e12..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_59 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 59 - 0.00010252 -0.00003351 -0.00003348 - -0.00003351 0.00010246 -0.00003369 - -0.00003348 -0.00003369 0.00010209 - #*EXTRAS*# Step: 1 Bead: 59 - 0.00010038 -0.00002944 -0.00002947 - -0.00002944 0.00010026 -0.00002944 - -0.00002947 -0.00002944 0.00010022 - #*EXTRAS*# Step: 2 Bead: 59 - 0.00009825 -0.00002516 -0.00002497 - -0.00002516 0.00009839 -0.00002488 - -0.00002497 -0.00002488 0.00009888 - #*EXTRAS*# Step: 3 Bead: 59 - 0.00009718 -0.00002032 -0.00002003 - -0.00002032 0.00009753 -0.00002002 - -0.00002003 -0.00002002 0.00009809 - #*EXTRAS*# Step: 4 Bead: 59 - 0.00009722 -0.00001919 -0.00001893 - -0.00001919 0.00009755 -0.00001894 - -0.00001893 -0.00001894 0.00009802 - #*EXTRAS*# Step: 5 Bead: 59 - 0.00009727 -0.00002177 -0.00002145 - -0.00002177 0.00009761 -0.00002142 - -0.00002145 -0.00002142 0.00009824 - #*EXTRAS*# Step: 6 Bead: 59 - 0.00009752 -0.00002303 -0.00002274 - -0.00002303 0.00009780 -0.00002268 - -0.00002274 -0.00002268 0.00009843 - #*EXTRAS*# Step: 7 Bead: 59 - 0.00009780 -0.00002399 -0.00002374 - -0.00002399 0.00009803 -0.00002367 - -0.00002374 -0.00002367 0.00009862 - #*EXTRAS*# Step: 8 Bead: 59 - 0.00009800 -0.00002453 -0.00002431 - -0.00002453 0.00009819 -0.00002422 - -0.00002431 -0.00002422 0.00009873 - #*EXTRAS*# Step: 9 Bead: 59 - 0.00009814 -0.00002488 -0.00002468 - -0.00002488 0.00009830 -0.00002459 - -0.00002468 -0.00002459 0.00009882 - #*EXTRAS*# Step: 10 Bead: 59 - 0.00009823 -0.00002511 -0.00002492 - -0.00002511 0.00009837 -0.00002482 - -0.00002492 -0.00002482 0.00009887 - #*EXTRAS*# Step: 11 Bead: 59 - 0.00009829 -0.00002525 -0.00002507 - -0.00002525 0.00009842 -0.00002497 - -0.00002507 -0.00002497 0.00009891 - #*EXTRAS*# Step: 12 Bead: 59 - 0.00009833 -0.00002534 -0.00002517 - -0.00002534 0.00009845 -0.00002507 - -0.00002517 -0.00002507 0.00009893 - #*EXTRAS*# Step: 13 Bead: 59 - 0.00009835 -0.00002540 -0.00002523 - -0.00002540 0.00009848 -0.00002513 - -0.00002523 -0.00002513 0.00009894 - #*EXTRAS*# Step: 14 Bead: 59 - 0.00009837 -0.00002543 -0.00002527 - -0.00002543 0.00009849 -0.00002517 - -0.00002527 -0.00002517 0.00009895 - #*EXTRAS*# Step: 15 Bead: 59 - 0.00009838 -0.00002546 -0.00002529 - -0.00002546 0.00009850 -0.00002519 - -0.00002529 -0.00002519 0.00009896 - #*EXTRAS*# Step: 16 Bead: 59 - 0.00009839 -0.00002547 -0.00002531 - -0.00002547 0.00009850 -0.00002521 - -0.00002531 -0.00002521 0.00009896 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_60 b/drivers/py/pes/friction/frictionH/060K/inst.fric_60 deleted file mode 100644 index a5af0b500..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_60 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 60 - 0.00010243 -0.00003337 -0.00003335 - -0.00003337 0.00010238 -0.00003355 - -0.00003335 -0.00003355 0.00010201 - #*EXTRAS*# Step: 1 Bead: 60 - 0.00010031 -0.00002930 -0.00002932 - -0.00002930 0.00010019 -0.00002928 - -0.00002932 -0.00002928 0.00010017 - #*EXTRAS*# Step: 2 Bead: 60 - 0.00009818 -0.00002499 -0.00002480 - -0.00002499 0.00009834 -0.00002470 - -0.00002480 -0.00002470 0.00009884 - #*EXTRAS*# Step: 3 Bead: 60 - 0.00009718 -0.00002010 -0.00001981 - -0.00002010 0.00009753 -0.00001980 - -0.00001981 -0.00001980 0.00009808 - #*EXTRAS*# Step: 4 Bead: 60 - 0.00009724 -0.00001892 -0.00001867 - -0.00001892 0.00009756 -0.00001867 - -0.00001867 -0.00001867 0.00009801 - #*EXTRAS*# Step: 5 Bead: 60 - 0.00009724 -0.00002148 -0.00002117 - -0.00002148 0.00009758 -0.00002114 - -0.00002117 -0.00002114 0.00009821 - #*EXTRAS*# Step: 6 Bead: 60 - 0.00009745 -0.00002273 -0.00002243 - -0.00002273 0.00009775 -0.00002238 - -0.00002243 -0.00002238 0.00009838 - #*EXTRAS*# Step: 7 Bead: 60 - 0.00009770 -0.00002369 -0.00002342 - -0.00002369 0.00009795 -0.00002335 - -0.00002342 -0.00002335 0.00009856 - #*EXTRAS*# Step: 8 Bead: 60 - 0.00009788 -0.00002422 -0.00002398 - -0.00002422 0.00009809 -0.00002390 - -0.00002398 -0.00002390 0.00009866 - #*EXTRAS*# Step: 9 Bead: 60 - 0.00009801 -0.00002457 -0.00002435 - -0.00002457 0.00009820 -0.00002426 - -0.00002435 -0.00002426 0.00009874 - #*EXTRAS*# Step: 10 Bead: 60 - 0.00009810 -0.00002479 -0.00002458 - -0.00002479 0.00009827 -0.00002449 - -0.00002458 -0.00002449 0.00009879 - #*EXTRAS*# Step: 11 Bead: 60 - 0.00009816 -0.00002493 -0.00002473 - -0.00002493 0.00009831 -0.00002464 - -0.00002473 -0.00002464 0.00009883 - #*EXTRAS*# Step: 12 Bead: 60 - 0.00009819 -0.00002502 -0.00002482 - -0.00002502 0.00009834 -0.00002473 - -0.00002482 -0.00002473 0.00009885 - #*EXTRAS*# Step: 13 Bead: 60 - 0.00009822 -0.00002508 -0.00002489 - -0.00002508 0.00009836 -0.00002479 - -0.00002489 -0.00002479 0.00009886 - #*EXTRAS*# Step: 14 Bead: 60 - 0.00009823 -0.00002511 -0.00002492 - -0.00002511 0.00009838 -0.00002483 - -0.00002492 -0.00002483 0.00009887 - #*EXTRAS*# Step: 15 Bead: 60 - 0.00009824 -0.00002514 -0.00002495 - -0.00002514 0.00009838 -0.00002485 - -0.00002495 -0.00002485 0.00009888 - #*EXTRAS*# Step: 16 Bead: 60 - 0.00009825 -0.00002515 -0.00002497 - -0.00002515 0.00009839 -0.00002487 - -0.00002497 -0.00002487 0.00009888 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_61 b/drivers/py/pes/friction/frictionH/060K/inst.fric_61 deleted file mode 100644 index 6e5e2c419..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_61 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 61 - 0.00010237 -0.00003327 -0.00003325 - -0.00003327 0.00010231 -0.00003345 - -0.00003325 -0.00003345 0.00010195 - #*EXTRAS*# Step: 1 Bead: 61 - 0.00010025 -0.00002918 -0.00002921 - -0.00002918 0.00010013 -0.00002916 - -0.00002921 -0.00002916 0.00010013 - #*EXTRAS*# Step: 2 Bead: 61 - 0.00009813 -0.00002487 -0.00002466 - -0.00002487 0.00009829 -0.00002457 - -0.00002466 -0.00002457 0.00009881 - #*EXTRAS*# Step: 3 Bead: 61 - 0.00009718 -0.00001993 -0.00001964 - -0.00001993 0.00009753 -0.00001964 - -0.00001964 -0.00001964 0.00009806 - #*EXTRAS*# Step: 4 Bead: 61 - 0.00009726 -0.00001871 -0.00001847 - -0.00001871 0.00009758 -0.00001847 - -0.00001847 -0.00001847 0.00009800 - #*EXTRAS*# Step: 5 Bead: 61 - 0.00009722 -0.00002127 -0.00002095 - -0.00002127 0.00009757 -0.00002093 - -0.00002095 -0.00002093 0.00009818 - #*EXTRAS*# Step: 6 Bead: 61 - 0.00009740 -0.00002250 -0.00002220 - -0.00002250 0.00009771 -0.00002215 - -0.00002220 -0.00002215 0.00009835 - #*EXTRAS*# Step: 7 Bead: 61 - 0.00009763 -0.00002346 -0.00002318 - -0.00002346 0.00009790 -0.00002312 - -0.00002318 -0.00002312 0.00009851 - #*EXTRAS*# Step: 8 Bead: 61 - 0.00009780 -0.00002398 -0.00002373 - -0.00002398 0.00009803 -0.00002365 - -0.00002373 -0.00002365 0.00009861 - #*EXTRAS*# Step: 9 Bead: 61 - 0.00009792 -0.00002433 -0.00002410 - -0.00002433 0.00009813 -0.00002401 - -0.00002410 -0.00002401 0.00009869 - #*EXTRAS*# Step: 10 Bead: 61 - 0.00009800 -0.00002455 -0.00002433 - -0.00002455 0.00009819 -0.00002424 - -0.00002433 -0.00002424 0.00009874 - #*EXTRAS*# Step: 11 Bead: 61 - 0.00009806 -0.00002469 -0.00002447 - -0.00002469 0.00009824 -0.00002439 - -0.00002447 -0.00002439 0.00009877 - #*EXTRAS*# Step: 12 Bead: 61 - 0.00009809 -0.00002478 -0.00002457 - -0.00002478 0.00009826 -0.00002448 - -0.00002457 -0.00002448 0.00009879 - #*EXTRAS*# Step: 13 Bead: 61 - 0.00009812 -0.00002483 -0.00002463 - -0.00002483 0.00009828 -0.00002454 - -0.00002463 -0.00002454 0.00009880 - #*EXTRAS*# Step: 14 Bead: 61 - 0.00009813 -0.00002487 -0.00002467 - -0.00002487 0.00009829 -0.00002458 - -0.00002467 -0.00002458 0.00009881 - #*EXTRAS*# Step: 15 Bead: 61 - 0.00009814 -0.00002489 -0.00002469 - -0.00002489 0.00009830 -0.00002460 - -0.00002469 -0.00002460 0.00009882 - #*EXTRAS*# Step: 16 Bead: 61 - 0.00009815 -0.00002491 -0.00002471 - -0.00002491 0.00009831 -0.00002462 - -0.00002471 -0.00002462 0.00009882 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_62 b/drivers/py/pes/friction/frictionH/060K/inst.fric_62 deleted file mode 100644 index ad22e7a79..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_62 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 62 - 0.00010233 -0.00003319 -0.00003317 - -0.00003319 0.00010227 -0.00003337 - -0.00003317 -0.00003337 0.00010191 - #*EXTRAS*# Step: 1 Bead: 62 - 0.00010021 -0.00002910 -0.00002913 - -0.00002910 0.00010009 -0.00002907 - -0.00002913 -0.00002907 0.00010010 - #*EXTRAS*# Step: 2 Bead: 62 - 0.00009809 -0.00002478 -0.00002457 - -0.00002478 0.00009826 -0.00002448 - -0.00002457 -0.00002448 0.00009879 - #*EXTRAS*# Step: 3 Bead: 62 - 0.00009719 -0.00001981 -0.00001953 - -0.00001981 0.00009753 -0.00001952 - -0.00001953 -0.00001952 0.00009806 - #*EXTRAS*# Step: 4 Bead: 62 - 0.00009728 -0.00001857 -0.00001834 - -0.00001857 0.00009759 -0.00001834 - -0.00001834 -0.00001834 0.00009800 - #*EXTRAS*# Step: 5 Bead: 62 - 0.00009721 -0.00002112 -0.00002081 - -0.00002112 0.00009756 -0.00002079 - -0.00002081 -0.00002079 0.00009817 - #*EXTRAS*# Step: 6 Bead: 62 - 0.00009737 -0.00002235 -0.00002204 - -0.00002235 0.00009769 -0.00002200 - -0.00002204 -0.00002200 0.00009832 - #*EXTRAS*# Step: 7 Bead: 62 - 0.00009759 -0.00002330 -0.00002302 - -0.00002330 0.00009786 -0.00002296 - -0.00002302 -0.00002296 0.00009848 - #*EXTRAS*# Step: 8 Bead: 62 - 0.00009775 -0.00002382 -0.00002356 - -0.00002382 0.00009799 -0.00002349 - -0.00002356 -0.00002349 0.00009858 - #*EXTRAS*# Step: 9 Bead: 62 - 0.00009787 -0.00002417 -0.00002393 - -0.00002417 0.00009808 -0.00002385 - -0.00002393 -0.00002385 0.00009866 - #*EXTRAS*# Step: 10 Bead: 62 - 0.00009794 -0.00002439 -0.00002416 - -0.00002439 0.00009814 -0.00002407 - -0.00002416 -0.00002407 0.00009870 - #*EXTRAS*# Step: 11 Bead: 62 - 0.00009800 -0.00002453 -0.00002430 - -0.00002453 0.00009819 -0.00002422 - -0.00002430 -0.00002422 0.00009873 - #*EXTRAS*# Step: 12 Bead: 62 - 0.00009803 -0.00002462 -0.00002440 - -0.00002462 0.00009821 -0.00002431 - -0.00002440 -0.00002431 0.00009875 - #*EXTRAS*# Step: 13 Bead: 62 - 0.00009805 -0.00002467 -0.00002446 - -0.00002467 0.00009823 -0.00002437 - -0.00002446 -0.00002437 0.00009877 - #*EXTRAS*# Step: 14 Bead: 62 - 0.00009807 -0.00002471 -0.00002450 - -0.00002471 0.00009824 -0.00002441 - -0.00002450 -0.00002441 0.00009878 - #*EXTRAS*# Step: 15 Bead: 62 - 0.00009808 -0.00002473 -0.00002452 - -0.00002473 0.00009825 -0.00002443 - -0.00002452 -0.00002443 0.00009878 - #*EXTRAS*# Step: 16 Bead: 62 - 0.00009808 -0.00002475 -0.00002454 - -0.00002475 0.00009825 -0.00002445 - -0.00002454 -0.00002445 0.00009878 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.fric_63 b/drivers/py/pes/friction/frictionH/060K/inst.fric_63 deleted file mode 100644 index f7bdcb1c6..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.fric_63 +++ /dev/null @@ -1,68 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 63 - 0.00010230 -0.00003314 -0.00003313 - -0.00003314 0.00010224 -0.00003332 - -0.00003313 -0.00003332 0.00010188 - #*EXTRAS*# Step: 1 Bead: 63 - 0.00010018 -0.00002905 -0.00002908 - -0.00002905 0.00010007 -0.00002902 - -0.00002908 -0.00002902 0.00010008 - #*EXTRAS*# Step: 2 Bead: 63 - 0.00009807 -0.00002473 -0.00002452 - -0.00002473 0.00009825 -0.00002443 - -0.00002452 -0.00002443 0.00009878 - #*EXTRAS*# Step: 3 Bead: 63 - 0.00009719 -0.00001975 -0.00001947 - -0.00001975 0.00009753 -0.00001946 - -0.00001947 -0.00001946 0.00009805 - #*EXTRAS*# Step: 4 Bead: 63 - 0.00009728 -0.00001850 -0.00001827 - -0.00001850 0.00009759 -0.00001828 - -0.00001827 -0.00001828 0.00009800 - #*EXTRAS*# Step: 5 Bead: 63 - 0.00009720 -0.00002105 -0.00002074 - -0.00002105 0.00009755 -0.00002072 - -0.00002074 -0.00002072 0.00009816 - #*EXTRAS*# Step: 6 Bead: 63 - 0.00009735 -0.00002227 -0.00002196 - -0.00002227 0.00009767 -0.00002192 - -0.00002196 -0.00002192 0.00009831 - #*EXTRAS*# Step: 7 Bead: 63 - 0.00009757 -0.00002322 -0.00002294 - -0.00002322 0.00009785 -0.00002288 - -0.00002294 -0.00002288 0.00009847 - #*EXTRAS*# Step: 8 Bead: 63 - 0.00009772 -0.00002374 -0.00002348 - -0.00002374 0.00009797 -0.00002341 - -0.00002348 -0.00002341 0.00009857 - #*EXTRAS*# Step: 9 Bead: 63 - 0.00009784 -0.00002409 -0.00002385 - -0.00002409 0.00009806 -0.00002377 - -0.00002385 -0.00002377 0.00009864 - #*EXTRAS*# Step: 10 Bead: 63 - 0.00009791 -0.00002431 -0.00002407 - -0.00002431 0.00009812 -0.00002399 - -0.00002407 -0.00002399 0.00009868 - #*EXTRAS*# Step: 11 Bead: 63 - 0.00009797 -0.00002445 -0.00002422 - -0.00002445 0.00009816 -0.00002413 - -0.00002422 -0.00002413 0.00009872 - #*EXTRAS*# Step: 12 Bead: 63 - 0.00009800 -0.00002453 -0.00002431 - -0.00002453 0.00009819 -0.00002423 - -0.00002431 -0.00002423 0.00009874 - #*EXTRAS*# Step: 13 Bead: 63 - 0.00009802 -0.00002459 -0.00002437 - -0.00002459 0.00009821 -0.00002429 - -0.00002437 -0.00002429 0.00009875 - #*EXTRAS*# Step: 14 Bead: 63 - 0.00009804 -0.00002463 -0.00002441 - -0.00002463 0.00009822 -0.00002432 - -0.00002441 -0.00002432 0.00009876 - #*EXTRAS*# Step: 15 Bead: 63 - 0.00009804 -0.00002465 -0.00002444 - -0.00002465 0.00009822 -0.00002435 - -0.00002444 -0.00002435 0.00009876 - #*EXTRAS*# Step: 16 Bead: 63 - 0.00009805 -0.00002467 -0.00002445 - -0.00002467 0.00009823 -0.00002436 - -0.00002445 -0.00002436 0.00009877 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 deleted file mode 100644 index 27460fb49..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -3.687051698286220730e-03 6.712672122199119407e-05 6.670489072127725708e-05 3.597103919094801067e-03 6.688353855426881094e-05 6.637432355016311401e-05 3.446380541554903542e-03 6.642988968271351126e-05 6.577450647052704099e-05 3.233794819632444285e-03 6.577054042733922071e-05 6.490807272544913960e-05 2.957929087122570209e-03 6.491116763040295562e-05 6.377948466901779700e-05 2.617100172870378844e-03 6.383725057939182294e-05 6.239852517102376919e-05 2.209817986040916657e-03 6.253454902204098626e-05 6.077594699559518189e-05 1.734890920274673089e-03 6.099384955601493672e-05 5.892223834795439272e-05 1.191713364145808619e-03 5.920485472984547866e-05 5.684839035742755668e-05 5.807302485874060900e-04 5.715646574297206126e-05 5.456558587034316906e-05 -9.583373646323547698e-05 5.483741080720607998e-05 5.208513874986009194e-05 -8.334336371683538462e-04 5.223662326176469389e-05 4.941784204856275155e-05 -1.624412779297941273e-03 4.934374824443024020e-05 4.657347105755226132e-05 -2.456767071165043802e-03 4.614997513664092431e-05 4.356063294874185668e-05 -3.312264498972893913e-03 4.265007699147176453e-05 4.038763604702730092e-05 -4.171955007478755223e-03 3.884484766268979210e-05 3.706341835737469043e-05 -5.021208332479681034e-03 3.474270766629070670e-05 3.359790397837897233e-05 -5.844570605133197344e-03 3.036295808641363613e-05 3.000406666772550819e-05 -6.625262159391994213e-03 2.574125236313446524e-05 2.630179817570448000e-05 -7.345737084648504972e-03 2.107281317731112612e-05 2.256006944115106897e-05 -7.996581183419889521e-03 1.700339321139999750e-05 1.899385535701655537e-05 -8.581919687979049083e-03 1.364408711491314641e-05 1.569715570056485668e-05 -9.119846779993261848e-03 1.100554512546160503e-05 1.273640074960215298e-05 -9.618205574438298475e-03 9.058542434013535743e-06 1.016265520293274001e-05 -1.006953860409344481e-02 7.729031766260979598e-06 8.005806112683246220e-06 -1.046227975324630875e-02 6.611123482606055839e-06 6.212737789760365811e-06 -1.075498312543026087e-02 5.361067485013917503e-06 4.714317308709317685e-06 -1.091448607726847563e-02 4.113517334544000208e-06 3.527307720055954718e-06 -1.093365237087965021e-02 3.027279127259768908e-06 2.673317802858884083e-06 -1.080852581671578987e-02 2.278755168214131729e-06 2.177551986360540227e-06 -1.058610477844376847e-02 2.068376842829107218e-06 2.067826896375531711e-06 -1.032149855623353679e-02 2.423463171366299489e-06 2.344498367174619087e-06 -1.001658513728016786e-02 3.227461798890613779e-06 2.978654107807571406e-06 -9.673862962391878081e-03 4.351809101365188379e-06 3.929788473729555465e-06 -9.293576645292915897e-03 5.663792845375619380e-06 5.149443811296981596e-06 -8.850179563279660447e-03 7.033938319953675549e-06 6.585301668762582057e-06 -8.323984071424943634e-03 8.451557743365051959e-06 8.191676061713374689e-06 -7.720099426882075927e-03 9.979659884623571354e-06 9.927826188797614262e-06 -7.048479129469204310e-03 1.160475364162369928e-05 1.174986676453138874e-05 -6.325205329894943371e-03 1.331208589211437322e-05 1.361714004026895923e-05 -5.590370455630477679e-03 1.508653716930309882e-05 1.549352288616760091e-05 -4.877878488176916848e-03 1.691271420505579030e-05 1.734757131791209584e-05 -4.209175003122370314e-03 1.877255302750453393e-05 1.915609080720812157e-05 -3.592482823959020077e-03 2.062211040169201006e-05 2.093283454958367050e-05 -3.025621890646428610e-03 2.243522943541333354e-05 2.266975808486205865e-05 -2.505776739150898831e-03 2.419485354316840448e-05 2.435138896146921516e-05 -2.030228049916816147e-03 2.588628420425477110e-05 2.596430979690243665e-05 -1.596049016924913286e-03 2.749721947780918175e-05 2.749725108402574402e-05 -1.199909672781787184e-03 2.901819301162580531e-05 2.894153045697316648e-05 -8.388471405732045392e-04 3.044221906136097421e-05 3.029077744283365477e-05 -5.103592734777898359e-04 3.176438837619366190e-05 3.154060100440498834e-05 -2.123015750098865197e-04 3.298171429531471124e-05 3.268846548383386066e-05 5.724683057222812801e-05 3.409304221179517618e-05 3.373360860153026657e-05 3.000009321055775377e-04 3.509873838555792590e-05 3.467675291752791663e-05 5.174372267731147581e-04 3.599998792473017362e-05 3.551976649211241905e-05 7.107745281670547512e-04 3.679196173016733998e-05 3.626638779259347569e-05 8.810316192170097004e-04 3.747691184278350868e-05 3.692057963552922292e-05 1.029113537900126036e-03 3.806125610085348281e-05 3.748585628435021331e-05 1.155813179166867433e-03 3.855107887547841840e-05 3.796552347387085156e-05 1.261815702870578695e-03 3.895194583877019368e-05 3.836258129766081395e-05 1.347706890221104462e-03 3.926876328570906284e-05 3.867965686323870819e-05 1.413972233150879781e-03 3.950565694881715928e-05 3.891894207394869281e-05 1.460987031222276029e-03 3.966586896449487694e-05 3.908213406009789843e-05 1.489049428411310001e-03 3.975174206213562901e-05 3.917045491972642062e-05 6.214209113239468646e-14 5.511521609455126702e-01 -1.440461788627384835e-10 6.331713199828990170e-14 5.511521609436190738e-01 -1.459721370424086715e-10 6.568875180584725120e-14 5.511521609398757349e-01 -1.497759379378698888e-10 6.927410859922842119e-14 5.511521609343169592e-01 -1.554202856507819117e-10 7.410775429293318489e-14 5.511521609269821598e-01 -1.628606955975279655e-10 8.010534227013608141e-14 5.511521609181956327e-01 -1.717616851374863036e-10 8.713747750575614579e-14 5.511521609083643858e-01 -1.817002004970280558e-10 9.503508775222376797e-14 5.511521608979391695e-01 -1.922074808801443090e-10 1.035338248661194884e-13 5.511521608875008527e-01 -2.026824021046269175e-10 1.122577710929522599e-13 5.511521608777599779e-01 -2.123946745851595849e-10 1.207173668336919303e-13 5.511521608695313379e-01 -2.205136838167573965e-10 1.283285449201366031e-13 5.511521608636760217e-01 -2.261699359770594329e-10 1.344680192224075975e-13 5.511521608609963874e-01 -2.285650833451976212e-10 1.385891092937863876e-13 5.511521608620525425e-01 -2.271570400857380375e-10 1.404279169742880858e-13 5.511521608668762395e-01 -2.219456903886431852e-10 1.398111648604193786e-13 5.511521608753515711e-01 -2.130871832821229697e-10 1.363311193391863769e-13 5.511521608877174572e-01 -2.003907086937662677e-10 1.296332279462241204e-13 5.511521609040913594e-01 -1.837891677527814647e-10 1.194814607441080576e-13 5.511521609243902331e-01 -1.634116578762896029e-10 1.067201906503765902e-13 5.511521609470668714e-01 -1.408239914331950504e-10 9.559626567381097086e-14 5.511521609663658783e-01 -1.217204848136540275e-10 8.675384355202638819e-14 5.511521609818084144e-01 -1.065232692331022409e-10 7.826018714004599400e-14 5.511521609961206325e-01 -9.247984378541648959e-11 6.865327774983465594e-14 5.511521610111320690e-01 -7.772592566641969480e-11 5.845239372775131977e-14 5.511521610262076765e-01 -6.285324408698775428e-11 4.459613189849634237e-14 5.511521610444052310e-01 -4.480067316967160117e-11 2.676115642486135634e-14 5.511521610649975367e-01 -2.430378012351983758e-11 9.364768478166032892e-15 5.511521610822469608e-01 -7.116455060910917107e-12 -1.586357099130291161e-14 5.511521610971128471e-01 7.691071487743581985e-12 -1.555801750953922711e-13 5.511521610493128609e-01 -3.988431500101186017e-11 -8.436026159030876454e-18 5.511521610892911038e-01 -9.746677626237533906e-14 6.763954804758626228e-16 5.511521610870893095e-01 -2.297252063625242817e-12 3.591251604890730770e-15 5.511521610811930261e-01 -8.183055272277690210e-12 8.268742835797673090e-15 5.511521610732805776e-01 -1.608783843325309575e-11 1.434592662600943016e-14 5.511521610637003521e-01 -2.566324457434849331e-11 2.298967289762069510e-14 5.511521610502575497e-01 -3.909493309481234838e-11 3.441252110610368102e-14 5.511521610326676202e-01 -5.665689329196240353e-11 4.721385074639117364e-14 5.511521610131441262e-01 -7.612960189599252253e-11 6.075750805272908347e-14 5.511521609924774356e-01 -9.672061468428386489e-11 7.402449115615789610e-14 5.511521609720498871e-01 -1.170532187493449933e-10 8.447714691322213181e-14 5.511521609556545576e-01 -1.333544322496923096e-10 9.009821829674368123e-14 5.511521609463335691e-01 -1.426065120650560898e-10 9.026586366509137767e-14 5.511521609450843462e-01 -1.438270907742335793e-10 8.801600169474791288e-14 5.511521609471893290e-01 -1.417180839858029265e-10 8.442512943189696533e-14 5.511521609510482422e-01 -1.378715929674737266e-10 7.976304953128347428e-14 5.511521609563609925e-01 -1.325845919040982410e-10 7.430737309625810828e-14 5.511521609628218243e-01 -1.261602247636665643e-10 6.834633733987281064e-14 5.511521609701016677e-01 -1.189252586792375370e-10 6.215863819747300337e-14 5.511521609778677888e-01 -1.112095457792338626e-10 5.597415964171980122e-14 5.511521609858432980e-01 -1.032876807044603081e-10 4.997475692334316975e-14 5.511521609938024868e-01 -9.538319687208626512e-11 4.429830358644298412e-14 5.511521610015637229e-01 -8.767569085822535484e-11 3.904346343482311428e-14 5.511521610089836765e-01 -8.030683330288472383e-11 3.427455191017545334e-14 5.511521610159516582e-01 -7.338601972844311365e-11 3.002599166778990511e-14 5.511521610223859557e-01 -6.699369006055789614e-11 2.629294900226683282e-14 5.511521610282641426e-01 -6.115105752093845831e-11 2.307091134815450859e-14 5.511521610335439192e-01 -5.590006740079363682e-11 2.034833358377567131e-14 5.511521610381819869e-01 -5.128450764645520049e-11 1.810094353643771280e-14 5.511521610421544759e-01 -4.732884702281752487e-11 1.629736078766880961e-14 5.511521610454530595e-01 -4.404256259996911319e-11 1.490408802447140001e-14 5.511521610480795141e-01 -4.142468940535541621e-11 1.388974164039281374e-14 5.511521610500415003e-01 -3.946839838051796434e-11 1.322851160710758841e-14 5.511521610513478997e-01 -3.816542134986832716e-11 1.290301829491247340e-14 5.511521610520045966e-01 -3.751025659229732100e-11 6.221501606188175836e-14 -1.440461788627384835e-10 5.511521609451746073e-01 6.340457957774758025e-14 -1.459721370424086715e-10 5.511521609432161739e-01 6.580376380814082238e-14 -1.497759379378698888e-10 5.511521609393517096e-01 6.942925353255286829e-14 -1.554202856507819117e-10 5.511521609336215155e-01 7.431444783674093954e-14 -1.628606955975279655e-10 5.511521609260749965e-01 8.037083459709717845e-14 -1.717616851374863036e-10 5.511521609170589864e-01 8.746225093946231463e-14 -1.817002004970280558e-10 5.511521609070124672e-01 9.541070542232824708e-14 -1.922074808801443090e-10 5.511521608964227159e-01 1.039406478252956770e-13 -2.026824021046269175e-10 5.511521608859111243e-01 1.126634471502650911e-13 -2.123946745851595849e-10 5.511521608762276481e-01 1.210770634005833960e-13 -2.205136838167573965e-10 5.511521608682191653e-01 1.285878473126325697e-13 -2.261699359770594329e-10 5.511521608627629742e-01 1.345690291161829474e-13 -2.285650833451976212e-10 5.511521608606532174e-01 1.384792286492893424e-13 -2.271570400857380375e-10 5.511521608624130319e-01 1.400695205470633384e-13 -2.219456903886431852e-10 5.511521608680107764e-01 1.391899063616154696e-13 -2.130871832821229697e-10 5.511521608772496084e-01 1.354646178765349879e-13 -2.003907086937662677e-10 5.511521608902728575e-01 1.285773269130440025e-13 -1.837891677527814647e-10 5.511521609070978434e-01 1.183315219454823936e-13 -1.634116578762896029e-10 5.511521609275510380e-01 1.055961105715284313e-13 -1.408239914331950504e-10 5.511521609500492636e-01 9.458330667887414129e-14 -1.217204848136540275e-10 5.511521609689592482e-01 8.590050478830427501e-14 -1.065232692331022409e-10 5.511521609839143965e-01 7.759775424726430374e-14 -9.247984378541648959e-11 5.511521609976928193e-01 6.818665710775702395e-14 -7.772592566641969480e-11 5.511521610121922210e-01 5.814802621308568053e-14 -6.285324408698775428e-11 5.511521610268639293e-01 4.441374752916432729e-14 -4.480067316967160117e-11 5.511521610447724928e-01 2.666398557013434343e-14 -2.430378012351983758e-11 5.511521610651743952e-01 9.329980235126581564e-15 -7.116455060910917107e-12 5.511521610822999184e-01 -1.579811414559805822e-14 7.691071487743581985e-12 5.511521610970492313e-01 -1.548322791642892399e-13 -3.988431500101186017e-11 5.511521610496974422e-01 -8.327495957707805058e-18 -9.746677626237533906e-14 5.511521610892937684e-01 6.754095284624679407e-16 -2.297252063625242817e-12 5.511521610870959709e-01 3.585164576980993844e-15 -8.183055272277690210e-12 5.511521610812206706e-01 8.257705556558323566e-15 -1.608783843325309575e-11 5.511521610733235432e-01 1.433124460641865560e-14 -2.566324457434849331e-11 5.511521610637529767e-01 2.296771337868236920e-14 -3.909493309481234838e-11 5.511521610503323787e-01 3.437277857951945537e-14 -5.665689329196240353e-11 5.511521610327984044e-01 4.714190397379072709e-14 -7.612960189599252253e-11 5.511521610133762739e-01 6.063718909172944234e-14 -9.672061468428386489e-11 5.511521609928607957e-01 7.384355870175640574e-14 -1.170532187493449933e-10 5.511521609726227622e-01 8.423650413834834384e-14 -1.333544322496923096e-10 5.511521609564152824e-01 8.981490276082814499e-14 -1.426065120650560898e-10 5.511521609472318506e-01 8.996653806297438653e-14 -1.438270907742335793e-10 5.511521609460398041e-01 8.771738226373245305e-14 -1.417180839858029265e-10 5.511521609481526696e-01 8.413826988509091466e-14 -1.378715929674737266e-10 5.511521609519868248e-01 7.949660054714757082e-14 -1.325845919040982410e-10 5.511521609572481717e-01 7.406795583899619877e-14 -1.261602247636665643e-10 5.511521609636361729e-01 6.813833594429864220e-14 -1.189252586792375370e-10 5.511521609708265323e-01 6.198440583191026940e-14 -1.112095457792338626e-10 5.511521609784920672e-01 5.583419927319790652e-14 -1.032876807044603081e-10 5.511521609863605509e-01 4.986796014519937379e-14 -9.538319687208626512e-11 5.511521609942106048e-01 4.422238229824093181e-14 -8.767569085822535484e-11 5.511521610018644823e-01 3.899521353195092224e-14 -8.030683330288472383e-11 5.511521610091822954e-01 3.425020122894599590e-14 -7.338601972844311365e-11 5.511521610160560192e-01 3.002138666792455657e-14 -6.699369006055789614e-11 5.511521610224064949e-01 2.630382285608616306e-14 -6.115105752093845831e-11 5.511521610282135164e-01 2.309325132027370087e-14 -5.590006740079363682e-11 5.511521610334356724e-01 2.037874463509782215e-14 -5.128450764645520049e-11 5.511521610380287761e-01 1.813676761837926348e-14 -4.732884702281752487e-11 5.511521610419674033e-01 1.633657968809540752e-14 -4.404256259996911319e-11 5.511521610452413400e-01 1.494533046131497762e-14 -4.142468940535541621e-11 5.511521610478505862e-01 1.393211229359675951e-14 -3.946839838051796434e-11 5.511521610498011370e-01 1.327141565082228396e-14 -3.816542134986832716e-11 5.511521610511007641e-01 1.294614403278912762e-14 -3.751025659229732100e-11 5.511521610517542413e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 deleted file mode 100644 index 0dc6b77d9..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -9.347872524786728088e-03 6.712672121485080119e-05 6.670489071390793491e-05 9.273652010035143139e-03 6.688353854799178181e-05 6.637432354365810426e-05 9.147439059930326591e-03 6.642988967825920216e-05 6.577450646584850533e-05 8.967550030165352334e-03 6.577054042582616237e-05 6.490807272372299487e-05 8.731679345861848712e-03 6.491116763319106282e-05 6.377948467161795776e-05 8.436818919606750566e-03 6.383725058819620865e-05 6.239852517968745257e-05 8.079311126273643062e-03 6.253454903897949035e-05 6.077594701247035502e-05 7.654775224920751242e-03 6.099384958361360118e-05 5.892223837560380461e-05 7.158085368802608039e-03 5.920485477101308238e-05 5.684839039879855673e-05 6.583413002619447826e-03 5.715646580091360073e-05 5.456558592867350344e-05 5.924402936314914978e-03 5.483741088525629005e-05 5.208513882850013510e-05 5.174094060325141325e-03 5.223662336311550640e-05 4.941784215068799612e-05 4.324868705021276544e-03 4.934374837171123844e-05 4.657347118572838365e-05 3.368498572081508186e-03 4.614997529128937411e-05 4.356063310428201534e-05 2.296834707283683212e-03 4.265007717281242479e-05 4.038763622907154063e-05 1.110036318947718939e-03 3.884484786732501037e-05 3.706341856230916206e-05 -1.765748375132571851e-04 3.474270788818305575e-05 3.359790419997435841e-05 -1.533594500273186695e-03 3.036295831714007465e-05 3.000406689745727592e-05 -2.911238960852235037e-03 2.574125259305255311e-05 2.630179840397482114e-05 -4.247577498639968502e-03 2.107281339700607520e-05 2.256006965875746858e-05 -5.504010641549026729e-03 1.700339341150782128e-05 1.899385555495306779e-05 -6.645490929733577877e-03 1.364408728889496230e-05 1.569715587263991163e-05 -7.637720015178880474e-03 1.100554527319888263e-05 1.273640089588996238e-05 -8.477721568372037497e-03 9.058542559613998594e-06 1.016265532756807150e-05 -9.209759562505514044e-03 7.729031870706388015e-06 8.005806216592377750e-06 -9.857964535778172138e-03 6.611123564161272148e-06 6.212737871081395297e-06 -1.040654539469148057e-02 5.361067538215793493e-06 4.714317361833893448e-06 -1.078932749179973595e-02 4.113517357060190001e-06 3.527307742552240507e-06 -1.093904248106147316e-02 3.027279133827050823e-06 2.673317809394812226e-06 -1.084366516591260717e-02 2.278755356609236858e-06 2.177552173789767334e-06 -1.055879087568206871e-02 2.068376917043852573e-06 2.067826970577884974e-06 -1.019819934887559489e-02 2.423463162189680064e-06 2.344498357969593988e-06 -9.769008853034567494e-03 3.227461799056207873e-06 2.978654107968644461e-06 -9.275229006621111064e-03 4.351809110869257189e-06 3.929788483219183211e-06 -8.667067413090130332e-03 5.663792870489289916e-06 5.149443836393115162e-06 -7.906019926576425202e-03 7.033938367551210560e-06 6.585301716329986412e-06 -7.008958869276481554e-03 8.451557818283191685e-06 8.191676136557873370e-06 -6.002358246765870931e-03 9.979659989402961474e-06 9.927826293416461146e-06 -4.984361528731690028e-03 1.160475377209505728e-05 1.174986689472591265e-05 -4.041998419404741610e-03 1.331208603830926650e-05 1.361714018607810524e-05 -3.187049009814481217e-03 1.508653732246899364e-05 1.549352303887193053e-05 -2.414101523419299317e-03 1.691271435906881632e-05 1.734757147142987186e-05 -1.717435792738181751e-03 1.877255317835829307e-05 1.915609095757313593e-05 -1.089894289363924854e-03 2.062211054676838448e-05 2.093283469420741423e-05 -5.228726115102345570e-04 2.243522957289094489e-05 2.266975822194380747e-05 -9.310244238998604399e-06 2.419485367184713923e-05 2.435138908982203534e-05 4.564787107415859899e-04 2.588628432342921680e-05 2.596430991582709572e-05 8.787853513530703188e-04 2.749721958713398614e-05 2.749725119317721498e-05 1.260966964334271807e-03 2.901819311102030375e-05 2.894153055626572958e-05 1.606116592628792058e-03 3.044221915098372448e-05 3.029077753241669614e-05 1.917029588481467114e-03 3.176438845641105658e-05 3.154060108463396366e-05 2.196002988252739908e-03 3.298171436665678629e-05 3.268846555522723202e-05 2.444599191705051997e-03 3.409304227490378604e-05 3.373360866471891765e-05 2.664523987393838372e-03 3.509873844116302325e-05 3.467675297323190677e-05 2.857624002502601006e-03 3.599998797362178948e-05 3.551976654111375616e-05 3.025753747743678557e-03 3.679196177316481947e-05 3.626638783570483029e-05 3.170723494128616354e-03 3.747691188070570906e-05 3.692057967356459367e-05 3.294237382566954017e-03 3.806125613449315236e-05 3.748585631809927209e-05 3.397846675615148401e-03 3.855107890558526261e-05 3.796552350408187405e-05 3.482925391316058980e-03 3.895194586604209993e-05 3.836258132503130128e-05 3.550657324290998600e-03 3.926876331079054867e-05 3.867965688841336764e-05 3.602023025285141372e-03 3.950565697230362108e-05 3.891894209752405918e-05 3.637785447419281462e-03 3.966586898694258496e-05 3.908213408263133974e-05 3.658506621611041457e-03 3.975174208407528668e-05 3.917045494175014461e-05 5.500170130961106367e-14 5.511521608618044077e-01 -2.269367215611519420e-10 5.704010405680159122e-14 5.511521608570782993e-01 -2.317362767773443392e-10 6.123444823139493053e-14 5.511521608476025458e-01 -2.413536953067251556e-10 6.776105207804547376e-14 5.511521608333026512e-01 -2.558664561342967407e-10 7.689585728624195383e-14 5.511521608140450557e-01 -2.754106509860798716e-10 8.890973096313529400e-14 5.511521607899544373e-01 -2.998549047359752558e-10 1.040759819469711551e-13 5.511521607612612783e-01 -3.289526414877505685e-10 1.226337524599377747e-13 5.511521607283141888e-01 -3.623311495451533198e-10 1.447014306328535884e-13 5.511521606917225702e-01 -3.993443660086038554e-10 1.701993082746672764e-13 5.511521606524262262e-01 -4.390032419569410939e-10 1.987675795768921959e-13 5.511521606117559813e-01 -4.799149044340733022e-10 2.296793565297596309e-13 5.511521605714931882e-01 -5.202265506892610749e-10 2.617490190012740940e-13 5.511521605339282370e-01 -5.575739399247616611e-10 2.932375573982282435e-13 5.511521605019192860e-01 -5.890346685256392748e-10 3.217685785067831703e-13 5.511521604789284545e-01 -6.111141618977726598e-10 3.444463817369242727e-13 5.511521604686906439e-01 -6.201169080482014932e-10 3.582234670765768616e-13 5.511521604745401870e-01 -6.128511540889425333e-10 3.603596670871516937e-13 5.511521604987587031e-01 -5.872695420361836577e-10 3.493995487374566699e-13 5.511521605412714742e-01 -5.437292526115152920e-10 3.264151408783095308e-13 5.511521605982492300e-01 -4.863068470355491671e-10 2.957040910534828700e-13 5.511521606618147162e-01 -4.229709143602422606e-10 2.607356590862606278e-13 5.511521607264855405e-01 -3.590626450275898279e-10 2.259974641062407812e-13 5.511521607862335248e-01 -3.003233659248520835e-10 1.942537412121955884e-13 5.511521608381325654e-01 -2.494054215157579504e-10 1.628978021176088081e-13 5.511521608863796384e-01 -2.019626567431730040e-10 1.261513479003100771e-13 5.511521609383505105e-01 -1.505406117350627827e-10 7.996303220468412749e-14 5.511521609980216674e-01 -9.116888943393377171e-11 3.188095834293928939e-14 5.511521610551078920e-01 -3.422315248731928876e-11 -9.296289073384724078e-15 5.511521610985175013e-01 9.094033836845564799e-12 3.281493015015344775e-14 5.511521610623719702e-01 -2.683856761770778641e-11 7.420630944540709436e-14 5.511521610558518525e-01 -3.353246191300290660e-11 -8.500223773163973587e-15 5.511521610755510947e-01 -1.388659913882601427e-11 3.756845763226421650e-15 5.511521610761623835e-01 -1.318997035335856249e-11 1.777281144469328842e-14 5.511521610514020786e-01 -3.793332779958233218e-11 3.945959737144810069e-14 5.511521610170397878e-01 -7.229120377322205053e-11 7.058720800872842703e-14 5.511521609690009926e-01 -1.203001083636300692e-10 1.093306610888626572e-13 5.511521609101300845e-01 -1.790739621343282196e-10 1.519932413329798365e-13 5.511521608456462218e-01 -2.433708032556352443e-10 1.912288658957538855e-13 5.511521607862555072e-01 -3.025047705045312566e-10 2.202193851458069641e-13 5.511521607417712021e-01 -3.467241630760958326e-10 2.376430418966924725e-13 5.511521607137482848e-01 -3.745315357392448112e-10 2.441112450969531294e-13 5.511521607011982127e-01 -3.869536108421099773e-10 2.411196235811953898e-13 5.511521607020792857e-01 -3.860447958878503824e-10 2.330923764380363062e-13 5.511521607097878972e-01 -3.783786029292043944e-10 2.219027391085381845e-13 5.511521607217442220e-01 -3.665145828269007459e-10 2.084417840767979949e-13 5.511521607369174180e-01 -3.514706216677918965e-10 1.934818202136176766e-13 5.511521607544316304e-01 -3.341111683290526537e-10 1.776711421000719895e-13 5.511521607735626604e-01 -3.151493185577620701e-10 1.615531372226940075e-13 5.511521607937052147e-01 -2.951789552288140352e-10 1.455969088200653213e-13 5.511521608143116202e-01 -2.747387221769127349e-10 1.301921513319508982e-13 5.511521608348926016e-01 -2.543111195491895119e-10 1.156403792696721269e-13 5.511521608550358220e-01 -2.343040348822992210e-10 1.021520744844273061e-13 5.511521608744203160e-01 -2.150361807756164801e-10 8.987965209893590931e-14 5.511521608927590909e-01 -1.967937971244044624e-10 7.891760698612248658e-14 5.511521609098056773e-01 -1.798232240202545052e-10 6.929043158152828411e-14 5.511521609253983156e-01 -1.642865844865648274e-10 6.099310907722853854e-14 5.511521609393893462e-01 -1.503336567212892964e-10 5.398800226901884680e-14 5.511521609516677467e-01 -1.380788264589358924e-10 4.820778899950885297e-14 5.511521609621747864e-01 -1.275844739591722243e-10 4.356926858947028141e-14 5.511521609708920355e-01 -1.188723894583655169e-10 3.998557073728686211e-14 5.511521609778287090e-01 -1.119363627536379070e-10 3.737620064418005726e-14 5.511521609830084545e-01 -1.067549918003414308e-10 3.567621843539242597e-14 5.511521609864570292e-01 -1.033040583407027288e-10 3.484267669223983703e-14 5.511521609881911976e-01 -1.015683107208767997e-10 5.484569735903678767e-14 -2.269367215611519420e-10 5.511521608630938207e-01 5.689956438115197238e-14 -2.317362767773443392e-10 5.511521608582217180e-01 6.112522932875903936e-14 -2.413536953067251556e-10 5.511521608484640788e-01 6.770310835292480759e-14 -2.558664561342967407e-10 5.511521608337403011e-01 7.691460349050310399e-14 -2.754106509860798716e-10 5.511521608139109407e-01 8.903451680338196149e-14 -2.998549047359752558e-10 5.511521607891136654e-01 1.043374246262881176e-13 -3.289526414877505685e-10 5.511521607596104877e-01 1.230601158771644737e-13 -3.623311495451533198e-10 5.511521607257989785e-01 1.453116501588892657e-13 -3.993443660086038554e-10 5.511521606883614810e-01 1.709937794599435649e-13 -4.390032419569410939e-10 5.511521606483370528e-01 1.997171077420623475e-13 -4.799149044340733022e-10 5.511521606071818624e-01 2.307130942010404764e-13 -5.202265506892610749e-10 5.511521605668205925e-01 2.627451539706799892e-13 -5.575739399247616611e-10 5.511521605296921811e-01 2.940193862356416535e-13 -5.890346685256392748e-10 5.511521604987825729e-01 3.221137577456277951e-13 -6.111141618977726598e-10 5.511521604776177252e-01 3.441243780622976041e-13 -6.201169080482014932e-10 5.511521604698507160e-01 3.570600073032966720e-13 -6.128511540889425333e-10 5.511521604785279971e-01 3.583090959165139554e-13 -5.872695420361836577e-10 5.511521605054613415e-01 3.466018614587919294e-13 -5.437292526115152920e-10 5.511521605500140364e-01 3.232025105669221885e-13 -4.863068470355491671e-10 5.511521606078693125e-01 2.925198200484150132e-13 -4.229709143602422606e-10 5.511521606709737231e-01 2.579755585755990434e-13 -3.590626450275898279e-10 5.511521607341280937e-01 2.238855639817954220e-13 -3.003233659248520835e-10 5.511521607918730137e-01 1.928219878260944152e-13 -2.494054215157579504e-10 5.511521608418227247e-01 1.620571578183509935e-13 -2.019626567431730040e-10 5.511521608884694112e-01 1.257347772449709999e-13 -1.505406117350627827e-10 5.511521609393463805e-01 7.978856161479742788e-14 -9.116888943393377171e-11 5.511521609984199044e-01 3.182626615443842201e-14 -3.422315248731928876e-11 5.511521610552254646e-01 -9.262186143060733612e-15 9.094033836845564799e-12 5.511521610984505548e-01 3.259694806454417176e-14 -2.683856761770778641e-11 5.511521610627297951e-01 7.419402562524563625e-14 -3.353246191300290660e-11 5.511521610558629547e-01 -8.529615668494333471e-15 -1.388659913882601427e-11 5.511521610754552825e-01 3.746237448928597887e-15 -1.318997035335856249e-11 5.511521610762374346e-01 1.774733344000654180e-14 -3.793332779958233218e-11 5.511521610515109915e-01 3.942737828290470028e-14 -7.229120377322205053e-11 5.511521610171576935e-01 7.053511746577062509e-14 -1.203001083636300692e-10 5.511521609691785173e-01 1.092172776647833765e-13 -1.790739621343282196e-10 5.511521609105016761e-01 1.517607512165544595e-13 -2.433708032556352443e-10 5.511521608463914035e-01 1.908317136348679551e-13 -3.025047705045312566e-10 5.511521607875135009e-01 2.196527043125509275e-13 -3.467241630760958326e-10 5.511521607435579950e-01 2.369408321949009480e-13 -3.745315357392448112e-10 5.511521607159651781e-01 2.433326785363629824e-13 -3.869536108421099773e-10 5.511521607036704573e-01 2.403315507435164059e-13 -3.860447958878503824e-10 5.511521607046069304e-01 2.323411252070865553e-13 -3.783786029292043944e-10 5.511521607122307209e-01 2.212200179458255766e-13 -3.665145828269007459e-10 5.511521607240029708e-01 2.078494213746609823e-13 -3.514706216677918965e-10 5.511521607389182620e-01 1.929926134048971817e-13 -3.341111683290526537e-10 5.511521607561234992e-01 1.772898062555484150e-13 -3.151493185577620701e-10 5.511521607749169105e-01 1.612769683316878247e-13 -2.951789552288140352e-10 5.511521607947156287e-01 1.454172422976312415e-13 -2.747387221769127349e-10 5.511521608149900775e-01 1.300969345175872961e-13 -2.543111195491895119e-10 5.511521608352646373e-01 1.156157567587759443e-13 -2.343040348822992210e-10 5.511521608551356310e-01 1.021838612525916262e-13 -2.150361807756164801e-10 5.511521608742867562e-01 8.995419410381289617e-14 -1.967937971244044624e-10 5.511521608924326854e-01 7.902272234025676427e-14 -1.798232240202545052e-10 5.511521609093271712e-01 6.941518066050684223e-14 -1.642865844865648274e-10 5.511521609248075659e-01 6.112862272680905213e-14 -1.503336567212892964e-10 5.511521609387222131e-01 5.412780127476468698e-14 -1.380788264589358924e-10 5.511521609509534292e-01 4.834778960576956214e-14 -1.275844739591722243e-10 5.511521609614349337e-01 4.370706634788092745e-14 -1.188723894583655169e-10 5.511521609701417468e-01 4.011998965623010534e-14 -1.119363627536379070e-10 5.511521609770770880e-01 3.750747766709494463e-14 -1.067549918003414308e-10 5.511521609822600531e-01 3.580485461594750435e-14 -1.033040583407027288e-10 5.511521609857134019e-01 3.496986638899174293e-14 -1.015683107208767997e-10 5.511521609874505678e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 deleted file mode 100644 index 23e54a7a2..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_10 +++ /dev/null @@ -1 +0,0 @@ -1.718649038085777805e-02 6.712673350968875979e-05 6.670490211180121135e-05 1.717152271981815456e-02 6.688355018160550478e-05 6.637433441549917001e-05 1.714136533978458110e-02 6.642990078332517920e-05 6.577451696810926885e-05 1.709556944098532608e-02 6.577055102175352326e-05 6.490808287167219403e-05 1.703344990836843514e-02 6.491117764001188780e-05 6.377949436601691431e-05 1.695407084041845869e-02 6.383725986420809271e-05 6.239853425371964118e-05 1.685622594127209398e-02 6.253455742088067477e-05 6.077595527726007975e-05 1.673841352207428024e-02 6.099385691904179839e-05 5.892224565531780663e-05 1.659880576603799465e-02 5.920486094259596688e-05 5.684839655569798956e-05 1.643521183533349500e-02 5.715647074174614743e-05 5.456559087893971357e-05 1.624503433046633680e-02 5.483741458612324804e-05 5.208514254959551381e-05 1.602521855068727435e-02 5.223662587203868358e-05 4.941784468091968977e-05 1.577219395912450930e-02 4.934374978769076825e-05 4.657347261787486540e-05 1.548180724505664879e-02 4.614997575391981669e-05 4.356063357494128672e-05 1.514924641993832186e-02 4.265007684957736764e-05 4.038763590547730085e-05 1.476895551507436365e-02 3.884484694014535841e-05 3.706341762820870883e-05 1.433453971750956769e-02 3.474270654066619041e-05 3.359790284203400726e-05 1.383866125752012712e-02 3.036295672362671492e-05 3.000406529337867095e-05 1.327292714619731501e-02 2.574125090955234430e-05 2.630179671257354659e-05 1.262777111708131110e-02 2.107281175380013171e-05 2.256006801182466483e-05 1.189233398003354016e-02 1.700339190571159437e-05 1.899385404950824436e-05 1.105434895207347244e-02 1.364408598254182127e-05 1.569715456960075651e-05 1.010004329271503749e-02 1.100554419290826763e-05 1.273639982041361500e-05 9.014072176196511951e-03 9.058541709641076213e-06 1.016265448236260291e-05 7.779508321436202391e-03 7.729031239679686719e-06 8.005805589054532318e-06 6.377920350501146800e-03 6.611123128998134460e-06 6.212737437952199709e-06 4.789585020561031026e-03 5.361067272144208292e-06 4.714317096972481159e-06 2.993892167246103419e-03 4.113517228851885501e-06 3.527307615199016190e-06 9.700164962100439516e-04 3.027279106167515614e-06 2.673317782227691151e-06 -1.260341055936776153e-03 2.278755306621517172e-06 2.177552124292042232e-06 -3.411026705626204764e-03 2.068376837255995072e-06 2.067826890849922867e-06 -5.357861613478405449e-03 2.423463170701058871e-06 2.344498366501071616e-06 -7.015941295327934348e-03 3.227461795458749255e-06 2.978654104380976698e-06 -8.303987546223296282e-03 4.351809093319252907e-06 3.929788465693123702e-06 -9.346242831455884442e-03 5.663792833419075091e-06 5.149443799346557120e-06 -1.020726021651514881e-02 7.033938489488615903e-06 6.585301840373609482e-06 -1.079682672561817561e-02 8.451557753625038382e-06 8.191676072134224527e-06 -1.093268725011149224e-02 9.979659883637110007e-06 9.927826187915930891e-06 -1.062235684197441500e-02 1.160475362923520715e-05 1.174986675224913317e-05 -1.011820308331466689e-02 1.331208586327828003e-05 1.361714001157214536e-05 -9.480098797369673064e-03 1.508653712085247542e-05 1.549352283790977577e-05 -8.662648630561011615e-03 1.691271413683766763e-05 1.734757124994206913e-05 -7.539323685016627308e-03 1.877255294150497386e-05 1.915609072150049649e-05 -6.142300187258327611e-03 2.062211029844177021e-05 2.093283444666223529e-05 -4.650710411453953981e-03 2.243522931512811593e-05 2.266975796493277446e-05 -3.324814081397755444e-03 2.419485340553063614e-05 2.435138882417971288e-05 -2.159611776123351867e-03 2.588628404608247111e-05 2.596430963887947873e-05 -1.142418920720949214e-03 2.749721928608520537e-05 2.749725089138852383e-05 -2.545479397900224285e-04 2.901819272011386337e-05 2.894153015836983760e-05 5.317726441482336849e-04 3.044221719937450113e-05 3.029077543144773746e-05 1.226363099134622449e-03 3.176438780505855627e-05 3.154060037169464643e-05 1.837422008428230783e-03 3.298171413060911399e-05 3.268846531128606647e-05 2.372693865194080813e-03 3.409304208628318253e-05 3.373360847471220910e-05 2.839350936860106454e-03 3.509873827285769861e-05 3.467675280561023936e-05 3.239603671107406813e-03 3.599998781941199431e-05 3.551976638840558101e-05 3.568873745170826704e-03 3.679196163053191149e-05 3.626638769486128280e-05 3.836796367068300625e-03 3.747691174800784025e-05 3.692057954268409842e-05 4.052581357246333622e-03 3.806125601034471235e-05 3.748585619566350560e-05 4.224004308410815069e-03 3.855107878869319801e-05 3.796552338874671021e-05 4.357508708301497703e-03 3.895194575515516011e-05 3.836258121553909269e-05 4.458302495483191727e-03 3.926876320467657852e-05 3.867965678355192205e-05 4.530443664137338323e-03 3.950565686974258822e-05 3.891894199611096604e-05 4.576911485286328830e-03 3.966586888673283426e-05 3.908213398349785620e-05 4.599661241046252083e-03 3.975174198499402780e-05 3.917045484371238289e-05 1.234983965041218072e-11 5.511521402005423731e-01 -1.935670941407772322e-08 1.169065383505894343e-11 5.511521413306121886e-01 -1.845862271845763925e-08 1.116630043105868726e-11 5.511521421824431277e-01 -1.787674267369684525e-08 1.066368839876500325e-11 5.511521428806802625e-01 -1.743705538664831927e-08 1.008371668903970571e-11 5.511521435371573574e-01 -1.700383611441586909e-08 9.364921619852337690e-12 5.511521442227608203e-01 -1.649981983698858644e-08 8.485977151923647820e-12 5.511521449697928121e-01 -1.589525296729221546e-08 7.458061954026639435e-12 5.511521457863468587e-01 -1.518779969299638823e-08 6.316284317020576669e-12 5.511521466671016611e-01 -1.438874614272897486e-08 5.111031848983411325e-12 5.511521476001219888e-01 -1.351514183465043154e-08 3.899634540605136872e-12 5.511521485705529466e-01 -1.258592955595114187e-08 2.738602530694810055e-12 5.511521495633795453e-01 -1.161933353431432390e-08 1.677728545737958490e-12 5.511521505642107410e-01 -1.063230357177421490e-08 7.558680056482992596e-13 5.511521515595533272e-01 -9.640466126281265452e-09 -1.466479734817472739e-15 5.511521525370669528e-01 -8.658070844883580952e-09 -5.827332731605856423e-13 5.511521534861399951e-01 -7.697579076654907082e-09 -9.892934002582803427e-13 5.511521543983062266e-01 -6.769336171183832162e-09 -1.233153693266008831e-12 5.511521552674258917e-01 -5.881419719165168109e-09 -1.334100660583720515e-12 5.511521560897966188e-01 -5.039584811366905008e-09 -1.316790799849569798e-12 5.511521568638416690e-01 -4.247695244985257096e-09 -1.210092141544493111e-12 5.511521575843766341e-01 -3.513087733780920503e-09 -1.045617483122716815e-12 5.511521582423005716e-01 -2.845442278870368109e-09 -8.542931534360541311e-13 5.511521588272930705e-01 -2.254803503898192850e-09 -6.557191818445007130e-13 5.511521593495096738e-01 -1.730891886948700653e-09 -4.681288982663520356e-13 5.511521598094056840e-01 -1.272633535033911209e-09 -3.090117889105796127e-13 5.511521601940259085e-01 -8.906145787165356227e-10 -1.861085542284147604e-13 5.511521605002654978e-01 -5.858073862103532133e-10 -9.632734683215291286e-14 5.511521607442989579e-01 -3.421984630932781749e-10 -3.695582417616926491e-14 5.511521609328942084e-01 -1.542490542968040559e-10 -1.717278975398314368e-14 5.511521609985814418e-01 -8.935461883491857421e-11 -5.581547939297903266e-15 5.511521610492944312e-01 -3.974413862269620217e-11 1.115568625318191289e-17 5.511521610895709911e-01 7.830030384215564803e-14 1.593867109705366448e-16 5.511521610938311388e-01 4.421617584926850854e-12 2.228082490798406273e-16 5.511521610684850803e-01 -2.080243566886737330e-11 2.389382971041424628e-15 5.511521610403125049e-01 -4.889941676177840064e-11 1.925246135813930800e-13 5.511521586057550603e-01 -2.510126570106235756e-09 4.467250563626549206e-14 5.511521606235184612e-01 -4.671344797901058354e-10 4.622738812621250593e-14 5.511521606437768117e-01 -4.459272570267462048e-10 4.836901590489915790e-14 5.511521606056530853e-01 -4.835956239729760836e-10 4.518840040445150929e-14 5.511521605655852474e-01 -5.233247326547379343e-10 3.602652290910030275e-14 5.511521605366749288e-01 -5.519781904761559653e-10 2.188010084690603363e-14 5.511521605231078924e-01 -5.653624521651853253e-10 4.266306501014683715e-15 5.511521605226834541e-01 -5.656729357314659067e-10 -1.523423745806230447e-14 5.511521605270097712e-01 -5.612823349495807664e-10 -3.586008803396624399e-14 5.511521605301911153e-01 -5.581168396521348987e-10 -5.787471542064953887e-14 5.511521605245897071e-01 -5.640197427954718336e-10 -8.386492397406668888e-14 5.511521604946716391e-01 -5.953512154369803387e-10 -1.233776367478026988e-13 5.511521604002502794e-01 -6.953636386873678149e-10 -2.293533009893482647e-13 5.511521600307198732e-01 -1.091886788810446255e-09 -1.806012315458012833e-12 5.511521540203067060e-01 -7.653112702650894129e-09 -5.211603507625244851e-13 5.511521592921732049e-01 -2.007184840231797248e-09 -1.204072919116495948e-13 5.511521606982753285e-01 -4.144165494804633031e-10 -8.646853929081415418e-14 5.511521608207085032e-01 -2.713747632321659252e-10 -7.842568554717587380e-14 5.511521608558297425e-01 -2.303981829709894755e-10 -7.529218273890837601e-14 5.511521608735718836e-01 -2.106633012932393127e-10 -7.334247064275786074e-14 5.511521608860444621e-01 -1.976903031360392270e-10 -7.170475893522882235e-14 5.511521608961096330e-01 -1.877946065877193359e-10 -7.016044501422173872e-14 5.511521609045965109e-01 -1.797644576673492743e-10 -6.868427561656979367e-14 5.511521609117649989e-01 -1.731327611824736505e-10 -6.731767427396906962e-14 5.511521609176960323e-01 -1.677071377206786822e-10 -6.612840467768450532e-14 5.511521609224147022e-01 -1.634092478412721441e-10 -6.518482762213818366e-14 5.511521609259235621e-01 -1.602145998470972676e-10 -6.453353348970856029e-14 5.511521609282148404e-01 -1.581266520562955671e-10 -6.423856585897039339e-14 5.511521609292620028e-01 -1.571730047983383117e-10 1.145273897543323599e-11 -1.935670941407772322e-08 5.511521431250109293e-01 1.092874061580428695e-11 -1.845862271845763925e-08 5.511521438221935743e-01 1.056338600789975741e-11 -1.787674267369684525e-08 5.511521441691823453e-01 1.021565228967897721e-11 -1.743705538664831927e-08 5.511521443787971153e-01 9.771313574744727879e-12 -1.700383611441586909e-08 5.511521446080671627e-01 9.163066699613016965e-12 -1.649981983698858644e-08 5.511521449421891150e-01 8.369127150609678433e-12 -1.589525296729221546e-08 5.511521454108135876e-01 7.402774126374717156e-12 -1.518779969299638823e-08 5.511521460125273775e-01 6.302211080805049613e-12 -1.438874614272897486e-08 5.511521467314317579e-01 5.121259987691963178e-12 -1.351514183465043154e-08 5.511521475462048958e-01 3.920812492673879379e-12 -1.258592955595114187e-08 5.511521484343242516e-01 2.760944796086644561e-12 -1.161933353431432390e-08 5.511521493746556200e-01 1.694891635525106688e-12 -1.063230357177421490e-08 5.511521503478613582e-01 7.646786486854869770e-13 -9.640466126281265452e-09 5.511521513362668268e-01 -1.480476333379472051e-15 -8.658070844883580952e-09 5.511521523237394860e-01 -5.899760723049388673e-13 -7.697579076654907082e-09 5.511521532959501313e-01 -1.000880341541505180e-12 -6.769336171183832162e-09 5.511521542406263574e-01 -1.245769504726223219e-12 -5.881419719165168109e-09 5.511521551476923353e-01 -1.344799412740105277e-12 -5.039584811366905008e-09 5.511521560092784711e-01 -1.323730294883332378e-12 -4.247695244985257096e-09 5.511521568191922738e-01 -1.212925004417184158e-12 -3.513087733780920503e-09 5.511521575679462215e-01 -1.045063597117934573e-12 -2.845442278870368109e-09 5.511521582453231538e-01 -8.515907818204200507e-13 -2.254803503898192850e-09 5.511521588415833062e-01 -6.523834797775612403e-13 -1.730891886948700653e-09 5.511521593671668828e-01 -4.654806875965434933e-13 -1.272633535033911209e-09 5.511521598238412478e-01 -3.073944181920002782e-13 -8.906145787165356227e-10 5.511521602033718770e-01 -1.850728504501117564e-13 -5.858073862103532133e-10 5.511521605068158136e-01 -9.552695804515585252e-14 -3.421984630932781749e-10 5.511521607500111664e-01 -3.642930707893929214e-14 -1.542490542968040559e-10 5.511521609373267738e-01 -1.690077756974858660e-14 -8.935461883491857421e-11 5.511521610014468164e-01 -5.533935559848325871e-15 -3.974413862269620217e-11 5.511521610499758861e-01 1.861467951235656317e-18 7.830030384215564803e-14 5.511521610893566070e-01 1.585693189421717974e-16 4.421617584926850854e-12 5.511521610937862858e-01 2.212739548769210066e-16 -2.080243566886737330e-11 5.511521610686861417e-01 2.380819449332062007e-15 -4.889941676177840064e-11 5.511521610406658889e-01 1.945787407739943124e-13 -2.510126570106235756e-09 5.511521585524743472e-01 4.479362730834713702e-14 -4.671344797901058354e-10 5.511521606209855983e-01 4.626021990967083335e-14 -4.459272570267462048e-10 5.511521606431466491e-01 4.835493406044413685e-14 -4.835956239729760836e-10 5.511521606059347489e-01 4.514674088497332810e-14 -5.233247326547379343e-10 5.511521605665448131e-01 3.597867492904659419e-14 -5.519781904761559653e-10 5.511521605381461963e-01 2.184487494377527788e-14 -5.653624521651853253e-10 5.511521605249426470e-01 4.258911642423805223e-15 -5.656729357314659067e-10 5.511521605247438060e-01 -1.520405252018804566e-14 -5.612823349495807664e-10 5.511521605291955783e-01 -3.579101604758702897e-14 -5.581168396521348987e-10 5.511521605323441708e-01 -5.779290319582549347e-14 -5.640197427954718336e-10 5.511521605261469059e-01 -8.395500175098229133e-14 -5.953512154369803387e-10 5.511521604934045415e-01 -1.244988868892402730e-13 -6.953636386873678149e-10 5.511521603876532449e-01 -2.366189200938784342e-13 -1.091886788810446255e-09 5.511521599625942569e-01 -1.955551713497116410e-12 -7.653112702650894129e-09 5.511521528012759408e-01 -5.828423913563023169e-13 -2.007184840231797248e-09 5.511521588419169282e-01 -1.283254014494917657e-13 -4.144165494804633031e-10 5.511521606453266831e-01 -8.782284775860520874e-14 -2.713747632321659252e-10 5.511521608122911253e-01 -7.766748075899960238e-14 -2.303981829709894755e-10 5.511521608603434652e-01 -7.368545440224478010e-14 -2.106633012932393127e-10 5.511521608826934759e-01 -7.142835923508907291e-14 -1.976903031360392270e-10 5.511521608965358476e-01 -6.975186550557357483e-14 -1.877946065877193359e-10 5.511521609064993221e-01 -6.830795903433389878e-14 -1.797644576673492743e-10 5.511521609142318034e-01 -6.698737777186208792e-14 -1.731327611824736505e-10 5.511521609204348415e-01 -6.578513997295560849e-14 -1.677071377206786822e-10 5.511521609254284026e-01 -6.474146716448689386e-14 -1.634092478412721441e-10 5.511521609293554835e-01 -6.390561940832882084e-14 -1.602145998470972676e-10 5.511521609322678206e-01 -6.332862419164222224e-14 -1.581266520562955671e-10 5.511521609341718531e-01 -6.306788851238875251e-14 -1.571730047983383117e-10 5.511521609350406026e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 deleted file mode 100644 index b2919b1ec..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_11 +++ /dev/null @@ -1 +0,0 @@ -1.719939196594755595e-02 6.712673266946838334e-05 6.670490133272344063e-05 1.718459434919301226e-02 6.688354941461073359e-05 6.637433369859337367e-05 1.715478011330678551e-02 6.642990010240409362e-05 6.577451632405153148e-05 1.710950662791227428e-02 6.577055044034974235e-05 6.490808231478008294e-05 1.704809818892040474e-02 6.491117716972993911e-05 6.377949391037641123e-05 1.696963173952223403e-02 6.383725951155527637e-05 6.239853390873182249e-05 1.687291752463070463e-02 6.253455718540845633e-05 6.077595504508626181e-05 1.675647442744151311e-02 6.099385679336974939e-05 5.892224553062502259e-05 1.661849964936421703e-02 5.920486091371550440e-05 5.684839652691686711e-05 1.645683231445262129e-02 5.715647079290539923e-05 5.456559093022730103e-05 1.626891051571507235e-02 5.483741469883078015e-05 5.208514266293441750e-05 1.605172125632800192e-02 5.223662602780642983e-05 4.941784483796753997e-05 1.580174269169089610e-02 4.934374996935832224e-05 4.657347280140796542e-05 1.551487806619144746e-02 4.614997594659469259e-05 4.356063376985974960e-05 1.518638077459337488e-02 4.265007704110084793e-05 4.038763609937592251e-05 1.481077010253941534e-02 3.884484712126680655e-05 3.706341781158429459e-05 1.438173745240086711e-02 3.474270670493576898e-05 3.359790300822791594e-05 1.389204331662844891e-02 3.036295686707619993e-05 3.000406543830258282e-05 1.333340601054608734e-02 2.574125103031586447e-05 2.630179683430869148e-05 1.269638438179691159e-02 2.107281185167303371e-05 2.256006811021769927e-05 1.197025849957668135e-02 1.700339198188834713e-05 1.899385412585867953e-05 1.114291460556332027e-02 1.364408603931177866e-05 1.569715462632226022e-05 1.020074517860963120e-02 1.100554423329182886e-05 1.273639986063333465e-05 9.128579466982540691e-03 9.058541736686096218e-06 1.016265450922016436e-05 7.909667182965724602e-03 7.729031256413884771e-06 8.005805605637052180e-06 6.525747257365046954e-03 6.611123138399648756e-06 6.212737447252131038e-06 4.957245444416256280e-03 5.361067276765619205e-06 4.714317101534695480e-06 3.183658032730485223e-03 4.113517230596880945e-06 3.527307616905818495e-06 1.184194079594015148e-03 3.027279106412311948e-06 2.673317782462635221e-06 -1.035500736562029213e-03 2.278755306614754461e-06 2.177552124288882376e-06 -3.201367848117564561e-03 2.068376837209919445e-06 2.067826890808161179e-06 -5.171765337620817631e-03 2.423463170671602029e-06 2.344498366471845591e-06 -6.862374388584077320e-03 3.227461795456846819e-06 2.978654104379212751e-06 -8.187934912062653711e-03 4.351809093314373997e-06 3.929788465689262926e-06 -9.246338800634919253e-03 5.663792833431273213e-06 5.149443799358645974e-06 -1.012700085100350610e-02 7.033938491440285692e-06 6.585301842345805421e-06 -1.075550169081277742e-02 8.451557754349788571e-06 8.191676072860850047e-06 -1.094105308675169703e-02 9.979659884798012707e-06 9.927826189076969116e-06 -1.066799029564482679e-02 1.160475363104392404e-05 1.174986675405712331e-05 -1.017925904410655648e-02 1.331208586567513594e-05 1.361714001396670750e-05 -9.555906977131637184e-03 1.508653712364954593e-05 1.549352284070310069e-05 -8.768169747357112964e-03 1.691271413988706078e-05 1.734757125298710853e-05 -7.679504328224222298e-03 1.877255294464485046e-05 1.915609072463527734e-05 -6.313379222240420550e-03 2.062211030152478718e-05 2.093283444973722239e-05 -4.814598317459496853e-03 2.243522931803725059e-05 2.266975796783272728e-05 -3.472202735100402178e-03 2.419485340818696873e-05 2.435138882682870678e-05 -2.291584706759869968e-03 2.588628404843902180e-05 2.596430964123586679e-05 -1.260217990940201314e-03 2.749721928813672256e-05 2.749725089345327506e-05 -3.612420930454100353e-04 2.901819272186568674e-05 2.894153016016526623e-05 4.341220264033718410e-04 3.044221719887379285e-05 3.029077543087035576e-05 1.136883910065480865e-03 3.176438780221747224e-05 3.154060036846004445e-05 1.755261848712437282e-03 3.298171412978680086e-05 3.268846531037745084e-05 2.297035914839235839e-03 3.409304208552935031e-05 3.373360847395665571e-05 2.769423503242729630e-03 3.509873827197292187e-05 3.467675280476736704e-05 3.176543171585788968e-03 3.599998781835492430e-05 3.551976638742071208e-05 3.512780520088757720e-03 3.679196162928287671e-05 3.626638769370893852e-05 3.786554408247124175e-03 3.747691174657915994e-05 3.692057954135923725e-05 4.007195176773644188e-03 3.806125600874636796e-05 3.748585619417009164e-05 4.182584644470333478e-03 3.855107878693996178e-05 3.796552338709175691e-05 4.319257257220477514e-03 3.895194575326105891e-05 3.836258121374271199e-05 4.422496319008115649e-03 3.926876320267451111e-05 3.867965678164013481e-05 4.496419648112232048e-03 3.950565686765957157e-05 3.891894199410879699e-05 4.544051030123891569e-03 3.966586888458199399e-05 3.908213398142982187e-05 4.567375228106673561e-03 3.975174198281028199e-05 3.917045484161410610e-05 1.150961927403827326e-11 5.511521401995620462e-01 -1.935776648831548527e-08 1.092365906663678658e-11 5.511521413296205374e-01 -1.845969218303314823e-08 1.048537934607205443e-11 5.511521421814317145e-01 -1.787783371314129723e-08 1.008228461275558181e-11 5.511521428796468669e-01 -1.743817079756862027e-08 9.613434739503625790e-12 5.511521435361083077e-01 -1.700496961480305481e-08 9.012268809986206650e-12 5.511521442217126587e-01 -1.650095431449761110e-08 8.250504929113550253e-12 5.511521449687725172e-01 -1.589636027325822645e-08 7.332389901787784856e-12 5.511521457853897354e-01 -1.518884249749017418e-08 6.287403853236499090e-12 5.511521466662474555e-01 -1.438968208102320096e-08 5.162191102578776422e-12 5.511521475994088926e-01 -1.351592975852124740e-08 4.012342071394003693e-12 5.511521485700098255e-01 -1.258653724951714097e-08 2.894370274809169344e-12 5.511521495630185008e-01 -1.161974587544692449e-08 1.859396101513526157e-12 5.511521505640200047e-01 -1.063252989496897901e-08 9.485428800098126741e-13 5.511521515594925980e-01 -9.640545506242272978e-09 1.900570014641486702e-13 5.511521525370658425e-01 -8.658074169534106889e-09 -4.016118233523795957e-13 5.511521534861002491e-01 -7.697607083930708995e-09 -8.250238226182257562e-13 5.511521543981081628e-01 -6.769513041744596726e-09 -1.089704207629616594e-12 5.511521552669392809e-01 -5.881882289444144581e-09 -1.213337141534901524e-12 5.511521560888950066e-01 -5.040467935242874776e-09 -1.218917898089451306e-12 5.511521568624189182e-01 -4.249114230086169934e-09 -1.133915389540746096e-12 5.511521575823652430e-01 -3.515119549984391534e-09 -9.888475251341740643e-13 5.511521582396852192e-01 -2.848109574756759962e-09 -8.139095920285730066e-13 5.511521588241194980e-01 -2.258063483108209475e-09 -6.286741619737592112e-13 5.511521593458857948e-01 -1.734632294284797539e-09 -4.513946998983169099e-13 5.511521598054955895e-01 -1.276677703432231343e-09 -2.996102742442352352e-13 5.511521601900346568e-01 -8.947365586253558271e-10 -1.814871432341193085e-13 5.511521604964205734e-01 -5.897546863809995804e-10 -9.458235169492127758e-14 5.511521607408301771e-01 -3.457203167461267589e-10 -3.671102799393254265e-14 5.511521609300097380e-01 -1.571301548201370949e-10 -1.717955250989264156e-14 5.511521609965831514e-01 -9.131145542194535946e-11 -5.627623403988793820e-15 5.511521610482661426e-01 -4.073450692068689380e-11 -1.830099796449069528e-17 5.511521610892079481e-01 -2.687557535131344893e-13 1.574841333179930627e-16 5.511521610937800686e-01 4.372096706019343672e-12 2.179291255199804592e-16 5.511521610684814165e-01 -2.080560663881342177e-11 2.401581201593757428e-15 5.511521610402501103e-01 -4.895926755842107694e-11 1.944762829818197620e-13 5.511521586056309374e-01 -2.510248282251679389e-09 4.539725584503234840e-14 5.511521606234192072e-01 -4.672322712477341546e-10 4.738829155859501236e-14 5.511521606438006815e-01 -4.459036194133875773e-10 5.017773243980506155e-14 5.511521606057752098e-01 -4.834727763870750174e-10 4.758525656917777609e-14 5.511521605657073719e-01 -5.231986141887154679e-10 3.882359397802343515e-14 5.511521605367640797e-01 -5.518845818258667780e-10 2.492949313622357194e-14 5.511521605231570753e-01 -5.653112513001446718e-10 7.406182975562565341e-15 5.511521605226895604e-01 -5.656669391894129287e-10 -1.215122215643300910e-14 5.511521605270285340e-01 -5.612623423362276745e-10 -3.295095268547512366e-14 5.511521605303311144e-01 -5.579742285608494688e-10 -5.521838251546908399e-14 5.511521605249423139e-01 -5.636665903215214719e-10 -8.150837188442329540e-14 5.511521604952966946e-01 -5.947308204843190107e-10 -1.213261187454938045e-13 5.511521604011684339e-01 -6.944565928575578858e-10 -2.276014777415627137e-13 5.511521600319331249e-01 -1.090688864004339338e-09 -1.806513023630696274e-12 5.511521540217911852e-01 -7.651641304408799313e-09 -5.240014369684663910e-13 5.511521592938759539e-01 -2.005484160341183784e-09 -1.212296031981369758e-13 5.511521607001359513e-01 -4.125388421995174064e-10 -8.722236931354790260e-14 5.511521608226684910e-01 -2.693725847105387515e-10 -7.931046493082143302e-14 5.511521608578402454e-01 -2.283184924402783856e-10 -7.634925276761038707e-14 5.511521608755406421e-01 -2.086034965415720113e-10 -7.459150428269256656e-14 5.511521608879197398e-01 -1.957120585287059311e-10 -7.313343966557059716e-14 5.511521608978892095e-01 -1.859081099750322919e-10 -7.175878630065574785e-14 5.511521609062838278e-01 -1.779720208962519095e-10 -7.043751000818438239e-14 5.511521609133672728e-01 -1.714306704901829224e-10 -6.921177485468739576e-14 5.511521609192231441e-01 -1.660868873135271057e-10 -6.813047214272243086e-14 5.511521609238790864e-01 -1.618585641108475485e-10 -6.726784728446901337e-14 5.511521609273392075e-01 -1.587183718685170691e-10 -6.668437198027579657e-14 5.511521609295972901e-01 -1.566677728605937657e-10 -6.642231001322649312e-14 5.511521609306275771e-01 -1.557331093052670950e-10 1.067366120938567819e-11 -1.935776648831548527e-08 5.511521431238710633e-01 1.021183482575975053e-11 -1.845969218303314823e-08 5.511521438210402746e-01 9.919328273732960155e-12 -1.787783371314129723e-08 5.511521441680053979e-01 9.658760176652192736e-12 -1.743817079756862027e-08 5.511521443775931894e-01 9.315673065320694955e-12 -1.700496961480305481e-08 5.511521446068424757e-01 8.818078883249084590e-12 -1.650095431449761110e-08 5.511521449409612083e-01 8.136953334594140242e-12 -1.589636027325822645e-08 5.511521454096118822e-01 7.278081345326079355e-12 -1.518884249749017418e-08 5.511521460113912863e-01 6.273429959840864985e-12 -1.438968208102320096e-08 5.511521467304062449e-01 5.172547576870842248e-12 -1.351592975852124740e-08 5.511521475453343699e-01 4.034151395491652537e-12 -1.258653724951714097e-08 5.511521484336443510e-01 2.917992647554491899e-12 -1.161974587544692449e-08 5.511521493741847744e-01 1.878424733517381316e-12 -1.063252989496897901e-08 5.511521503475927952e-01 9.595971124887965291e-13 -9.640545506242272978e-09 5.511521513361630209e-01 1.924181445612519743e-13 -8.658074169534106889e-09 5.511521523237292719e-01 -4.066004867494716085e-13 -7.697607083930708995e-09 5.511521532959303693e-01 -8.346864348694247062e-13 -6.769513041744596726e-09 5.511521542404683727e-01 -1.100845592023414336e-12 -5.881882289444144581e-09 5.511521551472525760e-01 -1.223064268689931139e-12 -5.040467935242874776e-09 5.511521560084134963e-01 -1.225337259882162327e-12 -4.249114230086169934e-09 5.511521568177769614e-01 -1.136574570110385441e-12 -3.515119549984391534e-09 5.511521575658937522e-01 -9.883420942287301780e-13 -2.848109574756759962e-09 5.511521582426028854e-01 -8.113710616387984672e-13 -2.258063483108209475e-09 5.511521588382346515e-01 -6.255259178520895160e-13 -1.734632294284797539e-09 5.511521593633061933e-01 -4.488981683597256339e-13 -1.276677703432231343e-09 5.511521598196583716e-01 -2.980944870696845405e-13 -8.947365586253558271e-10 5.511521601991148378e-01 -1.805106357352147016e-13 -5.897546863809995804e-10 5.511521605027633885e-01 -9.382015590921116747e-14 -3.457203167461267589e-10 5.511521607464354711e-01 -3.619436286969724798e-14 -1.571301548201370949e-10 5.511521609344490757e-01 -1.690393728324740627e-14 -9.131145542194535946e-11 5.511521609995305715e-01 -5.575697060464207564e-15 -4.073450692068689380e-11 5.511521610490220935e-01 -2.736437520564259389e-17 -2.687557535131344893e-13 5.511521610890248724e-01 1.568053465610302315e-16 4.372096706019343672e-12 5.511521610937383242e-01 2.174133287526413616e-16 -2.080560663881342177e-11 5.511521610686833661e-01 2.392908518946572045e-15 -4.895926755842107694e-11 5.511521610406084903e-01 1.965509365840766923e-13 -2.510248282251679389e-09 5.511521585523549982e-01 4.552025290747657116e-14 -4.672322712477341546e-10 5.511521606208892310e-01 4.742125867714527214e-14 -4.459036194133875773e-10 5.511521606431699638e-01 5.016292433057147593e-14 -4.834727763870750174e-10 5.511521606060583167e-01 4.754130365692046430e-14 -5.231986141887154679e-10 5.511521605666750423e-01 3.877200010379522687e-14 -5.518845818258667780e-10 5.511521605382445621e-01 2.488991462643134132e-14 -5.653112513001446718e-10 5.511521605249959377e-01 7.393693442366314323e-15 -5.656669391894129287e-10 5.511521605247496902e-01 -1.212906390711532263e-14 -5.612623423362276745e-10 5.511521605292168946e-01 -3.289106374595391207e-14 -5.579742285608494688e-10 5.511521605324894990e-01 -5.514390809268825563e-14 -5.636665903215214719e-10 5.511521605265006230e-01 -8.159861391321530174e-14 -5.947308204843190107e-10 5.511521604940202712e-01 -1.224341352598097951e-13 -6.944565928575578858e-10 5.511521603885494169e-01 -2.348234928160064096e-13 -1.090688864004339338e-09 5.511521599637770885e-01 -1.956129096375506553e-12 -7.651641304408799313e-09 5.511521528027344408e-01 -5.860769915074915935e-13 -2.005484160341183784e-09 5.511521588436155694e-01 -1.292340147249856563e-13 -4.125388421995174064e-10 5.511521606472217227e-01 -8.857840270973604569e-14 -2.693725847105387515e-10 5.511521608143363782e-01 -7.851035419279938246e-14 -2.283184924402783856e-10 5.511521608624947444e-01 -7.467032277977913861e-14 -2.086034965415720113e-10 5.511521608848485299e-01 -7.258070017163333038e-14 -1.957120585287059311e-10 5.511521608986227339e-01 -7.107672499042487070e-14 -1.859081099750322919e-10 5.511521609084991669e-01 -6.980137363431135541e-14 -1.779720208962519095e-10 5.511521609161359470e-01 -6.864232789095474304e-14 -1.714306704901829224e-10 5.511521609222430618e-01 -6.758152222713550061e-14 -1.660868873135271057e-10 5.511521609271474720e-01 -6.665325774218395422e-14 -1.618585641108475485e-10 5.511521609309976144e-01 -6.590778651539732583e-14 -1.587183718685170691e-10 5.511521609338492222e-01 -6.539666165875408180e-14 -1.566677728605937657e-10 5.511521609357113993e-01 -6.516616391889506258e-14 -1.557331093052670950e-10 5.511521609365589436e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 deleted file mode 100644 index b04831865..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_12 +++ /dev/null @@ -1 +0,0 @@ -1.720766903353992960e-02 6.712673240364842452e-05 6.670490108626119332e-05 1.719298022847327162e-02 6.688354917349438903e-05 6.637433347324535381e-05 1.716338556248604708e-02 6.642989989111473359e-05 6.577451612421388071e-05 1.711844633666995824e-02 6.577055026359329216e-05 6.490808214549058733e-05 1.705749284467645427e-02 6.491117703092936055e-05 6.377949377591227544e-05 1.697961021601139542e-02 6.383725941182556295e-05 6.239853381119218390e-05 1.688361923724005301e-02 6.253455712319055243e-05 6.077595498375613654e-05 1.676805190343103394e-02 6.099385676468269504e-05 5.892224550217712290e-05 1.663112136031247301e-02 5.920486091288620494e-05 5.684839652610927202e-05 1.647068582641797799e-02 5.715647081338764523e-05 5.456559095076968637e-05 1.628420601203704049e-02 5.483741473401079606e-05 5.208514269831571555e-05 1.606869549185516860e-02 5.223662607157148380e-05 4.941784488209893908e-05 1.582066344054361071e-02 4.934375001653104397e-05 4.657347284906382796e-05 1.553604912298846806e-02 4.614997599307863423e-05 4.356063381689207392e-05 1.521014756746910841e-02 4.265007708398618026e-05 4.038763614278569698e-05 1.483752596551282839e-02 3.884484715868498844e-05 3.706341784946671152e-05 1.441193058707400214e-02 3.474270673592729506e-05 3.359790303958845023e-05 1.392618443902047740e-02 3.036295689141765340e-05 3.000406546289170195e-05 1.337207662554033664e-02 2.574125104830591592e-05 2.630179685245107672e-05 1.274024554066844478e-02 2.107281186400266891e-05 2.256006812261701140e-05 1.202005976698990522e-02 1.700339198947167048e-05 1.899385413346095270e-05 1.119950277219134219e-02 1.364408604316665609e-05 1.569715463016341573e-05 1.026507197549429533e-02 1.100554423444300423e-05 1.273639986176074566e-05 9.201707158255644642e-03 9.058541736057313168e-06 1.016265450856425424e-05 7.992770393558144143e-03 7.729031254816282377e-06 8.005805604016440983e-06 6.620108712081153139e-03 6.611123136477652225e-06 6.212737445300371463e-06 5.064242443084469338e-03 5.361067274967163276e-06 4.714317099712187204e-06 3.304735478632547276e-03 4.113517229195584366e-06 3.527307615503401715e-06 1.320818783583201225e-03 3.027279105548599651e-06 2.673317781602658340e-06 -8.901083327286571497e-04 2.278755306081316828e-06 2.177552123765150470e-06 -3.065396834676581937e-03 2.068376836972744290e-06 2.067826890576520114e-06 -5.050552897229254254e-03 2.423463170645983941e-06 2.344498366448314169e-06 -6.761644112516061386e-03 3.227461795470871144e-06 2.978654104392542509e-06 -8.112599016120590825e-03 4.351809093247833630e-06 3.929788465622836908e-06 -9.181216153439759886e-03 5.663792833308059565e-06 5.149443799235741494e-06 -1.007433562402464469e-02 7.033938486909540339e-06 6.585301837766536938e-06 -1.072632012257225716e-02 8.451557753855180622e-06 8.191676072364819083e-06 -1.094353425061423898e-02 9.979659884712428498e-06 9.927826188991484857e-06 -1.069631606700133589e-02 1.160475363138787024e-05 1.174986675440338699e-05 -1.021744870764373578e-02 1.331208586641884272e-05 1.361714001470931992e-05 -9.603547471876550459e-03 1.508653712469378170e-05 1.549352284174571693e-05 -8.833459678664015713e-03 1.691271414116807953e-05 1.734757125426595210e-05 -7.767066675032636980e-03 1.877255294610733077e-05 1.915609072609284147e-05 -6.420834718545201901e-03 2.062211030310742759e-05 2.093283445131903609e-05 -4.920211111283457998e-03 2.243522931970551925e-05 2.266975796950608491e-05 -3.567211333762516142e-03 2.419485340992967465e-05 2.435138882857565464e-05 -2.376678574377389091e-03 2.588628405030659393e-05 2.596430964310633916e-05 -1.336190611095163308e-03 2.749721929029391558e-05 2.749725089562571467e-05 -4.298691802394400048e-04 2.901819272506737303e-05 2.894153016346485936e-05 3.713133446198814739e-04 3.044221721866077049e-05 3.029077545227462423e-05 1.079333774415499421e-03 3.176438780723478720e-05 3.154060037403846114e-05 1.702422575342495744e-03 3.298171413107827538e-05 3.268846531173310335e-05 2.248382339551281781e-03 3.409304208653416178e-05 3.373360847497514846e-05 2.724459231423815696e-03 3.509873827292100924e-05 3.467675280572270500e-05 3.135720026797372308e-03 3.599998781928790738e-05 3.551976638836314804e-05 3.476453216159429774e-03 3.679196163022590221e-05 3.626638769465039192e-05 3.754003360870916163e-03 3.747691174750813825e-05 3.692057954229713312e-05 3.977778302079064410e-03 3.806125600967092136e-05 3.748585619510746574e-05 4.155728217965017589e-03 3.855107878785266350e-05 3.796552338801991529e-05 4.294446121855468798e-03 3.895194575417592904e-05 3.836258121466188504e-05 4.399263866484369109e-03 3.926876320356236427e-05 3.867965678254353949e-05 4.474337820424311926e-03 3.950565686854117024e-05 3.891894199500844763e-05 4.522720461294434113e-03 3.966586888545855111e-05 3.908213398231935554e-05 4.546415557459232253e-03 3.975174198368902785e-05 3.917045484249861856e-05 1.124379931869220643e-11 5.511521401989626368e-01 -1.935841351429115791e-08 1.068254272358699679e-11 5.511521413290129123e-01 -1.846034814934950732e-08 1.027408998058894788e-11 5.511521421808095456e-01 -1.787850551040289174e-08 9.905528168303944524e-12 5.511521428790077115e-01 -1.743886122377381628e-08 9.474634165859584333e-12 5.511521435354553855e-01 -1.700567558995008580e-08 8.912539093504037754e-12 5.511521442210558508e-01 -1.650166565435186132e-08 8.188287019190832069e-12 5.511521449681285878e-01 -1.589705943338448584e-08 7.303702845549870186e-12 5.511521457847813332e-01 -1.518950564924520541e-08 6.286574551160031287e-12 5.511521466657003376e-01 -1.439028169662491015e-08 5.182673348452780155e-12 5.511521475989483720e-01 -1.351643860604680368e-08 4.047522087318860873e-12 5.511521485696557754e-01 -1.258693339415069893e-08 2.938135330587634489e-12 5.511521495627800249e-01 -1.162001802790125530e-08 1.906568825183546604e-12 5.511521505638913299e-01 -1.063268229413269174e-08 9.950268222235351917e-13 5.511521515594494103e-01 -9.640601494305080318e-09 2.329423361990660818e-13 5.511521525370643992e-01 -8.658077712328723820e-09 -3.641936430742544474e-13 5.511521534860784888e-01 -7.697621686808658634e-09 -7.940322944911115324e-13 5.511521543979897020e-01 -6.769617782389535027e-09 -1.065362753691833684e-12 5.511521552666405199e-01 -5.882164995684816938e-09 -1.195347090912788764e-12 5.511521560883340110e-01 -5.041015836648015701e-09 -1.206588261697937343e-12 5.511521568615262989e-01 -4.250002669372075316e-09 -1.126332066147028705e-12 5.511521575810958140e-01 -3.516399837255236973e-09 -9.849926473288025120e-13 5.511521582380271012e-01 -2.849798578494380019e-09 -8.127584164738010624e-13 5.511521588220997803e-01 -2.260136283318940185e-09 -6.293029450913584212e-13 5.511521593435717570e-01 -1.737019347213116293e-09 -4.529923020023661015e-13 5.511521598029908153e-01 -1.279267784340801185e-09 -3.015322705532040819e-13 5.511521601874694865e-01 -8.973861656373373035e-10 -1.832855995157782226e-13 5.511521604939404462e-01 -5.923023481320416498e-10 -9.598364863104476054e-14 5.511521607385827526e-01 -3.480045032003966609e-10 -3.757474025191286899e-14 5.511521609281296863e-01 -1.590108068873773524e-10 -1.771299034898742825e-14 5.511521609952499956e-01 -9.261896962241085490e-11 -5.864798637501380520e-15 5.511521610475662580e-01 -4.140909210779229826e-11 -4.391927574265215903e-17 5.511521610889511535e-01 -5.140827367412119686e-13 1.715086453772705563e-16 5.511521610937393234e-01 4.332831174106754494e-12 1.513887410876547534e-16 5.511521610684803063e-01 -2.080659314573204521e-11 2.278367481961941684e-15 5.511521610402135840e-01 -4.899432783941330235e-11 1.899455379625113068e-13 5.511521586055532218e-01 -2.510324466082188824e-09 4.490264714482788216e-14 5.511521606233507065e-01 -4.672998108815752970e-10 4.730270787552940163e-14 5.511521606438077869e-01 -4.458966340013474659e-10 5.052167883840936255e-14 5.511521606058522593e-01 -4.833954427332613350e-10 4.832896318673272088e-14 5.511521605657863088e-01 -5.231172197173016908e-10 3.986782951503364502e-14 5.511521605368231436e-01 -5.518225293869036179e-10 2.621051125816343297e-14 5.511521605231906040e-01 -5.652762271769840404e-10 8.868662136599932622e-15 5.511521605226950005e-01 -5.656615682293735280e-10 -1.056858058519397946e-14 5.511521605270374158e-01 -5.612528471115699621e-10 -3.128268501462715004e-14 5.511521605304121607e-01 -5.578913775721459780e-10 -5.347567658457378582e-14 5.511521605251552547e-01 -5.634529511221715852e-10 -7.964080116075407815e-14 5.511521604956814979e-01 -5.943484408425809568e-10 -1.191689243419147103e-13 5.511521604017403098e-01 -6.938913042591608016e-10 -2.243997898245069061e-13 5.511521600326927395e-01 -1.089938817921913829e-09 -1.786726045269459436e-12 5.511521540227259930e-01 -7.650715272933967494e-09 -5.189841187604374306e-13 5.511521592949527593e-01 -2.004409905900591651e-09 -1.199381289176239830e-13 5.511521607013160073e-01 -4.113497224068853493e-10 -8.621755856056185372e-14 5.511521608239140502e-01 -2.681024739049043217e-10 -7.836237992802480504e-14 5.511521608591191113e-01 -2.269979553438566608e-10 -7.541626996460634645e-14 5.511521608768014113e-01 -2.072864202597302569e-10 -7.364847706792762308e-14 5.511521608891201129e-01 -1.944469719894820574e-10 -7.220446163495824081e-14 5.511521608990276322e-01 -1.847017509930289891e-10 -7.083423009169807048e-14 5.511521609073625205e-01 -1.768258999667507354e-10 -6.952480605300450702e-14 5.511521609143911204e-01 -1.703423825329724973e-10 -6.829690398183426133e-14 5.511521609201985861e-01 -1.650509546242985757e-10 -6.724261811774589111e-14 5.511521609248141162e-01 -1.608671104193587100e-10 -6.638624667668800429e-14 5.511521609282430401e-01 -1.577617211897631018e-10 -6.580781169136277972e-14 5.511521609304798064e-01 -1.557349852814714842e-10 -6.554356378434271373e-14 5.511521609314992132e-01 -1.548124489046693648e-10 1.042719896619318982e-11 -1.935841351429115791e-08 5.511521431231726220e-01 9.986486801154351912e-12 -1.846034814934950732e-08 5.511521438203321743e-01 9.719490626731856674e-12 -1.787850551040289174e-08 5.511521441672800892e-01 9.489470681376607650e-12 -1.743886122377381628e-08 5.511521443768473416e-01 9.181208923542002080e-12 -1.700567558995008580e-08 5.511521446060790863e-01 8.720539251327147769e-12 -1.650166565435186132e-08 5.511521449401908246e-01 8.075623211860341507e-12 -1.589705943338448584e-08 5.511521454088527117e-01 7.249633443336263732e-12 -1.518950564924520541e-08 5.511521460106685311e-01 6.272622364703893631e-12 -1.439028169662491015e-08 5.511521467297489929e-01 5.193089962476587736e-12 -1.351643860604680368e-08 5.511521475447720420e-01 4.069532696420372134e-12 -1.258693339415069893e-08 5.511521484332011500e-01 2.962124045783573469e-12 -1.162001802790125530e-08 5.511521493738741340e-01 1.926080593438918644e-12 -1.063268229413269174e-08 5.511521503474122730e-01 1.006629438606728281e-12 -9.640601494305080318e-09 5.511521513360903013e-01 2.358279206230809016e-13 -8.658077712328723820e-09 5.511521523237205011e-01 -3.687180719021075485e-13 -7.697621686808658634e-09 5.511521532959205993e-01 -8.033259038266869828e-13 -6.769617782389535027e-09 5.511521542403757801e-01 -1.076256473256878706e-12 -5.882164995684816938e-09 5.511521551469850122e-01 -1.204921884804728665e-12 -5.041015836648015701e-09 5.511521560078783688e-01 -1.212937948927166847e-12 -4.250002669372075316e-09 5.511521568168927798e-01 -1.128972297457539521e-12 -3.516399837255236973e-09 5.511521575646025628e-01 -9.845009383190930151e-13 -2.849798578494380019e-09 5.511521582408823727e-01 -8.102436498178349529e-13 -2.260136283318940185e-09 5.511521588361073531e-01 -6.261818285015319774e-13 -1.737019347213116293e-09 5.511521593608438296e-01 -4.505187791928124553e-13 -1.279267784340801185e-09 5.511521598169800695e-01 -3.000462469393581990e-13 -8.973861656373373035e-10 5.511521601963780270e-01 -1.823331437867332905e-13 -5.923023481320416498e-10 5.511521605001463708e-01 -9.522257254679203343e-14 -3.480045032003966609e-10 5.511521607441138837e-01 -3.705433985772649198e-14 -1.590108068873773524e-10 5.511521609325678028e-01 -1.742766919971831788e-14 -9.261896962241085490e-11 5.511521609982481529e-01 -5.807337983523520383e-15 -4.140909210779229826e-11 5.511521610483718359e-01 -5.089578737354983002e-17 -5.140827367412119686e-13 5.511521610887905043e-01 1.701351139095099251e-16 4.332831174106754494e-12 5.511521610937004656e-01 1.509869087096243274e-16 -2.080659314573204521e-11 5.511521610686824779e-01 2.270004109583933712e-15 -4.899432783941330235e-11 5.511521610405748506e-01 1.919716683554967631e-13 -2.510324466082188824e-09 5.511521585522802802e-01 4.502422240739360567e-14 -4.672998108815752970e-10 5.511521606208227286e-01 4.733577444739967979e-14 -4.458966340013474659e-10 5.511521606431768472e-01 5.050918754756750035e-14 -4.833954427332613350e-10 5.511521606061359213e-01 4.828391608631327176e-14 -5.231172197173016908e-10 5.511521605667589752e-01 3.981461487940632085e-14 -5.518225293869036179e-10 5.511521605383097322e-01 2.616875810061634018e-14 -5.652762271769840404e-10 5.511521605250324640e-01 8.851257733283596241e-15 -5.656615682293735280e-10 5.511521605247550193e-01 -1.054724961264551410e-14 -5.612528471115699621e-10 5.511521605292271087e-01 -3.121770663943244416e-14 -5.578913775721459780e-10 5.511521605325740980e-01 -5.339695995542333494e-14 -5.634529511221715852e-10 5.511521605267150070e-01 -7.972814136744309671e-14 -5.943484408425809568e-10 5.511521604944001895e-01 -1.202616945646111708e-13 -6.938913042591608016e-10 5.511521603891081922e-01 -2.315239008243453951e-13 -1.089938817921913829e-09 5.511521599645177183e-01 -1.934724828688250947e-12 -7.650715272933967494e-09 5.511521528036518180e-01 -5.804985756064516118e-13 -2.004409905900591651e-09 5.511521588446872677e-01 -1.278783600244265403e-13 -4.113497224068853493e-10 5.511521606484199864e-01 -8.755991171992388262e-14 -2.681024739049043217e-10 5.511521608156314533e-01 -7.755501587582693302e-14 -2.269979553438566608e-10 5.511521608638583203e-01 -7.372788821349790250e-14 -2.072864202597302569e-10 5.511521608862244292e-01 -7.163924543844210218e-14 -1.944469719894820574e-10 5.511521608999560007e-01 -7.013883144285928668e-14 -1.847017509930289891e-10 5.511521609097775887e-01 -6.886399652958866370e-14 -1.768258999667507354e-10 5.511521609173536396e-01 -6.771416871767333033e-14 -1.703423825329724973e-10 5.511521609233999142e-01 -6.666234695991208654e-14 -1.650509546242985757e-10 5.511521609282475920e-01 -6.574985420717189904e-14 -1.608671104193587100e-10 5.511521609320488846e-01 -6.500813917222130397e-14 -1.577617211897631018e-10 5.511521609348618567e-01 -6.450712897602713600e-14 -1.557349852814714842e-10 5.511521609366973884e-01 -6.428164977997273187e-14 -1.548124489046693648e-10 5.511521609375313879e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 deleted file mode 100644 index 4ed9ce969..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_13 +++ /dev/null @@ -1 +0,0 @@ -1.721295036721734451e-02 6.712673211598307941e-05 6.670490081950747894e-05 1.719833101109900786e-02 6.688354891152763053e-05 6.637433322836087815e-05 1.716887648625218393e-02 6.642989965980925318e-05 6.577451590539713539e-05 1.712415060430064889e-02 6.577055006793076843e-05 6.490808195806892168e-05 1.706348748829126724e-02 6.491117687505381750e-05 6.377949362489370062e-05 1.698597749385840489e-02 6.383725929785905528e-05 6.239853369971054564e-05 1.689044813678616461e-02 6.253455705058646606e-05 6.077595491217876929e-05 1.677543977979850318e-02 6.099385673038053730e-05 5.892224546814600893e-05 1.663917574349344647e-02 5.920486091177206523e-05 5.684839652502240678e-05 1.647952642887269212e-02 5.715647083916808232e-05 5.456559097662456748e-05 1.629396697427812693e-02 5.483741477984106544e-05 5.208514274441522620e-05 1.607952790311147073e-02 5.223662613078247494e-05 4.941784494180467878e-05 1.583273817237159861e-02 4.934375008306843643e-05 4.657347291629032577e-05 1.554956001640854860e-02 4.614997606183171580e-05 4.356063388643919806e-05 1.522531500859121770e-02 4.265007715088150851e-05 4.038763621050970806e-05 1.485460088100761140e-02 3.884484722075094140e-05 3.706341791230791647e-05 1.443119887765129290e-02 3.474270679122035225e-05 3.359790309552031256e-05 1.394797184910202999e-02 3.036295693885474089e-05 3.000406551081653811e-05 1.339675401159413741e-02 2.574125108752354477e-05 2.630179689198243980e-05 1.276823444648033691e-02 2.107281189517444699e-05 2.256006815395380843e-05 1.205183813129992454e-02 1.700339201321977397e-05 1.899385415725917005e-05 1.123561047888494736e-02 1.364408606043832027e-05 1.569715464742198647e-05 1.030611576915033134e-02 1.100554424637104417e-05 1.273639987363437728e-05 9.248364213339344692e-03 9.058541743739051579e-06 1.016265451619682238e-05 8.045789494365048269e-03 7.729031259320825613e-06 8.005805608464805606e-06 6.680307569245398126e-03 6.611123138788110771e-06 6.212737447590208145e-06 5.132499128865464742e-03 5.361067275929808597e-06 4.714317100663564446e-06 3.381971325154171926e-03 4.113517229415139541e-06 3.527307615711116640e-06 1.407969392174824317e-03 3.027279105446231061e-06 2.673317781500067827e-06 -7.965506467413656843e-04 2.278755305966860654e-06 2.177552123653988407e-06 -2.977733455481294811e-03 2.068376836908302447e-06 2.067826890513496204e-06 -4.972186905860578356e-03 2.423463170631372623e-06 2.344498366434764183e-06 -6.696231234565619937e-03 3.227461795473075547e-06 2.978654104395773093e-06 -8.063808239355539295e-03 4.351809093232012748e-06 3.929788465606180006e-06 -9.139081605687892490e-03 5.663792833281853213e-06 5.149443799209220045e-06 -1.004011843075387940e-02 7.033938486306045457e-06 6.585301837156556325e-06 -1.070653577155281609e-02 8.451557753909792224e-06 8.191676072419649219e-06 -1.094394683151203584e-02 9.979659884968459453e-06 9.927826189249413166e-06 -1.071407880957648065e-02 1.160475363191492463e-05 1.174986675492620791e-05 -1.024152149876695304e-02 1.331208586718939029e-05 1.361714001548133116e-05 -9.633673638772205852e-03 1.508653712564603308e-05 1.549352284269552208e-05 -8.874323488512006822e-03 1.691271414222667759e-05 1.734757125532049117e-05 -7.822225237291480227e-03 1.877255294722611221e-05 1.915609072720962053e-05 -6.488779015713068941e-03 2.062211030423390687e-05 2.093283445243970811e-05 -4.988113161670612410e-03 2.243522932079603351e-05 2.266975797059254358e-05 -3.628313350716756615e-03 2.419485341096456256e-05 2.435138882960466414e-05 -2.431419318071098741e-03 2.588628405127860489e-05 2.596430964408243960e-05 -1.385076563559442010e-03 2.749721929123112365e-05 2.749725089657682425e-05 -4.739591523485466810e-04 2.901819272610700433e-05 2.894153016453239192e-05 3.309569451030824178e-04 3.044221722186931097e-05 3.029077545573263962e-05 1.042352396640172608e-03 3.176438780728337979e-05 3.154060037406913050e-05 1.668465229659840893e-03 3.298171413106951367e-05 3.268846531172054016e-05 2.217112294288576396e-03 3.409304208651129866e-05 3.373360847493998642e-05 2.695558071838491127e-03 3.509873827284897756e-05 3.467675280565772741e-05 3.109365022826470100e-03 3.599998781918287529e-05 3.551976638827716404e-05 3.452991700702481154e-03 3.679196163005348696e-05 3.626638769452183265e-05 3.732972709703424700e-03 3.747691174731124713e-05 3.692057954212250880e-05 3.958765563350454333e-03 3.806125600941796344e-05 3.748585619489000189e-05 4.138364275776920675e-03 3.855107878756508565e-05 3.796552338778019819e-05 4.278399431584325140e-03 3.895194575383368707e-05 3.836258121436942828e-05 4.384234036816399629e-03 3.926876320320372375e-05 3.867965678222908021e-05 4.460049202850799310e-03 3.950565686815673248e-05 3.891894199464233288e-05 4.508915825716490466e-03 3.966586888505558027e-05 3.908213398194559040e-05 4.532849875250227582e-03 3.975174198328113067e-05 3.917045484211030478e-05 1.095613397081323215e-11 5.511521401985970403e-01 -1.935880555269290127e-08 1.042057596433414104e-11 5.511521413286415427e-01 -1.846074647570244889e-08 1.004278450176409021e-11 5.511521421804278509e-01 -1.787891514045774313e-08 9.709865643111675681e-12 5.511521428786134713e-01 -1.743928460394935357e-08 9.318758622435209968e-12 5.511521435350501541e-01 -1.700611143225154642e-08 8.798572590483974915e-12 5.511521442206454013e-01 -1.650210808975193781e-08 8.115682938199146633e-12 5.511521449677231344e-01 -1.589749775642787399e-08 7.269400685698935079e-12 5.511521457843951977e-01 -1.518992490383253614e-08 6.285460411536010251e-12 5.511521466653500623e-01 -1.439066423844682559e-08 5.208453784077735955e-12 5.511521475986506102e-01 -1.351676659708996165e-08 4.093352356223616723e-12 5.511521485694239608e-01 -1.258719198451265319e-08 2.997346319600008901e-12 5.511521495626210410e-01 -1.162019880847234085e-08 1.973106218637771118e-12 5.511521505638028451e-01 -1.063278649821103143e-08 1.063779906906167971e-12 5.511521515594174359e-01 -9.640642401714403220e-09 2.998376666283024587e-13 5.511521525370624008e-01 -8.658081766074490919e-09 -3.021276893818964013e-13 5.511521534860680527e-01 -7.697627956657833016e-09 -7.387392356536309945e-13 5.511521543979231996e-01 -6.769675582814900476e-09 -1.017925665689531102e-12 5.511521552664651047e-01 -5.882329662673053204e-09 -1.156129461498360953e-12 5.511521560879973913e-01 -5.041342862102952239e-09 -1.175416483921707593e-12 5.511521568609838440e-01 -4.250540558901880616e-09 -1.102583961436972139e-12 5.511521575803176587e-01 -3.517182371230707500e-09 -9.677209835334849927e-13 5.511521582370041417e-01 -2.850838104559950033e-09 -8.008303772710203792e-13 5.511521588208475597e-01 -2.261418900734099523e-09 -6.216212069902853704e-13 5.511521593421312426e-01 -1.738502915092586535e-09 -4.484877595596141106e-13 5.511521598014261780e-01 -1.280883574282839505e-09 -2.992218118539822385e-13 5.511521601858621056e-01 -8.990446162327785056e-10 -1.823229538361239393e-13 5.511521604923819151e-01 -5.939019715933760666e-10 -9.576409366428380361e-14 5.511521607371665521e-01 -3.494431422061634473e-10 -3.767710891395697204e-14 5.511521609269410815e-01 -1.601992594044196056e-10 -1.782744669833678500e-14 5.511521609943960121e-01 -9.345596204951614450e-11 -5.929240445845408823e-15 5.511521610471139532e-01 -4.184434444575934867e-11 -5.853068583388004972e-17 5.511521610887827327e-01 -6.744288194837621236e-13 1.737132145498644102e-16 5.511521610937115678e-01 4.306344532639519234e-12 1.355682444771499907e-16 5.511521610684797512e-01 -2.080710179040346200e-11 2.252161361627504503e-15 5.511521610401906024e-01 -4.901647051611147232e-11 1.893420428048294971e-13 5.511521586055031507e-01 -2.510373647806366452e-09 4.495725796801629086e-14 5.511521606233041881e-01 -4.673457040907776911e-10 4.755873821221601097e-14 5.511521606438090082e-01 -4.458954598236297607e-10 5.104873314813767310e-14 5.511521606059016642e-01 -4.833459271123453165e-10 4.909951142735070996e-14 5.511521605658377121e-01 -5.230642479493962673e-10 4.082008047062512767e-14 5.511521605368623344e-01 -5.517813944196182784e-10 2.726911085656805681e-14 5.511521605232132526e-01 -5.652524989295393220e-10 9.987442966387723770e-15 5.511521605226993303e-01 -5.656572784206124303e-10 -9.442102275759914166e-15 5.511521605270418567e-01 -5.612480549135857038e-10 -3.019217099322405313e-14 5.511521605304605664e-01 -5.578417582022837131e-10 -5.244078930174357985e-14 5.511521605252867051e-01 -5.633207632901547776e-10 -7.866878971545750320e-14 5.511521604959228604e-01 -5.941082465345681717e-10 -1.182317149899083537e-13 5.511521604021025755e-01 -6.935329022246582895e-10 -2.233601598306526581e-13 5.511521600331764636e-01 -1.089460967409281549e-09 -1.783517504413031013e-12 5.511521540233245142e-01 -7.650122309124104859e-09 -5.189355289665292998e-13 5.511521592956452054e-01 -2.003719217243813544e-09 -1.199468913455386908e-13 5.511521607020777314e-01 -4.105825692333179972e-10 -8.624042360742396977e-14 5.511521608247205162e-01 -2.672806819565484605e-10 -7.843441309158790667e-14 5.511521608599493360e-01 -2.261414164331362712e-10 -7.552130291467565766e-14 5.511521608776249748e-01 -2.064267006581320498e-10 -7.382089447751411425e-14 5.511521608899055957e-01 -1.936195748501959040e-10 -7.240135218148223077e-14 5.511521608997735910e-01 -1.839113530777261947e-10 -7.108718510394105623e-14 5.511521609080702877e-01 -1.760737067581226890e-10 -6.981238372589967097e-14 5.511521609150638046e-01 -1.696270219126132408e-10 -6.863914555470223174e-14 5.511521609208401840e-01 -1.643690371174432359e-10 -6.760125877397316671e-14 5.511521609254298459e-01 -1.602136686352289888e-10 -6.677068756184130070e-14 5.511521609288386747e-01 -1.571305981423525883e-10 -6.621078283662278601e-14 5.511521609310617853e-01 -1.551191837018335948e-10 -6.595146015938489180e-14 5.511521609320741977e-01 -1.542044393343017922e-10 1.016044525788433388e-11 -1.935880555269290127e-08 5.511521431227522916e-01 9.741602331716402985e-12 -1.846074647570244889e-08 5.511521438199049605e-01 9.500673878906462187e-12 -1.787891514045774313e-08 5.511521441668405519e-01 9.302049022335230158e-12 -1.743928460394935357e-08 5.511521443763925943e-01 9.030190346277613044e-12 -1.700611143225154642e-08 5.511521446056103501e-01 8.609057617523781191e-12 -1.650210808975193781e-08 5.511521449397139838e-01 8.004045845184568908e-12 -1.589749775642787399e-08 5.511521454083788685e-01 7.215602326446723341e-12 -1.518992490383253614e-08 5.511521460102133396e-01 6.271535502029128145e-12 -1.439066423844682559e-08 5.511521467293311050e-01 5.218944842165977545e-12 -1.351676659708996165e-08 5.511521475444107754e-01 4.115632204117746247e-12 -1.258719198451265319e-08 5.511521484329127141e-01 3.021829784614994091e-12 -1.162019880847234085e-08 5.511521493736685207e-01 1.993307088385502147e-12 -1.063278649821103143e-08 5.511521503472894823e-01 1.076176559667642099e-12 -9.640642401714403220e-09 5.511521513360378988e-01 3.035519289922088602e-13 -8.658081766074490919e-09 5.511521523237122855e-01 -3.058768700270140061e-13 -7.697627956657833016e-09 5.511521532959168246e-01 -7.473940395182781010e-13 -6.769675582814900476e-09 5.511521542403254870e-01 -1.028331637348979012e-12 -5.882329662673053204e-09 5.511521551468304692e-01 -1.165390520182033455e-12 -5.041342862102952239e-09 5.511521560075606230e-01 -1.181601151700301850e-12 -4.250540558901880616e-09 5.511521568163594287e-01 -1.105174081235629311e-12 -3.517182371230707500e-09 5.511521575638156367e-01 -9.672423690794238515e-13 -2.850838104559950033e-09 5.511521582398259955e-01 -7.983700188792982360e-13 -2.261418900734099523e-09 5.511521588347936262e-01 -6.185492601714321537e-13 -1.738502915092586535e-09 5.511521593593159407e-01 -4.460704140162548011e-13 -1.280883574282839505e-09 5.511521598153115153e-01 -2.977564105289988776e-13 -8.990446162327785056e-10 5.511521601946668403e-01 -1.813817665643085847e-13 -5.939019715933760666e-10 5.511521604985044620e-01 -9.501485778097035877e-14 -3.494431422061634473e-10 5.511521607426524971e-01 -3.715693046811362058e-14 -1.601992594044196056e-10 5.511521609313794201e-01 -1.753883141499314953e-14 -9.345596204951614450e-11 5.511521609974278091e-01 -5.870361752854431537e-15 -4.184434444575934867e-11 5.511521610479529487e-01 -6.444557491325421710e-17 -6.744288194837621236e-13 5.511521610886378486e-01 1.733658548998054962e-16 4.306344532639519234e-12 5.511521610936751525e-01 1.343299218773930538e-16 -2.080710179040346200e-11 5.511521610686820338e-01 2.243482614486945224e-15 -4.901647051611147232e-11 5.511521610405535343e-01 1.913616876301035290e-13 -2.510373647806366452e-09 5.511521585522319855e-01 4.507905332476748612e-14 -4.673457040907776911e-10 5.511521606207774315e-01 4.759370199910946903e-14 -4.458954598236297607e-10 5.511521606431779574e-01 5.103200807249778396e-14 -4.833459271123453165e-10 5.511521606061855483e-01 4.905592678277543291e-14 -5.230642479493962673e-10 5.511521605668134871e-01 4.076442073851072263e-14 -5.517813944196182784e-10 5.511521605383529199e-01 2.722329766124028425e-14 -5.652524989295393220e-10 5.511521605250573330e-01 9.968038096534029670e-15 -5.656572784206124303e-10 5.511521605247593492e-01 -9.426577148354940974e-15 -5.612480549135857038e-10 5.511521605292323267e-01 -3.013124693639900107e-14 -5.578417582022837131e-10 5.511521605326249462e-01 -5.236795119408414104e-14 -5.633207632901547776e-10 5.511521605268479007e-01 -7.875203952025151817e-14 -5.941082465345681717e-10 5.511521604946392205e-01 -1.193105835213450212e-13 -6.935329022246582895e-10 5.511521603894627974e-01 -2.304563671188846337e-13 -1.089460967409281549e-09 5.511521599649897851e-01 -1.931266813415170220e-12 -7.650122309124104859e-09 5.511521528042393481e-01 -5.804679032761464065e-13 -2.003719217243813544e-09 5.511521588453761611e-01 -1.278909252944431302e-13 -4.105825692333179972e-10 5.511521606491925906e-01 -8.759507042147763233e-14 -2.672806819565484605e-10 5.511521608164687835e-01 -7.761999647692543881e-14 -2.261414164331362712e-10 5.511521608647420578e-01 -7.381387051429841039e-14 -2.064267006581320498e-10 5.511521608871219335e-01 -7.176780202684720655e-14 -1.936195748501959040e-10 5.511521609008276368e-01 -7.031345327145920070e-14 -1.839113530777261947e-10 5.511521609106150299e-01 -6.908146026147251275e-14 -1.760737067581226890e-10 5.511521609181530001e-01 -6.795388267596431858e-14 -1.696270219126132408e-10 5.511521609241606390e-01 -6.695480207488848551e-14 -1.643690371174432359e-10 5.511521609289723456e-01 -6.606431073194040527e-14 -1.602136686352289888e-10 5.511521609327423299e-01 -6.537425390018490676e-14 -1.571305981423525883e-10 5.511521609355305440e-01 -6.488089440724862222e-14 -1.551191837018335948e-10 5.511521609373489783e-01 -6.466996424246120561e-14 -1.542044393343017922e-10 5.511521609381743181e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 deleted file mode 100644 index e0b477046..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_14 +++ /dev/null @@ -1 +0,0 @@ -1.721632942869843336e-02 6.712673204326235999e-05 6.670490075228683582e-05 1.720175449329284373e-02 6.688354884888213084e-05 6.637433316997968114e-05 1.717238960348169141e-02 6.642989961067368506e-05 6.577451585906936629e-05 1.712780017332296220e-02 6.577055003466895011e-05 6.490808192630051054e-05 1.706732277147334637e-02 6.491117685874950392e-05 6.377949360914917417e-05 1.699005109041411624e-02 6.383725929830569236e-05 6.239853370017957150e-05 1.689481694320208588e-02 6.253455706633385210e-05 6.077595492773033486e-05 1.678016603653742847e-02 6.099385675893397051e-05 5.892224549651151603e-05 1.664432818915119461e-02 5.920486095006603853e-05 5.684839656323524787e-05 1.648518158270052478e-02 5.715647088382809097e-05 5.456559102136532887e-05 1.630021057058287856e-02 5.483741482765272106e-05 5.208514279247298216e-05 1.608645650023426965e-02 5.223662617888073941e-05 4.941784499029032869e-05 1.584046096287895777e-02 4.934375012910946116e-05 4.657347296279683237e-05 1.555820086062808735e-02 4.614997610409174808e-05 4.356063392919126839e-05 1.523501471733340260e-02 4.265007718822385723e-05 4.038763624833542799e-05 1.486551976487506324e-02 3.884484725262264313e-05 3.706341794457445753e-05 1.444351957620214864e-02 3.474270681746791784e-05 3.359790312209671667e-05 1.396190243696526431e-02 3.036295695969637619e-05 3.000406553188113959e-05 1.341253135900296115e-02 2.574125110342915656e-05 2.630179690802911645e-05 1.278612777498370177e-02 2.107281190676286398e-05 2.256006816560004728e-05 1.207215265376144001e-02 1.700339202117923416e-05 1.899385416522654830e-05 1.125869093895701806e-02 1.364408606550349090e-05 1.569715465247324034e-05 1.033234957588064808e-02 1.100554424925472040e-05 1.273639987650265615e-05 9.278183718190299509e-03 9.058541745085359626e-06 1.016265451750178337e-05 8.079672746624340027e-03 7.729031259655966057e-06 8.005805608796395288e-06 6.718776610978390365e-03 6.611123138569952353e-06 6.212737447366392394e-06 5.176114544984542626e-03 5.361067275502351726e-06 4.714317100218249579e-06 3.431321357095292769e-03 4.113517228988618641e-06 3.527307615272877040e-06 1.463651479512458444e-03 3.027279105135444508e-06 2.673317781190135083e-06 -7.364435113205050707e-04 2.278755305765620872e-06 2.177552123446766031e-06 -2.921346635785978564e-03 2.068376836816357444e-06 2.067826890421239916e-06 -4.921693669552004539e-03 2.423463170622163681e-06 2.344498366426606409e-06 -6.653968554831440896e-03 3.227461795477976056e-06 2.978654104399682150e-06 -8.032148847265406510e-03 4.351809093201792307e-06 3.929788465577178444e-06 -9.111923044719425283e-03 5.663792833225202802e-06 5.149443799153701271e-06 -1.001800621021347801e-02 7.033938484143804971e-06 6.585301834970980928e-06 -1.069341885884439805e-02 8.451557753641867233e-06 8.191676072150485866e-06 -1.094373034617290158e-02 9.979659884861194588e-06 9.927826189140095094e-06 -1.072529824394265544e-02 1.160475363197610413e-05 1.174986675498730101e-05 -1.025677780553416532e-02 1.331208586741465192e-05 1.361714001569960308e-05 -9.652805316628819063e-03 1.508653712597981149e-05 1.549352284303230916e-05 -8.900097482833761731e-03 1.691271414265535080e-05 1.734757125574980135e-05 -7.857162016506663224e-03 1.877255294771064555e-05 1.915609072769330345e-05 -6.531917501015669855e-03 2.062211030476308901e-05 2.093283445297244440e-05 -5.031687966667522903e-03 2.243522932135812796e-05 2.266975797113974042e-05 -3.667529308007861505e-03 2.419485341154213400e-05 2.435138883017904735e-05 -2.466556558475318465e-03 2.588628405187327284e-05 2.596430964468336204e-05 -1.416458986790087140e-03 2.749721929191475378e-05 2.749725089725096761e-05 -5.022326464818290329e-04 2.901819272706800725e-05 2.894153016551862626e-05 3.050775714754186429e-04 3.044221722743031266e-05 3.029077546174225029e-05 1.018637427149941257e-03 3.176438780862413807e-05 3.154060037557926828e-05 1.646689716077626023e-03 3.298171413143581137e-05 3.268846531209158125e-05 2.197060371892891294e-03 3.409304208679374011e-05 3.373360847525880285e-05 2.677025579203547081e-03 3.509873827312724482e-05 3.467675280595348421e-05 3.092419122338037601e-03 3.599998781944954837e-05 3.551976638855804694e-05 3.437903613149849436e-03 3.679196163032407671e-05 3.626638769478422990e-05 3.719445505954883067e-03 3.747691174756482169e-05 3.692057954240356789e-05 3.946534158528983149e-03 3.806125600969238856e-05 3.748585619516907552e-05 4.127191695384666188e-03 3.855107878782736770e-05 3.796552338802255803e-05 4.268072799266158825e-03 3.895194575410748877e-05 3.836258121464354169e-05 4.374560461130654054e-03 3.926876320348634815e-05 3.867965678247208379e-05 4.450851666851720137e-03 3.950565686840221618e-05 3.891894199491624978e-05 4.500029130380998540e-03 3.966586888531105896e-05 3.908213398220562274e-05 4.524116650982753715e-03 3.975174198350990410e-05 3.917045484238004073e-05 1.088341324858335609e-11 5.511521401983781043e-01 -1.935905287392650625e-08 1.035793046496640453e-11 5.511521413284184989e-01 -1.846099803977157015e-08 9.993648932038448851e-12 5.511521421801973686e-01 -1.787917437380476180e-08 9.676603820526318837e-12 5.511521428783737742e-01 -1.743955328566450094e-08 9.302454307014297187e-12 5.511521435348017972e-01 -1.700638893371802923e-08 8.799019221792749104e-12 5.511521442203914933e-01 -1.650239080877548630e-08 8.131430329951738621e-12 5.511521449674700035e-01 -1.589777892560557618e-08 7.297954118762742310e-12 5.511521457841518368e-01 -1.519019493977046330e-08 6.323754384502730536e-12 5.511521466651272405e-01 -1.439091172493197600e-08 5.253113793143077216e-12 5.511521475984590968e-01 -1.351697987869787717e-08 4.141164009940978633e-12 5.511521485692729705e-01 -1.258736121554650374e-08 3.045444583515264415e-12 5.511521495625159028e-01 -1.162031818998013262e-08 2.019147245595322573e-12 5.511521505637427820e-01 -1.063285636565140997e-08 1.106039936810297335e-12 5.511521515593944542e-01 -9.640670808874800330e-09 3.371800158108160899e-13 5.511521525370602914e-01 -8.658085246599578341e-09 -2.702559888377770889e-13 5.511521534860630567e-01 -7.697631224189195080e-09 -7.124916669122593160e-13 5.511521543978853410e-01 -6.769710042264150455e-09 -9.970840299148868029e-13 5.511521552663607437e-01 -5.882430732158349621e-09 -1.140223850718881914e-12 5.511521560877929993e-01 -5.041546230333120713e-09 -1.163828067423053053e-12 5.511521568606505550e-01 -4.250877610406287966e-09 -1.094624500946232024e-12 5.511521575798357109e-01 -3.517675213289613502e-09 -9.626558136490209840e-13 5.511521582363668736e-01 -2.851495237652952993e-09 -7.979467003300715814e-13 5.511521588200639643e-01 -2.262232085835988469e-09 -6.202748985450020685e-13 5.511521593412266329e-01 -1.739445836443565601e-09 -4.481526197705951307e-13 5.511521598004405220e-01 -1.281912826659938121e-09 -2.994399706297396859e-13 5.511521601848468066e-01 -9.001033159843344919e-10 -1.827504109608611009e-13 5.511521604913950378e-01 -5.949253905783392183e-10 -9.619061452600818050e-14 5.511521607362673825e-01 -3.503658594011561482e-10 -3.798789559964448668e-14 5.511521609261843535e-01 -1.609638521024267571e-10 -1.802868655179560966e-14 5.511521609938472288e-01 -9.399976927329045862e-11 -6.021185332048495441e-15 5.511521610468211874e-01 -4.212942936247324000e-11 -6.773952395400081477e-17 5.511521610886723765e-01 -7.810403461679758233e-13 1.786135731043945635e-16 5.511521610936928051e-01 4.287953491736612014e-12 1.053480399748806808e-16 5.511521610684795291e-01 -2.080730230282507112e-11 2.195511289704798603e-15 5.511521610401762805e-01 -4.903003592259049864e-11 1.871798026228309928e-13 5.511521586054713984e-01 -2.510404707292487337e-09 4.468933356173399527e-14 5.511521606232736570e-01 -4.673757643174587908e-10 4.745147285114143815e-14 5.511521606438083420e-01 -4.458960731809470847e-10 5.110991266568574592e-14 5.511521606059329725e-01 -4.833145700428660997e-10 4.932477312783468611e-14 5.511521605658705747e-01 -5.230303714350802938e-10 4.115385830195983621e-14 5.511521605368875365e-01 -5.517548372500375722e-10 2.769778349888052705e-14 5.511521605232277965e-01 -5.652370668567506689e-10 1.047197576248177316e-14 5.511521605227022169e-01 -5.656542890733709660e-10 -8.912919485991267405e-15 5.511521605270444102e-01 -5.612453418984826179e-10 -2.963007633101755437e-14 5.511521605304908755e-01 -5.578110704055413942e-10 -5.186321954183102540e-14 5.511521605253699718e-01 -5.632377424557201273e-10 -7.807412345317684663e-14 5.511521604960765153e-01 -5.939563388023209683e-10 -1.175480858637728777e-13 5.511521604023338350e-01 -6.933052914696258058e-10 -2.223991567737833292e-13 5.511521600334856608e-01 -1.089156979793541695e-09 -1.777956501573905822e-12 5.511521540237077632e-01 -7.649744328661686029e-09 -5.175947729319826826e-13 5.511521592960891835e-01 -2.003278291078481150e-09 -1.195805966802069151e-13 5.511521607025665626e-01 -4.100923029093940162e-10 -8.595797939966918156e-14 5.511521608252384352e-01 -2.667551017300005915e-10 -7.815614815746904792e-14 5.511521608604825762e-01 -2.255933561621592902e-10 -7.525462697467076300e-14 5.511521608781553283e-01 -2.058749987500544849e-10 -7.355030697196152430e-14 5.511521608904113023e-01 -1.930885510479689269e-10 -7.214777529499949941e-14 5.511521609002536515e-01 -1.834040601764511689e-10 -7.081276310054880853e-14 5.511521609085257012e-01 -1.755909314146968016e-10 -6.955009957053171465e-14 5.511521609154964585e-01 -1.691678828792371058e-10 -6.836534423802788119e-14 5.511521609212527428e-01 -1.639313556065464013e-10 -6.731863226501941533e-14 5.511521609258256404e-01 -1.597942542698442923e-10 -6.652520662144538559e-14 5.511521609292214796e-01 -1.567254992451573900e-10 -6.595530678280489262e-14 5.511521609314357084e-01 -1.547239112177524518e-10 -6.572268748629599226e-14 5.511521609324436799e-01 -1.538141639764282053e-10 1.009322461267230794e-11 -1.935905287392650625e-08 5.511521431224728484e-01 9.683221129356519417e-12 -1.846099803977157015e-08 5.511521438196211875e-01 9.454346115648882495e-12 -1.787917437380476180e-08 5.511521441665488963e-01 9.270280616732053829e-12 -1.743955328566450094e-08 5.511521443760913908e-01 9.014445818752422608e-12 -1.700638893371802923e-08 5.511521446053003759e-01 8.609526638300366761e-12 -1.650239080877548630e-08 5.511521449393991245e-01 8.019597412387737695e-12 -1.589777892560557618e-08 5.511521454080664517e-01 7.243967833172845190e-12 -1.519019493977046330e-08 5.511521460099136904e-01 6.309748342566365028e-12 -1.439091172493197600e-08 5.511521467290562137e-01 5.263685604796067150e-12 -1.351697987869787717e-08 5.511521475441731877e-01 4.163689961964815336e-12 -1.258736121554650374e-08 5.511521484327229770e-01 3.070315431495665953e-12 -1.162031818998013262e-08 5.511521493735329624e-01 2.039813592097844277e-12 -1.063285636565140997e-08 5.511521503472082140e-01 1.118928627368127796e-12 -9.640670808874800330e-09 5.511521513360028157e-01 3.413776472876586276e-13 -8.658085246599578341e-09 5.511521523237065123e-01 -2.736103315129615667e-13 -7.697631224189195080e-09 5.511521532959147152e-01 -7.208176329290261899e-13 -6.769710042264150455e-09 5.511521542402941787e-01 -1.007267034743990017e-12 -5.882430732158349621e-09 5.511521551467326585e-01 -1.149343844742678557e-12 -5.041546230333120713e-09 5.511521560073582293e-01 -1.169954912025725299e-12 -4.250877610406287966e-09 5.511521568160185902e-01 -1.097206704047857644e-12 -3.517675213289613502e-09 5.511521575633115955e-01 -9.621911148893752156e-13 -2.851495237652952993e-09 5.511521582391483154e-01 -7.955017404546139085e-13 -2.262232085835988469e-09 5.511521588339496347e-01 -6.172442989758384835e-13 -1.739445836443565601e-09 5.511521593583331713e-01 -4.457388245226045086e-13 -1.281912826659938121e-09 5.511521598142367084e-01 -2.979802259086439050e-13 -9.001033159843344919e-10 5.511521601935628345e-01 -1.818270813544377875e-13 -5.949253905783392183e-10 5.511521604974431998e-01 -9.545309733381103967e-14 -3.503658594011561482e-10 5.511521607417055879e-01 -3.746686301465359010e-14 -1.609638521024267571e-10 5.511521609306069269e-01 -1.774605366033301668e-14 -9.399976927329045862e-11 5.511521609968889068e-01 -5.962617838101021922e-15 -4.212942936247324000e-11 5.511521610476752819e-01 -7.260313753621762820e-17 -7.810403461679758233e-13 5.511521610885349309e-01 1.772747175051361825e-16 4.287953491736612014e-12 5.511521610936571669e-01 1.053281095942295464e-16 -2.080730230282507112e-11 5.511521610686819228e-01 2.187963437447270497e-15 -4.903003592259049864e-11 5.511521610405406557e-01 1.891761123394317276e-13 -2.510404707292487337e-09 5.511521585522016764e-01 4.480989042528005235e-14 -4.673757643174587908e-10 5.511521606207477886e-01 4.748438453461561990e-14 -4.458960731809470847e-10 5.511521606431774023e-01 5.109310172243078020e-14 -4.833145700428660997e-10 5.511521606062169676e-01 4.927419814197126184e-14 -5.230303714350802938e-10 5.511521605668484591e-01 4.110120937712491406e-14 -5.517548372500375722e-10 5.511521605383810085e-01 2.765260724889126862e-14 -5.652370668567506689e-10 5.511521605250736533e-01 1.045172149637338543e-14 -5.656542890733709660e-10 5.511521605247624578e-01 -8.893839318952197376e-15 -5.612453418984826179e-10 5.511521605292351023e-01 -2.958404852093917544e-14 -5.578110704055413942e-10 5.511521605326560325e-01 -5.179356791988099638e-14 -5.632377424557201273e-10 5.511521605269306123e-01 -7.815111714379901316e-14 -5.939563388023209683e-10 5.511521604947894337e-01 -1.186364385468051186e-13 -6.933052914696258058e-10 5.511521603896868404e-01 -2.294701335818708221e-13 -1.089156979793541695e-09 5.511521599652886572e-01 -1.925257201702678001e-12 -7.649744328661686029e-09 5.511521528046121610e-01 -5.789577674909127793e-13 -2.003278291078481150e-09 5.511521588458140331e-01 -1.275198813521842989e-13 -4.100923029093940162e-10 5.511521606496843084e-01 -8.727625171228622249e-14 -2.667551017300005915e-10 5.511521608170021347e-01 -7.732424094863017835e-14 -2.255933561621592902e-10 5.511521608653052740e-01 -7.353298860301103949e-14 -2.058749987500544849e-10 5.511521608876958078e-01 -7.150540306503423945e-14 -1.930885510479689269e-10 5.511521609013851908e-01 -7.003239666372419342e-14 -1.834040601764511689e-10 5.511521609111510456e-01 -6.880238471832445385e-14 -1.755909314146968016e-10 5.511521609186648130e-01 -6.771152092349896423e-14 -1.691678828792371058e-10 5.511521609246479159e-01 -6.668068752101708988e-14 -1.639313556065464013e-10 5.511521609294366408e-01 -6.582130952189463715e-14 -1.597942542698442923e-10 5.511521609331867522e-01 -6.510033372219995462e-14 -1.567254992451573900e-10 5.511521609359592011e-01 -6.462086522133413309e-14 -1.547239112177524518e-10 5.511521609377667552e-01 -6.440022823816495054e-14 -1.538141639764282053e-10 5.511521609385865439e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 deleted file mode 100644 index f1e2e8fb4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_15 +++ /dev/null @@ -1 +0,0 @@ -1.721848979898908324e-02 6.712673192145242210e-05 6.670490063903657921e-05 1.720394325798980592e-02 6.688354873430933732e-05 6.637433306260860568e-05 1.717463566457258853e-02 6.642989950338663526e-05 6.577451575740517870e-05 1.713013345720933861e-02 6.577054993593208128e-05 6.490808183159807996e-05 1.706977476683997977e-02 6.491117677040407594e-05 6.377949352350694681e-05 1.699265541848834354e-02 6.383725922198403937e-05 6.239853362546046419e-05 1.689760997148944538e-02 6.253455700286574112e-05 6.077595486512748498e-05 1.678318754749996006e-02 6.099385670837197181e-05 5.892224544630431571e-05 1.664762211764211214e-02 5.920486091168091771e-05 5.684839652493818460e-05 1.648879683610928945e-02 5.715647085630741453e-05 5.456559099380339176e-05 1.630420194437295564e-02 5.483741480938803442e-05 5.208514277413744969e-05 1.609088570668716286e-02 5.223662616808195025e-05 4.941784497942236742e-05 1.584539778671857982e-02 4.934375012407267122e-05 4.657347295771103649e-05 1.556372445931667597e-02 4.614997610317897182e-05 4.356063392828358110e-05 1.524121507776325310e-02 4.265007719005770389e-05 4.038763625018822786e-05 1.487249933242042882e-02 3.884484725604069890e-05 3.706341794803985905e-05 1.445139506078429482e-02 3.474270682159582110e-05 3.359790312623642418e-05 1.397080679707566643e-02 3.036295696386977189e-05 3.000406553609244849e-05 1.342261594703219978e-02 2.574125110720955608e-05 2.630179691181635661e-05 1.279756460787140858e-02 2.107281190986600645e-05 2.256006816873099615e-05 1.208513673815362482e-02 1.700339202353844453e-05 1.899385416759519801e-05 1.127344252902253915e-02 1.364408606711663973e-05 1.569715465409907265e-05 1.034911617538126875e-02 1.100554425022429361e-05 1.273639987746489405e-05 9.297241535879080185e-03 9.058541745550768655e-06 1.016265451795671968e-05 8.101327181530290980e-03 7.729031259749573362e-06 8.005805608871220485e-06 6.743361168859297004e-03 6.611123138469617913e-06 6.212737447212619492e-06 5.203987367576234403e-03 5.361067275275172407e-06 4.714317099982163709e-06 3.462858284672948490e-03 4.113517228760073905e-06 3.527307615044833324e-06 1.499234283636458618e-03 3.027279104974238468e-06 2.673317781016495023e-06 -6.978965788405388018e-04 2.278755305662842741e-06 2.177552123351406215e-06 -2.885157842819942916e-03 2.068376836761455733e-06 2.067826890371406851e-06 -4.889251559230993818e-03 2.423463170609756766e-06 2.344498366416368745e-06 -6.626767285110149452e-03 3.227461795482568245e-06 2.978654104401980150e-06 -8.011706557506275903e-03 4.351809093188863196e-06 3.929788465563879180e-06 -9.094468589958187854e-03 5.663792833205527921e-06 5.149443799131646227e-06 -1.000377162691906859e-02 7.033938483490738334e-06 6.585301834311243906e-06 -1.068484045842477657e-02 8.451557753610023876e-06 8.191676072117993682e-06 -1.094339525672049888e-02 9.979659884930934199e-06 9.927826189211330564e-06 -1.073241592166865321e-02 1.160475363217409299e-05 1.174986675518871189e-05 -1.026647789924258793e-02 1.331208586771803880e-05 1.361714001601530412e-05 -9.664985712106215210e-03 1.508653712638620604e-05 1.549352284344274744e-05 -8.916434181702391840e-03 1.691271414312630789e-05 1.734757125621577112e-05 -7.879367776299689430e-03 1.877255294823545700e-05 1.915609072822169954e-05 -6.559379479483174250e-03 2.062211030530560683e-05 2.093283445350816225e-05 -5.059619361099084237e-03 2.243522932190006981e-05 2.266975797169881266e-05 -3.692669196794029843e-03 2.419485341208146359e-05 2.435138883073945451e-05 -2.489083847778326714e-03 2.588628405246685320e-05 2.596430964525496698e-05 -1.436580766360725766e-03 2.749721929251997237e-05 2.749725089790402323e-05 -5.203491619558763643e-04 2.901819272792479802e-05 2.894153016638994873e-05 2.884946631964138892e-04 3.044221723214604662e-05 3.029077546684820556e-05 1.003441074108645317e-03 3.176438780966741839e-05 3.154060037670050951e-05 1.632735884426976493e-03 3.298171413167686340e-05 3.268846531235378199e-05 2.184210819109089381e-03 3.409304208696291630e-05 3.373360847540353706e-05 2.665149539484041978e-03 3.509873827327807089e-05 3.467675280610697336e-05 3.081540676969766503e-03 3.599998781957608154e-05 3.551976638867036351e-05 3.428216464870691843e-03 3.679196163045103679e-05 3.626638769494707707e-05 3.710759319052764783e-03 3.747691174766574058e-05 3.692057954249998734e-05 3.938678989113938468e-03 3.806125600977794567e-05 3.748585619526289289e-05 4.120015603592758549e-03 3.855107878792191013e-05 3.796552338815682292e-05 4.261439281623429116e-03 3.895194575416167178e-05 3.836258121470660838e-05 4.368345817073831377e-03 3.926876320352017525e-05 3.867965678255032931e-05 4.444942366241291971e-03 3.950565686848904045e-05 3.891894199496126450e-05 4.494319215016703319e-03 3.966586888536990403e-05 3.908213398224745939e-05 4.518505179236713930e-03 3.975174198359515627e-05 3.917045484244480825e-05 1.076160331081297282e-11 5.511521401982297785e-01 -1.935920754983413109e-08 1.024335766696377915e-11 5.511521413282677306e-01 -1.846115545618043853e-08 9.886361888389231852e-12 5.511521421800421594e-01 -1.787933675829096177e-08 9.577866953575361089e-12 5.511521428782132359e-01 -1.743972182418731696e-08 9.214108884359242438e-12 5.511521435346363740e-01 -1.700656328528707686e-08 8.722697566076826901e-12 5.511521442202235166e-01 -1.650256874000178815e-08 8.067962218711861798e-12 5.511521449673035811e-01 -1.589795618021919037e-08 7.247392116882516670e-12 5.511521457839928528e-01 -1.519036545152963618e-08 6.285369266116374148e-12 5.511521466649824674e-01 -1.439106823582639822e-08 5.225593116334719181e-12 5.511521475983355289e-01 -1.351711494934247475e-08 4.122899321020794496e-12 5.511521485691761590e-01 -1.258746853003858842e-08 3.034645796889589455e-12 5.511521495624490674e-01 -1.162039398537898282e-08 2.014110456926635608e-12 5.511521505637050344e-01 -1.063290077029466187e-08 1.105127161292660360e-12 5.511521515593803544e-01 -9.640688862771153505e-09 3.390138616994237602e-13 5.511521525370591812e-01 -8.658087399128429804e-09 -2.668379340887849775e-13 5.511521534860593929e-01 -7.697633155351319440e-09 -7.083637646337871855e-13 5.511521543978598059e-01 -6.769731724642895047e-09 -9.929106341375817155e-13 5.511521552662916879e-01 -5.882494732011854002e-09 -1.136443451373678330e-12 5.511521560876588843e-01 -5.041675326299733247e-09 -1.160724925732773719e-12 5.511521568604330623e-01 -4.251091877347558666e-09 -1.092265289862060340e-12 5.511521575795222949e-01 -3.517988846866913030e-09 -9.610426640091773301e-13 5.511521582359534266e-01 -2.851913781636485246e-09 -7.969771278980833765e-13 5.511521588195564814e-01 -2.262750417850144847e-09 -6.198094894248647026e-13 5.511521593406415453e-01 -1.740047295528750856e-09 -4.480590123706866859e-13 5.511521597998035871e-01 -1.282569822154058833e-09 -2.995403048469023369e-13 5.511521601841912199e-01 -9.007796117082587477e-10 -1.829775899798097411e-13 5.511521604907579919e-01 -5.955796855928333841e-10 -9.641915918768402035e-14 5.511521607356870689e-01 -3.509563451729904002e-10 -3.814910149840411656e-14 5.511521609256957444e-01 -1.614537600552021515e-10 -1.813146450624088902e-14 5.511521609934911803e-01 -9.435009148415887771e-11 -6.076087135461726023e-15 5.511521610466306731e-01 -4.231379029329368585e-11 -8.014651225594666778e-17 5.511521610885999900e-01 -8.504739017603125801e-13 1.832057766473458796e-16 5.511521610936802595e-01 4.275741872033373669e-12 9.241898436535996335e-17 5.511521610684794181e-01 -2.080740248417023836e-11 2.175836155853935001e-15 5.511521610401671767e-01 -4.903858001366859785e-11 1.865267362896636870e-13 5.511521586054509703e-01 -2.510424560806524411e-09 4.465748951559972117e-14 5.511521606232535619e-01 -4.673953928708112738e-10 4.752121329988923914e-14 5.511521606438073428e-01 -4.458970252877322569e-10 5.130790072460544927e-14 5.511521606059531786e-01 -4.832945226674204535e-10 4.962815973193545509e-14 5.511521605658920020e-01 -5.230085500946055661e-10 4.156025331904009532e-14 5.511521605369041898e-01 -5.517375842270966991e-10 2.816874101851453160e-14 5.511521605232376775e-01 -5.652269427131423154e-10 1.099678782709027527e-14 5.511521605227044374e-01 -5.656521972674172052e-10 -8.370401438355922594e-15 5.511521605270457425e-01 -5.612438257937127783e-10 -2.908813566502907994e-14 5.511521605305090832e-01 -5.577921320854747021e-10 -5.132388892635017531e-14 5.511521605254213751e-01 -5.631856510063933816e-10 -7.748054312950397374e-14 5.511521604961725496e-01 -5.938603331522170622e-10 -1.169428683164460800e-13 5.511521604024793852e-01 -6.931608341022993559e-10 -2.215423675673416366e-13 5.511521600336811710e-01 -1.088963637402754427e-09 -1.773240766164337878e-12 5.511521540239510131e-01 -7.649503428334469231e-09 -5.165514895289272318e-13 5.511521592963718463e-01 -2.002996828967367114e-09 -1.193395428572722796e-13 5.511521607028785352e-01 -4.097789542276175732e-10 -8.578880214724309130e-14 5.511521608255696147e-01 -2.664188438219313053e-10 -7.800532041952349678e-14 5.511521608608241918e-01 -2.252424303386193952e-10 -7.512809153967779500e-14 5.511521608784962778e-01 -2.055209028586943541e-10 -7.342334361324233210e-14 5.511521608907368197e-01 -1.927475289918059183e-10 -7.204685435696240395e-14 5.511521609005630706e-01 -1.830781122972167976e-10 -7.072720421799431840e-14 5.511521609088194662e-01 -1.752805912109371565e-10 -6.945555637856555737e-14 5.511521609157759016e-01 -1.688726088005699155e-10 -6.831116439283678313e-14 5.511521609215194184e-01 -1.636497711229837420e-10 -6.728480497182270038e-14 5.511521609260817689e-01 -1.595243318568651598e-10 -6.643838018052842657e-14 5.511521609294693924e-01 -1.564647207341681910e-10 -6.589646102072371846e-14 5.511521609316779591e-01 -1.544694115175494480e-10 -6.563743307314941825e-14 5.511521609326830440e-01 -1.535628580221406970e-10 9.979974358308881044e-12 -1.935920754983413109e-08 5.511521431223115330e-01 9.575850048904410047e-12 -1.846115545618043853e-08 5.511521438194568745e-01 9.352681922909241214e-12 -1.787933675829096177e-08 5.511521441663790322e-01 9.175578186415409232e-12 -1.743972182418731696e-08 5.511521443759145322e-01 8.928803596067684483e-12 -1.700656328528707686e-08 5.511521446051166340e-01 8.534807531620721963e-12 -1.650256874000178815e-08 5.511521449392107197e-01 7.956994563007477541e-12 -1.589795618021919037e-08 5.511521454078777138e-01 7.193760633254925050e-12 -1.519036545152963618e-08 5.511521460097308367e-01 6.271451281769358386e-12 -1.439106823582639822e-08 5.511521467288870157e-01 5.236123665431987525e-12 -1.351711494934247475e-08 5.511521475440255280e-01 4.145354426962566815e-12 -1.258746853003858842e-08 5.511521484326039610e-01 3.059447467353914821e-12 -1.162039398537898282e-08 5.511521493734470312e-01 2.034727799189598569e-12 -1.063290077029466187e-08 5.511521503471559225e-01 1.118020942006254049e-12 -9.640688862771153505e-09 5.511521513359797231e-01 3.432304498122728139e-13 -8.658087399128429804e-09 5.511521523237022935e-01 -2.701449267863008885e-13 -7.697633155351319440e-09 5.511521532959137160e-01 -7.166779234800977765e-13 -6.769731724642895047e-09 5.511521542402757490e-01 -1.003055727068151991e-12 -5.882494732011854002e-09 5.511521551466733726e-01 -1.145556604125919213e-12 -5.041675326299733247e-09 5.511521560072338843e-01 -1.166823962040927822e-12 -4.251091877347558666e-09 5.511521568158075368e-01 -1.094838053130782181e-12 -3.517988846866913030e-09 5.511521575629977354e-01 -9.605652812171936027e-13 -2.851913781636485246e-09 5.511521582387245433e-01 -7.945395019560117188e-13 -2.262750417850144847e-09 5.511521588334201693e-01 -6.167893634642589155e-13 -1.740047295528750856e-09 5.511521593577148881e-01 -4.456639995308125221e-13 -1.282569822154058833e-09 5.511521598135590283e-01 -2.981339987357135538e-13 -9.007796117082587477e-10 5.511521601928651704e-01 -1.820631674935685340e-13 -5.955796855928333841e-10 5.511521604967711818e-01 -9.568114085496997239e-14 -3.509563451729904002e-10 5.511521607411048462e-01 -3.764050298569133366e-14 -1.614537600552021515e-10 5.511521609301157643e-01 -1.784141363399237680e-14 -9.435009148415887771e-11 5.511521609965441826e-01 -6.012451004062239158e-15 -4.231379029329368585e-11 5.511521610474968691e-01 -8.284071942215237311e-17 -8.504739017603125801e-13 5.511521610884683176e-01 1.795725788959422072e-16 4.275741872033373669e-12 5.511521610936452875e-01 9.202898704220150794e-17 -2.080740248417023836e-11 5.511521610686818118e-01 2.165908406427662733e-15 -4.903858001366859785e-11 5.511521610405325511e-01 1.885163751640431240e-13 -2.510424560806524411e-09 5.511521585521824695e-01 4.477739762132338465e-14 -4.673953928708112738e-10 5.511521606207285817e-01 4.755561977978461996e-14 -4.458970252877322569e-10 5.511521606431765141e-01 5.129451306425290690e-14 -4.832945226674204535e-10 5.511521606062368406e-01 4.958989969546378069e-14 -5.230085500946055661e-10 5.511521605668706636e-01 4.151164759868559800e-14 -5.517375842270966991e-10 5.511521605383988831e-01 2.811857841993497710e-14 -5.652269427131423154e-10 5.511521605250840894e-01 1.098011812974512552e-14 -5.656521972674172052e-10 5.511521605247644562e-01 -8.358122055292600978e-15 -5.612438257937127783e-10 5.511521605292368786e-01 -2.902497705416381995e-14 -5.577921320854747021e-10 5.511521605326757944e-01 -5.123316103162277549e-14 -5.631856510063933816e-10 5.511521605269834589e-01 -7.757951276931117315e-14 -5.938603331522170622e-10 5.511521604948854680e-01 -1.179833842175861541e-13 -6.931608341022993559e-10 5.511521603898301702e-01 -2.285988126655494423e-13 -1.088963637402754427e-09 5.511521599654798376e-01 -1.920151245741639842e-12 -7.649503428334469231e-09 5.511521528048507479e-01 -5.778365268711398009e-13 -2.002996828967367114e-09 5.511521588460943644e-01 -1.272576827011360695e-13 -4.097789542276175732e-10 5.511521606499990567e-01 -8.713151568895694943e-14 -2.664188438219313053e-10 5.511521608173435283e-01 -7.717075124140390549e-14 -2.252424303386193952e-10 5.511521608656657634e-01 -7.342067401560538173e-14 -2.055209028586943541e-10 5.511521608880636247e-01 -7.134255801192855719e-14 -1.927475289918059183e-10 5.511521609017424606e-01 -6.993597472231197646e-14 -1.830781122972167976e-10 5.511521609114944376e-01 -6.870856435022445261e-14 -1.752805912109371565e-10 5.511521609189926618e-01 -6.757725777305666002e-14 -1.688726088005699155e-10 5.511521609249599996e-01 -6.661761966723348889e-14 -1.636497711229837420e-10 5.511521609297339586e-01 -6.574306605473312235e-14 -1.595243318568651598e-10 5.511521609334713023e-01 -6.505532073328666360e-14 -1.564647207341681910e-10 5.511521609362335372e-01 -6.457903059327643634e-14 -1.544694115175494480e-10 5.511521609380340969e-01 -6.433546120777005603e-14 -1.535628580221406970e-10 5.511521609388503329e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 deleted file mode 100644 index 08597e9b6..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.373666353899025139e-02 6.712672110484758101e-05 6.670489060346782191e-05 1.368394648580933959e-02 6.688353843747161403e-05 6.637432343271893300e-05 1.359223806777873703e-02 6.642988956635944133e-05 6.577450635355794383e-05 1.345980776411387358e-02 6.577054031147152387e-05 6.490807260900474207e-05 1.328422787279215367e-02 6.491116751507355160e-05 6.377948455314863649e-05 1.306229499067726452e-02 6.383725046495643848e-05 6.239852505608108654e-05 1.279002751236541120e-02 6.253454890937625303e-05 6.077594688245213254e-05 1.246257476598266849e-02 6.099384944673471676e-05 5.892223823822632949e-05 1.207415028256279312e-02 5.920485462654695793e-05 5.684839025372279896e-05 1.161799734826937831e-02 5.715646564940912039e-05 5.456558577643947700e-05 1.108643153581756122e-02 5.483741072833111054e-05 5.208513867074594751e-05 1.047071701375901047e-02 5.223662320358509072e-05 4.941784199028751497e-05 9.760959052645505618e-03 4.934374821362577966e-05 4.657347102683018659e-05 8.946060023365683123e-03 4.614997513987880600e-05 4.356063295224803098e-05 8.013936377738787448e-03 4.265007703435304466e-05 4.038763609032331548e-05 6.951683314977465285e-03 3.884484774881909728e-05 3.706341844396674666e-05 5.745423071307617299e-03 3.474270779669198458e-05 3.359790410913207382e-05 4.380498713936191446e-03 3.036295825871228744e-05 3.000406684005730898e-05 2.842069558432291313e-03 2.574125257088958368e-05 2.630179838294890196e-05 1.130075712032030041e-03 2.107281340921842005e-05 2.256006967185252341e-05 -7.069546820787581468e-04 1.700339345056386335e-05 1.899385559436134681e-05 -2.582916870958867732e-03 1.364408734344337927e-05 1.569715592696906226e-05 -4.373265356896885621e-03 1.100554533068940586e-05 1.273640095279585839e-05 -5.982468237851274601e-03 9.058542609547959640e-06 1.016265537687171976e-05 -7.349556653879032661e-03 7.729031909425319437e-06 8.005806254860519931e-06 -8.463062109429203908e-03 6.611123594701542270e-06 6.212737901392024623e-06 -9.379521147293706784e-03 5.361067564923804499e-06 4.714317388465322511e-06 -1.014542168803155009e-02 4.113517379233267076e-06 3.527307764702826316e-06 -1.069746468301832794e-02 3.027279150300321223e-06 2.673317825836078333e-06 -1.091705030120196721e-02 2.278755335873338796e-06 2.177552153175058935e-06 -1.076740337087958403e-02 2.068376852279830740e-06 2.067826905848401333e-06 -1.037836526764213119e-02 2.423463170988178476e-06 2.344498366843735830e-06 -9.874536176308292348e-03 3.227461798619695797e-06 2.978654107534810279e-06 -9.265689753556641262e-03 4.351809108736943224e-06 3.929788481089250255e-06 -8.473513040999100174e-03 5.663792843149224618e-06 5.149443809069330684e-06 -7.434790020242647984e-03 7.033926820126510293e-06 6.585290047746054206e-06 -6.178245562723674693e-03 8.451558351262473392e-06 8.191676671310220347e-06 -4.834317953134586315e-03 9.979660294653440705e-06 9.927826599183445821e-06 -3.620334931530992326e-03 1.160475401157629452e-05 1.174986713444931322e-05 -2.536865585574852189e-03 1.331208624059649420e-05 1.361714038852159866e-05 -1.574961204974291169e-03 1.508653749724492663e-05 1.549352321379509988e-05 -7.232843064911278694e-04 1.691271451112326838e-05 1.734757162366156727e-05 3.769714167986938994e-05 1.877255331170490780e-05 1.915609109114363502e-05 7.217488371353774322e-04 2.062211066494640095e-05 2.093283481265485833e-05 1.335814717783206842e-03 2.243522967855876923e-05 2.266975832790951297e-05 1.886051498971851384e-03 2.419485376707842329e-05 2.435138918535251855e-05 2.378136227812383853e-03 2.588628440990171264e-05 2.596431000257021858e-05 2.814136958843644308e-03 2.749721966610732998e-05 2.749725127236482428e-05 3.194254457828248506e-03 2.901819318339109014e-05 2.894153062877239361e-05 3.521320724698498352e-03 3.044221921745975787e-05 3.029077759893745626e-05 3.799658057993270804e-03 3.176438851759078269e-05 3.154060114576359963e-05 4.034484710513389950e-03 3.298171442307764413e-05 3.268846561150825489e-05 4.231746949067644557e-03 3.409304232708670765e-05 3.373360871668375200e-05 4.396840724513009432e-03 3.509873848959413101e-05 3.467675302138220617e-05 4.534420396913874107e-03 3.599998801874237399e-05 3.551976658590642373e-05 4.648471032902409469e-03 3.679196181537284393e-05 3.626638787755203226e-05 4.742392464969664989e-03 3.747691192036450316e-05 3.692057971284146400e-05 4.819028020566027554e-03 3.806125617194220013e-05 3.748585635515411750e-05 4.880731340252048890e-03 3.855107894114844234e-05 3.796552353924463082e-05 4.929486282236384721e-03 3.895194590003633070e-05 3.836258135862285936e-05 4.966929886029654295e-03 3.926876334353095383e-05 3.867965692075142538e-05 4.994365711391581669e-03 3.950565700410794642e-05 3.891894212892685025e-05 5.012775140247658669e-03 3.966586901813296727e-05 3.908213411342120421e-05 5.022836781642363822e-03 3.975174211498182485e-05 3.917045497225663252e-05 -5.500151666607322615e-14 5.511521608200300459e-01 -2.721293890774881578e-10 -5.348006779802408340e-14 5.511521608180414145e-01 -2.740551069510826915e-10 -5.066530703361410100e-14 5.511521608135669936e-01 -2.784149894095654804e-10 -4.659358816162153614e-14 5.511521608059500865e-01 -2.858787182328801345e-10 -4.122165471564999884e-14 5.511521607942766465e-01 -2.973772018629570962e-10 -3.433004346793797812e-14 5.511521607777398746e-01 -3.137309903922743545e-10 -2.552725348939239426e-14 5.511521607555464053e-01 -3.357451582591673832e-10 -1.424513091666318329e-14 5.511521607269938006e-01 -3.641340147529088578e-10 2.353062798100045774e-16 5.511521606916776062e-01 -3.993083346942835748e-10 1.869482508031005646e-14 5.511521606496225800e-01 -4.412426687232586892e-10 4.184239763153509858e-14 5.511521606013959351e-01 -4.893571352760252181e-10 7.014893768772302237e-14 5.511521605482093689e-01 -5.424126373321092238e-10 1.036635599356932453e-13 5.511521604920073258e-01 -5.984206284818538134e-10 1.418269896753338933e-13 5.511521604355433812e-01 -6.545672654513466155e-10 1.833091973820591854e-13 5.511521603824263149e-01 -7.071773683844376829e-10 2.259404662516650808e-13 5.511521603369646805e-01 -7.518949333103244052e-10 2.667323992704014940e-13 5.511521603039496453e-01 -7.839211436516620499e-10 3.019318798397147950e-13 5.511521602885319782e-01 -7.981383513098198078e-10 3.272365800679047548e-13 5.511521602958087129e-01 -7.895458931594356033e-10 3.386274852114067297e-13 5.511521603292194316e-01 -7.549338507939796348e-10 3.347601316519203190e-13 5.511521603862943319e-01 -6.971445151341872921e-10 3.152840755892441846e-13 5.511521604639127991e-01 -6.195659767864116359e-10 2.834879866022836975e-13 5.511521605534522861e-01 -5.308397009343291499e-10 2.441877028600625714e-13 5.511521606456978306e-01 -4.399450032978731226e-10 2.016167340147264029e-13 5.511521607342824147e-01 -3.528324076481157182e-10 1.566916184207069280e-13 5.511521608196109367e-01 -2.686663047119931276e-10 1.066710429943890246e-13 5.511521609083988027e-01 -1.805651814247127901e-10 5.405403580532119478e-14 5.511521609982864556e-01 -9.097341662724403193e-11 7.176981450280465153e-15 5.511521610772802671e-01 -1.211330055273011083e-11 1.207903210550608956e-14 5.511521610686717088e-01 -2.055233602790656704e-11 9.442287482361628969e-15 5.511521610728468135e-01 -1.658212512452871441e-11 2.982748415054754926e-16 5.511521610888833189e-01 -5.915824897589244437e-13 3.320333566738193677e-15 5.511521610827019302e-01 -6.671982459926880038e-12 1.564049721894080804e-14 5.511521610510032865e-01 -3.832982216504565357e-11 1.211953212181724715e-14 5.511521610156918660e-01 -7.360120158741778677e-11 -1.147683749203147388e-11 5.511521585723373473e-01 -2.543626899182389948e-09 6.423099425015562382e-13 5.511521605809929225e-01 -5.097089898408922634e-10 4.572437205544222133e-13 5.511521605958459302e-01 -4.938495912766638772e-10 4.307101035995892708e-13 5.511521605604778884e-01 -5.287205802605676925e-10 4.225066132994871241e-13 5.511521605284419589e-01 -5.604019362639261702e-10 4.124189744417864610e-13 5.511521605097645660e-01 -5.788444310044230059e-10 3.961656971220289345e-13 5.511521605061950879e-01 -5.823081791039646531e-10 3.744662366879928483e-13 5.511521605154265924e-01 -5.730968925577971546e-10 3.512703919359510142e-13 5.511521605308553617e-01 -5.577664268039431139e-10 3.275705638664282652e-13 5.511521605504041688e-01 -5.383503103243996008e-10 3.036730687881404902e-13 5.511521605732410123e-01 -5.156486219617856164e-10 2.799543171367619325e-13 5.511521605985126859e-01 -4.904923357668559732e-10 2.566444874072496177e-13 5.511521606256511996e-01 -4.634354868331003271e-10 2.339239245214432200e-13 5.511521606542117979e-01 -4.349163803577898265e-10 2.120729438318500437e-13 5.511521606835604326e-01 -4.055710087004050396e-10 1.913718788539526070e-13 5.511521607130183131e-01 -3.760857056013756979e-10 1.720612396061971069e-13 5.511521607419342939e-01 -3.471229052537857352e-10 1.543349989249154866e-13 5.511521607697077441e-01 -3.192954114581481920e-10 1.383107570782003264e-13 5.511521607958591584e-01 -2.930913849605035580e-10 1.240381922835246539e-13 5.511521608200294908e-01 -2.688739609217408333e-10 1.114984594081811040e-13 5.511521608419984730e-01 -2.468640471898817180e-10 1.006519062243630884e-13 5.511521608615960188e-01 -2.272313467653959222e-10 9.143704804166433972e-14 5.511521608787144366e-01 -2.100834784592905531e-10 8.377097035010259891e-14 5.511521608933133143e-01 -1.954604418057861859e-10 7.756349641639279596e-14 5.511521609053976478e-01 -1.833568180041312880e-10 7.272597403870567053e-14 5.511521609150008549e-01 -1.737388059527024926e-10 6.918052822548665811e-14 5.511521609221682327e-01 -1.665604312862687418e-10 6.686659939507631838e-14 5.511521609269419697e-01 -1.617790471370006597e-10 6.574921671919818885e-14 5.511521609293466017e-01 -1.593704039053126242e-10 -5.559441376694554179e-14 -2.721293890774881578e-10 5.511521608142031514e-01 -5.403961163184744738e-14 -2.740551069510826915e-10 5.511521608123450822e-01 -5.116532609723179577e-14 -2.784149894095654804e-10 5.511521608081080270e-01 -4.701514719910567241e-14 -2.858787182328801345e-10 5.511521608008097539e-01 -4.155471455354303494e-14 -2.973772018629570962e-10 5.511521607895019104e-01 -3.457185137704838782e-14 -3.137309903922743545e-10 5.511521607733500527e-01 -2.568080062017903533e-14 -3.357451582591673832e-10 5.511521607515370569e-01 -1.431735646671000850e-14 -3.641340147529088578e-10 5.511521607233373921e-01 2.358920095388196936e-16 -3.993083346942835748e-10 5.511521606883326152e-01 1.875975489497793822e-14 -4.412426687232586892e-10 5.511521606465482614e-01 4.196292240834368345e-14 -4.893571352760252181e-10 5.511521605985760797e-01 7.031261619045410911e-14 -5.424126373321092238e-10 5.511521605456805029e-01 1.038469558100675876e-13 -5.984206284818538134e-10 5.511521604898922400e-01 1.419854023627388088e-13 -6.545672654513466155e-10 5.511521604340825498e-01 1.833655319689581359e-13 -7.071773683844376829e-10 5.511521603819914406e-01 2.257819620107583824e-13 -7.518949333103244052e-10 5.511521603380206136e-01 2.662177250525314720e-13 -7.839211436516620499e-10 5.511521603069772235e-01 3.009091305849363170e-13 -7.981383513098198078e-10 5.511521602939485343e-01 3.255759413433372364e-13 -7.895458931594356033e-10 5.511521603038430639e-01 3.362975645428688821e-13 -7.549338507939796348e-10 5.511521603396444258e-01 3.319280990992823990e-13 -6.971445151341872921e-10 5.511521603981403006e-01 3.123047088639854824e-13 -6.195659767864116359e-10 5.511521604756778325e-01 2.807914599617506442e-13 -5.308397009343291499e-10 5.511521605635996135e-01 2.421256363038120212e-13 -4.399450032978731226e-10 5.511521606531596396e-01 2.003253003081719621e-13 -3.528324076481157182e-10 5.511521607388172317e-01 1.560454062702925320e-13 -2.686663047119931276e-10 5.511521608218313828e-01 1.064199904252616401e-13 -1.805651814247127901e-10 5.511521609092495666e-01 5.397685199429912262e-14 -9.097341662724403193e-11 5.511521609985462478e-01 7.179080032146043130e-15 -1.211330055273011083e-11 5.511521610772730506e-01 1.198223967803136338e-14 -2.055233602790656704e-11 5.511521610690025552e-01 9.464541944384051297e-15 -1.658212512452871441e-11 5.511521610727687648e-01 3.445262022608288049e-16 -5.915824897589244437e-13 5.511521610887132328e-01 3.312403306004423992e-15 -6.671982459926880038e-12 5.511521610827339046e-01 1.561740059294594426e-14 -3.832982216504565357e-11 5.511521610511167513e-01 1.210359369716532935e-14 -7.360120158741778677e-11 5.511521610158844897e-01 -1.159804881498518657e-11 -2.543626899182389948e-09 5.511521585188918770e-01 6.439696252014684787e-13 -5.097089898408922634e-10 5.511521605783619160e-01 4.575277351346104730e-13 -4.938495912766638772e-10 5.511521605952323100e-01 4.305551136240120741e-13 -5.287205802605676925e-10 5.511521605608585839e-01 4.220961973563882331e-13 -5.604019362639261702e-10 5.511521605295310877e-01 4.118640016673558072e-13 -5.788444310044230059e-10 5.511521605113225419e-01 3.955643723037132945e-13 -5.823081791039646531e-10 5.511521605079638952e-01 3.739020507864603691e-13 -5.730968925577971546e-10 5.511521605171546545e-01 3.507885708846885525e-13 -5.577664268039431139e-10 5.511521605323864703e-01 3.271857220439758199e-13 -5.383503103243996008e-10 5.511521605516701561e-01 3.033799037232419297e-13 -5.156486219617856164e-10 5.511521605742371044e-01 2.797357376678109757e-13 -4.904923357668559732e-10 5.511521605992787398e-01 2.564774142338341316e-13 -4.634354868331003271e-10 5.511521606262550499e-01 2.337836340106162543e-13 -4.349163803577898265e-10 5.511521606547337138e-01 2.119380017138451847e-13 -4.055710087004050396e-10 5.511521606840766863e-01 1.912265673622067871e-13 -3.760857056013756979e-10 5.511521607135897449e-01 1.718967779948091353e-13 -3.471229052537857352e-10 5.511521607425986513e-01 1.541486945220396470e-13 -3.192954114581481920e-10 5.511521607704789050e-01 1.381044919208799637e-13 -2.930913849605035580e-10 5.511521607967336811e-01 1.238153898930213039e-13 -2.688739609217408333e-10 5.511521608209959400e-01 1.112623829660866590e-13 -2.468640471898817180e-10 5.511521608430444141e-01 1.004054950600626403e-13 -2.272313467653959222e-10 5.511521608627099056e-01 9.118264783555289356e-14 -2.100834784592905531e-10 5.511521608798851668e-01 8.351054423347795557e-14 -1.954604418057861859e-10 5.511521608945303408e-01 7.729862400970102432e-14 -1.833568180041312880e-10 5.511521609066516447e-01 7.245804411925328948e-14 -1.737388059527024926e-10 5.511521609162833846e-01 6.891027064921020522e-14 -1.665604312862687418e-10 5.511521609234717456e-01 6.659472016418478000e-14 -1.617790471370006597e-10 5.511521609282603595e-01 6.547635634574151772e-14 -1.593704039053126242e-10 5.511521609306725411e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 deleted file mode 100644 index d1dc41291..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ -1.613862623239226829e-02 6.712671536666208730e-05 6.670488480277831690e-05 1.610630298739268440e-02 6.688353277026988009e-05 6.637431770076788638e-05 1.604644765796956959e-02 6.642988394754509470e-05 6.577450066498785901e-05 1.595779803767565647e-02 6.577053473353205993e-05 6.490806695416472894e-05 1.583852888403956827e-02 6.491116198814088031e-05 6.377947894083339070e-05 1.568619731384032767e-02 6.383724501858027321e-05 6.239851951564146524e-05 1.549770775869297075e-02 6.253454359151927198e-05 6.077594146298127766e-05 1.526923453045686378e-02 6.099384432013480720e-05 5.892223300493227965e-05 1.499614271698999045e-02 5.920484976236346618e-05 5.684838528141223111e-05 1.467290906279661647e-02 5.715646111865156279e-05 5.456558114056068542e-05 1.429305789922521476e-02 5.483740659242448685e-05 5.208513443737276046e-05 1.384902113779804163e-02 5.223661950663651391e-05 4.941783820771886241e-05 1.333198865219996712e-02 4.934374497772054286e-05 4.657346772027137700e-05 1.273176528115462815e-02 4.614997236404654827e-05 4.356063012234045805e-05 1.203670655396666365e-02 4.265007469692129639e-05 4.038763371532383997e-05 1.123362070542338435e-02 3.884484581248912857e-05 3.706341648493667444e-05 1.030756140871208135e-02 3.474270621510654959e-05 3.359790251690229426e-05 9.241779745629133402e-03 3.036295698291355605e-05 3.000406556227323739e-05 8.017865114881781927e-03 2.574125155445745682e-05 2.630179736981263450e-05 6.616057361986601992e-03 2.107281261104875371e-05 2.256006887933586347e-05 5.015523975752678339e-03 1.700339283265672662e-05 1.899385498227922179e-05 3.194837571647474866e-03 1.364408687241775090e-05 1.569715546074883306e-05 1.141383595442276369e-03 1.100554497642035239e-05 1.273640060198104933e-05 -1.063147092116985444e-03 9.058542347039633678e-06 1.016265511658264892e-05 -3.253180118076162176e-03 7.729031719743326045e-06 8.005806066391116883e-06 -5.246729420048055689e-03 6.611123464786350337e-06 6.212737771981303490e-06 -6.936584838637372200e-03 5.361067486955800674e-06 4.714317310622938755e-06 -8.288485029379507457e-03 4.113517345324820415e-06 3.527307730795928454e-06 -9.361761692409218197e-03 3.027279149217579335e-06 2.673317824727022520e-06 -1.021293069518640524e-02 2.278755331203564419e-06 2.177552148551422443e-06 -1.074832104021551313e-02 2.068376847166118348e-06 2.067826900722069421e-06 -1.084167526569917300e-02 2.423463168626011533e-06 2.344498364466290530e-06 -1.053542048864889585e-02 3.227461793737481321e-06 2.978654102662746224e-06 -1.000213501274142304e-02 4.351809099802938599e-06 3.929788472163594834e-06 -9.316875684266839874e-03 5.663792847084670982e-06 5.149443812990251279e-06 -8.403399089677634007e-03 7.033939020502195026e-06 6.585302377030206803e-06 -7.178122981306562372e-03 8.451557853479113179e-06 8.191676172254838570e-06 -5.692072248018396029e-03 9.979659983785355958e-06 9.927826288132720443e-06 -4.189432821941412380e-03 1.160475374899904040e-05 1.174986687198164653e-05 -2.848367511612658141e-03 1.331208601218785123e-05 1.361714016035381289e-05 -1.668963155192154137e-03 1.508653730676472666e-05 1.549352302358279610e-05 -6.364912390719550377e-04 1.691271436655417522e-05 1.734757147929186905e-05 2.775542955583215838e-04 1.877255322191849721e-05 1.915609100139927453e-05 1.092670213636845640e-03 2.062211063987489656e-05 2.093283478739837549e-05 1.817739679660578542e-03 2.243522973341313450e-05 2.266975838233976546e-05 2.461207006149570414e-03 2.419485392985024771e-05 2.435138934769001497e-05 3.030536864836771115e-03 2.588628474367506922e-05 2.596431033717939001e-05 3.515481004046864394e-03 2.749722035573592442e-05 2.749725197068154069e-05 3.915030632430193183e-03 2.901819520533457179e-05 2.894153272068318534e-05 4.241840967111820508e-03 3.044226640309636450e-05 3.029082868796046944e-05 4.507725949512546466e-03 3.176438220878497609e-05 3.154059412881867250e-05 4.721752465563991939e-03 3.298171383760096289e-05 3.268846500015810524e-05 4.892897574890191226e-03 3.409304206410438375e-05 3.373360845148143605e-05 5.028511819608802967e-03 3.509873833501951537e-05 3.467675286693173167e-05 5.134925806382951985e-03 3.599998792523644183e-05 3.551976649236308659e-05 5.217375529155284485e-03 3.679196176298165386e-05 3.626638782464965442e-05 5.279410316063984018e-03 3.747691189767044407e-05 3.692057968923258900e-05 5.324689363964825797e-03 3.806125617129834667e-05 3.748585635332021663e-05 5.356992179139181444e-03 3.855107895698839214e-05 3.796552355372945664e-05 5.379456122496442151e-03 3.895194592811900334e-05 3.836258138526470185e-05 5.394590987949170711e-03 3.926876338054822486e-05 3.867965695629074589e-05 5.404339756215325793e-03 3.950565704743653448e-05 3.891894217076457901e-05 5.410126333949546312e-03 3.966586906564832399e-05 3.908213415943971819e-05 5.412892255748440531e-03 3.975174216489233325e-05 3.917045502066018799e-05 -5.793187016315502416e-12 5.511521582948903930e-01 -2.824806208772561744e-09 -5.720681795045177674e-12 5.511521583102125810e-01 -2.810776730271247204e-09 -5.669479654029123246e-12 5.511521583149072701e-01 -2.808737265597598369e-09 -5.624533055152160088e-12 5.511521583132581448e-01 -2.814171188474681990e-09 -5.568154327302964459e-12 5.511521583103976551e-01 -2.821647338761268300e-09 -5.480706205252422211e-12 5.511521583122920287e-01 -2.824756452512094766e-09 -5.343384237875275264e-12 5.511521583250561518e-01 -2.816850747377917776e-09 -5.140845038326100405e-12 5.511521583543733671e-01 -2.791678836248339933e-09 -4.863948186703906367e-12 5.511521584048632016e-01 -2.744053783547043251e-09 -4.512062734151703366e-12 5.511521584794148998e-01 -2.670580149333415822e-09 -4.094064225698260839e-12 5.511521585786959276e-01 -2.570213916462058407e-09 -3.626799640196669834e-12 5.511521587012191414e-01 -2.444253155738303162e-09 -3.132241677976026357e-12 5.511521588437118258e-01 -2.296008854435307972e-09 -2.634005267045116838e-12 5.511521590017335326e-01 -2.130202913103554240e-09 -2.154122548227303047e-12 5.511521591704037215e-01 -1.952236455704332607e-09 -1.710389500788301164e-12 5.511521593451643719e-01 -1.767404042011249668e-09 -1.314853036625756055e-12 5.511521595224551096e-01 -1.580144403516162020e-09 -9.738668525592228703e-13 5.511521597001377559e-01 -1.393496708736658447e-09 -6.891955470607996752e-13 5.511521598774830055e-01 -1.209015320873593371e-09 -4.595421799515130646e-13 5.511521600545526978e-01 -1.027347562190075714e-09 -2.831470066440502834e-13 5.511521602272112519e-01 -8.530535093355652995e-10 -1.557415530895732929e-13 5.511521603893009269e-01 -6.918645091852147487e-10 -7.078106764869816280e-14 5.511521605302371896e-01 -5.531568963785673216e-10 -1.832062330747004822e-14 5.511521606435288989e-01 -4.420383787710077983e-10 1.193474134040807548e-14 5.511521607330481798e-01 -3.539872808909272515e-10 2.677642657494635209e-14 5.511521608117339044e-01 -2.761792148704446353e-10 2.870303943739735420e-14 5.511521608946468032e-01 -1.938867746219254380e-10 2.014558924149775042e-14 5.511521609817034983e-01 -1.072803676700567265e-10 6.094239380630301752e-15 5.511521610613400179e-01 -2.793826331642564373e-11 7.409257702306397006e-15 5.511521610584574349e-01 -3.072112151592375945e-11 4.328575280334095889e-15 5.511521610725316211e-01 -1.689593467328104210e-11 -2.063892006804842488e-15 5.511521610971757967e-01 7.669820784202833621e-12 -1.561881116321392352e-15 5.511521610951010119e-01 5.702965343693295134e-12 6.706492808471934743e-15 5.511521610652584391e-01 -2.407846272131777272e-11 1.605497829753559688e-14 5.511521610325108567e-01 -5.677063825811373054e-11 7.235381930833456721e-13 5.511521585924402666e-01 -2.523505442005969709e-09 1.445265816761071046e-13 5.511521606029948783e-01 -4.876980834984619759e-10 1.463756363238668385e-13 5.511521606163884979e-01 -4.733278666251849726e-10 1.681328489471375066e-13 5.511521605757800923e-01 -5.134702317164942527e-10 1.940979697648603807e-13 5.511521605381695110e-01 -5.507378004013513672e-10 2.219387743828506738e-13 5.511521605132918555e-01 -5.753523130797199126e-10 2.515966051806804062e-13 5.511521605021527659e-01 -5.862973793585489844e-10 2.846798258805276578e-13 5.511521605011419078e-01 -5.871656386809584245e-10 3.261988871460138805e-13 5.511521605017840608e-01 -5.863999970289990173e-10 3.824249286516296237e-13 5.511521604991101997e-01 -5.890257363438153998e-10 4.664448940508415876e-13 5.511521604865734503e-01 -6.018731390892066672e-10 6.137276747228302973e-13 5.511521604496039117e-01 -6.404246277816435564e-10 9.462730834442499822e-13 5.511521603488708232e-01 -7.471286628122369736e-10 2.255867406399652721e-12 5.511521599742655875e-01 -1.149289411146237127e-09 4.739770954968953922e-11 5.511521539603033704e-01 -7.714700795318075523e-09 -6.117433929567938487e-12 5.511521592301876771e-01 -2.071332623911632281e-09 -4.134154412731924028e-13 5.511521606357170366e-01 -4.795582530235170961e-10 -1.086473275217638657e-13 5.511521607588552030e-01 -3.360091170807818244e-10 -1.626385963643853050e-14 5.511521607958591584e-01 -2.930919908651065248e-10 3.053226238420687217e-14 5.511521608162454067e-01 -2.704339791130027653e-10 5.910726893381930903e-14 5.511521608315682608e-01 -2.541968482716389284e-10 7.795784630958714917e-14 5.511521608445915099e-01 -2.408773080814293362e-10 9.079319356314987408e-14 5.511521608560712160e-01 -2.294039737630084480e-10 9.961091713394299975e-14 5.511521608661620331e-01 -2.194575237296251111e-10 1.056461717846655391e-13 5.511521608748175538e-01 -2.109930246501027766e-10 1.097432461387710120e-13 5.511521608819252016e-01 -2.040718943921972902e-10 1.125091189097477926e-13 5.511521608873564126e-01 -1.987938006294107905e-10 1.143819579409991382e-13 5.511521608909906167e-01 -1.952636765273268476e-10 1.156597265146427019e-13 5.511521608927253402e-01 -1.935751538574403323e-10 -5.856283916477112254e-12 -2.824806208772561744e-09 5.511521582336887937e-01 -5.785990663747638422e-12 -2.810776730271247204e-09 5.511521582463978497e-01 -5.739735415813018816e-12 -2.808737265597598369e-09 5.511521582457219459e-01 -5.701855166701010957e-12 -2.814171188474681990e-09 5.511521582364082850e-01 -5.653869962635832506e-12 -2.821647338761268300e-09 5.511521582241838413e-01 -5.575011468006716353e-12 -2.824756452512094766e-09 5.511521582159043531e-01 -5.445151656094238441e-12 -2.816850747377917776e-09 5.511521582187620671e-01 -5.247611408248230360e-12 -2.791678836248339933e-09 5.511521582395967345e-01 -4.972074677726545334e-12 -2.744053783547043251e-09 5.511521582841885092e-01 -4.617119036014185579e-12 -2.670580149333415822e-09 5.511521583564699123e-01 -4.191410265724602019e-12 -2.570213916462058407e-09 5.511521584578903399e-01 -3.712256036559279873e-12 -2.444253155738303162e-09 5.511521585873607743e-01 -3.202711850702965034e-12 -2.296008854435307972e-09 5.511521587415371126e-01 -2.687922172663853900e-12 -2.130202913103554240e-09 5.511521589154010359e-01 -2.191633943281027041e-12 -1.952236455704332607e-09 5.511521591029954203e-01 -1.733248112566824149e-12 -1.767404042011249668e-09 5.511521592982360218e-01 -1.326012055053666307e-12 -1.580144403516162020e-09 5.511521594957475845e-01 -9.768749399588548336e-13 -1.393496708736658447e-09 5.511521596915436305e-01 -6.875603274837716875e-13 -1.209015320873593371e-09 5.511521598832267443e-01 -4.562190963828281742e-13 -1.027347562190075714e-09 5.511521600694652134e-01 -2.801540247217757753e-13 -8.530535093355652995e-10 5.511521602453420821e-01 -1.539155203980629622e-13 -6.918645091852147487e-10 5.511521604056209833e-01 -7.002334924805703158e-14 -5.531568963785673216e-10 5.511521605421455527e-01 -1.816343452199026625e-14 -4.420383787710077983e-10 5.511521606511391447e-01 1.185589790194504978e-14 -3.539872808909272515e-10 5.511521607377365406e-01 2.663468529727648117e-14 -2.761792148704446353e-10 5.511521608146657814e-01 2.857760693670375565e-14 -1.938867746219254380e-10 5.511521608963448893e-01 2.006995416033628065e-14 -1.072803676700567265e-10 5.511521609825107415e-01 6.070024148422210364e-15 -2.793826331642564373e-11 5.511521610615625066e-01 7.358603081465208491e-15 -3.072112151592375945e-11 5.511521610588789866e-01 4.338210211519193759e-15 -1.689593467328104210e-11 5.511521610724563480e-01 -2.032918931768371055e-15 7.669820784202833621e-12 5.511521610969437601e-01 -1.559660726623658022e-15 5.702965343693295134e-12 5.511521610950848027e-01 6.691745188028083607e-15 -2.407846272131777272e-11 5.511521610653643544e-01 1.602451402478919251e-14 -5.677063825811373054e-11 5.511521610327265730e-01 7.312353379780762211e-13 -2.523505442005969709e-09 5.511521585390318778e-01 1.449142432612977779e-13 -4.876980834984619759e-10 5.511521606003817464e-01 1.464770094422780850e-13 -4.733278666251849726e-10 5.511521606157332442e-01 1.680874469590173811e-13 -5.134702317164942527e-10 5.511521605760572040e-01 1.939284108976318576e-13 -5.507378004013513672e-10 5.511521605391321854e-01 2.216516962476272169e-13 -5.753523130797199126e-10 5.511521605147797764e-01 2.511946740447223469e-13 -5.862973793585489844e-10 5.511521605040270444e-01 2.841576912809955773e-13 -5.871656386809584245e-10 5.511521605032985160e-01 3.255320866524284268e-13 -5.863999970289990173e-10 5.511521605041840299e-01 3.816159728963913423e-13 -5.890257363438153998e-10 5.511521605016057590e-01 4.657174010596883118e-13 -6.018731390892066672e-10 5.511521604884533909e-01 6.143449076529121427e-13 -6.404246277816435564e-10 5.511521604483159420e-01 9.547941312091841860e-13 -7.471286628122369736e-10 5.511521603354764265e-01 2.325694424382652742e-12 -1.149289411146237127e-09 5.511521599041907526e-01 5.130096101651164838e-11 -7.714700795318075523e-09 5.511521527380205399e-01 -6.825718358785333397e-12 -2.071332623911632281e-09 5.511521587754978357e-01 -4.394533700115297862e-13 -4.795582530235170961e-10 5.511521605774737376e-01 -1.110536181445460596e-13 -3.360091170807818244e-10 5.511521607447387172e-01 -1.634598494712027876e-14 -2.930919908651065248e-10 5.511521607947900137e-01 3.027205452277625642e-14 -2.704339791130027653e-10 5.511521608203527878e-01 5.836000519182023417e-14 -2.541968482716389284e-10 5.511521608378892045e-01 7.679662267844138185e-14 -2.408773080814293362e-10 5.511521608517591098e-01 8.934874857210468925e-14 -2.294039737630084480e-10 5.511521608633997982e-01 9.799537134609122028e-14 -2.194575237296251111e-10 5.511521608733210842e-01 1.039404649926955723e-13 -2.109930246501027766e-10 5.511521608816759565e-01 1.079973673415061607e-13 -2.040718943921972902e-10 5.511521608884655254e-01 1.107479978744083478e-13 -1.987938006294107905e-10 5.511521608936258421e-01 1.126132329088361077e-13 -1.952636765273268476e-10 5.511521608970731956e-01 1.138799088652973939e-13 -1.935751538574403323e-10 5.511521608987248744e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 deleted file mode 100644 index 47d681213..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ -1.671079062185677061e-02 6.712650932241691793e-05 6.670469455695523413e-05 1.668835434357365116e-02 6.688334461851878346e-05 6.637414254977154579e-05 1.664370115981337814e-02 6.642970879926770277e-05 6.577433559093484009e-05 1.657603316889778855e-02 6.577037045166633387e-05 6.490791007153818323e-05 1.648415326231630895e-02 6.491100845621766214e-05 6.377933055833176533e-05 1.636643623424858043e-02 6.383710311737700175e-05 6.239838098205000656e-05 1.622079295447389005e-02 6.253441438723122926e-05 6.077581428124809480e-05 1.604462063330673940e-02 6.099372861430938639e-05 5.892211834872158611e-05 1.583474319148289386e-02 5.920474790185584804e-05 5.684828379810827272e-05 1.558734093432498531e-02 5.715637296552180844e-05 5.456549292632159002e-05 1.529786991573738042e-02 5.483733157885462077e-05 5.208505910142572574e-05 1.496095987409299354e-02 5.223655673763017879e-05 4.941777498505196033e-05 1.457029648631334717e-02 4.934369333835271899e-05 4.657341558805442412e-05 1.411848815801783341e-02 4.614993061499590021e-05 4.356058790326382789e-05 1.359692384185303034e-02 4.265004155281075949e-05 4.038760016230814778e-05 1.299560954494068631e-02 3.884482000530911362e-05 3.706339034970829356e-05 1.230297659149418889e-02 3.474268654189490178e-05 3.359788260198641360e-05 1.150569290725696019e-02 3.036294233706780501e-05 3.000405075601536358e-05 1.058848669113097302e-02 2.574124094440054960e-05 2.630178666818533656e-05 9.533993494786880893e-03 2.107280516885543824e-05 2.256006139725767742e-05 8.322652080827106988e-03 1.700338780773878896e-05 1.899384995049199938e-05 6.932786182892237622e-03 1.364408362526558861e-05 1.569715222387085008e-05 5.340985197172970142e-03 1.100554297849488976e-05 1.273639861978573731e-05 3.522901717210147332e-03 9.058541195503793389e-06 1.016265397851823068e-05 1.454294387375641186e-03 7.729031108917969211e-06 8.005805463367904193e-06 -8.304984649591005616e-04 6.611123167485814876e-06 6.212737477620122281e-06 -3.106176696666370848e-03 5.361067353923928989e-06 4.714317178233976935e-06 -5.171931475834960247e-03 4.113517294746291013e-06 3.527307680289302832e-06 -6.922222352566257883e-03 3.027279139251142344e-06 2.673317814769401025e-06 -8.301133545109772027e-03 2.278755322897815143e-06 2.177552140301546000e-06 -9.394039486365694108e-03 2.068376843430733968e-06 2.067826896978344307e-06 -1.026001186281871869e-02 2.423463170132080582e-06 2.344498365951221872e-06 -1.077973590058344151e-02 3.227461794517650758e-06 2.978654103441495186e-06 -1.082173341662590570e-02 4.351809095962884240e-06 3.929788468328745492e-06 -1.046531758235376419e-02 5.663792839026332405e-06 5.149443804939536000e-06 -9.889890660598390365e-03 7.033938733454190404e-06 6.585302086943209750e-06 -9.140293890814145394e-03 8.451557795372212540e-06 8.191676113996935674e-06 -8.127092871302353874e-03 9.979659923380371925e-06 9.927826227689860484e-06 -6.793734683009476291e-03 1.160475367677359639e-05 1.174986679977790859e-05 -5.266272555691389398e-03 1.331208592419969158e-05 1.361714007244240798e-05 -3.779841155990722873e-03 1.508653719916588065e-05 1.549352291612187416e-05 -2.462641928767641576e-03 1.691271423499903179e-05 1.734757134794580045e-05 -1.310189994403090918e-03 1.877255306097971985e-05 1.915609084075665716e-05 -3.000670846266782765e-04 2.062211044070534472e-05 2.093283458864111864e-05 5.928731469504767981e-04 2.243522948180358994e-05 2.266975813127224067e-05 1.385573458735353276e-03 2.419485359982238951e-05 2.435138901819166077e-05 2.087613722203672615e-03 2.588628427706100019e-05 2.596430987011803338e-05 2.706405823794466071e-03 2.749721958170437959e-05 2.749725118971636372e-05 3.240965257745461858e-03 2.901819321145349836e-05 2.894153066515345142e-05 3.689812156417624292e-03 3.044222070340118352e-05 3.029077922496747910e-05 4.057546419066739192e-03 3.176438876176033543e-05 3.154060144059985790e-05 4.355977708188006961e-03 3.298171434953839950e-05 3.268846554433114249e-05 4.596306418919021523e-03 3.409304223931538505e-05 3.373360863051554429e-05 4.788253313379808342e-03 3.509873840604694139e-05 3.467675293813766481e-05 4.940194578548487946e-03 3.599998794146143247e-05 3.551976650849038384e-05 5.059251280904410696e-03 3.679196174383172292e-05 3.626638780575062819e-05 5.151152614921389837e-03 3.747691185355205538e-05 3.692057964577414062e-05 5.220761823954781986e-03 3.806125610883782543e-05 3.748585629185468806e-05 5.272359562622132810e-03 3.855107888086073680e-05 3.796552347883743942e-05 5.309640930090019778e-03 3.895194584182923623e-05 3.836258130036850723e-05 5.335707663932439705e-03 3.926876328680870134e-05 3.867965686404299647e-05 5.353061509970152149e-03 3.950565694838599918e-05 3.891894207326485939e-05 5.363597302734952887e-03 3.966586896300712794e-05 3.908213405838561794e-05 5.368567892373939804e-03 3.975174206010077127e-05 3.917045491748145128e-05 -2.118374321920382312e-10 5.511521404905856958e-01 -1.905684872753888698e-08 -1.938724328875963400e-10 5.511521416093084769e-01 -1.817029996899029214e-08 -1.808177570481294715e-10 5.511521424393334145e-01 -1.761060262135134517e-08 -1.699063987858375435e-10 5.511521431074516419e-01 -1.720158775890124844e-08 -1.591000775461518004e-10 5.511521437282541624e-01 -1.680475987858995036e-08 -1.473819094715896996e-10 5.511521443756258742e-01 -1.633983953007211761e-08 -1.345476722834445427e-10 5.511521450847935988e-01 -1.577412927930516135e-08 -1.208466704572164629e-10 5.511521458664916384e-01 -1.510262948567272456e-08 -1.067244558025700383e-10 5.511521467176485611e-01 -1.433434664376904035e-08 -9.266519248758141015e-11 5.511521476281583398e-01 -1.348446071752300381e-08 -7.910763409205909175e-11 5.511521485845849444e-01 -1.257044115748742242e-08 -6.639580597826807235e-11 5.511521495729395648e-01 -1.160941602346493372e-08 -5.477160950036150743e-11 5.511521505794644282e-01 -1.061761548757732153e-08 -4.438305591610677947e-11 5.511521515908835989e-01 -9.610351565528635259e-09 -3.529823308679061841e-11 5.511521525946054822e-01 -8.602024769960184476e-09 -2.751756951835798926e-11 5.511521535792287541e-01 -7.605799546887860538e-09 -2.098806468114260931e-11 5.511521545348777584e-01 -6.633378669427989066e-09 -1.561971260503455299e-11 5.511521554533057587e-01 -5.694954836971713819e-09 -1.129925245341159228e-11 5.511521563279409008e-01 -4.799244067535938348e-09 -7.901735496721964053e-12 5.511521571535291653e-01 -3.953967421001337111e-09 -5.308064943985199728e-12 5.511521579204701204e-01 -3.171146795619367248e-09 -3.402893715312224226e-12 5.511521586149799035e-01 -2.465562471425500569e-09 -2.068706530220201531e-12 5.511521592222414778e-01 -1.852254433457865363e-09 -1.169856463368661219e-12 5.511521597486694901e-01 -1.325096993297818903e-09 -5.988906153905846053e-13 5.511521601924259661e-01 -8.853825235714362059e-10 -2.705241089913135974e-13 5.511521605385081291e-01 -5.451708207728942204e-10 -1.043288325523307235e-13 5.511521607826487257e-01 -3.052144051145781134e-10 -3.043294052846309874e-14 5.511521609466897287e-01 -1.427127460458694779e-10 -3.872197646291455744e-15 5.511521610542234884e-01 -3.530180398539488347e-11 -8.964916644735341457e-16 5.511521610580901731e-01 -3.111515961491596864e-11 5.931910963886242401e-16 5.511521610721302755e-01 -1.729508768513960241e-11 -5.578228701481284908e-16 5.511521610961797046e-01 6.670802997744094621e-12 -7.817116095716659245e-16 5.511521610959642103e-01 6.567433378794728568e-12 2.866438789203821140e-15 5.511521610695265805e-01 -1.979721687304424024e-11 7.996639910072554424e-15 5.511521610400375026e-01 -4.921116156134488933e-11 4.364901881870386758e-13 5.511521586037422260e-01 -2.512167332414277080e-09 8.641968121389346235e-14 5.511521606195256551e-01 -4.711491663883299871e-10 8.597065245455337413e-14 5.511521606385095806e-01 -4.512121560556135392e-10 9.590740568433980010e-14 5.511521606009011087e-01 -4.883666871036989253e-10 1.061098108008645769e-13 5.511521605627512921e-01 -5.261768376424609346e-10 1.143399283068085375e-13 5.511521605358611353e-01 -5.528054850268443113e-10 1.200414622947688337e-13 5.511521605226984422e-01 -5.657789379756805064e-10 1.237410486889189423e-13 5.511521605199599660e-01 -5.683871575121097612e-10 1.270293365405595095e-13 5.511521605191563866e-01 -5.690866396245933543e-10 1.308153831548447840e-13 5.511521605151097347e-01 -5.731043133573394579e-10 1.364170357247429706e-13 5.511521605011436842e-01 -5.873905303670086213e-10 1.471136057455872697e-13 5.511521604626582471e-01 -6.274512299028711483e-10 1.722415378736660787e-13 5.511521603601060582e-01 -7.359483976647036262e-10 2.619863334005289154e-13 5.511521599834559026e-01 -1.140118531863051920e-09 1.698014367774796719e-12 5.511521539675181547e-01 -7.707474468498933869e-09 4.355414289920362349e-13 5.511521592357144783e-01 -2.065773882990151527e-09 9.852199647776368639e-14 5.511521606398264161e-01 -4.754095872749126659e-10 6.656367078097356263e-14 5.511521607618293794e-01 -3.329978185108669088e-10 5.476356601450003345e-14 5.511521607979541493e-01 -2.909677670217017956e-10 4.675725431157888130e-14 5.511521608176821463e-01 -2.689776640429314818e-10 3.995733655604619206e-14 5.511521608325279376e-01 -2.532265184597714191e-10 3.383945675756668678e-14 5.511521608452134569e-01 -2.402514370721254383e-10 2.833267109355872307e-14 5.511521608564624586e-01 -2.290130217640591047e-10 2.348326316846335804e-14 5.511521608664030625e-01 -2.192188808484630325e-10 1.935640244624351525e-14 5.511521608749652135e-01 -2.108484430353434762e-10 1.600372308578419310e-14 5.511521608820174611e-01 -2.039828280732979285e-10 1.345858687790212443e-14 5.511521608874171418e-01 -1.987360186992170825e-10 1.174076416124587992e-14 5.511521608910345815e-01 -1.952223392338219211e-10 1.086816751866159700e-14 5.511521608927621996e-01 -1.935408297186730680e-10 -1.961021069993541866e-10 -1.905684872753888698e-08 5.511521434350652449e-01 -1.809369870032201074e-10 -1.817029996899029214e-08 5.511521441205186056e-01 -1.708137884333861522e-10 -1.761060262135134517e-08 5.511521444449473117e-01 -1.625844817160427363e-10 -1.720158775890124844e-08 5.511521446233351718e-01 -1.540363715850709712e-10 -1.680475987858995036e-08 5.511521448154942382e-01 -1.441086029259565901e-10 -1.633983953007211761e-08 5.511521451096514923e-01 -1.326268848358458427e-10 -1.577412927930516135e-08 5.511521455384194024e-01 -1.199038221043142383e-10 -1.510262948567272456e-08 5.511521461030703950e-01 -1.064553786371333150e-10 -1.433434664376904035e-08 5.511521467900136750e-01 -9.283135812856908290e-11 -1.348446071752300381e-08 5.511521475798365488e-01 -7.952735729886009843e-11 -1.257044115748742242e-08 5.511521484515431446e-01 -6.693492293634925342e-11 -1.160941602346493372e-08 5.511521493851656572e-01 -5.533492880432740798e-11 -1.061761548757732153e-08 5.511521503621731322e-01 -4.490699879979656780e-11 -9.610351565528635259e-09 5.511521513653055981e-01 -3.574464963249082701e-11 -8.602024769960184476e-09 5.511521523783844412e-01 -2.786847649240757009e-11 -7.605799546887860538e-09 5.511521533864700562e-01 -2.124092793753504740e-11 -6.633378669427989066e-09 5.511521543759920760e-01 -1.578313281386424987e-11 -5.694954836971713819e-09 5.511521553347566993e-01 -1.138918762478736057e-11 -4.799244067535938348e-09 5.511521562518449935e-01 -7.938297282739622690e-12 -3.953967421001337111e-09 5.511521571170231448e-01 -5.311941246485081776e-12 -3.171146795619367248e-09 5.511521579158407125e-01 -3.390793503446066678e-12 -2.465562471425500569e-09 5.511521586325458522e-01 -2.052218660593341770e-12 -1.852254433457865363e-09 5.511521592518856538e-01 -1.156227852334266109e-12 -1.325096993297818903e-09 5.511521597797256478e-01 -5.911673150222330834e-13 -8.853825235714362059e-10 5.511521602154108024e-01 -2.677264960262319207e-13 -5.451708207728942204e-10 5.511521605498427290e-01 -1.038113546748617676e-13 -3.052144051145781134e-10 5.511521607856837424e-01 -3.043667148639717654e-14 -1.427127460458694779e-10 5.511521609466547567e-01 -3.887597471559112547e-15 -3.530180398539488347e-11 5.511521610539433791e-01 -8.912732077205668890e-16 -3.111515961491596864e-11 5.511521610584562136e-01 5.944851411396152947e-16 -1.729508768513960241e-11 5.511521610720594433e-01 -5.479877044259260747e-16 6.670802997744094621e-12 5.511521610959418949e-01 -7.809118393579088025e-16 6.567433378794728568e-12 5.511521610959504436e-01 2.856895441494378233e-15 -1.979721687304424024e-11 5.511521610696586970e-01 7.973798380774037237e-15 -4.921116156134488933e-11 5.511521610403190552e-01 4.411483409220029700e-13 -2.512167332414277080e-09 5.511521585504062237e-01 8.665633973338486445e-14 -4.711491663883299871e-10 5.511521606169488274e-01 8.603414864931488041e-14 -4.512121560556135392e-10 5.511521606378435578e-01 9.588370964421651702e-14 -4.883666871036989253e-10 5.511521606011432484e-01 1.060170058457347239e-13 -5.261768376424609346e-10 5.511521605636723331e-01 1.141907744254997741e-13 -5.528054850268443113e-10 5.511521605373040922e-01 1.198486054827023034e-13 -5.657789379756805064e-10 5.511521605245182087e-01 1.235150730139972298e-13 -5.683871575121097612e-10 5.511521605220374154e-01 1.267748300251702673e-13 -5.690866396245933543e-10 5.511521605214385611e-01 1.305484475787006277e-13 -5.731043133573394579e-10 5.511521605174495297e-01 1.362190472856458021e-13 -5.873905303670086213e-10 5.511521605028488757e-01 1.472835493530588158e-13 -6.274512299028711483e-10 5.511521604612089620e-01 1.738289540369500443e-13 -7.359483976647036262e-10 5.511521603466019714e-01 2.701646915754946561e-13 -1.140118531863051920e-09 5.511521599133422100e-01 1.837968026399424164e-12 -7.707474468498933869e-09 5.511521527452584168e-01 4.860628239406353490e-13 -2.065773882990151527e-09 5.511521587810886968e-01 1.047196697283982988e-13 -4.754095872749126659e-10 5.511521605816621650e-01 6.798048749146937967e-14 -3.329978185108669088e-10 5.511521607477876117e-01 5.485994897359687179e-14 -2.909677670217017956e-10 5.511521607969439573e-01 4.639935205028451819e-14 -2.689776640429314818e-10 5.511521608218289403e-01 3.946098080181150545e-14 -2.532265184597714191e-10 5.511521608388703086e-01 3.333817557365040504e-14 -2.402514370721254383e-10 5.511521608523889393e-01 2.788321739188535862e-14 -2.290130217640591047e-10 5.511521608637904857e-01 2.310335286320624911e-14 -2.192188808484630325e-10 5.511521608735573396e-01 1.904427221418277966e-14 -2.108484430353434762e-10 5.511521608818175100e-01 1.574961510575420922e-14 -2.039828280732979285e-10 5.511521608885515677e-01 1.324827755792679272e-14 -1.987360186992170825e-10 5.511521608936807981e-01 1.155913561887655273e-14 -1.952223392338219211e-10 5.511521608971120534e-01 1.070117385028068578e-14 -1.935408297186730680e-10 5.511521608987568488e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 deleted file mode 100644 index 772ebad72..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ -1.684830067513857360e-02 6.712674724827587779e-05 6.670491481709989786e-05 1.682902214545057423e-02 6.688356266383820015e-05 6.637434605321353533e-05 1.679016293382153135e-02 6.642991177899530610e-05 6.577452734546529358e-05 1.673111393850434600e-02 6.577056030529450023e-05 6.490809174709723359e-05 1.665094589819876569e-02 6.491118503159688542e-05 6.377950151609839877e-05 1.654838947798170298e-02 6.383726528408017694e-05 6.239853954852647049e-05 1.642180822482116123e-02 6.253456091666644825e-05 6.077595871972967607e-05 1.626916397956381169e-02 6.099385865898245522e-05 5.892224737930316811e-05 1.608797417153872561e-02 5.920486118648587677e-05 5.684839679740701324e-05 1.587526030479660330e-02 5.715646980259507390e-05 5.456558993717689187e-05 1.562748684148160261e-02 5.483741279245596899e-05 5.208514074596934314e-05 1.534048959109307261e-02 5.223662353686053762e-05 4.941784232668106633e-05 1.500939261125728945e-02 4.934374718670664968e-05 4.657346999024691213e-05 1.462851259661572013e-02 4.614997311304872691e-05 4.356063090307065453e-05 1.419124980316582678e-02 4.265007434044474971e-05 4.038763336473827191e-05 1.368996483139258216e-02 3.884484468172764207e-05 3.706341534098054913e-05 1.311584108681242318e-02 3.474270460493742536e-05 3.359790088279883109e-05 1.245873357737880063e-02 3.036295514325033137e-05 3.000406369616539677e-05 1.170700632871967718e-02 2.574124968611301553e-05 2.630179547913165996e-05 1.084736340987432768e-02 2.107281086543724856e-05 2.256006711938202038e-05 9.864682700244091496e-03 1.700339131275534454e-05 1.899385345674443703e-05 8.741867192713061174e-03 1.364408563332431475e-05 1.569715422308901712e-05 7.459739843022222296e-03 1.100554402977306438e-05 1.273639966092352487e-05 5.997030910612793919e-03 9.058541676773888848e-06 1.016265445279812576e-05 4.330645057090176490e-03 7.729031285035317794e-06 8.005805636591002182e-06 2.436395110208634807e-03 6.611123207881331973e-06 6.212737517740668767e-06 2.936101703000753953e-04 5.361067351835979221e-06 4.714317176552229440e-06 -1.978830615753656829e-03 4.113517287885270777e-06 3.527307673627345504e-06 -4.123776100882096951e-03 3.027279136667426310e-06 2.673317812200429293e-06 -6.023233109404093656e-03 2.278755321638372441e-06 2.177552139041972009e-06 -7.581835083119876743e-03 2.068376842768837012e-06 2.067826896314877799e-06 -8.790339981004823694e-03 2.423463170426829836e-06 2.344498366239512924e-06 -9.781048634477061687e-03 3.227461794903344670e-06 2.978654103825142243e-06 -1.053822819603704615e-02 4.351809095228527003e-06 3.929788467596500756e-06 -1.089337105304939712e-02 5.663792836559564940e-06 5.149443802479995419e-06 -1.076017526017589501e-02 7.033938587380341519e-06 6.585301939313352870e-06 -1.030383748471300209e-02 8.451557759418772540e-06 8.191676077944526650e-06 -9.688283708871540251e-03 9.979659878922978632e-06 9.927826183200334149e-06 -8.896582065189072991e-03 1.160475361578466107e-05 1.174986673880583600e-05 -7.812723642966401191e-03 1.331208584254852084e-05 1.361713999086356877e-05 -6.422281817273027202e-03 1.508653709458688667e-05 1.549352281167932363e-05 -4.887377781359326240e-03 1.691271410699790646e-05 1.734757122015026697e-05 -3.471819758343314046e-03 1.877255291020361329e-05 1.915609069025453527e-05 -2.227648681226578661e-03 2.062211026717430113e-05 2.093283441545381796e-05 -1.141069660130177715e-03 2.243522928472819155e-05 2.266975793459655373e-05 -1.896504879309241550e-04 2.419485337603618320e-05 2.435138879474362051e-05 6.531960459441436568e-04 2.588628401641796445e-05 2.596430960922512291e-05 1.400277999203173012e-03 2.749721925319742325e-05 2.749725085828274592e-05 2.060517508161209283e-03 2.901819267214736673e-05 2.894153010910557807e-05 2.642358556019567227e-03 3.044221690119714851e-05 3.029077510923038362e-05 3.148824426777186228e-03 3.176438770914330326e-05 3.154060026545663000e-05 3.574670920714802420e-03 3.298171409643572559e-05 3.268846527521827871e-05 3.924418674832719917e-03 3.409304205481234422e-05 3.373360844230655135e-05 4.209661287099431860e-03 3.509873823987895870e-05 3.467675277201710918e-05 4.440729628263409209e-03 3.599998778435328708e-05 3.551976635292600004e-05 4.626523588764636444e-03 3.679196159348462162e-05 3.626638765754589005e-05 4.774641839267641102e-03 3.747691170928455677e-05 3.692057950381957051e-05 4.891507232701677171e-03 3.806125597031570387e-05 3.748585615559903693e-05 4.982482322858784729e-03 3.855107874770582934e-05 3.796552334780804256e-05 5.051972180857891223e-03 3.895194571349781549e-05 3.836258117399790678e-05 5.103513092957821622e-03 3.926876316257555126e-05 3.867965674161745536e-05 5.139840698849770274e-03 3.950565682736290746e-05 3.891894195392997887e-05 5.162942698322258751e-03 3.966586884417427368e-05 3.908213394116293943e-05 5.174154401314921652e-03 3.975174194233484649e-05 3.917045480128972707e-05 2.608842676250358649e-11 5.511521404323863615e-01 -1.911573677380113137e-08 2.417288653492700465e-11 5.511521415526217105e-01 -1.822768693896139199e-08 2.216197055117915186e-11 5.511521423858869451e-01 -1.766476719814908901e-08 1.994722937788455374e-11 5.511521430588141035e-01 -1.725096226707173279e-08 1.747530167850295825e-11 5.511521436857548251e-01 -1.684800883888574989e-08 1.478479370466823031e-11 5.511521443402634945e-01 -1.637594829585421272e-08 1.198176293187186363e-11 5.511521450571448266e-01 -1.580249562160286458e-08 9.198002611785832614e-12 5.511521458466248635e-01 -1.512315048454310041e-08 6.560174226537393445e-12 5.511521467050549683e-01 -1.434749111023679227e-08 4.171880778888202288e-12 5.511521476217073889e-01 -1.349131881154690588e-08 2.105967259401860646e-12 5.511521485825124911e-01 -1.257274459354779680e-08 4.034243827010482846e-13 5.511521495728723963e-01 -1.160952305735806477e-08 -9.232555670674846574e-13 5.511521505784884312e-01 -1.061845441130540378e-08 -1.885003086732669530e-12 5.511521515856586673e-01 -9.615315958179106677e-09 -2.510599095030524770e-12 5.511521525815346045e-01 -8.614811887088224459e-09 -2.841150990327766230e-12 5.511521535546860528e-01 -7.630181649387928036e-09 -2.925022156096534796e-12 5.511521544954994800e-01 -6.672899136858259548e-09 -2.813530077938787803e-12 5.511521553963445452e-01 -5.752544962912951102e-09 -2.557539988311978764e-12 5.511521562516766837e-01 -4.876764797551079581e-09 -2.205153685416695400e-12 5.511521570577216922e-01 -4.051697861864266534e-09 -1.803048389766289040e-12 5.511521578068074856e-01 -3.287277229730449250e-09 -1.394834988748856606e-12 5.511521584873952939e-01 -2.595827614109071002e-09 -1.017428356214806351e-12 5.511521590869827847e-01 -1.989861769752985069e-09 -6.885863683032028362e-13 5.511521596139913326e-01 -1.461140810188398937e-09 -4.227732670235887320e-13 5.511521600677534716e-01 -1.009944763385401304e-09 -2.301285915933615156e-13 5.511521604349394199e-01 -6.472621000970158200e-10 -1.064167824907953670e-13 5.511521607125362543e-01 -3.735655488084868713e-10 -3.729396106287693280e-14 5.511521609107553621e-01 -1.776834316369975440e-10 -6.455913584790844343e-15 5.511521610414169547e-01 -4.797183964873543864e-11 -2.155934217889526439e-15 5.511521610558370865e-01 -3.347095003278500073e-11 -6.870577772075903366e-17 5.511521610721287212e-01 -1.730023148423604965e-11 -2.630736839452844700e-16 5.511521610954310813e-01 5.966509813846617000e-12 -3.960176929488624420e-16 5.511521610943637128e-01 4.990127908179935624e-12 2.132081632434271151e-15 5.511521610687607486e-01 -2.055695205789533024e-11 5.529872746395285462e-15 5.511521610414723549e-01 -4.778191866322242035e-11 2.904163389513934429e-13 5.511521586066808753e-01 -2.509221840749997706e-09 5.046624070948872512e-14 5.511521606229070613e-01 -4.677539646305761187e-10 4.151325855126667699e-14 5.511521606418710029e-01 -4.478561818052801051e-10 3.491846955438926357e-14 5.511521606036459131e-01 -4.856495416159910992e-10 2.445864087988369905e-14 5.511521605641545030e-01 -5.247952874733308021e-10 9.760934406674832783e-15 5.511521605360691911e-01 -5.525996515344730033e-10 -7.959661505891755361e-15 5.511521605228230092e-01 -5.656591509249117194e-10 -2.703505638602696142e-14 5.511521605212166275e-01 -5.671616623169966772e-10 -4.650170775388289413e-14 5.511521605224594111e-01 -5.658385106277720405e-10 -6.626001613352058696e-14 5.511521605210468744e-01 -5.672006018512480477e-10 -8.736917174928547206e-14 5.511521605100394572e-01 -5.784201699987710026e-10 -1.135294284930753241e-13 5.511521604745870384e-01 -6.152334365999133571e-10 -1.562654170616490738e-13 5.511521603749960363e-01 -7.204652810677792869e-10 -2.773197976801776866e-13 5.511521600010982347e-01 -1.121554453384799586e-09 -2.104189668082807502e-12 5.511521539874826292e-01 -7.686332036399922470e-09 -6.170756060052933985e-13 5.511521592573827011e-01 -2.042818387045844225e-09 -1.545806796146075583e-13 5.511521606627496350e-01 -4.512374944040355930e-10 -1.179393685185212649e-13 5.511521607856899596e-01 -3.080450729571656196e-10 -1.114044148370059676e-13 5.511521608224089208e-01 -2.656622098290083899e-10 -1.103508892700626202e-13 5.511521608423758378e-01 -2.437213443434164518e-10 -1.103897620571443414e-13 5.511521608571153807e-01 -2.283745410302874118e-10 -1.104280411544224207e-13 5.511521608693613627e-01 -2.161148780100907009e-10 -1.101894491087092484e-13 5.511521608798736205e-01 -2.058438556738244217e-10 -1.096716454297215037e-13 5.511521608888573232e-01 -1.971816986344342908e-10 -1.089750199035848967e-13 5.511521608963512175e-01 -1.900000636106764599e-10 -1.082294299911353223e-13 5.511521609023483093e-01 -1.842640603328599955e-10 -1.075645027852724291e-13 5.511521609068303906e-01 -1.799757953341840606e-10 -1.070920915003985010e-13 5.511521609097764784e-01 -1.771530025026718079e-10 -1.068977570120967567e-13 5.511521609111527109e-01 -1.758303968038655942e-10 2.415803765802641155e-11 -1.911573677380113137e-08 5.511521433754802413e-01 2.256645498539479009e-11 -1.822768693896139199e-08 5.511521440624227441e-01 2.094074201606641571e-11 -1.766476719814908901e-08 5.511521443900549988e-01 1.909107733288769982e-11 -1.725096226707173279e-08 5.511521445732124880e-01 1.692139504823108127e-11 -1.684800883888574989e-08 5.511521447714824440e-01 1.445787353153917989e-11 -1.637594829585421272e-08 5.511521450727805416e-01 1.181159674360135247e-11 -1.580249562160286458e-08 5.511521455093169042e-01 9.126759479766404801e-12 -1.512315048454310041e-08 5.511521460818735729e-01 6.543920101039645170e-12 -1.434749111023679227e-08 5.511521467762943161e-01 4.179497172072494820e-12 -1.349131881154690588e-08 5.511521475725456032e-01 2.117186320512808606e-12 -1.257274459354779680e-08 5.511521484489830813e-01 4.067061674731970456e-13 -1.160952305735806477e-08 5.511521493849951270e-01 -9.327363153804636364e-13 -1.061845441130540378e-08 5.511521503614520423e-01 -1.907191975364226045e-12 -9.615315958179106677e-09 5.511521513605887046e-01 -2.542219507779940784e-12 -8.614811887088224459e-09 5.511521523658748922e-01 -2.877204236291840839e-12 -7.630181649387928036e-09 5.511521533622475433e-01 -2.960115518935515599e-12 -6.672899136858259548e-09 5.511521543363289144e-01 -2.842982781306965056e-12 -5.752544962912951102e-09 5.511521552765307197e-01 -2.578241301608981070e-12 -4.876764797551079581e-09 5.511521561730470253e-01 -2.216172940444382022e-12 -4.051697861864266534e-09 5.511521570173312234e-01 -1.805688808449919222e-12 -3.287277229730449250e-09 5.511521577971888464e-01 -1.391575336188519829e-12 -2.595827614109071002e-09 5.511521584995439094e-01 -1.011080873219392222e-12 -1.989861769752985069e-09 5.511521591118888619e-01 -6.819479570963594179e-13 -1.461140810188398937e-09 5.511521596423023528e-01 -4.179442176087034530e-13 -1.009944763385401304e-09 5.511521600909586871e-01 -2.276059496921086349e-13 -6.472621000970158200e-10 5.511521604492077842e-01 -1.054931021274384317e-13 -3.735655488084868713e-10 5.511521607190497107e-01 -3.709862873392000774e-14 -1.776834316369975440e-10 5.511521609126218690e-01 -6.456569115087631478e-15 -4.797183964873543864e-11 5.511521610414084060e-01 -2.150847305472643966e-15 -3.347095003278500073e-11 5.511521610559930728e-01 -6.898116614788134028e-17 -1.730023148423604965e-11 5.511521610720426789e-01 -2.596968498765096773e-16 5.966509813846617000e-12 5.511521610952793138e-01 -3.972647765703611451e-16 4.990127908179935624e-12 5.511521610943959093e-01 2.124650313485068228e-15 -2.055695205789533024e-11 5.511521610689049666e-01 5.514257940586376254e-15 -4.778191866322242035e-11 5.511521610417426942e-01 2.935184842301130138e-13 -2.509221840749997706e-09 5.511521585533586398e-01 5.060393081300308394e-14 -4.677539646305761187e-10 5.511521606203578783e-01 4.154462276604576656e-14 -4.478561818052801051e-10 5.511521606411939889e-01 3.491163732007257671e-14 -4.856495416159910992e-10 5.511521606038329857e-01 2.443816606033625668e-14 -5.247952874733308021e-10 5.511521605650325784e-01 9.748224981305378980e-15 -5.525996515344730033e-10 5.511521605375077071e-01 -7.946926682422886622e-15 -5.656591509249117194e-10 5.511521605246333388e-01 -2.698704822334196673e-14 -5.671616623169966772e-10 5.511521605232324594e-01 -4.641246969689941836e-14 -5.658385106277720405e-10 5.511521605246326727e-01 -6.612723773366139543e-14 -5.672006018512480477e-10 5.511521605233199450e-01 -8.722899314026716439e-14 -5.784201699987710026e-10 5.511521605118944178e-01 -1.136093594420768466e-13 -6.152334365999133571e-10 5.511521604737227298e-01 -1.576046648332854350e-13 -7.204652810677792869e-10 5.511521603627018706e-01 -2.858831806842593604e-13 -1.121554453384799586e-09 5.511521599328761400e-01 -2.277769069051067050e-12 -7.686332036399922470e-09 5.511521527676482846e-01 -6.890804065601317013e-13 -2.042818387045844225e-09 5.511521588054080212e-01 -1.643931912590787149e-13 -4.512374944040355930e-10 5.511521606071512203e-01 -1.202285087732659704e-13 -3.080450729571656196e-10 5.511521607738825157e-01 -1.112606048606853298e-13 -2.656622098290083899e-10 5.511521608231298996e-01 -1.091650344989341523e-13 -2.437213443434164518e-10 5.511521608476607215e-01 -1.087437553917318651e-13 -2.283745410302874118e-10 5.511521608639896597e-01 -1.086163952091983084e-13 -2.161148780100907009e-10 5.511521608765141966e-01 -1.083724304402665664e-13 -2.058438556738244217e-10 5.511521608867201438e-01 -1.079260426888560680e-13 -1.971816986344342908e-10 5.511521608951851503e-01 -1.073263283865657116e-13 -1.900000636106764599e-10 5.511521609021418078e-01 -1.066759261984709739e-13 -1.842640603328599955e-10 5.511521609076767136e-01 -1.060866036816425709e-13 -1.799757953341840606e-10 5.511521609118099629e-01 -1.056635457895235487e-13 -1.771530025026718079e-10 5.511521609145330070e-01 -1.054905483891994997e-13 -1.758303968038655942e-10 5.511521609158123169e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 deleted file mode 100644 index c0c44fd22..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ -1.701030840996054297e-02 6.712676713334509565e-05 6.670493328461960696e-05 1.699296624267677275e-02 6.688358085192915318e-05 6.637436307934456935e-05 1.695801556740624341e-02 6.642992798684574330e-05 6.577454269637968089e-05 1.690491836823251534e-02 6.577057425191731464e-05 6.490810512066535565e-05 1.683285349929638033e-02 6.491119649486393433e-05 6.377951263274547105e-05 1.674069942210072715e-02 6.383727416742538113e-05 6.239854824568308572e-05 1.662701070021436675e-02 6.253456727820668978e-05 6.077596499675085593e-05 1.648998793868652543e-02 6.099386269810331998e-05 5.892225139014369662e-05 1.632744071576312100e-02 5.920486320601422016e-05 5.684839881324360757e-05 1.613674297537261854e-02 5.715647016372053720e-05 5.456559029936706881e-05 1.591478028732052144e-02 5.483741187343907190e-05 5.208513982210150192e-05 1.565788831044484519e-02 5.223662170078782800e-05 4.941784047574990127e-05 1.536178175040133972e-02 4.934374475961584731e-05 4.657346753854768844e-05 1.502147311233030351e-02 4.614997037126535051e-05 4.356062812972362534e-05 1.463118064142372721e-02 4.265007150532147315e-05 4.038763049500762115e-05 1.418422507370719135e-02 3.884484192008532750e-05 3.706341254564300642e-05 1.367291525367373209e-02 3.474270203356210918e-05 3.359789828190076430e-05 1.308842342347713711e-02 3.036295283591009602e-05 3.000406136560869306e-05 1.242065219927721530e-02 2.574124768185943074e-05 2.630179345879105264e-05 1.165809720333329039e-02 2.107280917705240064e-05 2.256006542154042569e-05 1.078771205423442389e-02 1.700338993244838369e-05 1.899385207206501417e-05 9.794785629308919508e-03 1.364408453738333288e-05 1.569715312613605111e-05 8.662849872738449461e-03 1.100554318408410600e-05 1.273639881615677191e-05 7.373642002026285953e-03 9.058541048145356359e-06 1.016265382586808068e-05 5.907157351809907281e-03 7.729030840340038929e-06 8.005805193545924764e-06 4.241843931630280215e-03 6.611122911621502696e-06 6.212737222907818108e-06 2.355075223285590415e-03 5.361067169768765438e-06 4.714316995841140817e-06 2.245293820621841949e-04 4.113517192947402311e-06 3.527307579808045878e-06 -2.034598301210873393e-03 3.027279101744627201e-06 2.673317777846168016e-06 -4.151803923244577060e-03 2.278755306271852654e-06 2.177552123862964987e-06 -6.028763801412588552e-03 2.068376837725581668e-06 2.067826891266353910e-06 -7.573879914826294954e-03 2.423463170999915388e-06 2.344498366791816946e-06 -8.759992577848074377e-03 3.227461795457543080e-06 2.978654104380048349e-06 -9.746000063092136873e-03 4.351809093393142132e-06 3.929788465767380540e-06 -1.051995036279615957e-02 5.663792833345570419e-06 5.149443799274766843e-06 -1.090874159078391616e-02 7.033938466142982649e-06 6.585301816781236377e-06 -1.080864277005538950e-02 8.451557743313504922e-06 8.191676061795054076e-06 -1.036928796977470979e-02 9.979659867969207851e-06 9.927826172237037635e-06 -9.778237119432044502e-03 1.160475360756810097e-05 1.174986673059021780e-05 -9.035639146913923558e-03 1.331208583690722381e-05 1.361713998522709644e-05 -8.012684540365824087e-03 1.508653709167426731e-05 1.549352280877058538e-05 -6.682579831148923247e-03 1.691271410698661721e-05 1.734757122013901159e-05 -5.151691040704410238e-03 1.877255291322569132e-05 1.915609069327150739e-05 -3.726837064234695025e-03 2.062211027347040206e-05 2.093283442173689152e-05 -2.472363207895130355e-03 2.243522929483160393e-05 2.266975794467553090e-05 -1.375418969011573452e-03 2.419485339105069600e-05 2.435138880972704043e-05 -4.183232816082121854e-04 2.588628403863597747e-05 2.596430963145243974e-05 4.282275441390572630e-04 2.749721928816452896e-05 2.749725089354574395e-05 1.178365586787474524e-03 2.901819274287726396e-05 2.894153018200575328e-05 1.840830002644214388e-03 3.044221750842174626e-05 3.029077576647719647e-05 2.423951574282323228e-03 3.176438791299931899e-05 3.154060049299623581e-05 2.934970394376110615e-03 3.298171415485867794e-05 3.268846533735470482e-05 3.371088564282621013e-03 3.409304210414550141e-05 3.373360849268277879e-05 3.730763051282031360e-03 3.509873829040330848e-05 3.467675282258727329e-05 4.024678380280400335e-03 3.599998783794544789e-05 3.551976640604954835e-05 4.263161545323747650e-03 3.679196165036497789e-05 3.626638771366994755e-05 4.455081939869413692e-03 3.747691176918705884e-05 3.692057956281022467e-05 4.607971648492591860e-03 3.806125603280259155e-05 3.748585621710764899e-05 4.728142627731686358e-03 3.855107881229706535e-05 3.796552341140710482e-05 4.820794939143351401e-03 3.895194577973449092e-05 3.836258123925500555e-05 4.890112465689522812e-03 3.926876323004452411e-05 3.867965680813117155e-05 4.939344034184400128e-03 3.950565689570751586e-05 3.891894202134346090e-05 4.970868838187409919e-03 3.966586891309516942e-05 3.908213400916845683e-05 4.986245651175879104e-03 3.975174201157469418e-05 3.917045486961995624e-05 4.597349597848138029e-11 5.511521402279838666e-01 -1.932791803252088017e-08 4.236097748328004488e-11 5.511521413580215967e-01 -1.842985203714219561e-08 3.836982099486935323e-11 5.511521422097397371e-01 -1.784806414007445652e-08 3.389385219556707394e-11 5.511521429076889911e-01 -1.740864041748814177e-08 2.893856872934386065e-11 5.511521435635763355e-01 -1.697598953619772560e-08 2.366813891056918631e-11 5.511521442481511768e-01 -1.647299248038956659e-08 1.834330316720647493e-11 5.511521449935945505e-01 -1.587002688507245660e-08 1.323712347944667622e-11 5.511521458079244873e-01 -1.516484220833158792e-08 8.579702570482448158e-12 5.511521466858195772e-01 -1.436873328027675065e-08 4.533006241628900439e-12 5.511521476154425114e-01 -1.349865698003885018e-08 1.186950360864730283e-12 5.511521485821468946e-01 -1.257334848870582290e-08 -1.432648323601388037e-12 5.511521495712328189e-01 -1.161071109999093519e-08 -3.350346371865693595e-12 5.511521505687116962e-01 -1.062727936971972972e-08 -4.626786461194743220e-12 5.511521515615434019e-01 -9.638206314670413377e-09 -5.345722373249141092e-12 5.511521525378415554e-01 -8.657260536095541112e-09 -5.602793303383345295e-12 5.511521534873915495e-01 -7.696475176910638728e-09 -5.496397473215344138e-12 5.511521544020064889e-01 -6.765884462595390244e-09 -5.120870313241098442e-12 5.511521552756518672e-01 -5.873433249789491483e-09 -4.561793572912125590e-12 5.511521561045104045e-01 -5.024974112264690832e-09 -3.893538532264352186e-12 5.511521568866365461e-01 -4.224735367935752051e-09 -3.183355351459008892e-12 5.511521576162171643e-01 -3.480696297599475380e-09 -2.490775971119785123e-12 5.511521582833255328e-01 -2.803409549670527553e-09 -1.863117313873277241e-12 5.511521588767003266e-01 -2.203944734996069901e-09 -1.317214901334352794e-12 5.511521594055444062e-01 -1.673089449330466043e-09 -8.674685458817090679e-13 5.511521598694654189e-01 -1.210741652914280762e-09 -5.263884204961908319e-13 5.511521602548816734e-01 -8.282140860602899075e-10 -2.884839965303543533e-13 5.511521605583241668e-01 -5.268512462053545184e-10 -1.322318299071276143e-13 5.511521607958675961e-01 -2.905852836065203348e-10 -4.137871265371600753e-14 5.511521609729487237e-01 -1.148299578408345213e-10 -1.752245406250620226e-14 5.511521610226125523e-01 -6.603748592652048159e-11 -5.111961067771800988e-15 5.511521610602111432e-01 -2.920643345013642296e-11 3.100120076574351561e-16 5.511521610926781722e-01 3.112027914878660870e-12 1.581808477517425581e-16 5.511521610941061411e-01 4.703150989914121743e-12 2.966970205073969251e-16 5.511521610687135642e-01 -2.059765475810521031e-11 2.315878167140748414e-15 5.511521610412490890e-01 -4.799854125100212152e-11 1.691789803125355572e-13 5.511521586068536260e-01 -2.509051182721895728e-09 3.436097245327722309e-14 5.511521606235861848e-01 -4.670691124798578910e-10 3.055948698284136226e-14 5.511521606426478259e-01 -4.470602238498087955e-10 2.670190974984219084e-14 5.511521606043001675e-01 -4.849816101234730956e-10 1.881734397047649948e-14 5.511521605645497424e-01 -5.244019565458765822e-10 6.848315824402185411e-15 5.511521605361351384e-01 -5.525387524295642391e-10 -7.970949832535806704e-15 5.511521605229066090e-01 -5.655702269558547150e-10 -2.401297788694916441e-14 5.511521605219671383e-01 -5.664081883056827597e-10 -4.020560570115509958e-14 5.511521605243800970e-01 -5.639371522741663552e-10 -5.615660229888873501e-14 5.511521605243902000e-01 -5.639065875929313819e-10 -7.235465832132638097e-14 5.511521605148115288e-01 -5.737125582133833547e-10 -9.131141441520345948e-14 5.511521604806493002e-01 -6.092108032682453544e-10 -1.212983127442095091e-13 5.511521603820440651e-01 -7.133798737363403039e-10 -2.065899009003471450e-13 5.511521600087539996e-01 -1.113738936093074340e-09 -1.496965072017529434e-12 5.511521539953936344e-01 -7.678116295891208622e-09 -4.132195925691880615e-13 5.511521592652286472e-01 -2.034536260167014977e-09 -9.615772609164400011e-14 5.511521606701681453e-01 -4.433103971523875891e-10 -6.860621249513628218e-14 5.511521607924559918e-01 -3.007679353230842257e-10 -6.088006702337816015e-14 5.511521608284992713e-01 -2.591050745607201308e-10 -5.675872842192616592e-14 5.511521608478064937e-01 -2.378952327816368375e-10 -5.350940247060376818e-14 5.511521608619209811e-01 -2.232553292499120959e-10 -5.052553747740121672e-14 5.511521608735919786e-01 -2.116508920568673862e-10 -4.770256290167810643e-14 5.511521608835915353e-01 -2.019636412335477717e-10 -4.508041068438395000e-14 5.511521608921337023e-01 -1.938016975610461423e-10 -4.273834642267218804e-14 5.511521608992616672e-01 -1.870313905241016753e-10 -4.076045882233638897e-14 5.511521609049696568e-01 -1.816176561476259735e-10 -3.921989361211152912e-14 5.511521609092381313e-01 -1.775656648240360515e-10 -3.817119272961116851e-14 5.511521609120435539e-01 -1.748975368797114259e-10 -3.765790623937522106e-14 5.511521609133498423e-01 -1.736513911691102240e-10 4.262555736773414009e-11 -1.932791803252088017e-08 5.511521431552240946e-01 3.959258601467870361e-11 -1.842985203714219561e-08 5.511521438523986349e-01 3.629165640941322936e-11 -1.784806414007445652e-08 5.511521441993181281e-01 3.246464545557152187e-11 -1.740864041748814177e-08 5.511521444086970867e-01 2.803804212499793282e-11 -1.697598953619772560e-08 5.511521446374240130e-01 2.315503014712594746e-11 -1.647299248038956659e-08 5.511521449705404363e-01 1.808861792606652837e-11 -1.587002688507245660e-08 5.511521454375551965e-01 1.313760000857970319e-11 -1.516484220833158792e-08 5.511521460369592784e-01 8.559756697802202907e-12 -1.436873328027675065e-08 5.511521467528360807e-01 4.541687347149083540e-12 -1.349865698003885018e-08 5.511521475639502565e-01 1.193318481874178999e-12 -1.257334848870582290e-08 5.511521484479856570e-01 -1.444224997542120595e-12 -1.161071109999093519e-08 5.511521493841342600e-01 -3.384435541045491505e-12 -1.062727936971972972e-08 5.511521503534861921e-01 -4.680539007707846253e-12 -9.638206314670413377e-09 5.511521513388610849e-01 -5.411950159739711089e-12 -8.657260536095541112e-09 5.511521523246352139e-01 -5.672541777108141882e-12 -7.696475176910638728e-09 5.511521532969401171e-01 -5.561013586184473846e-12 -6.765884462595390244e-09 5.511521542438485577e-01 -5.173539483634930625e-12 -5.873433249789491483e-09 5.511521551554465770e-01 -4.598581909494709728e-12 -5.024974112264690832e-09 5.511521560237873096e-01 -3.914014535243330518e-12 -4.224735367935752051e-09 5.511521568423191075e-01 -3.190368231954326373e-12 -3.480696297599475380e-09 5.511521576008989731e-01 -2.488528302186609467e-12 -2.803409549670527553e-09 5.511521582883892600e-01 -1.855847626806525961e-12 -2.203944734996069901e-09 5.511521588939367611e-01 -1.308878001562463831e-12 -1.673089449330466043e-09 5.511521594267930757e-01 -8.609892944358017396e-13 -1.210741652914280762e-09 5.511521598876212291e-01 -5.224387999916249551e-13 -8.282140860602899075e-10 5.511521602673571385e-01 -2.862041906915919046e-13 -5.268512462053545184e-10 5.511521605666848123e-01 -1.309179285689420661e-13 -2.905852836065203348e-10 5.511521608016716200e-01 -4.081083041258977245e-14 -1.148299578408345213e-10 5.511521609761225182e-01 -1.732985435123424839e-14 -6.603748592652048159e-11 5.511521610240714963e-01 -5.117504863960055656e-15 -2.920643345013642296e-11 5.511521610601478605e-01 2.926070273396778050e-16 3.112027914878660870e-12 5.511521610923195702e-01 1.576411530976983358e-16 4.703150989914121743e-12 5.511521610940761651e-01 2.955302216200349800e-16 -2.059765475810521031e-11 5.511521610688698836e-01 2.309029279894106175e-15 -4.799854125100212152e-11 5.511521610415325290e-01 1.709863680682179991e-13 -2.509051182721895728e-09 5.511521585535271717e-01 3.445445739681572810e-14 -4.670691124798578910e-10 5.511521606210485480e-01 3.058132650639365307e-14 -4.470602238498087955e-10 5.511521606420095587e-01 2.669601949747156468e-14 -4.849816101234730956e-10 5.511521606045148847e-01 1.880169311320351904e-14 -5.244019565458765822e-10 5.511521605654240430e-01 6.839485446582324286e-15 -5.525387524295642391e-10 5.511521605375638844e-01 -7.958182979860916456e-15 -5.655702269558547150e-10 5.511521605247279298e-01 -2.397007547539137048e-14 -5.664081883056827597e-10 5.511521605239888544e-01 -4.012939623684019864e-14 -5.639371522741663552e-10 5.511521605265149448e-01 -5.604826027804925671e-14 -5.639065875929313819e-10 5.511521605265653490e-01 -7.224557366331130988e-14 -5.737125582133833547e-10 5.511521605165384807e-01 -9.138204249295920117e-14 -6.092108032682453544e-10 5.511521604797059437e-01 -1.223416652687031986e-13 -7.133798737363403039e-10 5.511521603698249505e-01 -2.129830045377929158e-13 -1.113738936093074340e-09 5.511521599408547578e-01 -1.620522254705928785e-12 -7.678116295891208622e-09 5.511521527761804595e-01 -4.615408026704069298e-13 -2.034536260167014977e-09 5.511521588141504724e-01 -1.022567635012034642e-13 -4.433103971523875891e-10 5.511521606156217779e-01 -6.985228057420778234e-14 -3.007679353230842257e-10 5.511521607817093660e-01 -6.069044405931200307e-14 -2.591050745607201308e-10 5.511521608301895858e-01 -5.604148932928016319e-14 -2.378952327816368375e-10 5.511521608539110550e-01 -5.261969644949252592e-14 -2.232553292499120959e-10 5.511521608694429641e-01 -4.962574337582342192e-14 -2.116508920568673862e-10 5.511521608812244288e-01 -4.686381589154660389e-14 -2.019636412335477717e-10 5.511521608907696823e-01 -4.432698032424932218e-14 -1.938016975610461423e-10 5.511521608986720278e-01 -4.206923026706256500e-14 -1.870313905241016753e-10 5.511521609051698301e-01 -4.016221051937299026e-14 -1.816176561476259735e-10 5.511521609103483543e-01 -3.867312123854241278e-14 -1.775656648240360515e-10 5.511521609142224776e-01 -3.765802768316938033e-14 -1.748975368797114259e-10 5.511521609167769897e-01 -3.716031591300322923e-14 -1.736513911691102240e-10 5.511521609179733661e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 deleted file mode 100644 index ceb741065..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ -1.708232349966676278e-02 6.712673933944084614e-05 6.670490751617054622e-05 1.706599159884072958e-02 6.688355564912015652e-05 6.637433952491531540e-05 1.703308120092475800e-02 6.642990591901372518e-05 6.577452182494018936e-05 1.698309393758010502e-02 6.577055582441606338e-05 6.490808747120525586e-05 1.691526903834774179e-02 6.491118208676439720e-05 6.377949867385709101e-05 1.682856727250368542e-02 6.383726392716237074e-05 6.239853822813383629e-05 1.672164917790415831e-02 6.253456107962119452e-05 6.077595888481588927e-05 1.659284729482567167e-02 6.099386016594198363e-05 5.892224887749566834e-05 1.644013201841195912e-02 5.920486378331775174e-05 5.684839938957464368e-05 1.626107059944004521e-02 5.715647319323930494e-05 5.456559333495372309e-05 1.605277875717793165e-02 5.483741667379863109e-05 5.208514464834468035e-05 1.581186430657722380e-02 5.223662762683650837e-05 4.941784644987245832e-05 1.553436216702992756e-02 4.934375124363112378e-05 4.657347408863019987e-05 1.521566013234458559e-02 4.614997694621620039e-05 4.356063478110268496e-05 1.485041486765758222e-02 4.265007781319608561e-05 4.038763688104381156e-05 1.443245780425995474e-02 3.884484770870763522e-05 3.706341840632874956e-05 1.395469098874177125e-02 3.474270714561701970e-05 3.359790345405595568e-05 1.340897360099873800e-02 3.036295719361688109e-05 3.000406576814274869e-05 1.278600091314905166e-02 2.574125127001431992e-05 2.630179707588773286e-05 1.207517910811056749e-02 2.107281202670538561e-05 2.256006828616379642e-05 1.126450180525668046e-02 1.700339210984125595e-05 1.899385425418969708e-05 1.034043732653437513e-02 1.364408613379187156e-05 1.569715472096673003e-05 9.287841392658211306e-03 1.100554430440322634e-05 1.273639993188865319e-05 8.089916112834796141e-03 9.058541791075999444e-06 1.016265456382313703e-05 6.728245334855066304e-03 7.729031298280898845e-06 8.005805647789357115e-06 5.182947974605629955e-03 6.611123170440782486e-06 6.212737479571106821e-06 3.433005461494493052e-03 5.361067300634107262e-06 4.714317125562671372e-06 1.456837807813450569e-03 4.113517247114451168e-06 3.527307633424048134e-06 -7.520971974839577544e-04 3.027279116165919205e-06 2.673317792100992211e-06 -2.947903667069822538e-03 2.278755311982207430e-06 2.177552129539345696e-06 -4.957269617621875776e-03 2.068376839382254023e-06 2.067826892935536942e-06 -6.694222249269812797e-03 2.423463170828646173e-06 2.344498366627974092e-06 -8.071099556765810520e-03 3.227461795329263752e-06 2.978654104252142986e-06 -9.155132398603774840e-03 4.351809093782741712e-06 3.929788466155123424e-06 -1.006009652310661286e-02 5.663792834050860026e-06 5.149443799977213807e-06 -1.071925651401983183e-02 7.033938500042092466e-06 6.585301851041656568e-06 -1.093833351444793191e-02 8.451557750443082883e-06 8.191676068944274731e-06 -1.068781674431596232e-02 9.979659875180914126e-06 9.927826179453317889e-06 -1.019989019792669552e-02 1.160475361483386489e-05 1.174986673785311367e-05 -9.573289389085607934e-03 1.331208584326821932e-05 1.361713999158218813e-05 -8.777454647229098947e-03 1.508653709590008589e-05 1.549352281299089655e-05 -7.675400594854039915e-03 1.691271410777238257e-05 1.734757122092378762e-05 -6.285966251271946428e-03 1.877255290948800937e-05 1.915609068954092018e-05 -4.768488987046302745e-03 2.062211026429424342e-05 2.093283441257885939e-05 -3.406960721872945210e-03 2.243522927932745188e-05 2.266975792919903278e-05 -2.209829954633037510e-03 2.419485336804977720e-05 2.435138878675027223e-05 -1.164256854547730553e-03 2.588628400585071682e-05 2.596430959862052113e-05 -2.509163564554965295e-04 2.749721923945775263e-05 2.749725084437823591e-05 5.585826606644436840e-04 2.901819265002557666e-05 2.894153008617759897e-05 1.274823091556380331e-03 3.044221675263042575e-05 3.029077494801766225e-05 1.906239551755201534e-03 3.176438769101786884e-05 3.154060024463131533e-05 2.460826088495756889e-03 3.298171410347169625e-05 3.268846528258117698e-05 2.945870918914990713e-03 3.409304206655566321e-05 3.373360845457759897e-05 3.358810193096657421e-03 3.509873825519548956e-05 3.467675278780927276e-05 3.698385055419625700e-03 3.599998780293596343e-05 3.551976637186104210e-05 3.975394962818158684e-03 3.679196161501615848e-05 3.626638767929191598e-05 4.199531243625499385e-03 3.747691173340030984e-05 3.692057952801714018e-05 4.379056322358608651e-03 3.806125599662120651e-05 3.748585618187477144e-05 4.520915678877454602e-03 3.855107877581251028e-05 3.796552337579544092e-05 4.630845227116132945e-03 3.895194574303753387e-05 3.836258120335269415e-05 4.713468684102874347e-03 3.926876319321446769e-05 3.867965677202616856e-05 4.772381536031781481e-03 3.950565685880038622e-05 3.891894198510531788e-05 4.810219585267649575e-03 3.966586887613983344e-05 3.908213397284631524e-05 4.828710953851045838e-03 3.975174197457888357e-05 3.917045483323974207e-05 1.817959172901466443e-11 5.511521402137409265e-01 -1.934267196095108421e-08 1.715816848245907422e-11 5.511521413437642236e-01 -1.844462767040880423e-08 1.630198897451969554e-11 5.511521421954768130e-01 -1.786285891502244586e-08 1.546635094248336895e-11 5.511521428934766931e-01 -1.742340218289289816e-08 1.453046919435925661e-11 5.511521435495355670e-01 -1.699059859405107007e-08 1.342787589726266628e-11 5.511521442344756716e-01 -1.648725236084111931e-08 1.214471766993066708e-11 5.511521449805477646e-01 -1.588366693656065501e-08 1.070496214265862917e-11 5.511521457958226122e-01 -1.517753423601151218e-08 9.157006104515838413e-12 5.511521466750007869e-01 -1.438012275311532661e-08 7.562525008646765753e-12 5.511521476062241076e-01 -1.350840699241152112e-08 5.987309921736836116e-12 5.511521485747746807e-01 -1.258119216644426902e-08 4.493400358799021097e-12 5.511521495658294745e-01 -1.161650602365409030e-08 3.133668902205495841e-12 5.511521505652312580e-01 -1.063105628167230057e-08 1.948164388993238073e-12 5.511521515597395116e-01 -9.640204128084713602e-09 9.621522406368090087e-13 5.511521525372569119e-01 -8.657940522721284656e-09 1.858290040383143854e-13 5.511521534873716766e-01 -7.696509053497173256e-09 -3.843425656414447816e-13 5.511521544017412566e-01 -6.766113691078879279e-09 -7.631635270795560582e-13 5.511521552742427721e-01 -5.874799889879429891e-09 -9.736386839662992956e-13 5.511521561010604975e-01 -5.028426627142446109e-09 -1.043885547378631685e-12 5.511521568803569027e-01 -4.231115490226015247e-09 -1.005962480806071699e-12 5.511521576065404604e-01 -3.490616973776464584e-09 -8.943674317681705798e-13 5.511521582700021904e-01 -2.817145039940886538e-09 -7.427981943483676249e-13 5.511521588598663479e-01 -2.221348414685849684e-09 -5.742842588350599631e-13 5.511521593857481305e-01 -1.693554839309210160e-09 -4.095276865937943067e-13 5.511521598476469830e-01 -1.233220298243455396e-09 -2.675691408359044481e-13 5.511521602323027347e-01 -8.512984840386142132e-10 -1.576186549459351691e-13 5.511521605364754217e-01 -5.489102213024452650e-10 -7.806478071963261313e-14 5.511521607763735231e-01 -3.099361531387873750e-10 -2.695742075210912849e-14 5.511521609587466397e-01 -1.286836669996377391e-10 -1.181209946756317522e-14 5.511521610147095407e-01 -7.366644678268270889e-11 -3.455288753729757644e-15 5.511521610570513374e-01 -3.226997733458114363e-11 1.387428024798480804e-16 5.511521610920301351e-01 2.459591165551820557e-12 2.990135122441377084e-17 5.511521610941021443e-01 4.696578060058418760e-12 6.862967081380124879e-16 5.511521610685371497e-01 -2.075798713614003394e-11 3.021167872133130111e-15 5.511521610407880134e-01 -4.844406965360940077e-11 2.030780902439223876e-13 5.511521586065332157e-01 -2.509364734022321120e-09 4.149055008502228342e-14 5.511521606238458659e-01 -4.668122875828121212e-10 3.777119309933092226e-14 5.511521606432117082e-01 -4.464899601955411577e-10 3.396767370647672329e-14 5.511521606048007671e-01 -4.844636845337691356e-10 2.517834008715204214e-14 5.511521605648480593e-01 -5.240920998188742714e-10 1.107413370226291463e-14 5.511521605362114107e-01 -5.524620298479828344e-10 -7.185184745191947675e-15 5.511521605229431353e-01 -5.655303020775093994e-10 -2.775065901318032248e-14 5.511521605226323839e-01 -5.657271719152777481e-10 -4.938176415142497903e-14 5.511521605263790535e-01 -5.619299171472131937e-10 -7.166075318172712669e-14 5.511521605282305725e-01 -5.600890655977344089e-10 -9.535557628011155589e-14 5.511521605207515551e-01 -5.678384890048607467e-10 -1.240966755091123706e-13 5.511521604886981951e-01 -6.012596034386217838e-10 -1.700050895544190617e-13 5.511521603921374357e-01 -7.033741311366347891e-10 -2.994415874821451287e-13 5.511521600205605553e-01 -1.101945444860965601e-09 -2.252756391139398523e-12 5.511521540084718396e-01 -7.664911142678275440e-09 -6.352010409027822892e-13 5.511521592791303048e-01 -2.020319631022494617e-09 -1.475447064921005898e-13 5.511521606844924648e-01 -4.284676632627916839e-10 -1.061960523368612223e-13 5.511521608065924616e-01 -2.859552896878218516e-10 -9.608788921546297265e-14 5.511521608419105434e-01 -2.449490509889375123e-10 -9.176821357975784458e-14 5.511521608604195155e-01 -2.245382612247591430e-10 -8.885822290289893206e-14 5.511521608737206535e-01 -2.107624340942649344e-10 -8.631228347633129129e-14 5.511521608845943998e-01 -2.000355433628559918e-10 -8.388394623239646726e-14 5.511521608938392269e-01 -1.911952813721230759e-10 -8.156496602587800504e-14 5.511521609016929446e-01 -1.838130589050837112e-10 -7.943530124067115713e-14 5.511521609082190576e-01 -1.777262501278581958e-10 -7.759051435762920425e-14 5.511521609134284461e-01 -1.728785311564917800e-10 -7.612702407493218625e-14 5.511521609173136715e-01 -1.692606920780024897e-10 -7.512652740407383361e-14 5.511521609198594129e-01 -1.668859868406682589e-10 -7.465371417297480828e-14 5.511521609210348061e-01 -1.657876541768426392e-10 1.685710831026280571e-11 -1.934267196095108421e-08 5.511521431399407644e-01 1.603815676582165254e-11 -1.844462767040880423e-08 5.511521438370858839e-01 1.542021691792142629e-11 -1.786285891502244586e-08 5.511521441839717372e-01 1.481518534910445233e-11 -1.742340218289289816e-08 5.511521443933646847e-01 1.407915375106537065e-11 -1.699059859405107007e-08 5.511521446222237275e-01 1.313748089238150580e-11 -1.648725236084111931e-08 5.511521449556712193e-01 1.197668296051709733e-11 -1.588366693656065501e-08 5.511521454232949369e-01 1.062495198250415445e-11 -1.517753423601151218e-08 5.511521460236483705e-01 9.136087735939556900e-12 -1.438012275311532661e-08 5.511521467408457831e-01 7.577274000213827370e-12 -1.350840699241152112e-08 5.511521475536379500e-01 6.019561661049463671e-12 -1.258119216644426902e-08 5.511521484396403325e-01 4.529897558348316408e-12 -1.161650602365409030e-08 5.511521493779193426e-01 3.165646967205888878e-12 -1.063105628167230057e-08 5.511521503493875818e-01 1.970840051217073628e-12 -9.640204128084713602e-09 5.511521513366484104e-01 9.740860311300255639e-13 -8.657940522721284656e-09 5.511521523238442910e-01 1.881439668883626948e-13 -7.696509053497173256e-09 5.511521532968822745e-01 -3.888583963164798194e-13 -6.766113691078879279e-09 5.511521542436504939e-01 -7.710054264008373829e-13 -5.874799889879429891e-09 5.511521551541210817e-01 -9.814852283150440017e-13 -5.028426627142446109e-09 5.511521560203321846e-01 -1.049391163468972314e-12 -4.231115490226015247e-09 5.511521568358368484e-01 -1.008243548078872404e-12 -3.490616973776464584e-09 5.511521575907282200e-01 -8.936976243800850408e-13 -2.817145039940886538e-09 5.511521582742288095e-01 -7.401157450435895589e-13 -2.221348414685849684e-09 5.511521588759440426e-01 -5.709229460472436724e-13 -1.693554839309210160e-09 5.511521594056358886e-01 -4.067458614197352831e-13 -1.233220298243455396e-09 5.511521598644624209e-01 -2.657755113375785837e-13 -8.512984840386142132e-10 5.511521602437559064e-01 -1.564826598800243097e-13 -5.489102213024452650e-10 5.511521605444136274e-01 -7.730192614386982948e-14 -3.099361531387873750e-10 5.511521607824628743e-01 -2.655600615384577944e-14 -1.286836669996377391e-10 5.511521609626086615e-01 -1.165347377984996390e-14 -7.366644678268270889e-11 5.511521610167071650e-01 -3.448321636627680464e-15 -3.226997733458114363e-11 5.511521610571775698e-01 1.287642411075479133e-16 2.459591165551820557e-12 5.511521610916626512e-01 2.973561146243910029e-17 4.696578060058418760e-12 5.511521610940653959e-01 6.832732329645033568e-16 -2.075798713614003394e-11 5.511521610687242223e-01 3.011476514933773169e-15 -4.844406965360940077e-11 5.511521610411019845e-01 2.052467879022802596e-13 -2.509364734022321120e-09 5.511521585532203060e-01 4.160367854027873717e-14 -4.668122875828121212e-10 5.511521606213025670e-01 3.779760686503868085e-14 -4.464899601955411577e-10 5.511521606425863196e-01 3.395891488868462112e-14 -4.844636845337691356e-10 5.511521606050507893e-01 2.515678417914779215e-14 -5.240920998188742714e-10 5.511521605657458966e-01 1.105979810311886012e-14 -5.524620298479828344e-10 5.511521605376410449e-01 -7.173407070718241760e-15 -5.655303020775093994e-10 5.511521605247715616e-01 -2.770066393299722025e-14 -5.657271719152777481e-10 5.511521605246859634e-01 -4.928742847476661447e-14 -5.619299171472131937e-10 5.511521605285305547e-01 -7.152475706751673963e-14 -5.600890655977344089e-10 5.511521605303600913e-01 -9.522234104127251949e-14 -5.678384890048607467e-10 5.511521605223473896e-01 -1.242139605007993229e-13 -6.012596034386217838e-10 5.511521604875605496e-01 -1.715091723795854443e-13 -7.033741311366347891e-10 5.511521603797437940e-01 -3.088111574784731553e-13 -1.101945444860965601e-09 5.511521599526352233e-01 -2.438981788062160099e-12 -7.664911142678275440e-09 5.511521527895137940e-01 -7.099057232423970088e-13 -2.020319631022494617e-09 5.511521588286892870e-01 -1.570302911872788532e-13 -4.284676632627916839e-10 5.511521606310016974e-01 -1.079574570920006682e-13 -2.859552896878218516e-10 5.511521607972305059e-01 -9.546844457290758040e-14 -2.449490509889375123e-10 5.511521608451317444e-01 -9.022999584327202942e-14 -2.245382612247591430e-10 5.511521608680559625e-01 -8.699772883429120328e-14 -2.107624340942649344e-10 5.511521608826698282e-01 -8.441882646849042296e-14 -2.000355433628559918e-10 5.511521608934868421e-01 -8.209669183768376646e-14 -1.911952813721230759e-10 5.511521609020851864e-01 -7.993864699931289145e-14 -1.838130589050837112e-10 5.511521609091093454e-01 -7.797154060263277748e-14 -1.777262501278581958e-10 5.511521609148362089e-01 -7.626721588367134837e-14 -1.728785311564917800e-10 5.511521609193771321e-01 -7.491126157325592999e-14 -1.692606920780024897e-10 5.511521609227634233e-01 -7.398016895919274784e-14 -1.668859868406682589e-10 5.511521609249890874e-01 -7.354053030042744017e-14 -1.657876541768426392e-10 5.511521609260200405e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 deleted file mode 100644 index 2ebdccfd3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_8 +++ /dev/null @@ -1 +0,0 @@ -1.713477698953392095e-02 6.712673775002379873e-05 6.670490604346691400e-05 1.711912395300437331e-02 6.688355408266165932e-05 6.637433806170960592e-05 1.708758341762308883e-02 6.642990430482690006e-05 6.577452029893566046e-05 1.703968153973756117e-02 6.577055411447303094e-05 6.490808583398467756e-05 1.697469499491697370e-02 6.491118025660798233e-05 6.377949690114623378e-05 1.689163571938829406e-02 6.383726197460965434e-05 6.239853631829441643e-05 1.678923022575696741e-02 6.253455902170674098e-05 6.077595685576170495e-05 1.666589322524608674e-02 6.099385803475986456e-05 5.892224676253725242e-05 1.651969519008901141e-02 5.920486162104448197e-05 5.684839723245865259e-05 1.634832341028488040e-02 5.715647104692072065e-05 5.456559118459836951e-05 1.614903603370955454e-02 5.483741459042181828e-05 5.208514255383608601e-05 1.591860851707095278e-02 5.223662564930893742e-05 4.941784445633009643e-05 1.565327187588112443e-02 4.934374940778831246e-05 4.657347223407157217e-05 1.534864212308078776e-02 4.614997527894333358e-05 4.356063309442787798e-05 1.499964035192833008e-02 4.265007633163073371e-05 4.038763538110884936e-05 1.460040308791880383e-02 3.884484642047150911e-05 3.706341710206697692e-05 1.414418286325435335e-02 3.474270604981524599e-05 3.359790234541154297e-05 1.362323953760866992e-02 3.036295628236232607e-05 3.000406484756791407e-05 1.302872381339576641e-02 2.574125053017993123e-05 2.630179633012437443e-05 1.235055585912742462e-02 2.107281144166487551e-05 2.256006769803412329e-05 1.157730409140364167e-02 1.700339166031601226e-05 1.899385380357505721e-05 1.069607185959152960e-02 1.364408579865978942e-05 1.569715438592646288e-05 9.692405280355864683e-03 1.100554406198933742e-05 1.273639969009743005e-05 8.550240564918900471e-03 9.058541622376074334e-06 1.016265439579070438e-05 7.251917752842354514e-03 7.729031186334246267e-06 8.005805536277200253e-06 5.778298234705885224e-03 6.611123099766791975e-06 6.212737409105982776e-06 4.109036756284921779e-03 5.361067258463725797e-06 4.714317083530700172e-06 2.223073242483456814e-03 4.113517224350351772e-06 3.527307610817089443e-06 9.942739863833427883e-05 3.027279106202265565e-06 2.673317782284505463e-06 -2.136193067527132096e-03 2.278755307034543566e-06 2.177552124685150647e-06 -4.220097605988774696e-03 2.068376837541075022e-06 2.067826891116833114e-06 -6.065891327715239832e-03 2.423463170805375637e-06 2.344498366600760618e-06 -7.586534911913248719e-03 3.227461795458096616e-06 2.978654104380614167e-06 -8.750576523709887450e-03 4.351809093334847630e-06 3.929788465709140248e-06 -9.725386246142055449e-03 5.663792833340972724e-06 5.149443799269060382e-06 -1.050152072281932206e-02 7.033938479332243632e-06 6.585301830109927454e-06 -1.091022146711084426e-02 8.451557749966484548e-06 8.191676068466382130e-06 -1.084346563277923184e-02 9.979659877982389202e-06 9.927826182256886830e-06 -1.042176568050747452e-02 1.160475362091818895e-05 1.174986674393535572e-05 -9.855496697486391608e-03 1.331208585255742637e-05 1.361714000086276391e-05 -9.154233241011175762e-03 1.508653710834979309e-05 1.549352282542389010e-05 -8.195205069123065456e-03 1.691271412306968579e-05 1.734757123619640152e-05 -6.934572091581161016e-03 1.877255292718740654e-05 1.915609070720879079e-05 -5.435054286739417727e-03 2.062211028415544825e-05 2.093283443240262197e-05 -4.006612047362821671e-03 2.243522930129911044e-05 2.266975795112929855e-05 -2.746369879701437804e-03 2.419485339242510182e-05 2.435138881109051953e-05 -1.642343815866283271e-03 2.588628403371263234e-05 2.596430962650196246e-05 -6.807533561223263769e-04 2.749721927410573699e-05 2.749725087931558366e-05 1.664203690111292931e-04 2.901819270660126196e-05 2.894153014447893094e-05 9.168864875246272254e-04 3.044221715198048019e-05 3.029077538026310516e-05 1.579114389357641566e-03 3.176438780200338297e-05 3.154060036849625680e-05 2.161211874356697409e-03 3.298171413052055500e-05 3.268846531129919209e-05 2.670772713174267548e-03 3.409304208684569372e-05 3.373360847525251448e-05 3.113434949287211765e-03 3.509873827412183768e-05 3.467675280672836351e-05 3.482645690879011911e-03 3.599998782147271028e-05 3.551976639023328160e-05 3.784680935669635423e-03 3.679196163338822856e-05 3.626638769743280706e-05 4.029752677833396343e-03 3.747691175163199608e-05 3.692057954599483851e-05 4.226590240376074635e-03 3.806125601469392838e-05 3.748585619969360027e-05 4.382546946290049109e-03 3.855107879369893911e-05 3.796552339344244403e-05 4.503705523839223943e-03 3.895194576073235707e-05 3.836258122082171869e-05 4.594975519269350016e-03 3.926876321072726012e-05 3.867965678932559678e-05 4.660178383866506353e-03 3.950565687616044844e-05 3.891894200226360330e-05 4.702117553571557966e-03 3.966586889339530404e-05 3.908213398990547071e-05 4.722631938629855836e-03 3.975174199178632402e-05 3.917045485025554300e-05 1.659017468630103125e-11 5.511521402053181085e-01 -1.935160320882036856e-08 1.559170998527053015e-11 5.511521413354139032e-01 -1.845348709861994639e-08 1.468780214748485002e-11 5.511521421872837001e-01 -1.787156165087343942e-08 1.375640791083813917e-11 5.511521428855480353e-01 -1.743183928294362866e-08 1.270031277402381138e-11 5.511521435420060344e-01 -1.699863149610558955e-08 1.147532318584934073e-11 5.511521442275051363e-01 -1.649471473608626031e-08 1.008680321497333630e-11 5.511521449743105316e-01 -1.589037525966716719e-08 8.573780020719129758e-12 5.511521457904885457e-01 -1.518330707655132023e-08 6.994732834770471642e-12 5.511521466707094419e-01 -1.438480734731076972e-08 5.416206422366364323e-12 5.511521476030548650e-01 -1.351191027174761311e-08 3.903933107049085838e-12 5.511521485727168823e-01 -1.258351225889758274e-08 2.515872784574653000e-12 5.511521495647572211e-01 -1.161775955796313093e-08 1.297826091793800550e-12 5.511521505648868668e-01 -1.063149674514378448e-08 2.808915208646122081e-13 5.511521515597306298e-01 -9.640227066485009197e-09 -5.194131120001689301e-13 5.511521525370688401e-01 -8.658072459741522047e-09 -1.102407123038785162e-12 5.511521534863973448e-01 -7.697378519813512721e-09 -1.480144341405881292e-12 5.511521543993270766e-01 -6.768404532479990080e-09 -1.674418082786696955e-12 5.511521552697495885e-01 -5.879188854068157681e-09 -1.713473071332322489e-12 5.511521560939344200e-01 -5.035508879072788943e-09 -1.628926056990774118e-12 5.511521568702071328e-01 -4.241322961291501020e-09 -1.455487723419839249e-12 5.511521575932145645e-01 -3.504138191036157724e-09 -1.229499513773631641e-12 5.511521582536325070e-01 -2.833867572158170867e-09 -9.852120836687679869e-13 5.511521588408871963e-01 -2.240830050665222392e-09 -7.429841832855307579e-13 5.511521593648787132e-01 -1.715031458081818526e-09 -5.214743397658997073e-13 5.511521598258385390e-01 -1.255656434667987616e-09 -3.382431314221100330e-13 5.511521602106526085e-01 -8.734814911817993375e-10 -1.997890364428741830e-13 5.511521605161356918e-01 -5.695709704157088273e-10 -1.008288804299350728e-13 5.511521607584647375e-01 -3.278840603390017767e-10 -3.692107454942065996e-14 5.511521609445070302e-01 -1.427152896041513295e-10 -1.675976327913841342e-14 5.511521610061183019e-01 -8.200918286973899295e-11 -5.296467658449921734e-15 5.511521610529886983e-01 -3.619232072030148591e-11 1.154722451806042521e-16 5.511521610907639257e-01 1.223296483280825981e-12 1.587342513670089686e-16 5.511521610939605909e-01 4.549788750706598670e-12 2.384025213466439690e-16 5.511521610685204964e-01 -2.077105414537354572e-11 2.311280662034517475e-15 5.511521610405907268e-01 -4.863229818108253414e-11 1.823682413018444021e-13 5.511521586062358979e-01 -2.509655227198275826e-09 4.101395123826436280e-14 5.511521606237905768e-01 -4.668666714032849381e-10 4.057266825536399084e-14 5.511521606435340059e-01 -4.461679569773115205e-10 4.005199738490519439e-14 5.511521606051706934e-01 -4.840841330481253406e-10 3.446754679459731603e-14 5.511521605651396039e-01 -5.237870176364415893e-10 2.352384121665701243e-14 5.511521605363755016e-01 -5.522914281458247401e-10 8.112118310231518127e-15 5.511521605229702248e-01 -5.655036047575591453e-10 -1.005126219709777004e-14 5.511521605226799014e-01 -5.656761358222706785e-10 -2.952055948801385837e-14 5.511521605268293600e-01 -5.614701909029006683e-10 -4.968909387755774331e-14 5.511521605294102955e-01 -5.589064285028748551e-10 -7.098025024522084237e-14 5.511521605228754117e-01 -5.657299300762512336e-10 -9.623475983860923062e-14 5.511521604918324657e-01 -5.981629218416102146e-10 -1.353571061709359288e-13 5.511521603962505900e-01 -6.993123764450517217e-10 -2.428659036070826300e-13 5.511521600255566700e-01 -1.096990852780888798e-09 -1.853406337801639187e-12 5.511521540141353093e-01 -7.659247849084998999e-09 -5.242155258709628255e-13 5.511521592852222096e-01 -2.014157947663624812e-09 -1.204958479626876181e-13 5.511521606907894277e-01 -4.220132240560907281e-10 -8.590602510272594618e-14 5.511521608129116290e-01 -2.793886168842412695e-10 -7.716154169948040534e-14 5.511521608479372780e-01 -2.386119670614415495e-10 -7.323146648713172718e-14 5.511521608660052696e-01 -2.186174224072553064e-10 -7.048615283729345257e-14 5.511521608788687576e-01 -2.052828980019744479e-10 -6.808059998929272578e-14 5.511521608893266144e-01 -1.949944534203251546e-10 -6.581122296416141796e-14 5.511521608981893028e-01 -1.865688648450702272e-10 -6.367853626730804039e-14 5.511521609057032922e-01 -1.795616943757476789e-10 -6.174047668696540826e-14 5.511521609119387488e-01 -1.737987841189906866e-10 -6.007772443307350536e-14 5.511521609169115488e-01 -1.692160301143297319e-10 -5.876696219799887713e-14 5.511521609206172512e-01 -1.657994888612208013e-10 -5.787105953067175665e-14 5.511521609230425334e-01 -1.635598896112065293e-10 -5.744627176694154665e-14 5.511521609241575304e-01 -1.625293259229893996e-10 1.538440467207404895e-11 -1.935160320882036856e-08 5.511521431304704510e-01 1.457495104972140615e-11 -1.845348709861994639e-08 5.511521438276864027e-01 1.389421238997405903e-11 -1.787156165087343942e-08 5.511521441747276873e-01 1.317796477385941533e-11 -1.743183928294362866e-08 5.511521443843865331e-01 1.230644289504629872e-11 -1.699863149610558955e-08 5.511521446136538049e-01 1.122764147354828434e-11 -1.649471473608626031e-08 5.511521449476823875e-01 9.947628778482634541e-12 -1.589037525966716719e-08 5.511521454160800415e-01 8.509993568922793114e-12 -1.518330707655132023e-08 5.511521460174007014e-01 6.978971743255363861e-12 -1.438480734731076972e-08 5.511521467357319848e-01 5.426918648450093845e-12 -1.351191027174761311e-08 5.511521475497654921e-01 3.925053067723695523e-12 -1.258351225889758274e-08 5.511521484370245361e-01 2.536355198245511111e-12 -1.161775955796313093e-08 5.511521493764539592e-01 1.311088341005534557e-12 -1.063149674514378448e-08 5.511521503488242546e-01 2.841652421099741529e-13 -9.640227066485009197e-09 5.511521513365893465e-01 -5.258489310286736654e-13 -8.658072459741522047e-09 5.511521523237516984e-01 -1.116117804825003115e-12 -7.697378519813512721e-09 5.511521532961064507e-01 -1.497502806237437836e-12 -6.768404532479990080e-09 5.511521542414766772e-01 -1.691580261605742732e-12 -5.879188854068157681e-09 5.511521551498339555e-01 -1.727248585981737581e-12 -5.035508879072788943e-09 5.511521560132934816e-01 -1.637520836535352060e-12 -4.241322961291501020e-09 5.511521568255713932e-01 -1.458858188853701943e-12 -3.504138191036157724e-09 5.511521575770088610e-01 -1.228737891821798441e-12 -2.833867572158170867e-09 5.511521582571458078e-01 -9.819069675751142093e-13 -2.240830050665222392e-09 5.511521588559465945e-01 -7.389553782908963340e-13 -1.715031458081818526e-09 5.511521593835343458e-01 -5.182580188763215688e-13 -1.255656434667987616e-09 5.511521598413805512e-01 -3.362406351383427082e-13 -8.734814911817993375e-10 5.511521602210268655e-01 -1.985146312986772384e-13 -5.695709704157088273e-10 5.511521605234268595e-01 -9.990888473137864253e-14 -3.278840603390017767e-10 5.511521607644757070e-01 -3.637249279351709039e-14 -1.427152896041513295e-10 5.511521609487820550e-01 -1.650766897542000973e-14 -8.200918286973899295e-11 5.511521610086057565e-01 -5.267025344193551408e-15 -3.619232072030148591e-11 5.511521610533907101e-01 1.015505578064483685e-16 1.223296483280825981e-12 5.511521610904556168e-01 1.582069029037815868e-16 4.549788750706598670e-12 5.511521610939131843e-01 2.372904626248556501e-16 -2.077105414537354572e-11 5.511521610687138972e-01 2.303322667613766795e-15 -4.863229818108253414e-11 5.511521610409223504e-01 1.843150590278145069e-13 -2.509655227198275826e-09 5.511521585529364220e-01 4.112578556170054317e-14 -4.668666714032849381e-10 5.511521606212490543e-01 4.060117553004877685e-14 -4.461679569773115205e-10 5.511521606429080622e-01 4.004115731711573412e-14 -4.840841330481253406e-10 5.511521606054401445e-01 3.443735978513502537e-14 -5.237870176364415893e-10 5.511521605660651968e-01 2.349279037011701372e-14 -5.522914281458247401e-10 5.511521605378184585e-01 8.099205486725988359e-15 -5.655036047575591453e-10 5.511521605247978739e-01 -1.003279347096412020e-14 -5.656761358222706785e-10 5.511521605247408084e-01 -2.946366435168920325e-14 -5.614701909029006683e-10 5.511521605289999570e-01 -4.959449195664726446e-14 -5.589064285028748551e-10 5.511521605315456984e-01 -7.088209480391129695e-14 -5.657299300762512336e-10 5.511521605244408262e-01 -9.633251748482270366e-14 -5.981629218416102146e-10 5.511521604906201022e-01 -1.365718259719362211e-13 -6.993123764450517217e-10 5.511521603837548078e-01 -2.505098252290237740e-13 -1.096990852780888798e-09 5.511521599575486263e-01 -2.006736345190037132e-12 -7.659247849084998999e-09 5.511521527951769306e-01 -5.860407804712711905e-13 -2.014157947663624812e-09 5.511521588349215239e-01 -1.283122760379521660e-13 -4.220132240560907281e-10 5.511521606376175164e-01 -8.728253851640750099e-14 -2.793886168842412695e-10 5.511521608040543807e-01 -7.654935684941968875e-14 -2.386119670614415495e-10 5.511521608517951920e-01 -7.185775433738838426e-14 -2.186174224072553064e-10 5.511521608743319423e-01 -6.885683919931450890e-14 -2.052828980019744479e-10 5.511521608885021628e-01 -6.644113150479566240e-14 -1.949944534203251546e-10 5.511521608988569909e-01 -6.427786546958953929e-14 -1.865688648450702272e-10 5.511521609070055838e-01 -6.229164268042224227e-14 -1.795616943757476789e-10 5.511521609136162958e-01 -6.050251742403082573e-14 -1.737987841189906866e-10 5.511521609189830029e-01 -5.896778866982194059e-14 -1.692160301143297319e-10 5.511521609232282737e-01 -5.775297854725520129e-14 -1.657994888612208013e-10 5.511521609263897448e-01 -5.692101139909804771e-14 -1.635598896112065293e-10 5.511521609284645296e-01 -5.652473085922103339e-14 -1.625293259229893996e-10 5.511521609294198765e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 b/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 deleted file mode 100644 index 5677de76e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton.hess_9 +++ /dev/null @@ -1 +0,0 @@ -1.716607023163032805e-02 6.712673397489208867e-05 6.670490254301343332e-05 1.715083445336837084e-02 6.688355061390774295e-05 6.637433481944311103e-05 1.712013603553473248e-02 6.642990118229077554e-05 6.577451734536573602e-05 1.707351647352834539e-02 6.577055138581163146e-05 6.490808322028881030e-05 1.701027584362403353e-02 6.491117796747237221e-05 6.377949468320146605e-05 1.692945802486673854e-02 6.383726015455691951e-05 6.239853453769728944e-05 1.682983067395428869e-02 6.253455767541427871e-05 6.077595552818937553e-05 1.670985969261164217e-02 6.099385714070865372e-05 5.892224587526038749e-05 1.656767783521957693e-02 5.920486113542650032e-05 5.684839674802864482e-05 1.640104702553544375e-02 5.715647091014936198e-05 5.456559104762753797e-05 1.620731388598812411e-02 5.483741473432429312e-05 5.208514269856573257e-05 1.598335791943642295e-02 5.223662600368422575e-05 4.941784481361551214e-05 1.572553174210152005e-02 4.934374990566331486e-05 4.657347273704517759e-05 1.542959275941762319e-02 4.614997586033649609e-05 4.356063368259237094e-05 1.509062572920793002e-02 4.265007694587135957e-05 4.038763600296335274e-05 1.470295580321366417e-02 3.884484702722622719e-05 3.706341771637263458e-05 1.426005192981773945e-02 3.474270661908836314e-05 3.359790292136810244e-05 1.375442101368445566e-02 3.036295679371342954e-05 3.000406536417264114e-05 1.317749406748939915e-02 2.574125097149987189e-05 2.630179677500625127e-05 1.251950692359237241e-02 2.107281180773930838e-05 2.256006806604372489e-05 1.176938004117055771e-02 1.700339195182300415e-05 1.899385409573693431e-05 1.091460446824520786e-02 1.364408602116247824e-05 1.569715460823453910e-05 9.941145957291811983e-03 1.100554422457359317e-05 1.273639985203943831e-05 8.833384146485554270e-03 9.058541734822681332e-06 1.016265450749848858e-05 7.574111633134894897e-03 7.729031258892936755e-06 8.005805608249340753e-06 6.144627621422465297e-03 6.611123142990455522e-06 6.212737451953759359e-06 4.524973420861299646e-03 5.361067281765332820e-06 4.714317106600638602e-06 2.694371160588617583e-03 4.113517234822132855e-06 3.527307621151601637e-06 6.319425834628735307e-04 3.027279109209723806e-06 2.673317785237651105e-06 -1.607561093244242161e-03 2.278755308316708774e-06 2.177552125957519494e-06 -3.733193042597741408e-03 2.068376837951883884e-06 2.067826891533787199e-06 -5.641732705292781640e-03 2.423463170741331052e-06 2.344498366541275188e-06 -7.247411685131509296e-03 3.227461795412457211e-06 2.978654104334419108e-06 -8.481923754476285854e-03 4.351809093510096206e-06 3.929788465883568896e-06 -9.498323821922328297e-03 5.663792833758554885e-06 5.149443799684922219e-06 -1.032806636650972047e-02 7.033938501765433513e-06 6.585301852781868818e-06 -1.085107440428375626e-02 8.451557754889423097e-06 8.191676073402554722e-06 -1.090854720905152023e-02 9.979659883752890940e-06 9.927826188031767729e-06 -1.054751942381316164e-02 1.160475362824309610e-05 1.174986675125713562e-05 -1.001922482459517705e-02 1.331208586126104396e-05 1.361714000955761810e-05 -9.358107639122242166e-03 1.508653711798835548e-05 1.549352283504993843e-05 -8.488999973257095252e-03 1.691271413319223434e-05 1.734757124630102347e-05 -7.311905785616917494e-03 1.877255293722268360e-05 1.915609071722573805e-05 -5.867683581756972730e-03 2.062211029364484306e-05 2.093283444187435106e-05 -4.397448032838530488e-03 2.243522930987327260e-05 2.266975795968800405e-05 -3.097264451503864858e-03 2.419485339978975176e-05 2.435138881844519480e-05 -1.956047709060777361e-03 2.588628403962520692e-05 2.596430963241944982e-05 -9.608777353898350282e-04 2.749721927820988267e-05 2.749725088344669209e-05 -8.951084652988265233e-05 2.901819270758866520e-05 2.894153014546753020e-05 6.827441232111798597e-04 3.044221711406219650e-05 3.029077533912306051e-05 1.364634091503801700e-03 3.176438778184120023e-05 3.154060034581713937e-05 1.964323992513952125e-03 3.298171412482555270e-05 3.268846530516644316e-05 2.489500633497109764e-03 3.409304208187725595e-05 3.373360847022587538e-05 2.947256930101382292e-03 3.509873826868886671e-05 3.467675280142968453e-05 3.335829505946318052e-03 3.599998781527757229e-05 3.551976638428204844e-05 3.654367023575753708e-03 3.679196162638149071e-05 3.626638769073307461e-05 3.913282701222680314e-03 3.747691174384116999e-05 3.692057953853672018e-05 4.121598039554516535e-03 3.806125600617186891e-05 3.748585619151073345e-05 4.286922910778201423e-03 3.855107878452454230e-05 3.796552338459771244e-05 4.415559073245258273e-03 3.895194575099881009e-05 3.836258121140140450e-05 4.512597141253055395e-03 3.926876320054060473e-05 3.867965677943381727e-05 4.582002043733972123e-03 3.950565686562965373e-05 3.891894199201090645e-05 4.626683838219528000e-03 3.966586888262648629e-05 3.908213397940691068e-05 4.648551984442779797e-03 3.975174198089392755e-05 3.917045483962859989e-05 1.281504297699230771e-11 5.511521402023373817e-01 -1.935478351223872520e-08 1.212295607321613051e-11 5.511521413324182994e-01 -1.845668433781024189e-08 1.156526602378864426e-11 5.511521421842662249e-01 -1.787478467958008584e-08 1.102774650505019870e-11 5.511521428825165714e-01 -1.743508103638494177e-08 1.041117716708914639e-11 5.511521435389894474e-01 -1.700186300902267600e-08 9.655270450984303501e-12 5.511521442245557179e-01 -1.649788201311955965e-08 8.740510753339279172e-12 5.511521449715029997e-01 -1.589340026354385315e-08 7.679728809667810479e-12 5.511521457879139385e-01 -1.518609376055870615e-08 6.509114851048885910e-12 5.511521466684640158e-01 -1.438725295516263648e-08 5.279435064490895241e-12 5.511521476012247733e-01 -1.351392118900651072e-08 4.047835582862455238e-12 5.511521485713601898e-01 -1.258502271627824327e-08 2.870248073271488084e-12 5.511521495638856960e-01 -1.161875069017721165e-08 1.795701091023848716e-12 5.511521505644508823e-01 -1.063201306311381425e-08 8.622846862604221085e-13 5.511521515596093934e-01 -9.640387379593077134e-09 9.482751164997244964e-14 5.511521525370688401e-01 -8.658072684199765554e-09 -4.956524032854954422e-13 5.511521534862600102e-01 -7.697484564560490551e-09 -9.108712245567344232e-13 5.511521543987469851e-01 -6.768934467649125785e-09 -1.163066979785959468e-12 5.511521552684022218e-01 -5.880484708023413087e-09 -1.272153131559511332e-12 5.511521560915116913e-01 -5.037899532135495708e-09 -1.262851624715231911e-12 5.511521568664594639e-01 -4.245080569887221205e-09 -1.163980731831825910e-12 5.511521575879935186e-01 -3.509432459178988652e-09 -1.006996825732622959e-12 5.511521582469238734e-01 -2.840727852352582425e-09 -8.226278273064875758e-13 5.511521588328291976e-01 -2.249120312285812417e-09 -6.305375767223204645e-13 5.511521593557635601e-01 -1.724443623864292817e-09 -4.489156487456416730e-13 5.511521598160934454e-01 -1.265726697132438938e-09 -2.950194675159263818e-13 5.511521602008004894e-01 -8.836317193807144718e-10 -1.764874297373167745e-13 5.511521605067479790e-01 -5.791686009639116499e-10 -9.035709964130471695e-14 5.511521607501110864e-01 -3.363147263218885991e-10 -3.391361609626004807e-14 5.511521609376965891e-01 -1.494674786456979681e-10 -1.547759826220212810e-14 5.511521610018099704e-01 -8.620088477203978682e-11 -4.885658973517567835e-15 5.511521610509294566e-01 -3.817034486824466341e-11 5.142774404369569226e-17 5.511521610901354284e-01 6.193303132278570683e-13 1.130947325768317641e-16 5.511521610939075222e-01 4.496453378265000845e-12 4.136513651974087706e-16 5.511521610684909644e-01 -2.079741003411662122e-11 2.728863045298038135e-15 5.511521610404068738e-01 -4.880900835368724331e-11 2.048014313407751851e-13 5.511521586059382471e-01 -2.509947009572090081e-09 4.593688996750234102e-14 5.511521606236448045e-01 -4.670101214811094248e-10 4.634316965878483403e-14 5.511521606437111975e-01 -4.459921564008768569e-10 4.737690530610808787e-14 5.511521606054677891e-01 -4.837827331656330462e-10 4.317116425292660219e-14 5.511521605654073896e-01 -5.235090060151520279e-10 3.316240339351514410e-14 5.511521605365513610e-01 -5.521078636227861260e-10 1.823466755749745295e-14 5.511521605230450538e-01 -5.654273523000821551e-10 -1.598372586441093769e-17 5.511521605226799014e-01 -5.656761585843985763e-10 -2.003116592465766434e-14 5.511521605269618096e-01 -5.613327771396840342e-10 -4.111493167432380796e-14 5.511521605299342097e-01 -5.583777055282256501e-10 -6.361560046377966419e-14 5.511521605239915189e-01 -5.646178396797403317e-10 -9.032218656456708609e-14 5.511521604936521213e-01 -5.963621354256216426e-10 -1.312529597499976788e-13 5.511521603987905582e-01 -6.968052865545069617e-10 -2.418784992687487789e-13 5.511521600288195044e-01 -1.093764192525222358e-09 -1.891324620996800766e-12 5.511521540180173151e-01 -7.655385224996448601e-09 -5.443777089457081449e-13 5.511521592895811672e-01 -2.009779475734690550e-09 -1.261908500633661561e-13 5.511521606954750130e-01 -4.172508361540185208e-10 -9.087446539658035041e-14 5.511521608177878395e-01 -2.743683395656152550e-10 -8.259451519680031645e-14 5.511521608528597849e-01 -2.334812712347328372e-10 -7.942660150838539443e-14 5.511521608707140585e-01 -2.136624796213153962e-10 -7.749288918899735012e-14 5.511521608833401809e-01 -2.005497895737852017e-10 -7.587142767387911264e-14 5.511521608935591177e-01 -1.905026336568400354e-10 -7.433328561915655837e-14 5.511521609021924339e-01 -1.823205030485850573e-10 -7.285293248569393713e-14 5.511521609094947038e-01 -1.755449746796282230e-10 -7.147402400542534850e-14 5.511521609155430879e-01 -1.699905106060844336e-10 -7.026437958962186165e-14 5.511521609203593464e-01 -1.655840492869361490e-10 -6.929775915815507357e-14 5.511521609239435904e-01 -1.623049739376445792e-10 -6.863988049284224624e-14 5.511521609262860499e-01 -1.601593937228434601e-10 -6.833866895419431386e-14 5.511521609273590805e-01 -1.591765368266342892e-10 1.188395119716847024e-11 -1.935478351223872520e-08 5.511521431270772764e-01 1.133268455172245169e-11 -1.845668433781024189e-08 5.511521438242739102e-01 1.094064246842367980e-11 -1.787478467958008584e-08 5.511521441712851077e-01 1.056426890421861703e-11 -1.743508103638494177e-08 5.511521443809198617e-01 1.008849813178730996e-11 -1.700186300902267600e-08 5.511521446101921295e-01 9.447044353019076949e-12 -1.649788201311955965e-08 5.511521449442812193e-01 8.620056447858793201e-12 -1.589340026354385315e-08 5.511521454128207598e-01 7.622716705985257345e-12 -1.518609376055870615e-08 5.511521460143844475e-01 6.494541736261246248e-12 -1.438725295516263648e-08 5.511521467330683377e-01 5.289947815465035814e-12 -1.351392118900651072e-08 5.511521475475559262e-01 4.069782714276322304e-12 -1.258502271627824327e-08 5.511521484353429923e-01 2.893640615962603618e-12 -1.161875069017721165e-08 5.511521493753268608e-01 1.814061949493092534e-12 -1.063201306311381425e-08 5.511521503482128548e-01 8.723297356094363309e-13 -9.640387379593077134e-09 5.511521513363772939e-01 9.600557434034686942e-14 -8.658072684199765554e-09 5.511521523237412623e-01 -5.018121446543699175e-13 -7.697484564560490551e-09 5.511521532960246272e-01 -9.215462433869075946e-13 -6.768934467649125785e-09 5.511521542409925090e-01 -1.174975535568901580e-12 -5.880484708023413087e-09 5.511521551485877302e-01 -1.282366709024147523e-12 -5.037899532135495708e-09 5.511521560109344797e-01 -1.269511235786867569e-12 -4.245080569887221205e-09 5.511521568218038514e-01 -1.166696313278829481e-12 -3.509432459178988652e-09 5.511521575716402666e-01 -1.006429815976388160e-12 -2.840727852352582425e-09 5.511521582501305305e-01 -8.199649587621143052e-13 -2.249120312285812417e-09 5.511521588474174171e-01 -6.272475937587419444e-13 -1.724443623864292817e-09 5.511521593738154534e-01 -4.462858783271978013e-13 -1.265726697132438938e-09 5.511521598309743197e-01 -2.933928583769899904e-13 -8.836317193807144718e-10 5.511521602105694528e-01 -1.754446930974700274e-13 -5.791686009639116499e-10 5.511521605136145974e-01 -8.957437265478453964e-14 -3.363147263218885991e-10 5.511521607559674019e-01 -3.341934701048448084e-14 -1.494674786456979681e-10 5.511521609420876322e-01 -1.523530032605837644e-14 -8.620088477203978682e-11 5.511521610045274633e-01 -4.850071367375814057e-15 -3.817034486824466341e-11 5.511521610514906744e-01 4.206516453480050924e-17 6.193303132278570683e-13 5.511521610898751922e-01 1.120116829775175110e-16 4.496453378265000845e-12 5.511521610938596716e-01 4.117192622065791900e-16 -2.079741003411662122e-11 5.511521610686903605e-01 2.719184912111166164e-15 -4.880900835368724331e-11 5.511521610407524863e-01 2.069870004862024100e-13 -2.509947009572090081e-09 5.511521585526503175e-01 4.606195826940893242e-14 -4.670101214811094248e-10 5.511521606211079449e-01 4.637605667182122609e-14 -4.459921564008768569e-10 5.511521606430824782e-01 4.736293679846921958e-14 -4.837827331656330462e-10 5.511521606057459000e-01 4.313221343157584333e-14 -5.235090060151520279e-10 5.511521605663538548e-01 3.311883900325864808e-14 -5.521078636227861260e-10 5.511521605380100830e-01 1.820382867038617666e-14 -5.654273523000821551e-10 5.511521605248755895e-01 -1.584732974842213889e-17 -5.656761585843985763e-10 5.511521605247408084e-01 -1.999193642381300046e-14 -5.613327771396840342e-10 5.511521605291425097e-01 -4.103578641631294540e-14 -5.583777055282256501e-10 5.511521605320792716e-01 -6.352742109268810089e-14 -5.646178396797403317e-10 5.511521605255489398e-01 -9.041503069129772483e-14 -5.963621354256216426e-10 5.511521604924022322e-01 -1.324407170537945633e-13 -6.968052865545069617e-10 5.511521603862293839e-01 -2.495212269575103295e-13 -1.093764192525222358e-09 5.511521599607395183e-01 -2.047876389463727066e-12 -7.655385224996448601e-09 5.511521527990201896e-01 -6.087198977018805135e-13 -2.009779475734690550e-09 5.511521588393196724e-01 -1.344450235041416592e-13 -4.172508361540185208e-10 5.511521606424579778e-01 -9.230918025093273733e-14 -2.743683395656152550e-10 5.511521608092229130e-01 -8.184803889791664601e-14 -2.334812712347328372e-10 5.511521608571429143e-01 -7.780898625506240098e-14 -2.136624796213153962e-10 5.511521608795458826e-01 -7.555656980816377738e-14 -2.005497895737852017e-10 5.511521608935122662e-01 -7.389924670228079816e-14 -1.905026336568400354e-10 5.511521609036239555e-01 -7.246073180064096096e-14 -1.823205030485850573e-10 5.511521609115141995e-01 -7.113637737086842949e-14 -1.755449746796282230e-10 5.511521609178717807e-01 -6.992283011562215829e-14 -1.699905106060844336e-10 5.511521609230066732e-01 -6.885956860484515045e-14 -1.655840492869361490e-10 5.511521609270543243e-01 -6.800567615651293285e-14 -1.623049739376445792e-10 5.511521609300609192e-01 -6.741957033659485020e-14 -1.601593937228434601e-10 5.511521609320295667e-01 -6.715167214005167517e-14 -1.591765368266342892e-10 5.511521609329310678e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener deleted file mode 100644 index 1b4d65d49..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0664002017488833 -1 0.06667365593451077 -2 0.06713695988020449 -3 0.067796836613134 -4 0.06866237205023622 -5 0.06974516641578213 -6 0.07105889989080325 -7 0.07261928732543141 -8 0.07444371611586816 -9 0.07655047817475837 -10 0.07895728260094416 -11 0.08168057099484198 -12 0.08473451999776835 -13 0.08812944707942322 -14 0.09186839129225591 -15 0.09594214806092592 -16 0.10032690227836429 -17 0.10498255406688793 -18 0.1098483232060156 -19 0.11483878775895508 -20 0.11984423882995195 -21 0.12473074060960117 -22 0.12934285866875134 -23 0.13355751682838457 -24 0.13728858183497364 -25 0.14045734977473875 -26 0.14299335108782182 -27 0.14482932783769725 -28 0.1459060307534103 -29 0.1461792955843088 -30 0.14563969678111466 -31 0.1443661433411809 -32 0.1424681582326872 -33 0.1400627264874011 -34 0.1372639231049528 -35 0.13412314641315637 -36 0.13065684232605987 -37 0.12688922552029253 -38 0.12285209286630051 -39 0.11859195676558423 -40 0.11420121555320153 -41 0.10977446753411108 -42 0.10539040288983371 -43 0.10111213382221786 -44 0.09698737769505618 -45 0.09305199775204236 -46 0.08933203292791317 -47 0.08584340092115128 -48 0.08259161577465039 -49 0.07957772981052592 -50 0.07680039166659965 -51 0.0742562926126846 -52 0.07194009948668192 -53 0.06984509215414765 -54 0.0679640798031597 -55 0.0662898936478203 -56 0.06481532387567544 -57 0.06353338989102478 -58 0.06243760826185266 -59 0.06152211383217668 -60 0.060781716178440644 -61 0.06021200342435023 -62 0.05980949590339288 -63 0.05957143220707113 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz deleted file mode 100644 index 00113f45d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.070571367386998 -1.974799801769878e-05 -1.9771178540014944e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.0718473443181664 -1.987211165941734e-05 -1.9899551288344118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0739995623938667 -2.0112522562216087e-05 -2.0147736841617664e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0770447593409105 -2.0460429767174882e-05 -2.0506252577627274e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.0810048397953103 -2.0905143891446237e-05 -2.0963450350487837e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.0859077436572875 -2.1433933650344404e-05 -2.150497190304288e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.091785833035111 -2.2031573294588305e-05 -2.2113688032067307e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.0986763748907187 -2.2680191692969447e-05 -2.276983306601563e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.106621011267111 -2.3359435111598943e-05 -2.3451223002361653e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.1156640700490454 -2.4046658032876445e-05 -2.413355764361509e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.125848685211275 -2.4717142592137046e-05 -2.4790791224643602e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.1372174121758856 -2.534438825188339e-05 -2.539559949129101e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.1498124818439455 -2.590043764215583e-05 -2.5919889844368953e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.1636747059543717 -2.635621451003324e-05 -2.633531419254953e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.178836528138095 -2.6681865854005902e-05 -2.6613761484890003e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.1953181349239865 -2.6847187527928186e-05 -2.6727886639345033e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.21313306610275 -2.6822150387706843e-05 -2.6651672548648967e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.232286823593361 -2.6577381459110935e-05 -2.6360896248049773e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.2527697455450624 -2.6084515518448184e-05 -2.5833467391195525e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.274550108792876 -2.5316269923377855e-05 -2.504961452942146e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.297582380985114 -2.424987358172993e-05 -2.399291661708992e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.321811977659147 -2.2879736984150653e-05 -2.2654684532970384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.347169382839471 -2.1214154941781136e-05 -2.1034587862791187e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.3735585777968575 -1.9271737447416662e-05 -1.914075185815995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.4008689506481797 -1.7078584953952025e-05 -1.6989668444125805e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.428979348433055 -1.466573474795671e-05 -1.4605756427896154e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.4577579593531436 -1.2063534635746473e-05 -1.2019731450693276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.4870566559986376 -9.301474070549956e-06 -9.26692095182171e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.5167173817721276 -6.4130892958516e-06 -6.3866549052724545e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.546578597088741 -3.4379064997519634e-06 -3.421372045307226e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.5764789558676076 -4.2100417056215174e-07 -4.154538894527361e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.606261446389075 2.5900009145006493e-06 2.586225586146799e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.6357757791378837 5.549241300117769e-06 5.539861396310451e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.664877334527358 8.41536745875219e-06 8.404134464433443e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.693427940729297 1.1152777019709476e-05 1.1141362952990739e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.7213048248084415 1.3731443865494569e-05 1.371830607663582e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.748402612827402 1.612519468338217e-05 1.610658687378885e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.774626460032595 1.8310828168681452e-05 1.8282925231022628e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.799893260729304 2.0269474890364766e-05 2.0229334965419635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.8241364359536862 2.198680660362312e-05 2.1933065929289577e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.847312464524109 2.3453186639864707e-05 2.338638388792695e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8693905855822006 2.466380085370361e-05 2.4586245082969145e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.890351061198904 2.5618784905701677e-05 2.5533831885458882e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.9101861656224197 2.6323338469876775e-05 2.6234023075608607e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9289034641492373 2.6786862045375394e-05 2.669583344288244e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.94651520436692 2.7022374445599042e-05 2.6932106037085585e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.963035595940167 2.7046102279650066e-05 2.6958953450277214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9784794363208755 2.687702922941901e-05 2.6795233183220657e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9928694519489754 2.6536409462813327e-05 2.6462027183974525e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.006231215427587 2.6047321018307744e-05 2.5982182880233604e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.018588530701608 2.543423293986042e-05 2.53798796586159e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0299641236248633 2.4722557642813533e-05 2.4680186537988778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.04038226764309 2.393820164319065e-05 2.3908618817458852e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0498679663260337 2.3107145380269723e-05 2.3090717175611894e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0584445224466896 2.2255056597126162e-05 2.2251643366422472e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.0661326662270794 2.1406922063585835e-05 2.1415775178526685e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.0729519683125197 2.0586416163775735e-05 2.0606350355962306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.0789205365216494 1.9815514859627336e-05 1.9845129574393313e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.0840545225140987 1.9114240200724986e-05 1.915205186827103e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.0883681449160285 1.8500392954712808e-05 1.854491337914434e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.09187388789215 1.7989309395176827e-05 1.8039089201843406e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.094582367651359 1.7593674998920045e-05 1.764732299149796e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.0965018628453564 1.7323432929472504e-05 1.7379618064048753e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.0976395187837706 1.71858469072733e-05 1.7243287137539115e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener deleted file mode 100644 index 92db6261f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.051333281550313324 -1 0.051499955363093194 -2 0.051787702801461534 -3 0.05220471847265196 -4 0.05276264096835856 -5 0.05347695267256018 -6 0.054367115787132526 -7 0.05545700008187273 -8 0.056775165282265054 -9 0.058354886287776145 -10 0.06023362065221712 -11 0.062452781722932574 -12 0.06505701961104628 -13 0.06809264091395671 -14 0.07160406414417671 -15 0.07562951547991927 -16 0.08019737641838721 -17 0.08532038822774221 -18 0.09098773418659739 -19 0.09715237865488138 -20 0.10371597163132877 -21 0.11052804005173529 -22 0.11738106248638033 -23 0.1240066006705141 -24 0.13008807261644603 -25 0.13538982434441077 -26 0.139767993126606 -27 0.14309758170155162 -28 0.14526382118016282 -29 0.14616792382361748 -30 0.14575465987594782 -31 0.14413181711542095 -32 0.14151405820966442 -33 0.13813067235048104 -34 0.13413572504103535 -35 0.12955438571344982 -36 0.1244162877763492 -37 0.11877684652986194 -38 0.11279846496260197 -39 0.1066866776803444 -40 0.10060940613794503 -41 0.09469791062653166 -42 0.08905000055179445 -43 0.08372749303913941 -44 0.07875826477205652 -45 0.07415552767970494 -46 0.06992240147222695 -47 0.06605444437714549 -48 0.06254032872231992 -49 0.059364435455593445 -50 0.05650899726526013 -51 0.05395415336101867 -52 0.05167714735152695 -53 0.0496564217914778 -54 0.04787270349170621 -55 0.04630900807777758 -56 0.04495029412599795 -57 0.04378339397788243 -58 0.04279697429359291 -59 0.04198142628989 -60 0.04132874264268565 -61 0.040832455591959964 -62 0.040487635357711445 -63 0.04029066344696545 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz deleted file mode 100644 index 88ab14702..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_1.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9894292479695213 -2.9615127649984973e-05 -2.954191783113394e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9905209670914408 -2.991363703930515e-05 -2.985096013362627e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9923885260334004 -3.0495186171088184e-05 -3.045215565920055e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9950580821882966 -3.134259134210931e-05 -3.1327208668018574e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9985653044640443 -3.243502723216518e-05 -3.245380656929519e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.0029562921652238 -3.374758484252058e-05 -3.38044104252575e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.008286514670109 -3.525041957796329e-05 -3.5345954170736435e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.014621418654998 -3.690844810807243e-05 -3.703991654831893e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.0220361534502835 -3.8681585509578014e-05 -3.8842533620988805e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.030614237981283 -4.05250169371004e-05 -4.0705138508916085e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0404442550591226 -4.238949357865671e-05 -4.257460799060058e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.051619871143616 -4.422172741485884e-05 -4.439399991097857e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0642391556222037 -4.596479775100013e-05 -4.610330546141413e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.0784022851896227 -4.7558486547982304e-05 -4.764028165934302e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0942038493470596 -4.893945861751164e-05 -4.89413909787358e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.1117268073162943 -5.0041346908879136e-05 -4.994308358377355e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.1310438803936 -5.079522534986968e-05 -5.058315858211956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.1522135757773806 -5.113043644925478e-05 -5.080174608256984e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.1752714995963895 -5.097517116337386e-05 -5.0542138159669847e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.2002218946193555 -5.0256539772117195e-05 -4.9751445664571496e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.2270417044167 -4.8907206030883216e-05 -4.8383015837904746e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.25568287388535 -4.68922062162063e-05 -4.640537535361332e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2860674732863666 -4.420765636123571e-05 -4.3804210305651965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.318079466812348 -4.087938542035722e-05 -4.058352575733408e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.351574877861254 -3.6957766767896144e-05 -3.676668706992015e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.3863849995647604 -3.2509451596844247e-05 -3.2396514227543664e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.422316687725039 -2.7601929795121568e-05 -2.7532421485648622e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.4591479832163907 -2.2297367709674592e-05 -2.224733413309293e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.4966355630359356 -1.6664411060878754e-05 -1.6626008107305517e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.534524359257488 -1.0786356099720716e-05 -1.076230773598527e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.5725556040309248 -4.7620520536238924e-06 -4.7559520325133514e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.6104756452696134 1.3008482615429074e-06 1.2913602531165837e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.6480414182074425 7.297677472020775e-06 7.2800317613412764e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.6850218087231927 1.3134669123022057e-05 1.3116312712618501e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.721200200920078 1.873196681530965e-05 1.8715248332229088e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.7563833665565527 2.4022216953118747e-05 2.4002576480967412e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.7904054786901327 2.8946922440345635e-05 2.891570875527773e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.823125144569492 3.345536168468603e-05 3.3404246427933656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.854427858292927 3.750690196859605e-05 3.743016693979597e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.8842304534721226 4.107151772843525e-05 4.0967407078307474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.9124858516751164 4.4130211436200646e-05 4.400107937842202e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.939171704489991 4.667482773764293e-05 4.652649256708423e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.964285377010969 4.870764713217335e-05 4.854788183672962e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.9878414737163754 5.0240970912124915e-05 5.007700843347424e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 3.0098720007814173 5.129518317075481e-05 5.113349925746853e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 3.03041617233961 5.189751737177381e-05 5.17440511116988e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.0495168911211885 5.208115745271433e-05 5.194124552508117e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.0672185458152184 5.188430684404805e-05 5.176244074561696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0835720942171547 5.1349207376748504e-05 5.124880296732515e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0986303293780226 5.052125697402656e-05 5.0444614253473356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.112443661642474 4.944819664343203e-05 4.939656975762365e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.1250602951141255 4.817928832282193e-05 4.815300336982503e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.136528058458419 4.6764496673857114e-05 4.676307571205041e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1468935319801394 4.525372980635384e-05 4.5275985078861685e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1561999355542545 4.369614169054357e-05 4.3740199068584945e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1644863256545497 4.213946235820326e-05 4.2202678681034115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1717886735210414 4.0628850106355717e-05 4.07081797611322e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1781395823084164 3.920618281434048e-05 3.9298584167733116e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.183567876040233 3.790958367112162e-05 3.801223537075171e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.188098624074944 3.6772926470580354e-05 3.6883330048689516e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.191753318999364 3.5825388214581084e-05 3.594139981700684e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.194549792708353 3.5091113513602225e-05 3.521093080302721e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1965018628453565 3.458906784295463e-05 3.47111899381832e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.197620330925452 3.433320307408093e-05 3.44563779426472e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener deleted file mode 100644 index ac4597702..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04190876747135735 -1 0.041920088735621 -2 0.041943217025232134 -3 0.04197914777236345 -4 0.04202943506348141 -5 0.04209626804577452 -6 0.042182578335365276 -7 0.04229218328173832 -8 0.04242997125007986 -9 0.04260213637113936 -10 0.042816471371944796 -11 0.043082727954943625 -12 0.04341305443480354 -13 0.043822519501103704 -14 0.04432972835209367 -15 0.044957532034339456 -16 0.045733821233028264 -17 0.04669238013137153 -18 0.047873751936101466 -19 0.04932603243803338 -20 0.05110545851090071 -21 0.05327659204811242 -22 0.05591181521247091 -23 0.0590897520367581 -24 0.06289212264850834 -25 0.06739843856334064 -26 0.07267789561525202 -27 0.07877787235149848 -28 0.0857086797050146 -29 0.09342430739487176 -30 0.10178420744905577 -31 0.11051833059526216 -32 0.1192239427806562 -33 0.1273618332715952 -34 0.13437377223014874 -35 0.13995103252868624 -36 0.14386709698492647 -37 0.145917665844633 -38 0.14594715691396856 -39 0.14404607219397567 -40 0.14060543682144333 -41 0.13604330582703347 -42 0.13052953060728245 -43 0.12409818744487276 -44 0.11684840942211118 -45 0.10910976155449764 -46 0.10125730444371918 -47 0.09358389415207309 -48 0.08630254488334099 -49 0.07953552513717896 -50 0.07334184018464693 -51 0.0677485510987431 -52 0.06275860485172198 -53 0.05835734554993165 -54 0.054517670666586734 -55 0.05119944398030612 -56 0.04835898622438526 -57 0.045957336956464756 -58 0.04396059672344129 -59 0.042339945743186995 -60 0.04107158766257789 -61 0.040136656452036026 -62 0.039521114202071 -63 0.039215659474268603 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz deleted file mode 100644 index 425c17112..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8950947685770183 -5.100020867385895e-06 -4.6895380446007e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.895372724021385 -5.164334318841226e-06 -4.749635261696173e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8959324566932887 -5.2941916938143395e-06 -4.8710632531023625e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8967816773887705 -5.4920261743083306e-06 -5.0562698953842336e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8979321202761057 -5.761410448127307e-06 -5.308864712508523e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8993997441338821 -6.1069593816697965e-06 -5.633537686769727e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9012049999607217 -6.5341916541383404e-06 -6.035945664087528e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9033731640235265 -7.049346842391893e-06 -6.522560085218425e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.905934734738546 -7.659151186536994e-06 -7.100468406574065e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.908925890766667 -8.370522444695685e-06 -7.7771199072925e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.912389006227581 -9.190203809879406e-06 -8.56000440180725e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9163732168480785 -1.0124315943369243e-05 -9.456250422630228e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.920935027966217 -1.1177815783252299e-05 -1.0472127522826008e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9261389513760756 -1.2353851367136105e-05 -1.1612435997969077e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9320581527285376 -1.3653003800556517e-05 -1.287976687106473e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9387750842407112 -1.5072411348028342e-05 -1.4273616187342426e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.946382068393259 -1.660477641524001e-05 -1.5789340911287333e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9549817866175916 -1.8237263644904494e-05 -1.741694981237018e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.96468761215247 -1.9950307157106157e-05 -1.9139733763997334e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9756237077076633 -2.17163554725401e-05 -2.0932756754057092e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9879247857774376 -2.3498678919381052e-05 -2.2761276637441373e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.001735401983213 -2.5250577307689894e-05 -2.4579264003189098e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.017208619603048 -2.6914617121176304e-05 -2.6328035771225686e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.034503846915922 -2.8422233345008568e-05 -2.7935252445059312e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0537836096087387 -2.9693858985829564e-05 -2.9314555962977662e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0752089812317864 -3.063969476203259e-05 -3.036617921042996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.0989333608796636 -3.116082200042428e-05 -3.097883207593786e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1250942675556597 -3.115079380765429e-05 -3.1033267061363705e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.153802828187216 -3.0497911161619438e-05 -3.0407936019161863e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.185130689683803 -2.9087182536814326e-05 -2.898678247857788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2190942153165003 -2.6801717660992e-05 -2.6668849710078672e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2556412599030016 -2.3536817160730632e-05 -2.3377774968214665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.294645460392858 -1.9228489734318263e-05 -1.9073588429142748e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3359055313974446 -1.3884011376581398e-05 -1.376874427115767e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3791506964542695 -7.605249040178157e-06 -7.544231450466205e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.4240501849513842 -5.687030324475929e-07 -5.50458210139891e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4702198559105333 7.0282886584673905e-06 7.0133430020352325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.517231481262297 1.4967676678340866e-05 1.4916796936986852e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5646310650703863 2.298334693969296e-05 2.2909380195130556e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.611963415155412 3.080274175034897e-05 3.074190461892755e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.6587915533966 3.8215872995412856e-05 3.819469222973272e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.7047070560947524 4.5085026742698814e-05 4.5095746583148826e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.7493386909159057 5.131150260584945e-05 5.132686248273719e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.792364344263743 5.682292504058026e-05 5.6821880751162415e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8335226250957413 6.157926931406114e-05 6.155819226155432e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.872619381560204 6.55768014300381e-05 6.554417123384368e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9095213189073243 6.884404188111294e-05 6.881335537594423e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.944145270939175 7.143448206889088e-05 7.141948480216476e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.976448311334598 7.34195476561614e-05 7.342999772782847e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.006418951592256 7.488223064487765e-05 7.49190437505325e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.034069828152482 7.590847877607198e-05 7.596175052301838e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.059431607552022 7.65801911340881e-05 7.663070401277953e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.082547770001524 7.697138458135054e-05 7.699398069629116e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1034702120711706 7.714625711331638e-05 7.711414672000215e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.12225559071452 7.715814511237144e-05 7.704778695980804e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.138962326349594 7.704929035811265e-05 7.684539072545172e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.153648023669918 7.685502319549961e-05 7.655205197369798e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1663673832898684 7.660708563216139e-05 7.620788893379254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1771706367968164 7.633456856303105e-05 7.5848050559076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1861023924167426 7.606379669733997e-05 7.550262989523555e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.193200797818841 7.581782561011782e-05 7.519660780700216e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.198496945065552 7.561586657266375e-05 7.494985538242183e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2020144590812674 7.547277815471765e-05 7.477718228176792e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.203769225372395 7.539867654034172e-05 7.46884044966086e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener deleted file mode 100644 index c220958ad..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04190112347991632 -1 0.04191227222750605 -2 0.04193504739395501 -3 0.04197042782422024 -4 0.04201994168798369 -5 0.04208574159563933 -6 0.04217071020819507 -7 0.04227860113177584 -8 0.04241422118397822 -9 0.042583661402873 -10 0.042794585339684235 -11 0.0430565840548092 -12 0.0433816075310742 -13 0.04378448147259509 -14 0.04428351599324344 -15 0.04490120753726749 -16 0.04566502615786451 -17 0.046608265191370644 -18 0.04777090708953561 -19 0.049200424935613704 -20 0.05095239095406812 -21 0.05309069838799945 -22 0.05568712003578204 -23 0.0588198271956021 -24 0.06257038445017278 -25 0.06701863650402974 -26 0.07223484669127235 -27 0.07826848798827281 -28 0.08513330769874043 -29 0.09278856389495131 -30 0.10110314169930694 -31 0.10981747812682267 -32 0.11854004522019156 -33 0.12674291669958238 -34 0.13385625058511375 -35 0.13955600534242216 -36 0.1436133990185933 -37 0.14582318486847906 -38 0.14602295759975162 -39 0.1442714719930307 -40 0.14094719229696237 -41 0.13647362444228398 -42 0.13104755756314748 -43 0.12470261152469449 -44 0.11752673115133551 -45 0.10982886031336865 -46 0.10198894378796454 -47 0.09430611772204446 -48 0.08699989561291781 -49 0.08020040509123763 -50 0.07397006082848108 -51 0.0683382518477484 -52 0.06330973269025028 -53 0.05887119799539318 -54 0.054996742193373624 -55 0.05164789751609006 -56 0.048780991888003396 -57 0.04635682480064937 -58 0.04434126467534778 -59 0.04270527891481764 -60 0.041424885527479006 -61 0.04048106531781924 -62 0.039859663134455756 -63 0.03955129837109909 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz deleted file mode 100644 index 35fd04d0b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_11.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8949055662847083 -5.152162084366482e-06 -4.745764823500667e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.895181101871981 -5.217102869499377e-06 -4.80654416575866e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8957359565332543 -5.348137026776369e-06 -4.929257274237608e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8965777639414942 -5.547543112512544e-06 -5.116193843281624e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8977181412651092 -5.818666982561284e-06 -5.3707309204839426e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8991728888574702 -6.165830951577445e-06 -5.697258477680526e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.900962255854965 -6.594204839003973e-06 -6.101074530837611e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9031112708032412 -7.109634621370661e-06 -6.588243772122229e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.905650135781485 -7.71842176104306e-06 -7.165412175463887e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.908614681511888 -8.427043928872852e-06 -7.839568288710485e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9120468795044492 -9.24180708076332e-06 -8.617739814266718e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9159954052503567 -1.0168417900767946e-05 -9.506612116314813e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9205162436521173 -1.1211465225636655e-05 -1.0512053419408285e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.925673324030494 -1.2373799626938765e-05 -1.163853011416891e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9315391668930375 -1.3655802209487783e-05 -1.288839510896344e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9381955178311414 -1.5054537472988325e-05 -1.4261033249485369e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.945733935020958 -1.6562790964908173e-05 -1.575185098563752e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.954256285350956 -1.8168000441104672e-05 -1.7351103575081953e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9638750896492423 -1.9851099962274454e-05 -1.904256398547673e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.974713639265508 -2.1585308824180117e-05 -2.0802054431603578e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9869057838397046 -2.3334965941495475e-05 -2.2595900846918413e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.00059526303582 -2.5054654693476292e-05 -2.437944644258556e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0159344232184058 -2.66884168787141e-05 -2.6095679196778026e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.033082123902936 -2.8169314118422778e-05 -2.767419699121647e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.052200599690814 -2.9419487868253338e-05 -2.903077468605057e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0734510041383465 -3.0350833074464744e-05 -3.0067854978346007e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.09698732773581 -3.086612286550992e-05 -3.067628633543527e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.12294836123037 -3.086066537764307e-05 -3.073869986332153e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1514473806590826 -3.0224561400728538e-05 -3.013490464268135e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.182559279862579 -2.8844767633421533e-05 -2.874939180821124e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2163050237971835 -2.660637852264559e-05 -2.648072280010979e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2526378992961122 -2.3404157056203663e-05 -2.3250969910847505e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2914373526433685 -1.9169964979422627e-05 -1.901687981979901e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.33250788225089 -1.3903008438010424e-05 -1.3785348080971111e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3755839173423583 -7.694387332574764e-06 -7.629733209154692e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.4203392759759668 -7.146238227153109e-07 -6.935722269968617e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4663939523921594 6.840753303497581e-06 6.82864045778394e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.513323086355808 1.4758666347229044e-05 1.4710296440084038e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5606743371739626 2.277867425126805e-05 2.2703461821182454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6079921112008786 3.06251410225674e-05 3.055847419263321e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.654837860763116 3.80803239048431e-05 3.805229281586868e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.700800836746957 4.5000654044616666e-05 4.50079963868114e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.7455068088260246 5.128612424233093e-05 5.130211274945847e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7886294979032775 5.686205718999907e-05 5.6863537560353965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8299024044914716 6.168507753115422e-05 6.166597707986015e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8691257746448917 6.574767123938044e-05 6.571532295178553e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.906161522373144 6.907526463240125e-05 6.90428534325143e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.94092251010044 7.171899502056058e-05 7.170057238148552e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9733625877893353 7.374859549615813e-05 7.375489349838055e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.003467705197862 7.524610505594345e-05 7.527971757270702e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.031248458813082 7.62976807945669e-05 7.635047789653674e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0567339166895313 7.698615256893628e-05 7.704040417691142e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.079966332507684 7.738688006258118e-05 7.741840974051719e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1009966836165805 7.756566831068089e-05 7.754800197574823e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1198809567375556 7.757772661825212e-05 7.748676782376893e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1366770947154494 7.746712924126584e-05 7.72861699164721e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1514424053104753 7.727012233029726e-05 7.699209815000943e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.164231427050356 7.701892325518257e-05 7.66453896243946e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.175094322875011 7.674293601620056e-05 7.628187184734602e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1840756930058642 7.646874968511397e-05 7.59322732464893e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1912137121810358 7.621966914463541e-05 7.562214863848882e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.196539515068156 7.601513732107625e-05 7.537185973822071e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2000767702441815 7.587021044630686e-05 7.51966035173306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.201841397703709 7.579515006974185e-05 7.510646438872808e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener deleted file mode 100644 index e818027bc..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04189628391620653 -1 0.041907323373906694 -2 0.041929874833646186 -3 0.04196490662795677 -4 0.042013930500640485 -5 0.04207907590391665 -6 0.0421631944669496 -7 0.04226999938569372 -8 0.042404245773605555 -9 0.0425719592932915 -10 0.04278072156317679 -11 0.04304002172688188 -12 0.043361683899869934 -13 0.043760379522009445 -14 0.044254231279711474 -15 0.04486551025609772 -16 0.04562141898567497 -17 0.046554938340937276 -18 0.04770569337409733 -19 0.04912075962732308 -20 0.050855284001361786 -21 0.05297273027084682 -22 0.05554447723937128 -23 0.058648398825604894 -24 0.06236594737626685 -25 0.06677716146015887 -26 0.07195295990127763 -27 0.07794411878050164 -28 0.08476653742079225 -29 0.09238274814335581 -30 0.10066753374473396 -31 0.10936803997834117 -32 0.11809986654555682 -33 0.12634236316194136 -34 0.13351985713168565 -35 0.13929733176772335 -36 0.1434444768861111 -37 0.1457554940480348 -38 0.14606420354961566 -39 0.1444096914945241 -40 0.14116124134723615 -41 0.13674474011543822 -42 0.13137456932122168 -43 0.12508481225274135 -44 0.11795725554866583 -45 0.11028683929066119 -46 0.10245610451117247 -47 0.09476820472488676 -48 0.08744670777316393 -49 0.0806268401705663 -50 0.07437334134526351 -51 0.06871710581760616 -52 0.06366406002466193 -53 0.05920177671828256 -54 0.05530507394288428 -55 0.051936577127561674 -56 0.049052692833963164 -57 0.04661406779662805 -58 0.04458642246150086 -59 0.042940588399494994 -60 0.0416524650318594 -61 0.04070293526055379 -62 0.040077768962522985 -63 0.039767534892597864 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz deleted file mode 100644 index a124de321..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_12.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8947851274956027 -5.184569661831169e-06 -4.780746052277871e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8950591196264228 -5.249935991269749e-06 -4.841986919211064e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8956108629313704 -5.38177095408252e-06 -4.965572011396933e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8964479418573035 -5.582253252718596e-06 -5.153688906935528e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8975818988918038 -5.8545822277326325e-06 -5.409564548009973e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8990284332616256 -6.202891172864509e-06 -5.737395156979022e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9008076652431092 -6.632124424355883e-06 -6.14224694970594e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.902944465237774 -7.14787343393264e-06 -6.629921760119157e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9054688461310896 -7.75616478915734e-06 -7.206780098603869e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9084164164888464 -8.463191101570493e-06 -7.879512364478856e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.911828890734002 -9.27497471346435e-06 -8.654846865010017e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9157546504433165 -1.0196953209380487e-05 -9.539181323455182e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9202493481217249 -1.1233475320963889e-05 -1.0538122713429751e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9253765410209218 -1.2387196365126674e-05 -1.1655918909495565e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9312083374860987 -1.3658364234573058e-05 -1.2894765156029469e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9378260315893594 -1.5043990714113999e-05 -1.4253969365127665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9453206930327245 -1.6536908839500242e-05 -1.5728963360828643e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.953793667994485 -1.8124725354133536e-05 -1.7310153316045235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9633569322171271 -1.9788688617039395e-05 -1.8981613405043905e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9741332196234407 -2.1502506052207776e-05 -2.071964341755961e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.986255827562412 -2.323119609866492e-05 -2.249124503957348e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9998679729946278 -2.4930159695213464e-05 -2.4252632202621783e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0151215423956437 -2.6544379764975647e-05 -2.5947855255406603e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0321750422547185 -2.8007957135168948e-05 -2.7507746445285115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.051190518093723 -2.9244126203219794e-05 -2.8849442924561212e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.072329170672319 -3.0165866734052493e-05 -2.9876803227369345e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.095745363479534 -3.067703521290943e-05 -3.0482052319248733e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1215786938935213 -3.06740607965863e-05 -3.054903963426455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1499438040129233 -3.0048183933980617e-05 -2.995846859899953e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.18091765401003 -2.86875723580523e-05 -2.8595216932352195e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.21452412371792 -2.647861051490505e-05 -2.635756909825979e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2507199632518065 -2.3315870370459627e-05 -2.3166642036055076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.289388325678912 -1.9128750096292632e-05 -1.897717047426371e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.330337403475771 -1.3911500368776416e-05 -1.3792612528768056e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.373304975135935 -7.748383799404712e-06 -7.681515892986215e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.417967794581098 -8.05696413738496e-07 -7.829004347602262e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4639485047461536 6.722234951747012e-06 6.71185711456117e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.510824392314502 1.4625241229950242e-05 1.4578553996475766e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.558144191100308 2.264673221074789e-05 2.2570998824371542e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6054520951248406 3.050965201346922e-05 3.0439410051259475e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.6523085636036643 3.79912884982702e-05 3.7958705060289386e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.698301370239445 4.494399519875651e-05 4.4948847408969456e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.7430543615683227 5.1266829688519196e-05 5.128299233545161e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.786238608788138 5.688374620733897e-05 5.688682688878233e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8275843586057086 6.174931177260328e-05 6.173160053792185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.866888305555324 6.585359069637209e-05 6.582160421523342e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9040092924844165 6.921999859027109e-05 6.918666825893286e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9388576348462285 7.189813903926782e-05 7.187766429685601e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9713851140498155 7.395664494090802e-05 7.396031583418657e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0015760331937735 7.547688691754664e-05 7.550832925337906e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.02943967865953 7.654509580770699e-05 7.659731299310662e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0550040912727283 7.724466214704674e-05 7.730089763757368e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0783107359350566 7.76517812380231e-05 7.768852686315523e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.09940999831891 7.783326128730157e-05 7.782430779597877e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1183574332586868 7.784546732112942e-05 7.776646526063805e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1352106776164947 7.77336951448344e-05 7.756709959493157e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1500268467327097 7.753484656342726e-05 7.727262453618136e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1628603734712217 7.728147321054287e-05 7.692434257336152e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.173761375297395 7.700319077147207e-05 7.655851709364482e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.182774446098795 7.672676034038222e-05 7.620628351316276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.18993777700517 7.64756457274523e-05 7.589356406107737e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.195282529255332 7.626943640635788e-05 7.564103459437777e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.19883239887066 7.612331339318662e-05 7.546414018358929e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.2006033276030563 7.604762998944867e-05 7.5373137244459e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener deleted file mode 100644 index ea6e46bdd..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041893194545286803 -1 0.04190416430686307 -2 0.041926573107446304 -3 0.041961382581028335 -4 0.04201009400488142 -5 0.042074822074995806 -6 0.042158398647329405 -7 0.04226451116876075 -8 0.04239788180676558 -9 0.04256449456535044 -10 0.042771878851080275 -11 0.043029458855995656 -12 0.043348978471638724 -13 0.04374501080009371 -14 0.04423555902579416 -15 0.04484275050552148 -16 0.04559361710077131 -17 0.04652094024260626 -18 0.047664116713822265 -19 0.04906996792176053 -20 0.05079336851582768 -21 0.05289750679779858 -22 0.055453507909553244 -23 0.05853905262363751 -24 0.06223551678426397 -25 0.06662305590417485 -26 0.07177299811383939 -27 0.0777369397030407 -28 0.08453213980582987 -29 0.09212319131119805 -30 0.10038859382054334 -31 0.10907979033504547 -32 0.11781692566332927 -33 0.1260840033375966 -34 0.13330230048462352 -35 0.13912928683748174 -36 0.1433336350927979 -37 0.1457092052023126 -38 0.14608760797734582 -39 0.14449567470983662 -40 0.14129631180244404 -41 0.13691652159688794 -42 0.13158200535880082 -43 0.1253274946332697 -44 0.11823120975875165 -45 0.11057888046994681 -46 0.1027544559205986 -47 0.09506366259704169 -48 0.08773262780429705 -49 0.08089985610521704 -50 0.07463164058079062 -51 0.0689598456643313 -52 0.06389115372324804 -53 0.059413704718590934 -54 0.0555027659978752 -55 0.05212166261610249 -56 0.04922688615920054 -57 0.046778985655057254 -58 0.04474358682496325 -59 0.04309143424163736 -60 0.04179835134430192 -61 0.040845158289268026 -62 0.04021757689517635 -63 0.03990614345230872 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz deleted file mode 100644 index d0026ca45..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_13.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8947079768256523 -5.204865147437134e-06 -4.802507976924209e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.894980981379237 -5.270518580957707e-06 -4.864061781199086e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8955307339029879 -5.402895399878576e-06 -4.988239858505211e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8963647873733993 -5.604110065799059e-06 -5.177164032551676e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8974946365343803 -5.877267650343919e-06 -5.433964583588275e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8989359159620496 -6.226379809743363e-06 -5.762712944383561e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9007086635518635 -6.656245735805535e-06 -6.1683259932492806e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9028376486027487 -7.172292971212752e-06 -6.656436152526726e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.905352763046988 -7.780370985393091e-06 -7.233219852947007e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9082894734232838 -8.48648855879627e-06 -7.905175088111664e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9116893297951036 -9.296484920616162e-06 -8.678836742855878e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9156005258341668 -1.0215623609246334e-05 -9.560416405496355e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9200785015355037 -1.1248097628017197e-05 -1.0555351547001976e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9251865762751883 -1.239643501409844e-05 -1.166774760397955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.930996594885822 -1.3660795815948255e-05 -1.2899696008484267e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9375895627584583 -1.5038155208451937e-05 -1.4250452170118069e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9450562372781475 -1.6521373458085582e-05 -1.5715460491412334e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.95349763168276 -1.8098162011741877e-05 -1.7285219640479505e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9630253731704514 -1.9749966653128907e-05 -1.8943992022531888e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9737618392015792 -2.1450803210887507e-05 -2.066837808565619e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.985839973907779 -2.3166120850308813e-05 -2.2425806630396083e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.999402659896469 -2.4851839916732752e-05 -2.4173043369999744e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0146014893799444 -2.645354238936253e-05 -2.5854813290870793e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.031594742814394 -2.7905991719677026e-05 -2.7402734015058705e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0505443443888454 -2.913312031363421e-05 -2.8734811243100843e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.071611524447786 -3.0048601775664795e-05 -2.975580844378243e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.0949508841788496 -3.055698580229129e-05 -3.0358833333562854e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.120702535683957 -3.055541760151133e-05 -3.0428520740086557e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1489819932102363 -2.9935861761509287e-05 -2.984615684087173e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1798675365316385 -2.8587246812917173e-05 -2.8496882341773656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2133849033958395 -2.639678412266393e-05 -2.6278820114545666e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2494930578647 -2.3258986809734143e-05 -2.311249607098485e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.288077523372152 -1.9101757046589183e-05 -1.895139622207738e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3289488556460434 -1.3916264575780528e-05 -1.3796831511441126e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.371846982492969 -7.782446745722426e-06 -7.71431184282335e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.416450536692653 -8.637264740960753e-07 -8.399201109556976e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4623838568680787 6.646371974970047e-06 6.637000527907664e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.509225601737712 1.4539425789386458e-05 1.449378592561719e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5565251973956045 2.25613803778682e-05 2.248539184177841e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6038267139147586 3.0434515672486144e-05 3.036203911457984e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.650689976709297 3.793294905983966e-05 3.789738870512627e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.696701815634483 4.490630362412236e-05 4.4909430756766336e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.741484844259748 5.1252976079237635e-05 5.1269163287504245e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7847084416846153 5.6896090891066394e-05 5.690020458124208e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.826100775192595 6.178893450126702e-05 6.177219328372322e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8654562742195813 6.592002441271463e-05 6.588838518842861e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9026318128052644 6.93114754087251e-05 6.927768297143114e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9375360732490847 7.201189613686782e-05 7.199022398947189e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.970119510257496 7.408920532570541e-05 7.409127449051786e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0003653700354866 7.562432203505797e-05 7.565439960682852e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0282820983925904 7.670349570627532e-05 7.675530916837157e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0538970769107987 7.74104584734645e-05 7.746788359669338e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.077251264131969 7.782192878187901e-05 7.786190186888465e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0983946657677164 7.800534575888003e-05 7.80018521040246e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1173825591831696 7.801779751999227e-05 7.794636452155895e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.134272385133945 7.79053727139194e-05 7.77479505649619e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.149121135036387 7.770542315832043e-05 7.745336422842561e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.161983173508699 7.745072656740418e-05 7.710420671585507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1729085884187556 7.717103763082247e-05 7.67370196468066e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.18194196921165 7.689322723497846e-05 7.638319774777458e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.189121517206625 7.664085915196578e-05 7.606889729033312e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1944784104212918 7.643361460623868e-05 7.581499431343483e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1980363622792747 7.628675270024002e-05 7.563709206344425e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.199811328352653 7.621068419611643e-05 7.554555666814928e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener deleted file mode 100644 index a70398bc2..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041891224895152124 -1 0.04190215022291224 -2 0.04192446807319051 -3 0.04195913580959552 -4 0.04200764803681465 -5 0.042072110043344456 -6 0.04215534107889665 -7 0.042261012173715085 -8 0.04239382448928322 -9 0.04255973546709604 -10 0.0427662412198763 -11 0.043022724518458476 -12 0.043340878087975335 -13 0.04373521230249169 -14 0.044223654104929004 -15 0.04482823913557161 -16 0.045575890313696486 -17 0.046499261719503235 -18 0.04763760430842543 -19 0.04903757703204434 -20 0.050753880341968996 -21 0.0528495260272313 -22 0.055395476276634895 -23 0.058469287047334374 -24 0.06215228318792485 -25 0.06652469191286386 -26 0.07165809877539783 -27 0.07760461884618047 -28 0.08438237369401985 -29 0.09195726049081913 -30 0.10021013154665162 -31 0.10889518083347778 -32 0.11763545419189651 -33 0.12591793095263132 -34 0.1331622089358044 -35 0.13902076907170102 -36 0.14326161120353967 -37 0.14567837981409174 -38 0.14610134850232134 -39 0.14454966388617393 -40 0.1413819375612364 -41 0.13702572825631126 -42 0.13171398185015334 -43 0.12548199997311907 -44 0.11840586490122801 -45 0.11076533083818534 -46 0.10294513264516854 -47 0.09525264316343797 -48 0.08791561405555194 -49 0.08107464986400466 -50 0.07479706653686623 -51 0.06911535169353057 -52 0.06403667384609679 -53 0.05954953811223001 -54 0.05562949493948561 -55 0.05224031502480873 -56 0.049338559994586244 -57 0.046884716451280756 -58 0.04484434955812766 -59 0.0431881482461641 -60 0.04189188734447817 -61 0.04093634685911633 -62 0.04030721785234237 -63 0.03999501583580433 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz deleted file mode 100644 index c1dcd648f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_14.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8946586789989965 -5.2174122228782045e-06 -4.816682602086411e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8949310522991487 -5.283261154322763e-06 -4.878435649554147e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.895479532326985 -5.4160080467744745e-06 -5.002991179786227e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8963116519421301 -5.617725815473759e-06 -5.192428961492306e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8974388753689173 -5.89145855924812e-06 -5.449817449769258e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8988767958557784 -6.241139246594177e-06 -5.779148258654037e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.90064539863562 -6.6714731511403035e-06 -6.185242741108464e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9027693883755539 -7.1877817171155655e-06 -6.673624945277116e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9052785796843683 -7.79579970715573e-06 -7.2503535316015325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9082083483026264 -8.501416761758388e-06 -7.92180337721009e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9116001392153297 -9.31035331117105e-06 -8.694385571173829e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9155020259584379 -1.0227759797889639e-05 -9.57419252809697e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9199693126549908 -1.1257727771793668e-05 -1.0566553132220194e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9250651665842857 -1.2402701961852842e-05 -1.1675481479321645e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9308612640813299 -1.3662784305188165e-05 -1.2903002286018852e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9374384259350275 -1.5034924635262016e-05 -1.4248336969662304e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.944887209799507 -1.6511998740444014e-05 -1.5706937458372555e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.953308415973918 -1.80817832087735e-05 -1.7269360943952817e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9628134487129527 -1.9725848383955706e-05 -1.891998947181918e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9735244574350754 -2.1418405812773587e-05 -2.0635614938852323e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.985574160259612 -2.3125178853254628e-05 -2.238393841125878e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9991052257863104 -2.4802419019744335e-05 -2.4122077590571538e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.014269057782205 -2.6396090738748427e-05 -2.5795188119407102e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.031223791797256 -2.7841380975121703e-05 -2.7335389347799686e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0501312739539066 -2.9062668725663505e-05 -2.866124235743439e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.071152752901293 -2.9974071920788516e-05 -2.9678089990866097e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.094442981054004 -3.0480584419496906e-05 -3.0279606179431574e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1201423987069976 -3.047980997220289e-05 -3.035093103576172e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.148367076661321 -2.9864175584695134e-05 -2.9773727985243547e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.179196137168203 -2.8523092317902405e-05 -2.8433312119209232e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.212656503538666 -2.63443009809711e-05 -2.6227708860202295e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2487085548573544 -2.322230330366334e-05 -2.307707274409322e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2872393300526443 -1.908407631789816e-05 -1.8934104529510843e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3280608964075626 -1.3918853722977315e-05 -1.3798760224868436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3709145582667577 -7.803828812160812e-06 -7.734621537746708e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.415480151040219 -9.005165178886027e-07 -8.758716973394315e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4613830988358547 6.598088322161077e-06 6.5894650021201695e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.5082029385517437 1.4484631604863868e-05 1.4439709537807796e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5554895418029444 2.250670453003413e-05 2.2430564195807956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.602786904016518 3.0386263779303566e-05 3.0312283445144177e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.6496544465987446 3.789540188756766e-05 3.785774478919682e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6956783969249294 4.488194671680843e-05 4.488368376438484e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.740480580221862 5.124383982941972e-05 5.125971789402086e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.783729295102974 5.690369346365528e-05 5.6908135500281214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.825151380130197 6.181398921611348e-05 6.179752911431782e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8645398178936823 6.596225734250148e-05 6.593048662226043e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.901750221803815 6.936977501310867e-05 6.933531728760855e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.936690228284718 7.208450960046999e-05 7.20616852888148e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.969309442286094 7.417391979790582e-05 7.41745585737375e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.999590432826521 7.571862821810202e-05 7.574740541254459e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0275411071796894 7.680488564464828e-05 7.685599652533593e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0531884244868484 7.751663702250646e-05 7.757436984386669e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.076573018747992 7.793093212882697e-05 7.797251761251315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0977446520841316 7.81156106573832e-05 7.811517098556977e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.116758423919164 7.812821810652215e-05 7.806121883354767e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1336716493464007 7.801535346934488e-05 7.786343679003902e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1485412401936923 7.781467077810964e-05 7.756879918695899e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1614215171763074 7.755909894537367e-05 7.721909918331988e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1723625490380254 7.727848442841177e-05 7.685105651429436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1814089222365776 7.699976945992336e-05 7.649623167141474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1885988445003606 7.674658210658962e-05 7.618093048840221e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.193963504500889 7.653866233201462e-05 7.592615693940158e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.197526626738813 7.639131914187403e-05 7.574761538084735e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.19930417559225 7.631499999891348e-05 7.565574208460529e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener deleted file mode 100644 index 4dd14351e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04188996657777692 -1 0.041900863526889834 -2 0.041923123290036494 -3 0.04195770050408234 -4 0.0420060855131063 -5 0.04207037759868062 -6 0.042153387961075615 -7 0.04225877714797312 -8 0.04239123290766601 -9 0.042556695720057956 -10 0.04276264043735885 -11 0.043018423378940955 -12 0.043335704593480864 -13 0.04372895439217363 -14 0.044216051019865206 -15 0.04481897152736948 -16 0.04556456922968684 -17 0.04648541682458694 -18 0.04762067205218661 -19 0.04901688998007385 -20 0.05072865960581607 -21 0.05281887968573434 -22 0.05535840789837423 -23 0.058424719865035474 -24 0.06209910701146486 -25 0.066461841209792 -26 0.07158467096788483 -27 0.07752004091605551 -28 0.08428662141762541 -29 0.09185113866674895 -30 0.10009593976347193 -31 0.10877697963014449 -32 0.11751915734160046 -33 0.12581135530799012 -34 0.13307220508135698 -35 0.13895092600109205 -36 0.1432150762092829 -37 0.1456581628459286 -38 0.14610963278888334 -39 0.14458378473150957 -40 0.14143639238751873 -41 0.13709530919860483 -42 0.1317981110496677 -43 0.1255805307751963 -44 0.11851733915702649 -45 0.1108844393473955 -46 0.10306701924110809 -47 0.09537350522366975 -48 0.08803268331193705 -49 0.08118650169152661 -50 0.07490294300227612 -51 0.06921489462993596 -52 0.06412983710469453 -53 0.05963651004553192 -54 0.05571064347467451 -55 0.05231629164973843 -56 0.049410067695638174 -57 0.04695241828952321 -58 0.044908869850933196 -59 0.04325007570479916 -60 0.041951779568970234 -61 0.04099473574992911 -62 0.040364615621776574 -63 0.040051921394414956 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz deleted file mode 100644 index 03f537d8c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_15.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8946271398760188 -5.225674326534558e-06 -4.825299010770842e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.894899109419571 -5.2916432707833165e-06 -4.887187119363123e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.895446775546507 -5.4246169236537335e-06 -5.0119991824009696e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8962776582522902 -5.626641858383424e-06 -5.2017878008586234e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8974032022448168 -5.9007235149928205e-06 -5.459581488696508e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8988389743444964 -6.250744972334116e-06 -5.7893202884395674e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9006049261077105 -6.681351960823729e-06 -6.195763822662202e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9027257208707462 -7.197798664507583e-06 -6.684366088456167e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.90523112379517 -7.80574713701134e-06 -7.261109594481661e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9081564525570596 -8.511011512938801e-06 -7.932289568040796e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.911543084944227 -9.319236953174516e-06 -8.704236947962577e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9154390176656064 -1.0235502275610576e-05 -9.582966901477077e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9198994679528358 -1.126383482718653e-05 -1.0573737795484804e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9249875058165546 -1.2406626692887115e-05 -1.1680504208512654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9307746998326776 -1.3663943213980859e-05 -1.290524706979121e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9373417527292698 -1.503271850069238e-05 -1.424716492717185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.944779094420871 -1.650583865094421e-05 -1.570171339007281e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.953187389015454 -1.8071122182861637e-05 -1.7259485953697328e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9626778981716309 -1.9710219250651552e-05 -1.890494006963599e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9733726254423485 -2.1397466597219028e-05 -2.0614988994520776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.985404144367682 -2.309876285158577e-05 -2.235750689012247e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9989149866301472 -2.477057117183863e-05 -2.4089835630680675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.014056435407754 -2.635910038661744e-05 -2.5757405486377288e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0309865334809216 -2.7799808120986523e-05 -2.7292656105029734e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0498670769172844 -2.9017358809225584e-05 -2.8614503494832755e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.070859325905254 -2.992615438489003e-05 -2.9628661207129954e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.094118129360892 -3.0431472525075695e-05 -3.0229166038632114e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1197841372029558 -3.043120969346356e-05 -3.0301482705393987e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1479737758413475 -2.981808737647457e-05 -2.9727518169822278e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.178766705931564 -2.8481822464053572e-05 -2.8392702192500464e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.212190608326317 -2.6310492811714702e-05 -2.6195001186767487e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2482067670047514 -2.319860216518191e-05 -2.3054335836613523e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2867031902053014 -1.9072547471747827e-05 -1.8922911325537084e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3274929122114663 -1.3920337147790386e-05 -1.3799825996184825e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3703181182985524 -7.817417906453827e-06 -7.747436062366614e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.4148594137053774 -9.240550242396838e-07 -8.987028790194439e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4607429171896102 6.567104365739194e-06 6.559199249699151e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.507548727689012 1.4449371230768683e-05 1.4405220830461087e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.554827002764131 2.2471398928987787e-05 2.239554565206991e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6021216915269947 3.035498083996165e-05 3.028046212828326e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.648991957297969 3.7870917165324084e-05 3.7832354620149705e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6950236423421674 4.4865869090935684e-05 4.48671592704662e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.73983806768427 5.123747267698633e-05 5.1253610279762644e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7831028413206846 5.690802039625416e-05 5.6913142731370934e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8245439522388858 6.182948478653381e-05 6.181367386648955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8639534578924675 6.598876546999072e-05 6.595736191042346e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9011861646946615 6.940660101072146e-05 6.937213695273768e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.936149039492901 7.213054584672816e-05 7.210735952696322e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.968791143171844 7.422776215706213e-05 7.42278049024549e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.999094611103431 7.577867899885721e-05 7.580687723786092e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0270670057098226 7.686954249543517e-05 7.692038513930809e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.052735015597897 7.75844301862082e-05 7.764246694994407e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.076139066907417 7.800060124858014e-05 7.804325146392526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.097328765727429 7.818614923009226e-05 7.81876256634651e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.116359097484316 7.819890905789125e-05 7.813464424699091e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.133287296790556 7.808580578382377e-05 7.793725285196824e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1481702244493515 7.78846917365719e-05 7.764256848804073e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.161062173004411 7.762859424139345e-05 7.729250801913218e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1720131988989606 7.734741862733973e-05 7.692390566845112e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1810678866287674 7.706815229061926e-05 7.656842835474966e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1882644479839457 7.681446374419966e-05 7.62524778961691e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1936340784233743 7.660612985522283e-05 7.599714036390405e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1972005095141953 7.645849099769777e-05 7.581818499920253e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1989797112554377 7.638201772451874e-05 7.572609308953489e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener deleted file mode 100644 index 3389bbc33..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04371373853924163 -1 0.04377279682441858 -2 0.043879440899471794 -3 0.04403866981965937 -4 0.044257913475114395 -5 0.04454746472268966 -6 0.044920952995220455 -7 0.045396038507791545 -8 0.04599521819759 -9 0.04674671691079392 -10 0.04768535494532812 -11 0.04885365412601556 -12 0.050302891004951604 -13 0.0520938643658403 -14 0.05429674872306641 -15 0.05699012466246713 -16 0.06025926559406508 -17 0.06419186949563181 -18 0.06887030575536993 -19 0.07435995273343649 -20 0.08069519692535944 -21 0.08786317188330431 -22 0.09578305995093409 -23 0.10426424462585888 -24 0.11299201995525958 -25 0.12153034115023935 -26 0.1293276999083341 -27 0.13591030997143946 -28 0.1410287785347692 -29 0.1444829668230005 -30 0.14609038340530406 -31 0.14572913793329656 -32 0.14355547696383517 -33 0.1399531080024541 -34 0.1352948085878865 -35 0.12968556019599656 -36 0.12314313621155477 -37 0.11576558764683059 -38 0.10789191818215327 -39 0.09988032370245704 -40 0.09201439807054475 -41 0.0845022184881069 -42 0.07745968861051876 -43 0.07094874882391104 -44 0.06500061370561551 -45 0.05962302621834198 -46 0.05480580219755224 -47 0.05051658601487003 -48 0.046707214814439374 -49 0.04333178293410624 -50 0.04034827448886562 -51 0.03771853964990129 -52 0.03540804513061452 -53 0.03338583491221042 -54 0.03162453234588845 -55 0.03010017935527278 -56 0.02879190936785377 -57 0.02768178681578717 -58 0.026754607301713192 -59 0.025997602311532565 -60 0.02540027513953168 -61 0.024954285786171548 -62 0.024653374813461255 -63 0.024493207033670958 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz deleted file mode 100644 index 4c85b6bac..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_2.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.92479820821466 -2.3309567153614935e-05 -2.2720386483107385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.925529539077169 -2.3799148727890006e-05 -2.32224133116635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9268294897361136 -2.4758341507054243e-05 -2.4205310747225572e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9287240835853154 -2.6166482735296483e-05 -2.5647797501544824e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9312499184897716 -2.799921182817904e-05 -2.752476105865621e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.934455068145866 -3.022744693141057e-05 -2.98054422996273e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9383990360788836 -3.281620726027869e-05 -3.245271269073706e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.943153707546518 -3.5724058455962664e-05 -3.542279247394234e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9488039246545936 -3.890308079361455e-05 -3.866507235123782e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.955447572522225 -4.229882289680538e-05 -4.212196429519972e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.963194653193207 -4.5850213751372115e-05 -4.5728738089561874e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.972168132103515 -4.94895431713935e-05 -4.941346547351479e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9825043417655723 -5.314239624665733e-05 -5.309697151013283e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.994352372993371 -5.6727445684468146e-05 -5.6692755690683835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.007870307918806 -6.0156027085158746e-05 -6.0106940483607235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.0232218717201818 -6.333167046837596e-05 -6.323865462939384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0405757440970413 -6.614984262466391e-05 -6.598092729997819e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0600997964466883 -6.849742253421255e-05 -6.822177540200282e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.0819503592227684 -7.025104384794905e-05 -6.984579661910421e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.106258397717625 -7.127316334896938e-05 -7.07366054719994e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1331204287470515 -7.141606589162124e-05 -7.078184662312268e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.1625912373916707 -7.055875211249342e-05 -6.988539680196473e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.194673749904038 -6.861300960162608e-05 -6.797210201323669e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.229308399817824 -6.553159401679397e-05 -6.499295768001037e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.266376887223972 -6.131959469182547e-05 -6.09319069101125e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.3057080286723304 -5.604777070684699e-05 -5.581314056681226e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3470805991232497 -4.9827106798958765e-05 -4.9701420020779724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.390220999601711 -4.2772854196576336e-05 -4.269717655303836e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.4348059382696343 -3.499669807092489e-05 -3.4932529999396784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.480470603132379 -2.662373420290193e-05 -2.656574599927365e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.5268234116810153 -1.7815127384931018e-05 -1.7774728142259696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.5734657434516115 -8.766912945754458e-06 -8.748300726433559e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.6200087949294026 3.1927099173551256e-07 3.2466780812701995e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.666080461788052 9.261933270219657e-06 9.265738132713077e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.711332090117266 1.7908474959039507e-05 1.7914907784736767e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.7554480628097395 2.613154686621462e-05 2.613537293710691e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.7981547194290135 3.382470532613696e-05 3.381569001550386e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.839225153935033 4.0900862837490995e-05 4.086997061122992e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.8784845596019 4.7294255279446275e-05 4.7236516617813294e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.9158110322065975 5.2960865345852606e-05 5.2876178876359986e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.951132180079015 5.7877333580052634e-05 5.777038497515608e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.9844134060197485 6.203908442150987e-05 6.19184355654877e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 3.0156503172947953 6.5458197023884e-05 6.533427047060786e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 3.044863059613534 6.816137158806694e-05 6.804300693886844e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 3.0720927614512017 7.018647412819967e-05 7.007944484378024e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 3.0973931563725223 7.157967224511434e-05 7.148652306509956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.1208262490390326 7.239340939762308e-05 7.231371033804117e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.142459076504152 7.268476061592121e-05 7.261559638053656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.162364696907433 7.25140026859153e-05 7.245062751233139e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.180618198637129 7.194350269849672e-05 7.188014198387779e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.1972932694302933 7.103675788901315e-05 7.096746299100067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.2124613614776787 6.985739437916357e-05 6.977693521996941e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.2261919192553528 6.846833808076981e-05 6.837295908523478e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.238551263917111 6.693162714526306e-05 6.68191381636456e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.2496009915279407 6.530800091773223e-05 6.517743214407655e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.259397230201954 6.365625020876716e-05 6.350728723512863e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.267991025506514 6.203193774433818e-05 6.186484740865745e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.2754280871424513 6.0486547755952795e-05 6.030221726646524e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.2817485327340257 5.906689149599563e-05 5.8866756343816e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.2869869095970974 5.7814512252216745e-05 5.760045378849618e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.29117232649902 5.676517280264541e-05 5.653942264399849e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.294328459694895 5.5948509456554105e-05 5.571357868587529e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2964734183869573 5.538796050407633e-05 5.514660605068508e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.297620330925452 5.510115199500064e-05 5.485639704044741e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener deleted file mode 100644 index 88f4c1114..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04234439533764382 -1 0.04236839918367198 -2 0.04241646418346911 -3 0.042491041261955256 -4 0.04259592864722523 -5 0.0427364938749353 -6 0.04291997426332715 -7 0.043155883611461984 -8 0.043456532068844596 -9 0.04383767518487475 -10 0.04431930181258359 -11 0.04492660150786696 -12 0.04569109948336716 -13 0.046651938453812235 -14 0.047857224189416805 -15 0.04936536982338376 -16 0.051246305276850423 -17 0.053582133156981245 -18 0.05646672187031824 -19 0.06000354373929622 -20 0.06430080989636294 -21 0.06946206310883705 -22 0.07557047018988694 -23 0.08266564556459426 -24 0.09071642386380709 -25 0.09958258888219103 -26 0.10895817794979358 -27 0.11836689708293813 -28 0.1271626427898523 -29 0.1346624827671432 -30 0.14049189952087515 -31 0.14438781779879103 -32 0.1461183316080246 -33 0.1455386658906989 -34 0.14288462745816183 -35 0.13865439360417323 -36 0.1332488873430738 -37 0.12672450310693636 -38 0.11912366851096838 -39 0.11071997429279795 -40 0.10198346160961576 -41 0.09330364699146029 -42 0.08497176507698755 -43 0.0771570468546294 -44 0.06994829599404244 -45 0.06339300110857964 -46 0.05750629211475038 -47 0.05227498284978294 -48 0.04764859783869698 -49 0.04356838475978137 -50 0.03997986115273254 -51 0.036833192146592995 -52 0.03408329023461092 -53 0.031689780850504994 -54 0.029616866329690503 -55 0.02783313847620978 -56 0.026311487396144147 -57 0.025028536469708564 -58 0.023964278035207696 -59 0.023101911060134962 -60 0.022427684836963575 -61 0.02193076017963605 -62 0.02160309437298838 -63 0.021439339957655675 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz deleted file mode 100644 index 54bdcf47b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_3.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9043635681982705 -2.3574664737804618e-06 -1.5397985465406904e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9048105633209322 -2.7177608342399073e-06 -1.898146200288798e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9056908003447979 -3.429033185197331e-06 -2.6057209628847055e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9070200400959174 -4.485420444307854e-06 -3.6570873640669584e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9088215754820397 -5.882155453810695e-06 -5.048052569302132e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9111267217819135 -7.6144064405881e-06 -6.7743645974462586e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9139753068873389 -9.676325726903756e-06 -8.830939781121699e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9174164031740366 -1.2060330367428353e-05 -1.1211266469280338e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9215091311331909 -1.4756449864971422e-05 -1.3906743399618697e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9263235185470224 -1.7751513178314547e-05 -1.690583448957746e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9319413413575892 -2.10281260541375e-05 -2.0192964261938985e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9384572734046674 -2.456349766034613e-05 -2.3747188261991633e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9459800472079374 -2.8328028034451463e-05 -2.7540522532319264e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9546335183461465 -3.2283595167012166e-05 -3.1535852202013807e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9645573047457148 -3.638152073453732e-05 -3.568440543340355e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9759073380559127 -4.0560416724592786e-05 -3.9923059412096665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9888564570639893 -4.474403437173501e-05 -4.417168581622764e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.003593896760544 -4.883880558172852e-05 -4.833048281276236e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.0203234100931824 -5.273081855745851e-05 -5.227767017465835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.0392598586655946 -5.6281788824456207e-05 -5.5868200245259076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.060623851805577 -5.9328531750137885e-05 -5.893548892133e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.0846308945698953 -6.169946947701013e-05 -6.130079896562089e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.1114734690620978 -6.321478364782044e-05 -6.278265426183996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.141295580349001 -6.368353449352105e-05 -6.320926468764245e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.1741725783268615 -6.292004179981589e-05 -6.242949772820317e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.210097671609064 -6.0779346213361455e-05 -6.032598758225549e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.248975979849285 -5.718776508489356e-05 -5.683168886346341e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.2906297437535494 -5.218423629801967e-05 -5.1951922892723266e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.3348059382696342 -4.592097644387481e-05 -4.5777791634917916e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.3811738889642644 -3.8583267723281397e-05 -3.8472081483582665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4293232283559085 -3.0346456135051507e-05 -3.0249903554367233e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.478780021539536 -2.1434388633311783e-05 -2.13683512469113e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5290432018813616 -1.2140449822425741e-05 -1.2110853012062934e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.579613861313698 -2.7680185965670163e-06 -2.761025571539499e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.630008491701989 6.4240422198967984e-06 6.422583048046855e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6797654792217624 1.5229367322623172e-05 1.5223151813907907e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.7284574475471914 2.3485795774409485e-05 2.347258567160085e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.775709737014369 3.1071481348260974e-05 3.105056711754361e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.8212192000440464 3.790399991656536e-05 3.7878111911277255e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.8647627388024834 4.393987521889933e-05 4.391398875740664e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.9061865838321896 4.917081362962761e-05 4.9150710691837515e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.9453942777438735 5.361843786472015e-05 5.360838353227041e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.982335906468645 5.7328213221599804e-05 5.732715727459007e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 3.016998703531696 6.036055233959352e-05 6.0359646007444474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 3.0493993554945726 6.27828710599343e-05 6.276511522097818e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 3.0795768518118565 6.46636954482279e-05 6.460589866664239e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.1075867068744163 6.606817767466444e-05 6.594500397687752e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.1334961190553403 6.705416756766916e-05 6.684437603272461e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.157380237051859 6.767276492842254e-05 6.73642696697139e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.179318301741303 6.797263897177988e-05 6.756325279387656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.1993905189366725 6.80017410474991e-05 6.749767903780615e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.2176758616909913 6.780742088469688e-05 6.722095899069421e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.2342505248167663 6.743586719504821e-05 6.678288796054374e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.249186648588034 6.693144063326089e-05 6.622918496311525e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.2625513302429 6.633602512051017e-05 6.560123973889089e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.274406008351491 6.568847736918379e-05 6.493601091612761e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.2848061867355307 6.502412004135624e-05 6.42660521877788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.293801225005649 6.437451334898567e-05 6.361965473187706e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.3014342284811242 6.376717424833377e-05 6.302099303726131e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.307742039604898 6.322521425167444e-05 6.249027004115932e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.312755291646201 6.276744748045058e-05 6.204399405712043e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.3164984729277367 6.240878431501535e-05 6.169536056008451e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.31898998158741 6.216082833132373e-05 6.145476942080818e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.3202422646486256 6.203274941913098e-05 6.133060331085558e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener deleted file mode 100644 index ac3be1528..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04231656490895323 -1 0.042336762809028004 -2 0.042378052489083634 -3 0.04244226282974432 -4 0.04253224752178663 -5 0.04265202434489661 -6 0.04280696967870729 -7 0.043004075794746584 -8 0.04325228010880712 -9 0.04356287677386368 -10 0.043950021422365024 -11 0.04443133893036542 -12 0.04502864103573455 -13 0.045768754124141775 -14 0.04668444573323813 -15 0.04781541866745719 -16 0.0492093110013863 -17 0.05092259468680595 -18 0.053021199003867106 -19 0.05558059198280212 -20 0.058684927809034136 -21 0.062424709599573434 -22 0.06689222673835961 -23 0.07217375562692263 -24 0.07833652660707639 -25 0.08540865785574313 -26 0.09335220387387985 -27 0.10201730975668992 -28 0.11109913352878645 -29 0.12013349855733638 -30 0.1284951788762275 -31 0.13557801392595056 -32 0.14104888250592384 -33 0.14465041760882258 -34 0.14615608500327512 -35 0.14543811843260246 -36 0.14274974602637228 -37 0.13857232305696274 -38 0.1332896579869666 -39 0.12696565416953873 -40 0.11965224688183355 -41 0.11159703925342612 -42 0.10323691680820642 -43 0.09493451406059365 -44 0.08696145860175497 -45 0.0794837096161297 -46 0.0725831489889727 -47 0.06630202198059178 -48 0.06065263498151688 -49 0.05562477796892386 -50 0.051185157477042054 -51 0.047280296617014515 -52 0.04385865202849526 -53 0.04087345769019551 -54 0.03828279806280522 -55 0.036049534030144555 -56 0.03414113637536859 -57 0.03252946567892822 -58 0.031190537988946682 -59 0.03010429411312098 -60 0.029254382228693622 -61 0.028627966864195404 -62 0.028215569980439743 -63 0.028010930217530393 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz deleted file mode 100644 index e8da1e1e4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_4.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9038388331314848 5.698536736320816e-07 1.1290180629367577e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.904220363458139 4.4389542697350707e-07 1.0095747382564004e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9049889110233125 1.8988447627589312e-07 7.684414742619577e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.90615548589555 -1.9753292944332575e-07 4.0002429014501395e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9077368046118404 -7.265405641500772e-07 -1.0422716356024385e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9097555618942592 -1.4077625865124074e-06 -7.554693953192855e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9122407898213216 -2.253824521808497e-06 -1.5670778902071553e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9152283023197108 -3.2788271086441376e-06 -2.55417985248935e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.918761221979587 -4.497699554015382e-06 -3.733067126516505e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.922890584405618 -5.9254018380265275e-06 -5.1204555193977045e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9276760127982777 -7.575953025786163e-06 -6.732557509855707e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9331864517377133 -9.461273368088894e-06 -8.58394172183588e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9395009453856655 -1.1589812338024467e-05 -1.0686132048112176e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9467094392402293 -1.3964938310632951e-05 -1.304589745418351e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9549135761447582 -1.6583071719167955e-05 -1.5663186383789955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9642274444205894 -1.9431573467954114e-05 -1.8528692194298156e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.974778220678466 -2.2486392603352305e-05 -2.1621042682664642e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9867066314159105 -2.570942322513759e-05 -2.490359200430806e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.0001671268406636 -2.9045508595686295e-05 -2.832086775229247e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.0153276172685186 -3.241894385682509e-05 -3.17948086126933e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.0323685638556466 -3.573057267197226e-05 -3.522139694711719e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.051481141876455 -3.886030194760903e-05 -3.846965094672999e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0728640837699572 -4.1667507703254776e-05 -4.1381962705768466e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0967183568521306 -4.399237373770205e-05 -4.377777640459725e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.1232352690593963 -4.56581206163419e-05 -4.546219184976732e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.15257501756976 -4.647150889990407e-05 -4.623987925195038e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.1848389827674644 -4.622067141626852e-05 -4.593025104344344e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.220050194802684 -4.470320740344736e-05 -4.4381462908685316e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.2581422521203933 -4.1780308853106125e-05 -4.1493411906960015e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.298961142696549 -3.744384853385056e-05 -3.724946161333574e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.342273505465722 -3.1845064125990966e-05 -3.1740215043882384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.3877612980278493 -2.5201050287707027e-05 -2.5145868048986387e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.435016681655949 -1.7729541982841655e-05 -1.770788108783422e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.4835631281119506 -9.69940997077131e-06 -9.713670766968289e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.532896645529289 -1.4376954425932356e-06 -1.47344445834695e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.582511981476462 6.749246380210344e-06 6.715914582301642e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.6319087626852085 1.4623926810823502e-05 1.4601016783586861e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.680598515385747 2.2006139820941445e-05 2.1987445048542396e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7281290708491888 2.8761247908343198e-05 2.8741728886643453e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7741223032088365 3.4800649519847865e-05 3.4782511872173486e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.8182914405998827 4.008230234885231e-05 4.007125626783367e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.860430042537471 4.460627792546947e-05 4.460819181605814e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.9003990731983094 4.8407960954145466e-05 4.8425683308588556e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.938113703159167 5.155026963608926e-05 5.157928807154999e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9735325183173305 5.411202549260218e-05 5.413657789474284e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 3.006648885878958 5.617587539015603e-05 5.616911737581659e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.037483332524887 5.7819596382423816e-05 5.774753662845888e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.066076979253715 5.910935817802774e-05 5.893844070756152e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0924869408381226 6.009527703975397e-05 5.9802808193535256e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.1167814646332865 6.081808110078547e-05 6.039688308673685e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.1390351048639924 6.13151688300516e-05 6.0772570984988586e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.1593249605044105 6.16226965534016e-05 6.097703322547115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.177727890785579 6.177577640990062e-05 6.105213270808306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1943183874161005 6.180794860339532e-05 6.103407072646633e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.2091670459074058 6.175052795160348e-05 6.0953312428960636e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.222339481010774 6.163218075535107e-05 6.083482218582735e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.233895588013838 6.147883225382208e-05 6.0698498287783946e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.2438890814698595 6.13121413845217e-05 6.055941297491275e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.2523671863281205 6.114865094809774e-05 6.04283147882392e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.259370444056758 6.1000166094095175e-05 6.031242015290682e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2649326238881895 6.087461631028677e-05 6.021626348722421e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2690807016945453 6.077702546974523e-05 6.014249171823521e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2718348757982745 6.0710411437919616e-05 6.0092552004136126e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.273208597006055 6.0676541791426664e-05 6.006725849216844e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener deleted file mode 100644 index 3f45c655e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.042088744413916156 -1 0.04210428149256628 -2 0.04213604523791847 -3 0.04218544909864358 -4 0.04225470075102366 -5 0.042346911648582494 -6 0.04246625059729074 -7 0.04261814782168433 -8 0.042809557540910696 -9 0.04304928842450113 -10 0.04334841221332773 -11 0.04372076089081081 -12 0.0441835214898591 -13 0.04475793404213838 -14 0.045470091063186655 -15 0.0463518245705576 -16 0.04744164664467103 -17 0.048785679026471386 -18 0.05043846264773974 -19 0.052463475506141576 -20 0.05493310352229413 -21 0.05792770228248838 -22 0.06153325992226248 -23 0.06583703282414399 -24 0.07092039956354898 -25 0.07684810883447224 -26 0.08365270609036946 -27 0.09131224181122999 -28 0.09971402935088211 -29 0.10860521741246201 -30 0.11758395014083117 -31 0.12609440121935803 -32 0.13350642086169745 -33 0.13944145352444956 -34 0.14364005822719678 -35 0.14587145411584898 -36 0.14595660424021498 -37 0.14398079802593797 -38 0.14036782191546796 -39 0.1355681404838385 -40 0.1297439031797784 -41 0.12292919419310921 -42 0.11525211261401658 -43 0.10710332283476995 -44 0.09887559611948059 -45 0.0908716745187629 -46 0.08330288548441715 -47 0.07627845296459117 -48 0.06985459576280433 -49 0.06405492989453869 -50 0.05887807226127574 -51 0.054303888578283284 -52 0.05029041776875599 -53 0.04678598035031476 -54 0.04374315914565484 -55 0.04111944103004751 -56 0.03887723900238802 -57 0.03698379829296657 -58 0.035411036663021166 -59 0.03413535468352987 -60 0.03313744084941658 -61 0.032402089247400435 -62 0.03191804216965744 -63 0.03167786608450653 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz deleted file mode 100644 index 96da9f908..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_5.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8992377696771305 -2.4314150304199494e-06 -1.9070819654733822e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8995714268158068 -2.5145080384154506e-06 -1.9848027511456223e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9002434785176934 -2.6833405793644183e-06 -2.142933534257312e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9012634781084639 -2.943170208656056e-06 -2.3868683869701266e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.902645956463107 -3.3016981078136197e-06 -2.7245371152713614e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9044106635082718 -3.7688284738526844e-06 -3.166165155770922e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.906582888443784 -4.356307308645491e-06 -3.7239595966247675e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9091938567757036 -5.0772684379681775e-06 -4.411704670976655e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9122812011594474 -5.9456856609864204e-06 -5.244254563875975e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9158895014549175 -6.97570853271297e-06 -6.236913169226133e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9200708871441754 -8.180872136322946e-06 -7.404685827662849e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.924885692138877 -9.573171511307989e-06 -8.761386754605175e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9304031478254033 -1.1161991186809736e-05 -1.0318582688822955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9367020945512587 -1.2952881528348548e-05 -1.2084352264007857e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.943871684286473 -1.4946175525846125e-05 -1.4061841079472016e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9520120373585854 -1.7135444623912406e-05 -1.6247597809053998e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.961234803568854 -1.950579296828792e-05 -1.8629682424187195e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9716635620588396 -2.2031975096310987e-05 -2.118554199249268e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.983433973937925 -2.4676295478698772e-05 -2.3879664155384792e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9966935762823415 -2.7386182727217016e-05 -2.666103484228257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.011601074948531 -3.0092343839708424e-05 -2.9460751684796827e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.028324955938075 -3.27108637182728e-05 -3.2191016008757996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0470411882341426 -3.514302191230037e-05 -3.474418316337717e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.067929734093796 -3.727564222162443e-05 -3.699293800984737e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.091169513907649 -3.898228366573795e-05 -3.8792257694215044e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.11693138795257 -4.012509023720548e-05 -3.998399471291908e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.145366745947713 -4.055223156732037e-05 -4.0404210964629156e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1765854722014875 -4.009231106671659e-05 -3.98942157268235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.2106333874508235 -3.856640938650025e-05 -3.831377231673804e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.247478256527688 -3.582470127237623e-05 -3.555652245631403e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.287001749220857 -3.1793441740736674e-05 -3.157223971508864e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.3290045288720664 -2.6527135272660785e-05 -2.6393474365902037e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.373214538352732 -2.0203610845046616e-05 -2.0146149967297176e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.419283559944299 -1.304020951513216e-05 -1.302800741594035e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.466787012971946 -5.2652378009033106e-06 -5.286012364750997e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.515248004122567 2.8406128359715693e-06 2.798142639660091e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.5641740704868243 1.097243455629281e-05 1.0934654600958404e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.6130778602248963 1.8873043127713535e-05 1.8859474488705417e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.6614835754484103 2.6353418812605053e-05 2.6358192519046133e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.708936941518349 3.3270479170629903e-05 3.327592945705999e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.755030944623973 3.95209917980221e-05 3.9515893614677356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.7994339811480353 4.5043502927271174e-05 4.5028567431639046e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.8418986277441345 4.981849577331233e-05 4.9801188689731144e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.882250473117543 5.386274326018282e-05 5.3853306044207034e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.920375441537646 5.722253819530466e-05 5.722957041173356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9562079145823463 5.996642976059287e-05 5.999146430252046e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9897208259405463 6.217519159283544e-05 6.220863853120505e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.020917576680385 6.393106774164902e-05 6.395222927840133e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.049825039633153 6.531074753328928e-05 6.52907605500414e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0764878489706606 6.638079106132334e-05 6.628780305653786e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.100963543533455 6.719403122459858e-05 6.70006918359338e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.1233181082251065 6.779022692330842e-05 6.748057635504697e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.143621804173958 6.820299370861223e-05 6.777355476228947e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1619458937988467 6.846329643020575e-05 6.792097136588705e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.17836016786663 6.860047797594376e-05 6.795933957096715e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.192931111205149 6.864221275080588e-05 6.79202636305897e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.2057205699170614 6.861416708170804e-05 6.783048774529675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.216784811851118 6.853954722943051e-05 6.77121156394533e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.2261738749883992 6.843872940691963e-05 6.758297672248745e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.2339311249063343 6.832905573604279e-05 6.745708447656801e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2400929648852204 6.822477447922182e-05 6.734513359587738e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2446886541929985 6.813708453729172e-05 6.725498677795304e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2477401999519313 6.807422101942577e-05 6.719210499266661e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.2492622965939777 6.804151306619349e-05 6.715988094246444e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener deleted file mode 100644 index aba262f5f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04202427419527589 -1 0.04203819343951703 -2 0.04206663922950997 -3 0.042110856155735996 -4 0.042172787479328296 -5 0.0422551707394483 -6 0.0423616718678849 -7 0.04249706355690327 -8 0.04266745506039303 -9 0.04288058191379515 -10 0.04314616505603532 -11 0.04347634922953382 -12 0.043886229855924726 -13 0.044394475134901745 -14 0.04502404487826873 -15 0.04580299815477217 -16 0.0467653662816581 -17 0.047952043613821015 -18 0.049411613001676645 -19 0.051200972463545324 -20 0.05338556152127221 -21 0.05603889802814633 -22 0.05924103056727636 -23 0.06307539515993507 -24 0.06762345618227601 -25 0.07295644418592767 -26 0.07912353489693238 -27 0.0861360146134591 -28 0.09394617997244799 -29 0.10240480470714856 -30 0.11122729486361727 -31 0.11998914092971706 -32 0.12812290551922187 -33 0.13507106977153135 -34 0.14052883463476248 -35 0.1442608376718066 -36 0.146053492102032 -37 0.14575843859482807 -38 0.1435297943821569 -39 0.1397901285284156 -40 0.13494860151963053 -41 0.1291207337094112 -42 0.12234472821579757 -43 0.11476399938422355 -44 0.10676613418653115 -45 0.09872173428658386 -46 0.09091567347901552 -47 0.08354634398854648 -48 0.07671614963014885 -49 0.07047725282011548 -50 0.06485101076398221 -51 0.05983526420819895 -52 0.055410669872433295 -53 0.05154062482211275 -54 0.048176589337751916 -55 0.04527337329472695 -56 0.042790658445638875 -57 0.04069305750615932 -58 0.03895006005161101 -59 0.03753591280243378 -60 0.03642946955875758 -61 0.03561403639324741 -62 0.035077230278710965 -63 0.034810863699555966 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz deleted file mode 100644 index 8794c94b6..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_6.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8978159796825167 -4.028610513499038e-06 -3.5650418598073504e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8981282718087522 -4.0869727683485146e-06 -3.6183793999256646e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8987572191689226 -4.206022971906942e-06 -3.727407575399803e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8997116226590098 -4.390363417395252e-06 -3.896803942025078e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.901004870074107 -4.646743061806468e-06 -4.133449618403866e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9026551590969478 -4.983863718122925e-06 -4.446249752868138e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9046857931632908 -5.412104688152744e-06 -4.845891880964082e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.907125548533084 -5.943170628362143e-06 -5.344533185349511e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9100091099054584 -6.589657778021608e-06 -5.955407674703047e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9133775704833509 -7.364525695633537e-06 -6.692343483644135e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9172789903641543 -8.28046491119391e-06 -7.569177557247376e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9217690043180742 -9.349150551073257e-06 -8.599053164533597e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.926911466177327 -1.0580371950411062e-05 -9.793583386320717e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9327791119019855 -1.1981029471207051e-05 -1.1161862566667591e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.939454216559495 -1.3553992186108183e-05 -1.2709307865882701e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9470292115223764 -1.5296815034791746e-05 -1.4436316295155833e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9556072166610987 -1.7200318971807092e-05 -1.633672780111371e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9653024276234572 -1.924703803193928e-05 -1.8396091896528034e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9762402798560805 -2.1409534009868644e-05 -2.0589749574128474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9885572882524152 -2.364856120064625e-05 -2.288076149589036e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.00240043373405 -2.591151744416489e-05 -2.5217872436916455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.017925935462007 -2.8132762561826876e-05 -2.7534122077446155e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.035297210029664 -3.0233210104471703e-05 -2.9745635496295267e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0546817780290514 -3.21204904733199e-05 -3.1751183444460355e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0762468362017565 -3.3689956261570975e-05 -3.343296940427967e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.1001531727667557 -3.482651220757587e-05 -3.4659102677812204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.12654707053516 -3.5404883907845567e-05 -3.528778501451466e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.155549764648997 -3.5288882388122176e-05 -3.5173817137458714e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.187241449101104 -3.433170434677546e-05 -3.417865264670666e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.2216412469413713 -3.2382111963383574e-05 -3.218211519082495e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.258695743970447 -2.931386600620474e-05 -2.909503626316568e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.298272333589189 -2.5065145749805486e-05 -2.4877568140152216e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.34016016609659 -1.9678649425653198e-05 -1.9561187779697415e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3840807088697686 -1.3311990509938088e-05 -1.3262273421389856e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.4296922257989753 -6.172196302415008e-06 -6.166135431919723e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.47659098904163 1.5222610535815657e-06 1.4960176452932645e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.5243239630512706 9.510793929241758e-06 9.460672970232615e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.572418860855003 1.7499810062347594e-05 1.7452423524710218e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.6204109674756384 2.523457359668248e-05 2.521592437834687e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.667854301410021 3.253192704968164e-05 3.254091241464369e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.714327751533159 3.925885580255501e-05 3.927388303294857e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.759449235700605 4.531640598202856e-05 4.531875965953587e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.8028962212115336 5.064288829176215e-05 5.062882800533428e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8444226748734183 5.5216711586253376e-05 5.5193666154045674e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.88385346895518 5.905278268306527e-05 5.903280041396174e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.921072739716549 6.219534901548507e-05 6.219029006304804e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9560126651993572 6.471063007020991e-05 6.472749656207732e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9886433068644154 6.66792434042409e-05 6.671499935510214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0189645168713075 6.818567204245428e-05 6.822567338032754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.046999060372 6.931045076278708e-05 6.933030711301838e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0727866765433838 7.012551264650555e-05 7.009512222305992e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0963791635907234 7.069125036165483e-05 7.058047954425384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.1178364444089217 7.10543257648549e-05 7.084028490141883e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.137222864471989 7.125135348279761e-05 7.092271363785741e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.154603911432096 7.13146226906527e-05 7.087110187092866e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.17004370397338 7.127431182678016e-05 7.07241191911124e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1836031098069544 7.115900285074346e-05 7.051572495370694e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1953383586180606 7.099541083017548e-05 7.027516221157547e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.2053000381483887 7.080787470968041e-05 7.002706823375144e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.213532381977822 7.06178758437018e-05 6.979169601359021e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2200727755139966 7.044366583652507e-05 6.958521218712614e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.224951422177844 7.030001595484498e-05 6.942002632672218e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2281911250958575 7.019806804802454e-05 6.930510739378674e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.229807150894914 7.014525476365761e-05 6.924624869771312e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener deleted file mode 100644 index 2f9c5154b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04196953734854048 -1 0.041982244582010456 -2 0.04200821034582581 -3 0.04204856445668673 -4 0.04210507099661592 -5 0.04218021520097934 -6 0.0422773254634851 -7 0.042400735818370526 -8 0.04255599564613359 -9 0.0427501346602363 -10 0.042991992324205495 -11 0.04329262147675258 -12 0.04366577571654324 -13 0.04412848842402384 -14 0.044701747305799906 -15 0.04541126080788455 -16 0.046288299984122636 -17 0.04737057924044942 -18 0.04870310910550324 -19 0.05033891071988255 -20 0.052339422008515414 -21 0.05477434724113537 -22 0.0577206049623673 -23 0.06125991898479421 -24 0.06547448682037978 -25 0.07044007697947366 -26 0.07621589855431567 -27 0.08283072682273204 -28 0.09026515712253111 -29 0.09842335493072557 -30 0.10708536882685105 -31 0.11589740119638758 -32 0.12436590372587204 -33 0.13189207122712596 -34 0.13806809596268665 -35 0.14264654374109662 -36 0.14541030270912325 -37 0.14617172195436134 -38 0.14489282271958023 -39 0.14190099182296279 -40 0.1376338743489742 -41 0.13237158088241263 -42 0.12615227010197355 -43 0.11904056059282447 -44 0.11129692262292946 -45 0.10332175096641658 -46 0.09544087764730547 -47 0.08789775407896246 -48 0.08084439696876068 -49 0.07435460255496354 -50 0.06846520139114567 -51 0.06318604172890484 -52 0.05850686694643862 -53 0.05440275857283308 -54 0.05083267331271065 -55 0.04775009156419277 -56 0.045113020120012136 -57 0.04288441988003665 -58 0.04103223220376689 -59 0.03952931446396736 -60 0.03835332683167748 -61 0.03748660122359935 -62 0.036916014663044935 -63 0.0366328826046249 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz deleted file mode 100644 index dbecbd925..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_7.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8965568666991899 -4.588078527096859e-06 -4.144636128281333e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8968537720169967 -4.649680265378605e-06 -4.201588280315056e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.897451707121282 -4.774708913838731e-06 -4.317332196128768e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8983589923935953 -4.966779282465679e-06 -4.495529818456639e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8995882868365117 -5.2311961539958015e-06 -4.741574000506416e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.901156801625892 -5.574805101535365e-06 -5.062452595469091e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9030865837235402 -6.005777874684609e-06 -5.466564594934753e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9054048682033031 -6.533335976123867e-06 -5.9634798557790925e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.90814449709151 -7.16740709233778e-06 -6.563633846784319e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9113444012725052 -7.918201938663792e-06 -7.277947941838295e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.915050140219553 -8.795701644810472e-06 -8.117363024949191e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.919314491809013 -9.809045182895552e-06 -9.092272341299037e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9241980810422366 -1.0965806008849506e-05 -1.0211837286843315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9297700318627806 -1.227114789863771e-05 -1.1483168554625725e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9361086200889457 -1.3726852015512181e-05 -1.2910354888634859e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9433018973785112 -1.5330211672080035e-05 -1.4493324097527434e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9514482456400255 -1.7072796317905898e-05 -1.6226525165516502e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.960656807863374 -1.8939089110164678e-05 -1.8097426463781383e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.97104772438198 -2.090500438895976e-05 -2.0084837809619745e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9827520825070737 -2.2936284772901693e-05 -2.215708210168009e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9959114617791214 -2.4987110771800983e-05 -2.427016223716368e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.01067692644118 -2.7000052398315022e-05 -2.6366368712770393e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.027207281281395 -2.8905522297323557e-05 -2.8373013133070546e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0456663675561173 -3.062172280376228e-05 -3.0201752763540088e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.06621913443754 -3.205533584683959e-05 -3.174888667527909e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0890261823659753 -3.310301896298905e-05 -3.28970242430309e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.1142364447532302 -3.365222412299664e-05 -3.351826051727239e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.14197766378892 -3.358186224220077e-05 -3.347933781323716e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.172344334038455 -3.276405373463894e-05 -3.2649456155080185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.2053812016232643 -3.106469250246989e-05 -3.091038712199254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2410667872766408 -2.835653945592035e-05 -2.8166866576069723e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.279305508409514 -2.455034999739649e-05 -2.43592707077872e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.3199244127652574 -1.9629793511110425e-05 -1.9481217452528926e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3626768662750344 -1.36818318623962e-05 -1.3598397073347778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.407253157403654 -6.882733496065429e-06 -6.852695356659494e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.4532858288218593 5.63905955266529e-07 5.582069885873884e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.500355102061761 8.438188392970528e-06 8.399999212009082e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.548005264865397 1.647262065273241e-05 1.6413605370784385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5957723572825437 2.4385640865350934e-05 2.433756791480932e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6432065948049908 3.1951309017661184e-05 3.193790428477724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.689883042525204 3.90147095439944e-05 3.9028349114356225e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.735408692599177 4.546230071496612e-05 4.547806186719656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.779435859361417 5.1211052159955535e-05 5.121044194652228e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.821677131679718 5.6213111435807304e-05 5.619420608773319e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8619172173260976 6.0458957422459255e-05 6.0430591439415186e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9000059657040556 6.397281215796824e-05 6.394802841917511e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9358472340065043 6.680535107891478e-05 6.679678476226381e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9693884618268553 6.90265863629903e-05 6.904196791106214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.000611224369587 7.071878954617557e-05 7.075598761327601e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0295236398292738 7.196681021723425e-05 7.201245198845529e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0561539453932443 7.285104320383582e-05 7.28824117585492e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0805449768051045 7.344343107027165e-05 7.343226857092276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.102749509571541 7.380516706466512e-05 7.372270603869284e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1228265057808087 7.39850017250833e-05 7.380817753713556e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1408378764512594 7.402115525012008e-05 7.373728435698962e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1568455563244426 7.394687397973563e-05 7.35536887968507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1709092461545434 7.379290349763545e-05 7.32963529411441e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1830847230815653 7.358803985085553e-05 7.299951662731125e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.193422596205607 7.335887294319743e-05 7.269266870215398e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.2019674056524723 7.312927606471794e-05 7.240059406520661e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.208756982629277 7.29198840015618e-05 7.214350273071068e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.213822004889515 7.274765692083532e-05 7.193721380831316e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2171856967003376 7.262555506316466e-05 7.179335698604439e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.2188636350774367 7.256231629483702e-05 7.171955489078067e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener deleted file mode 100644 index 998c568de..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04194012329997676 -1 0.0419521527720407 -2 0.04197673071603981 -3 0.04201492071450579 -4 0.042068383330353086 -5 0.04213945780608267 -6 0.04223127684347383 -7 0.0423479195747651 -8 0.04249460918456512 -9 0.04267796294328453 -10 0.04290630354352807 -11 0.04319004137591249 -12 0.04354213739377418 -13 0.043978654965528045 -14 0.04451940581496669 -15 0.04518868868634656 -16 0.046016108209447036 -17 0.0470374435580314 -18 0.048295509361406835 -19 0.049840911989420346 -20 0.051732549718657476 -21 0.05403763290195245 -22 0.056830909467142116 -23 0.060192675277374035 -24 0.0642050389512481 -25 0.06894581974657119 -26 0.07447942632040912 -27 0.08084415902670551 -28 0.08803569170908836 -29 0.0959846924924321 -30 0.10451073757849966 -31 0.11330148182934606 -32 0.12190845862746806 -33 0.12975264186924948 -34 0.13634518357850636 -35 0.14141951638896344 -36 0.14475603579009552 -37 0.14615639749646314 -38 0.14550795089347615 -39 0.14303136108064418 -40 0.13915060455463096 -41 0.13423546836663236 -42 0.12836573963304282 -43 0.12158638058012451 -44 0.11406459514991728 -45 0.10618772705186642 -46 0.09830626145919072 -47 0.09068791479618038 -48 0.08351692956180229 -49 0.07688710924212741 -50 0.07084561933972346 -51 0.06541050079324771 -52 0.06057774915293659 -53 0.05632755741924666 -54 0.052626672314726494 -55 0.04942988447376093 -56 0.046694269321995004 -57 0.044381843181182865 -58 0.042459645772376604 -59 0.04089971510052133 -60 0.03967900106955908 -61 0.03877925220373704 -62 0.038186900383236216 -63 0.03789296111654189 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz deleted file mode 100644 index f1bd1f9a8..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8958581999206419 -4.8680277599829295e-06 -4.441486175283861e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8961459056046055 -4.930283294765563e-06 -4.499300155433196e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8967252932130516 -5.056332382568e-06 -4.616474885276018e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8976043845889603 -5.249218528324607e-06 -4.796084048528479e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.898795385760316 -5.513409235422537e-06 -5.042656473224096e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9003148944051365 -5.85467247809568e-06 -5.362067728142766e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9021841755492694 -6.279900402858112e-06 -5.761391372266775e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9044295043506394 -6.796879729073745e-06 -6.248702654577927e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9070825740587725 -7.414002694181318e-06 -6.8328266089667534e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.910180966103793 -8.139907735622323e-06 -7.523021133973093e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9137686776313751 -8.983039935388208e-06 -8.328583209633614e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.917896699499042 -9.951120464885866e-06 -9.258364489756397e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9226236345788605 -1.1050513907659269e-05 -1.0320180439346198e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9280163419159135 -1.2285483027799712e-05 -1.1520095857771568e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9341505865620696 -1.365732252595812e-05 -1.2861569292954984e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.941111667357038 -1.516336744533048e-05 -1.4344440594497384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9489949851220238 -1.6795877371615153e-05 -1.5963749543203163e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9579065011480619 -1.8540802924107974e-05 -1.7708379648901188e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9679630199395537 -2.0376447214243715e-05 -1.9559533062321877e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9792922103290278 -2.227203750525472e-05 -2.1489060005193865e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9920322547875058 -2.4186428784395714e-05 -2.345774761198459e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.0063309876467694 -2.606764992610705e-05 -2.5413867175631144e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0223443490416435 -2.7852242479312654e-05 -2.7291844711173174e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0402339433245773 -2.9465032350338127e-05 -2.9011405882114994e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0601634503043096 -3.081954160505814e-05 -3.0477523791579954e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0822935984364452 -3.181913591824302e-05 -3.158153744639648e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.106775377215175 -3.235805590932343e-05 -3.220366911839773e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1337411513059066 -3.2322661978050236e-05 -3.2217383399124684e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.163293356125858 -3.159362080684683e-05 -3.1496121728321614e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1954904019624393 -3.0047135165487627e-05 -2.99222635481677e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2303295068839653 -2.755943377875317e-05 -2.7397294165103147e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.267736499190767 -2.4031005752814797e-05 -2.3852197598088504e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.307561480199159 -1.9418452831223412e-05 -1.9262137523914124e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.349579772444302 -1.3765782740204285e-05 -1.3664393762959254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.393500368458386 -7.216629660059491e-06 -7.171251838809915e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.438974050327761 3.508735420831755e-08 4.1452419075679566e-08 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.485599635417053 7.783645297046363e-06 7.756505134795124e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.53293522100764 1.578689183477721e-05 1.5728447776133324e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5805205644803024 2.376284864336961e-05 2.3698628884683257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6279031331805185 3.145945242826066e-05 3.1423163497891604e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.674652386274464 3.86968719669288e-05 3.869788235446143e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.7203688335236267 4.535361781526583e-05 4.537116858667671e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.76469325974449 5.133718015605995e-05 5.134603451360962e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.807320507323918 5.6586250796125705e-05 5.6575176450877983e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8480111230205596 6.107575375470371e-05 6.104892379575989e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.886593503056448 6.481666855909687e-05 6.478581389991801e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9229534271367204 6.784933707726341e-05 6.782825791942204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9570235073162943 7.02361514540329e-05 7.023641363387885e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9887735400158935 7.205492371024401e-05 7.208102046684253e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.018202150794045 7.33909203441837e-05 7.343653239344367e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.045330037042902 7.432813130358481e-05 7.437640801729877e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0701941662053636 7.49440100731309e-05 7.497037543641385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.092842839189349 7.530662517041693e-05 7.528297779018778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.113331553729586 7.547305271003923e-05 7.537286236681931e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1317196526204834 7.548834891530693e-05 7.529248829266743e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1480674175722756 7.538910438117983e-05 7.508877186811404e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.162433581181935 7.520793242564115e-05 7.480373856189447e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1748734425356244 7.497502362979176e-05 7.447462007108964e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.185437466777092 7.471828895417412e-05 7.413379670636859e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.194170260932313 7.446294950077127e-05 7.380875928804382e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2011098380919285 7.423097720030838e-05 7.352214064158206e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2062870997554676 7.404056781188734e-05 7.329180979832711e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2097254816531935 7.390571531829176e-05 7.313099999455114e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.211440721863998 7.383590292839817e-05 7.304843691922246e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener deleted file mode 100644 index 559de7f50..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04192071540988187 -1 0.0419323074659327 -2 0.041955990079457384 -3 0.04199278480627341 -4 0.042044286552461875 -5 0.04211274201613616 -6 0.04220115993157387 -7 0.04231345807011824 -8 0.04245465327597851 -9 0.04263110210922754 -10 0.0428508008207388 -11 0.04312375419806772 -12 0.04346242297780677 -13 0.0438822585251563 -14 0.044402330603632356 -15 0.04504604824880446 -16 0.04584196357317651 -17 0.0468246318442424 -18 0.048035475967952594 -19 0.04952356670692098 -20 0.05134617851734779 -21 0.05356891217067314 -22 0.05626508828932307 -23 0.05951401310273079 -24 0.06339760837238655 -25 0.0679948020022467 -26 0.07337303174070849 -27 0.07957628194545846 -28 0.08660933980433268 -29 0.09441758277051122 -30 0.10284529374457874 -31 0.11160603143573884 -32 0.12027940154082536 -33 0.12830925439547033 -34 0.13516063745919746 -35 0.14054456422087022 -36 0.14423765400455962 -37 0.14603739091462428 -38 0.1458015548287259 -39 0.14367160724352815 -40 0.14005436089814596 -41 0.13535457306281404 -42 0.12970263347716052 -43 0.1231355859872112 -44 0.11577438033651932 -45 0.10797666764720155 -46 0.10010848771379521 -47 0.09245291308885899 -48 0.08521233556481599 -49 0.07849720207998781 -50 0.07236163578686053 -51 0.06682912146252433 -52 0.06189983727812716 -53 0.05755706525847329 -54 0.05377159904088672 -55 0.05050090727634307 -56 0.04770150555426588 -57 0.04533480856129836 -58 0.043367278846348535 -59 0.04177042806829096 -60 0.04052074871552562 -61 0.03959961291343041 -62 0.03899316496290895 -63 0.03869222642449964 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz deleted file mode 100644 index 5d907ce46..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_9.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8953880328055166 -5.0130787712638725e-06 -4.596255343379978e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8956697612924167 -5.076576070612137e-06 -4.655448155008299e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.896237099989678 -5.204921343507293e-06 -4.775189603145139e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8970978804057614 -5.400786528779379e-06 -4.958172241477491e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8982640198412206 -5.668094505885149e-06 -5.2083651588148084e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8997517250567304 -6.011911615174307e-06 -5.530922135909751e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9015817630398908 -6.438294456032044e-06 -5.932054348191314e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.903779797855278 -6.954088759238604e-06 -6.4188609495151826e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9063767918539674 -7.5666738296934055e-06 -6.999109734504425e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9094094684586695 -8.283642442170246e-06 -7.680958548426498e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.9129208322015752 -9.112406184253573e-06 -8.47260582614492e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9169607395204846 -1.005971537072823e-05 -9.381856705446286e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9215865108180312 -1.11310822617166e-05 -1.0415589176962866e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9268635702125572 -1.2330096930659368e-05 -1.1579103386693028e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9328660939612572 -1.3657627037861727e-05 -1.2875336788972256e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9396776413462518 -1.5110896708000047e-05 -1.4303929254858241e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9473917324560697 -1.66824453539696e-05 -1.5860125635680215e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.956112325265467 -1.8358973868179214e-05 -1.7533509355058717e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9659541291665434 -2.0120093936217227e-05 -1.930657191992844e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.977042673054979 -2.193700353593643e-05 -2.1153140284933235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9895140226968455 -2.3771252900918377e-05 -2.303674539328656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.003514013995765 -2.5574089426429172e-05 -2.4909152667608896e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.01919683589849 -2.7285733495280377e-05 -2.6709008370162234e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0367227595465063 -2.8835045685809015e-05 -2.836089176327729e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0562547704935983 -3.013976698021906e-05 -2.9775070191315354e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0779538215461404 -3.110743901272365e-05 -3.0848302488412675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.1019723907024526 -3.1636488282068106e-05 -3.1465965016780276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.128446010867251 -3.161769471125333e-05 -3.150592054151664e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.15748244925535 -3.093646831226285e-05 -3.0844592020810614e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1891482741174926 -2.9474589035779926e-05 -2.9365210648000647e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2234525462395376 -2.711220918282908e-05 -2.6967703208554634e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2603346088926632 -2.374609228953151e-05 -2.3578382977981898e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.299658996939004 -1.9319553439378824e-05 -1.916282789624497e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.341215365364151 -1.3853409377993662e-05 -1.3742722400934995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.384724909225187 -7.46636214749746e-06 -7.411235127803613e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.429849678336601 -3.42864483703564e-07 -3.2909696795593646e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.476199032751295 7.316890058572454e-06 7.297316354531806e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.523339414598455 1.5286139116514928e-05 1.5231740651636708e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.57081425902459 2.3291056197035297e-05 2.322002298332427e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.61816918789958 3.106581168067886e-05 3.101445253265021e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.6649696781561163 3.8412475714453565e-05 3.8401061437919206e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.710810904530623 4.5201095380382286e-05 4.521571469464244e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.755326257938455 5.13350108412465e-05 5.134847434765659e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.798200159478623 5.6745829198609515e-05 5.6740739749077724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8391793715052205 6.139909344921678e-05 6.137526267337509e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.878078532051734 6.529689674446522e-05 6.526431447609267e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.914771793957555 6.847246159242888e-05 6.844492062519706e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9491821595391614 7.098282716266558e-05 7.097341542381775e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9812717020586406 7.290196714647324e-05 7.291866486167306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.011032897327867 7.431405143075688e-05 7.43550464291655e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.038481544479951 7.530444737898028e-05 7.53571033204611e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0636507863322797 7.595343886239649e-05 7.599634432776649e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0865860014272815 7.6332825578528e-05 7.633948934665525e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.107340507449314 7.650416889405788e-05 7.644759460449442e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.125972003370495 7.651768424519157e-05 7.637563715872254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1425396514597224 7.64130563029271e-05 7.617263684682473e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.157101510333914 7.622439105117741e-05 7.588246211318034e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.169712525706377 7.598275808302583e-05 7.554409775090243e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.180423029835724 7.571676616530362e-05 7.519161299403245e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.189277638190774 7.545230743682428e-05 7.485408796822535e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.196314452014182 7.521202009590526e-05 7.455558944122418e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2015644936511505 7.501472626329336e-05 7.431520850511981e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2050513175471917 7.487495339559412e-05 7.414714017124631e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.206790753846926 7.480257515468446e-05 7.406077512536044e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 deleted file mode 100644 index 7ab572db3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL.hess_15 +++ /dev/null @@ -1 +0,0 @@ -1.727383303901745479e-02 9.876045985552216080e-05 9.301372163904792812e-05 1.725965036487376453e-02 9.903296422322807276e-05 9.329785760897939490e-05 1.723106007309421414e-02 9.956761471920773734e-05 9.385710205058722514e-05 1.718760795879083550e-02 1.003438914951457965e-04 9.467355317945790841e-05 1.712860185230593787e-02 1.013315037473431108e-04 9.572073782516736203e-05 1.705309839468980432e-02 1.024909693080474856e-04 9.696405707962897570e-05 1.695988508623337207e-02 1.037743758618825651e-04 9.836136457634600289e-05 1.684745733078327895e-02 1.051263146205977589e-04 9.986366447657460952e-05 1.671399012500478579e-02 1.064849758664791020e-04 1.014159139504167216e-04 1.655730396744246880e-02 1.077833948716652539e-04 1.029579133843452329e-04 1.637482449008172136e-02 1.089508363226908476e-04 1.044252669438727044e-04 1.616353524829612642e-02 1.099143054934201031e-04 1.057503967539088292e-04 1.591992305337416869e-02 1.106001749670933496e-04 1.068635962071205894e-04 1.563991520563156462e-02 1.109359165246224800e-04 1.076941121448503341e-04 1.531880800676637192e-02 1.108519286692303282e-04 1.081712523510421943e-04 1.495118602645078079e-02 1.102834507606511775e-04 1.082255243796680392e-04 1.453083181417766205e-02 1.091725543321596468e-04 1.077898245488184589e-04 1.405062614746193858e-02 1.074702000501406775e-04 1.068007120558834341e-04 1.350243958181548097e-02 1.051383438114447769e-04 1.051998221693285020e-04 1.287701714319420404e-02 1.021520660633386040e-04 1.029354930347903924e-04 1.216385965032427095e-02 9.850168245408583503e-05 9.996470014182481337e-05 1.135110759802385356e-02 9.419476864618741598e-05 9.625540636951097743e-05 1.042543705672739282e-02 8.925799424258686336e-05 9.178943677904237582e-05 9.371981988663766888e-03 8.373860657710494092e-05 8.656596615126032268e-05 8.174304119689616149e-03 7.770533093862153388e-05 8.060565145883772623e-05 6.814440388895224784e-03 7.124835651042790198e-05 7.395533735287364231e-05 5.273069239329630786e-03 6.447795474182070380e-05 6.669309788478391683e-05 3.529850493512150592e-03 5.752112655889230657e-05 5.893314379738244838e-05 1.564008500679232860e-03 5.051548806989974896e-05 5.082981988244174786e-05 -6.360958036632190227e-04 4.357541628624850294e-05 4.258350576582113265e-05 -2.830310340706148134e-03 3.617097866584258073e-05 3.448502374140691780e-05 -4.844214584222945527e-03 2.816769406016551082e-05 2.665248869309457181e-05 -6.594061415177154828e-03 1.990528396653173287e-05 1.918651019803476219e-05 -7.993078852302050799e-03 1.203985439445222588e-05 1.233878119343504988e-05 -9.087774815752534818e-03 6.219049174407898834e-06 6.803049194916287488e-06 -1.000742582528402376e-02 3.110452334575398169e-06 3.200542223193799929e-06 -1.069934570915073192e-02 1.274164383519764496e-06 1.408083450309705753e-06 -1.096942489298423709e-02 6.821408442325081452e-07 1.314570769652686566e-06 -1.076791963106161001e-02 3.051907752271295032e-06 3.129955718070008314e-06 -1.030761396249101763e-02 7.853747603154791744e-06 6.736075830434458834e-06 -9.710639865800278769e-03 1.318541695007172153e-05 1.163698649880599216e-05 -8.966647294758708225e-03 1.792850279461740499e-05 1.732365920739451892e-05 -7.934275668239884616e-03 2.306672784326020264e-05 2.343140223888938597e-05 -6.618336452019358412e-03 2.882553680551470801e-05 2.959544462302374592e-05 -5.120479058678744852e-03 3.505761333585043736e-05 3.558358883311735785e-05 -3.753129911485434886e-03 4.134598833370841699e-05 4.153359546500197006e-05 -2.548208049675364240e-03 4.746633660210726685e-05 4.731435169642162061e-05 -1.493512788805755748e-03 5.326358121242644834e-05 5.277143267427324082e-05 -5.744910153884352083e-04 5.860336931087591528e-05 5.778806551649603323e-05 2.365336683252724365e-04 6.322166304470301450e-05 6.234585377909795749e-05 9.528980440722933237e-04 6.710375251076490738e-05 6.648617069429822789e-05 1.582923401194022417e-03 7.032399225828891878e-05 7.025195579926990573e-05 2.134541141321846802e-03 7.296374557798316761e-05 7.368148530392251098e-05 2.615145479200166670e-03 7.510355382844396402e-05 7.680448685395513224e-05 3.030928733205361450e-03 7.683988756418429949e-05 7.964517405242436997e-05 3.377774045574535519e-03 7.861646644413388123e-05 8.227659514335519393e-05 3.661236113113291307e-03 8.049641603513580865e-05 8.468652921785852308e-05 3.890567089390303476e-03 8.236917054529611687e-05 8.683883846474603615e-05 4.073571877971898098e-03 8.414003130964540513e-05 8.870869329199827856e-05 4.216712840588885888e-03 8.572999660325585861e-05 9.028001308339974338e-05 4.325209080886620316e-03 8.707517545176822861e-05 9.154314832875224935e-05 4.403124515458753385e-03 8.812595910325828064e-05 9.249287137535040998e-05 4.453441112598670662e-03 8.884612708742146091e-05 9.312672820984942493e-05 4.478115131312937480e-03 8.921204068014498834e-05 9.344378465597305583e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893898027e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.270549420881450509e-18 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 -8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 -4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 -2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 -1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893900247e-01 0.000000000000000000e+00 6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 6.776263578034402713e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.016439536705160407e-17 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener deleted file mode 100644 index 4dd14351e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04188996657777692 -1 0.041900863526889834 -2 0.041923123290036494 -3 0.04195770050408234 -4 0.0420060855131063 -5 0.04207037759868062 -6 0.042153387961075615 -7 0.04225877714797312 -8 0.04239123290766601 -9 0.042556695720057956 -10 0.04276264043735885 -11 0.043018423378940955 -12 0.043335704593480864 -13 0.04372895439217363 -14 0.044216051019865206 -15 0.04481897152736948 -16 0.04556456922968684 -17 0.04648541682458694 -18 0.04762067205218661 -19 0.04901688998007385 -20 0.05072865960581607 -21 0.05281887968573434 -22 0.05535840789837423 -23 0.058424719865035474 -24 0.06209910701146486 -25 0.066461841209792 -26 0.07158467096788483 -27 0.07752004091605551 -28 0.08428662141762541 -29 0.09185113866674895 -30 0.10009593976347193 -31 0.10877697963014449 -32 0.11751915734160046 -33 0.12581135530799012 -34 0.13307220508135698 -35 0.13895092600109205 -36 0.1432150762092829 -37 0.1456581628459286 -38 0.14610963278888334 -39 0.14458378473150957 -40 0.14143639238751873 -41 0.13709530919860483 -42 0.1317981110496677 -43 0.1255805307751963 -44 0.11851733915702649 -45 0.1108844393473955 -46 0.10306701924110809 -47 0.09537350522366975 -48 0.08803268331193705 -49 0.08118650169152661 -50 0.07490294300227612 -51 0.06921489462993596 -52 0.06412983710469453 -53 0.05963651004553192 -54 0.05571064347467451 -55 0.05231629164973843 -56 0.049410067695638174 -57 0.04695241828952321 -58 0.044908869850933196 -59 0.04325007570479916 -60 0.041951779568970234 -61 0.04099473574992911 -62 0.040364615621776574 -63 0.040051921394414956 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz deleted file mode 100644 index 03f537d8c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_15.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8946271398760188 -5.225674326534558e-06 -4.825299010770842e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.894899109419571 -5.2916432707833165e-06 -4.887187119363123e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.895446775546507 -5.4246169236537335e-06 -5.0119991824009696e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8962776582522902 -5.626641858383424e-06 -5.2017878008586234e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8974032022448168 -5.9007235149928205e-06 -5.459581488696508e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8988389743444964 -6.250744972334116e-06 -5.7893202884395674e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9006049261077105 -6.681351960823729e-06 -6.195763822662202e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9027257208707462 -7.197798664507583e-06 -6.684366088456167e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.90523112379517 -7.80574713701134e-06 -7.261109594481661e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9081564525570596 -8.511011512938801e-06 -7.932289568040796e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.911543084944227 -9.319236953174516e-06 -8.704236947962577e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9154390176656064 -1.0235502275610576e-05 -9.582966901477077e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9198994679528358 -1.126383482718653e-05 -1.0573737795484804e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9249875058165546 -1.2406626692887115e-05 -1.1680504208512654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9307746998326776 -1.3663943213980859e-05 -1.290524706979121e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9373417527292698 -1.503271850069238e-05 -1.424716492717185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.944779094420871 -1.650583865094421e-05 -1.570171339007281e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.953187389015454 -1.8071122182861637e-05 -1.7259485953697328e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9626778981716309 -1.9710219250651552e-05 -1.890494006963599e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9733726254423485 -2.1397466597219028e-05 -2.0614988994520776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.985404144367682 -2.309876285158577e-05 -2.235750689012247e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9989149866301472 -2.477057117183863e-05 -2.4089835630680675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.014056435407754 -2.635910038661744e-05 -2.5757405486377288e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0309865334809216 -2.7799808120986523e-05 -2.7292656105029734e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0498670769172844 -2.9017358809225584e-05 -2.8614503494832755e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.070859325905254 -2.992615438489003e-05 -2.9628661207129954e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.094118129360892 -3.0431472525075695e-05 -3.0229166038632114e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1197841372029558 -3.043120969346356e-05 -3.0301482705393987e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1479737758413475 -2.981808737647457e-05 -2.9727518169822278e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.178766705931564 -2.8481822464053572e-05 -2.8392702192500464e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.212190608326317 -2.6310492811714702e-05 -2.6195001186767487e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2482067670047514 -2.319860216518191e-05 -2.3054335836613523e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2867031902053014 -1.9072547471747827e-05 -1.8922911325537084e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3274929122114663 -1.3920337147790386e-05 -1.3799825996184825e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3703181182985524 -7.817417906453827e-06 -7.747436062366614e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.4148594137053774 -9.240550242396838e-07 -8.987028790194439e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4607429171896102 6.567104365739194e-06 6.559199249699151e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.507548727689012 1.4449371230768683e-05 1.4405220830461087e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.554827002764131 2.2471398928987787e-05 2.239554565206991e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.6021216915269947 3.035498083996165e-05 3.028046212828326e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.648991957297969 3.7870917165324084e-05 3.7832354620149705e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6950236423421674 4.4865869090935684e-05 4.48671592704662e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.73983806768427 5.123747267698633e-05 5.1253610279762644e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7831028413206846 5.690802039625416e-05 5.6913142731370934e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8245439522388858 6.182948478653381e-05 6.181367386648955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8639534578924675 6.598876546999072e-05 6.595736191042346e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9011861646946615 6.940660101072146e-05 6.937213695273768e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.936149039492901 7.213054584672816e-05 7.210735952696322e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.968791143171844 7.422776215706213e-05 7.42278049024549e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.999094611103431 7.577867899885721e-05 7.580687723786092e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0270670057098226 7.686954249543517e-05 7.692038513930809e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.052735015597897 7.75844301862082e-05 7.764246694994407e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.076139066907417 7.800060124858014e-05 7.804325146392526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.097328765727429 7.818614923009226e-05 7.81876256634651e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.116359097484316 7.819890905789125e-05 7.813464424699091e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.133287296790556 7.808580578382377e-05 7.793725285196824e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1481702244493515 7.78846917365719e-05 7.764256848804073e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.161062173004411 7.762859424139345e-05 7.729250801913218e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1720131988989606 7.734741862733973e-05 7.692390566845112e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1810678866287674 7.706815229061926e-05 7.656842835474966e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1882644479839457 7.681446374419966e-05 7.62524778961691e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1936340784233743 7.660612985522283e-05 7.599714036390405e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1972005095141953 7.645849099769777e-05 7.581818499920253e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1989797112554377 7.638201772451874e-05 7.572609308953489e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz deleted file mode 100644 index b7c941ca3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_FINAL_forces_15.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005010508174177688 2.880141698218864e-06 2.659473977688845e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.000505731984652697 2.9165006244063527e-06 2.6935837424852152e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005151464703787807 2.9897893405538334e-06 2.7623741807585497e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005293988647536939 3.1011358199240455e-06 2.8669765879716553e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005486467129722798 3.252196517279274e-06 3.009060136138709e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005731011373683852 3.445111599920587e-06 3.1907963882121183e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006030273709696027 3.682441572206831e-06 3.4148086204597325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006387449225388285 3.967082289029679e-06 3.6841028151652482e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006806269888151341 4.302154403481119e-06 4.001976244905471e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.000729098600334379 4.690862388412898e-06 4.371898537812508e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007846328257909343 5.136317586446236e-06 4.79735900450369e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008477441585479468 5.641319199038137e-06 5.281672917397186e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.000918977959018366 6.208086907157791e-06 5.827738436774011e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0009988945193813033 6.837939113614044e-06 6.437735137135464e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0010880459444634087 7.530911831388253e-06 7.112754811907943e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0011869435989032466 8.285315288705059e-06 7.852355739007727e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0012960133558410697 9.097228643060683e-06 8.654033267744839e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014155353062609184 9.959938044394604e-06 9.512602982672253e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001545563978430439 1.0863329935542299e-05 1.0419498574645277e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0016858245300475914 1.1793259956895301e-05 1.1361995735164115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018355799135251 1.2730933064142816e-05 1.2322388239061923e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0019934638471937574 1.3652353832777404e-05 1.327716496813784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0021572748213821357 1.4527875142456375e-05 1.419624969787255e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.00232372773480264 1.5321924323752095e-05 1.5042406394156668e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002488162680816023 1.5992980016810927e-05 1.5770945439676976e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0026442156899678317 1.6493864662326865e-05 1.6329900654495044e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002783464919479201 1.6772371847327867e-05 1.666087019012208e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0028950790706707545 1.6772226987116835e-05 1.670072767729067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029655139049724957 1.6434303297096218e-05 1.6384385883121654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029783486643399906 1.5697818002827464e-05 1.564869917256409e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029180801211318185 1.4501084972503415e-05 1.4437431513826034e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0027774641243684525 1.278595971759301e-05 1.2706447018830111e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0025549109073469346 1.0511875756533794e-05 1.0429403471172655e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002255148340938154 7.672223902097584e-06 7.605803920454809e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018884306549855673 4.308586773280921e-06 4.2700161286752325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0014625602879105362 5.092949235752104e-07 4.95322033948823e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0009868523728680872 -3.619473763276723e-06 -3.6151168414875923e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.00047893685675401307 -7.96380218022102e-06 -7.939468591678524e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 3.530477438730657e-05 -1.2385160082413421e-05 -1.234335338491442e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0005325857262817188 -1.6730213289771892e-05 -1.668914214078875e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0010004251125810912 -2.0872637838105642e-05 -2.0851384007995674e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0014292142803359396 -2.4727920708622863e-05 -2.4728631793859303e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018071524363355467 -2.8239643794679583e-05 -2.824853806932455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002121044644027006 -3.1364978424714566e-05 -3.1367801610784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002362483296822944 -3.407745415914167e-05 -3.406873993639046e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025350393159975886 -3.63698506964063e-05 -3.6352542556684896e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002650202785526583 -3.8253598140928166e-05 -3.8234603200890495e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002718901028178075 -3.975490622398154e-05 -3.9742127033735385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.00275092379976032 -4.091079152569403e-05 -4.0910815084909634e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027545521060843865 -4.1765582694719316e-05 -4.178112421508513e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002736585679037901 -4.236681446831179e-05 -4.239483650135785e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027028444779164077 -4.276082636401755e-05 -4.2792813451773205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002658259634966319 -4.299019994442671e-05 -4.30137067027851e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002606953084952551 -4.309246511542289e-05 -4.3093278854867036e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025523299758952664 -4.309949772208943e-05 -4.306407803267972e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024972609662667327 -4.303716060816085e-05 -4.295528533873251e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002444164337346623 -4.2926316166392555e-05 -4.279286941471461e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023948813207254832 -4.278516747847537e-05 -4.25999328307637e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002350777874996688 -4.263019693114402e-05 -4.2396776848603205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023128509070616137 -4.247627868614102e-05 -4.2200854758938395e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022818137832638463 -4.233645769553823e-05 -4.202671798089454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022581633311467737 -4.222163402240049e-05 -4.188598814817942e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022422305037931006 -4.214026254701479e-05 -4.178735651218564e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022342166099583 -4.209811413723659e-05 -4.1736599857153466e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz deleted file mode 100644 index bb6a9c240..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0026422684125283935 1.0884151784643673e-05 1.0896927779613405e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0026508558212976355 1.095255728649753e-05 1.0967680697280016e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0026650990115527112 1.1085060275124511e-05 1.1104468701317897e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0026847329173591626 1.127681008299612e-05 1.1302065424004143e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002709353087074789 1.1521915233655251e-05 1.15540509645615e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0027383997844794934 1.1813358852033914e-05 1.1852511738528695e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0027711204773091308 1.2142749233511634e-05 1.2188006948530475e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0028065392775141573 1.250023666550174e-05 1.2549642701979164e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0028434134770780614 1.287460314358513e-05 1.2925192237940836e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.002880179322960277 1.325336754179739e-05 1.3301262450053821e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0029148893905362166 1.3622906555610938e-05 1.3663498158578205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.002945170832769486 1.3968614356514076e-05 1.399683954178565e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.002968176733194069 1.4275082179635167e-05 1.428580330292288e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0029805310900656696 1.4526284585340354e-05 1.4514765330191754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.002978300816058654 1.4705768027332552e-05 1.4668232157114699e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002957647277916273 1.4796885425189734e-05 1.4731132482627247e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0029153473665308655 1.4783086151249245e-05 1.4689126921834646e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0028484957799799287 1.4648181227286073e-05 1.4528864935365823e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002754690043154893 1.4376537098962445e-05 1.4238171381089697e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0026322963494654246 1.3953116878992028e-05 1.3806149182346819e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002480640151439093 1.3365370230714955e-05 1.3223747844346644e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0023001519875567003 1.2610216483971474e-05 1.2486178339145003e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002092430106010159 1.1692227341847834e-05 1.1593258558202013e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.001858862853873094 1.0621659742091016e-05 1.0549466751500612e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0016006300616233195 9.412899005719398e-06 9.36389247917215e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0013196465891901585 8.0830514003001e-06 8.049994219580213e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0010186878082760423 6.6488431848683745e-06 6.624700964763707e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0007027592263207662 5.126527535300533e-06 5.107483509241082e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0003786059951944522 3.534588024667843e-06 3.5200186531730666e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -5.352088494991685e-05 1.8948095969615545e-06 1.885696596661904e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 0.00026568199721098564 2.32037358432976e-07 2.28978309004868e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 0.0005750042221474241 -1.427484601250529e-06 -1.4254038208694825e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 0.0008714040855598774 -3.058476334966405e-06 -3.0533065807121906e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.0011521861689291226 -4.638147961252597e-06 -4.631956872158315e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.00141495168306276 -6.146877156560963e-06 -6.140586269022113e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0016565300932428427 -7.568114961344976e-06 -7.560874040623541e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.001873707644049373 -8.887435897733226e-06 -8.877180163262725e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0020641468245299046 -1.0092052516505258e-05 -1.0076673752113855e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.002226422424461447 -1.1171564889971666e-05 -1.114944168359219e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0023604139900985973 -1.2118075975041352e-05 -1.2088456686244018e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002468740474752123 -1.2926274500994243e-05 -1.2889456019897026e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0025546767054558882 -1.3593507141197084e-05 -1.3550762110551832e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0026212930485554967 -1.4119848665261721e-05 -1.4073026624563835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002671427358275382 -1.4508164884760057e-05 -1.4458938512190607e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002707668659771677 -1.4763636905112001e-05 -1.4713466294127064e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027323247929936048 -1.4893440073458617e-05 -1.4843688445028324e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002747434747269618 -1.4906517720473808e-05 -1.4858485454828552e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027547583291830952 -1.4813332743456986e-05 -1.4768250675826198e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002755799969190708 -1.4625599422982502e-05 -1.4584603469253743e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027518766327772172 -1.43560372698294e-05 -1.43201362442605e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027441392061743545 -1.4018132450455018e-05 -1.39881755220348e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027335909019859704 -1.3625891072493692e-05 -1.3602538146501783e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027210997464172646 -1.3193591568238111e-05 -1.3177286929904901e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002707411021964941 -1.273555311294237e-05 -1.2726498672442391e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002693162950393912 -1.2265922538672769e-05 -1.2264041329194132e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0026789011100542704 -1.1798471357617476e-05 -1.1803350771049497e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0026650872412306926 -1.1346247757750543e-05 -1.1357234530853744e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002652108982271125 -1.0921363837982525e-05 -1.093768605202584e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002640289128158375 -1.053485479421127e-05 -1.0555694776493668e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002629892787364928 -1.0196531557992888e-05 -1.0221069086130943e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.002621132923460851 -9.914846749657373e-06 -9.942282997680271e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0026141756337873722 -9.696791997159153e-06 -9.72636020420658e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0026091454322259297 -9.547847496565871e-06 -9.578814054908669e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002606125249482514 -9.472016663095088e-06 -9.503674970139563e-06 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz deleted file mode 100644 index 2d7682eaf..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001883760909718643 1.6322441605227365e-05 1.6282091855354656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0018966619675293548 1.6486965700256653e-05 1.6452421188241346e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0019185656623403277 1.6807487761018533e-05 1.678377140139888e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001949511870093031 1.727453695234515e-05 1.7266058758276704e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0019895160178731368 1.7876635354001052e-05 1.788698562624408e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002038551855585949 1.8600054317502754e-05 1.8631373860233375e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002096501874568409 1.942834492970221e-05 1.9480999026967922e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.002163115772327773 2.0342170937219724e-05 2.0414630052176635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0022379460618002583 2.131943944796795e-05 2.1408146347395264e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0023202593065719916 2.2335450663067013e-05 2.2434725056632046e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0024089172383899658 2.336306099336146e-05 2.346508720155312e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0025022791791875732 2.4372900631805374e-05 2.446784899033802e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0025980814025706187 2.533359761450045e-05 2.540993643842267e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0026932891559394764 2.6211962639061126e-05 2.6257044191454132e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.002783911690992785 2.697308837958631e-05 2.697415340465101e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0028648561069145235 2.7580396492652597e-05 2.7526238448664822e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0029298406142217385 2.7995898224603236e-05 2.787901716726252e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002971294193621249 2.8180650546450485e-05 2.7999492140522817e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0029803046655592466 2.8095075748595054e-05 2.7856408672780555e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.002948010116666279 2.7699000504277267e-05 2.7420616795349938e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002868895903413367 2.695531229676533e-05 2.666640373908338e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0027396116464303557 2.5844740794311424e-05 2.5576422912308293e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0025591088405104924 2.4365145340192177e-05 2.4142785174774204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0023291988960112563 2.253076161843598e-05 2.2367697925781598e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020546163078697405 2.0369353023163596e-05 2.026403903468382e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0017395399412620369 1.7917654503431624e-05 1.7855408828273858e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.001387508853885373 1.5212863256818872e-05 1.517455360183919e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0010038749375851604 1.2289242399791932e-05 1.2261666285931918e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0005982818050399754 9.184626169485258e-06 9.163460298631152e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.00018423297109171168 5.9449234746407955e-06 5.931669166997341e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 0.00022425616359005048 2.6246152805749755e-06 2.62125324075721e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 0.0006179814685869888 -7.169653305987494e-07 -7.117359942501466e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 0.0009912272113921496 -4.022130709637606e-06 -4.012405238062643e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.001339030741258096 -7.239201272347688e-06 -7.229084097083925e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.001655655652421879 -1.032416399171265e-05 -1.0314949563632663e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0019338616031889645 -1.3239896787869579e-05 -1.3229071899198553e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.002168103789981237 -1.5954158859883456e-05 -1.5936955369902714e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0023552530023580975 -1.8438994892541877e-05 -1.8410822608318168e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.00249824217239885 -2.0672010075759605e-05 -2.0629717398805185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0026033134006731903 -2.263665575524828e-05 -2.2579274945437933e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0026764506223990315 -2.4322461402393694e-05 -2.4251289989683087e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0027231346580408665 -2.57249321760769e-05 -2.564317692625791e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002748269614546617 -2.6845324978476764e-05 -2.6757269990625873e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0027560624427724494 -2.7690419693446823e-05 -2.760005141900093e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0027500037861249204 -2.8271451058037618e-05 -2.8182338619816495e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002733104725441547 -2.8603428854627287e-05 -2.8518845593732642e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002707956580429593 -2.8704642482100285e-05 -2.8627529720823093e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0026767743255071688 -2.8596147843722103e-05 -2.852898108020828e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026414254963229144 -2.830122661592218e-05 -2.82458885086856e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0026034713966902358 -2.784489996218715e-05 -2.780265816112248e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0025642146228401982 -2.7253480442000682e-05 -2.7225026172317075e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0025247578842906 -2.6554118878872116e-05 -2.653963187022374e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002486060274723122 -2.5774353404053933e-05 -2.5773570237883346e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0024488825282588922 -2.4941690980127256e-05 -2.495395702166559e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0024138132003758903 -2.4083222924011278e-05 -2.4107505243130717e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002381305639780563 -2.3225255745868726e-05 -2.3260097558813076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002351701884644044 -2.239267853869484e-05 -2.2436401249363376e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023252564253151515 -2.1608572386189455e-05 -2.165949959179939e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023021565700827766 -2.089394896633773e-05 -2.0950525672428354e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002282537553954488 -2.0267477893841593e-05 -2.032832706450846e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022664938969980137 -1.9745240136332726e-05 -1.9809180181721122e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022540892921487734 -1.934054304805496e-05 -1.9406580606057414e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022453655252727732 -1.906383949171197e-05 -1.9131147348413954e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022403434303462457 -1.8922819071400595e-05 -1.899070716640279e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz deleted file mode 100644 index b1ab25d14..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005090972444601614 2.810887522660721e-06 2.5846490277925876e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005138744482446504 2.846334020417444e-06 2.6177717388702157e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005234819996440104 2.9179051932672712e-06 2.684697038750481e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005380264533103175 3.0269420947295306e-06 2.7867740798922436e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005576682462723143 3.1754138194083554e-06 2.9259922592302752e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005826222447807373 3.365863860892433e-06 3.1049364706416576e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006131581612910316 3.6013338511506023e-06 3.3267244969799737e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006496005464527016 3.8852627464529586e-06 3.5949230868035304e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006923279512532001 4.221357728570229e-06 3.913438507030233e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007417707186108262 4.61343153484127e-06 4.286376443955577e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007984066943874759 5.065200690666979e-06 4.717864924990756e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008627539369126597 5.5800386117397235e-06 5.211832856235106e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009353592428856233 6.160677325198596e-06 5.771735715409233e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0010167809870510805 6.808851878774178e-06 6.4002191957928826e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0011075643854926368 7.524882550038377e-06 7.098711345314856e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0012082068326664838 8.307192087294067e-06 7.866934408214277e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0013191104316383742 9.151758405665665e-06 8.702329365433131e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014405182478076772 1.0051507270246076e-05 9.59938952867327e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0015724302006675079 1.099565490403618e-05 1.0548905626702693e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0017144939293003477 1.1969016249675876e-05 1.1537134122557088e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018658655381329516 1.2951347669162557e-05 1.2544926807879254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0020250350363600696 1.3916910251887994e-05 1.354691447334432e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002189611820499473 1.4834049391229812e-05 1.4510753812549799e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002356067153971223 1.5664975331088392e-05 1.5396574755672102e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0025194339000411885 1.6365834551123567e-05 1.6156780870371e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0026729696196196363 1.688713398321352e-05 1.6736385295856178e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0028077986372493364 1.717435438685565e-05 1.7074050246678464e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029125630460118436 1.7168827326738648e-05 1.7104052206534788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029731330341508507 1.680898964543878e-05 1.675939965122896e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002972594122000254 1.6031463515166783e-05 1.597612780609626e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0028968273414535874 1.4771824609763408e-05 1.469859415147801e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0027398299556359025 1.2972367643302526e-05 1.2884711195192958e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0025011332574879446 1.059782367155466e-05 1.0512449482451607e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.00218684066026452 7.652202874792514e-06 7.588673160535707e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018072823520440464 4.1916494441172e-06 4.158019467682992e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0013699243219328417 3.1344190535158025e-07 3.0338623210799846e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0008851784923852562 -3.873656482874352e-06 -3.865419152032869e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0003729822497652182 -8.24946734775483e-06 -8.221424868351894e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0001401427250924134 -1.2667321334878993e-05 -1.2626554403764676e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0006331039947221361 -1.697699768318321e-05 -1.694346716672582e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0010944881042054533 -2.106276098933945e-05 -2.105108716456132e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0015146851710132352 -2.484870992201139e-05 -2.485461818524195e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018808580857437372 -2.8280445549957785e-05 -2.828891117929853e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0021804094219102757 -3.1318077935536226e-05 -3.1317502373166774e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0024065691869618565 -3.3939547360750354e-05 -3.392793069771182e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025658735949723108 -3.61427958254953e-05 -3.612481162234597e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002669944941825029 -3.7943542460903866e-05 -3.792662952726385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027295275444557954 -3.937126916857048e-05 -3.936300339260395e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027541649781418743 -4.0465342356898805e-05 -4.0471101936481655e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002751788420880334 -4.1271503247118455e-05 -4.1291792869856536e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027289887520485193 -4.183712212244016e-05 -4.1866482960894674e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002691410253825679 -4.22073378401912e-05 -4.223517812244482e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026438206803997676 -4.242294495405389e-05 -4.243539885163565e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.00259019466098773 -4.251932632796204e-05 -4.250162861529347e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025338177137093627 -4.252587842433227e-05 -4.246505429005311e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002477512764741972 -4.246588289127768e-05 -4.235350316809128e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024235840761749746 -4.2358812124774795e-05 -4.219182888113094e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002373763893299763 -4.22221608009257e-05 -4.2002142677919964e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002329332148325764 -4.207196242934077e-05 -4.180381698005205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0022912189617263555 -4.192272593040292e-05 -4.161343763469145e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022600869118370487 -4.178715843411493e-05 -4.144477289942053e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022363953457975017 -4.1675848274170595e-05 -4.130877476735903e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002220448921073606 -4.159698478339273e-05 -4.121360561477162e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002212432270452029 -4.155614351848922e-05 -4.116467554662434e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz deleted file mode 100644 index 8747fdb44..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_11.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005058430728231948 2.8396252670814026e-06 2.6156385384944002e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005105814920321858 2.875417521150239e-06 2.649137204329484e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005201110751951233 2.94763728010998e-06 2.7167707992616536e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005345375872916964 3.057540375197849e-06 2.819801293276899e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005540203034200945 3.206970882098131e-06 2.9600899534543334e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005787725865475763 3.398311053873759e-06 3.14005632225847e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006090623523038444 3.6344102476831527e-06 3.362620412638585e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006452121318568563 3.918490486124386e-06 3.6311247927888807e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006875983363840162 4.2540248337982574e-06 3.949232405603148e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007366491934521192 4.644583472993496e-06 4.320795004330634e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007928406595068623 5.0936419449339296e-06 4.749685922339179e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008566894056661197 5.604345500868291e-06 5.239589812545487e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.000928741717391026 6.179223288088187e-06 5.793740959593987e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0010095568335028104 6.819846405274388e-06 6.41460102432814e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0010996828685102852 7.5264248991684565e-06 7.103466817279124e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.001199623008975866 8.297340862438719e-06 7.859999294821505e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.001309789150362073 9.128618033980961e-06 8.681666711892155e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014304395568639965 1.0013332705787829e-05 9.563098232692257e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0015615965133487263 1.0940976644209073e-05 1.0495350293278486e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0017029393562551767 1.189678960622875e-05 1.1465097255077433e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018536678274515168 1.286111690760254e-05 1.2453779583540659e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0020123305712405424 1.3808927079657885e-05 1.343678459299407e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002176614073321076 1.4709378638757825e-05 1.4382689984399643e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0023430888474112407 1.5525578352774578e-05 1.525269347812245e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002506912822835591 1.621461431673092e-05 1.6000374206315927e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0026614975091867198 1.6727927239854577e-05 1.6571963250637776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002798151676318484 1.7011930321776423e-05 1.690730150797207e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029057312163343254 1.7008922415544494e-05 1.6941700858747793e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029703437286906463 1.6658332333990492e-05 1.6608917818036515e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029752568198334692 1.5897856017281568e-05 1.5845289425101227e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002905756570298819 1.4664163021518445e-05 1.4594907598489591e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0027553626325377786 1.2899251740002145e-05 1.2814822313787983e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.002523148494301663 1.0565567626416703e-05 1.0481194409859432e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002214660390182614 7.662673146253467e-06 7.597824386196702e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018402619991946592 4.240778206607407e-06 4.205143946761095e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0014075046983160464 3.9386646425550463e-07 3.8226383178090123e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0009263280010480216 -3.770295966702075e-06 -3.7636199456100595e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0004157442017851492 -8.134270852072542e-06 -8.107611673217877e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 9.79323950855461e-05 -1.2554515540337626e-05 -1.2513062046955166e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0005926790678880882 -1.6879112658255353e-05 -1.6842369090864147e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.001056706989434943 -2.098805281513823e-05 -2.097260341987229e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.001480434779650579 -2.480220772712647e-05 -2.4806254474894556e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018514311315997773 -2.8266458210059644e-05 -2.8275270310315577e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002156829918820871 -3.1339645704256474e-05 -3.1340461613576785e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0023891392741144206 -3.399786378826222e-05 -3.3987336533253716e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025537430751836447 -3.6236971090179254e-05 -3.621914226156378e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026622456715252197 -3.807098137996945e-05 -3.805311787710826e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002725466147713874 -3.952807909674116e-05 -3.9517925419401965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027530502659584696 -4.0646697785014804e-05 -4.0650168942550235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027530695999432504 -4.1472053415142506e-05 -4.1490579026396394e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027321962968313764 -4.2051631656033984e-05 -4.2080730892883925e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0026961453808944554 -4.243108436232672e-05 -4.246098525330479e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026497503065520023 -4.265194618645704e-05 -4.266932383658992e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002597044879060316 -4.275048571577458e-05 -4.2740748877097914e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025413608103564776 -4.2757131678051544e-05 -4.270699954190205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024855402505517036 -4.2696175694714744e-05 -4.2596439571785394e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024319357382934395 -4.258759490998486e-05 -4.2434361282184115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023823230547653923 -4.244914599687174e-05 -4.224327212902339e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023380164748389495 -4.2297035033673714e-05 -4.2042918520608655e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002299972765609061 -4.214591664475417e-05 -4.185023649623264e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.002268874758516123 -4.2008635366584095e-05 -4.167931064832618e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002245196740300181 -4.189590721001791e-05 -4.154136338004672e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022292538458734525 -4.181603044978883e-05 -4.1444770535158775e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002221237350653934 -4.177466076103284e-05 -4.1395090159630784e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz deleted file mode 100644 index 094af7ffc..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_12.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.000503770597492631 2.857486773436737e-06 2.634918518332518e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005084842491475941 2.8935135671692906e-06 2.668671554489735e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005179640408517077 2.9661746918306885e-06 2.7367857451264083e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.000532315230193523 3.07667094398413e-06 2.840466778639932e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005516963453042081 3.2267656470903756e-06 2.9814931911882456e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005763197819663234 3.418736874926575e-06 3.1621777397927875e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006064522984020399 3.6553097090974714e-06 3.3853126802751424e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006424151226892295 3.939565890305413e-06 3.654095705943245e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006845832816206521 4.274826985309501e-06 3.972032425841529e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007333836283016144 4.6645060653430715e-06 4.34281026801309e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007892908817090353 5.111922357375321e-06 4.770137553548002e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008528207868835026 5.620072797877446e-06 5.25754040144587e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009245192507307047 6.191354199693576e-06 5.808109107331993e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0010049459967115038 6.827230046478201e-06 6.424184896451166e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.001094650904044545 7.5278369648309715e-06 7.106977682485806e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0011941407479410242 8.291527993492646e-06 7.856106019692072e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0013038335371801809 9.114353044628794e-06 8.669052148016541e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014239970647757223 9.989481548082356e-06 9.540528408927e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0015546676756720457 1.0906578496406272e-05 1.046175724915328e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0016955446711026962 1.1851152679512002e-05 1.1419676246589532e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018458553179047852 1.2803923934470574e-05 1.2396098309151946e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0020041852880972673 1.3740311392320507e-05 1.3366890650581126e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0021682697966358745 1.4629992272243798e-05 1.4301216499652033e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0023347421508689505 1.5436646102747363e-05 1.5160953900017874e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0024988394753583686 1.6117963356075445e-05 1.5900432814096924e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002654070852094555 1.6625982641607573e-05 1.6466664665207074e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0027918620701484487 1.6907714253410346e-05 1.6800249010193787e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029012048295289075 1.6906074897425874e-05 1.6837169213630333e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029683577774194557 1.6561121512024905e-05 1.651167471126722e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002976718045377979 1.5811217501548773e-05 1.5760315609085827e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029112157362836013 1.4593743407934159e-05 1.4527031169568806e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0027650492703947148 1.2850592342358898e-05 1.2768344823356059e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0025370032856635656 1.0542851954510559e-05 1.0459308518252206e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.00223226861409265 7.667353492246965e-06 7.60182820229911e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018611854596205482 4.270538475991925e-06 4.233684084861847e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0014313957965852325 4.440613196139434e-07 4.314972665359216e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.000952558653383756 -3.7049743210059957e-06 -3.6992545536135857e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.00044308874296853425 -8.060733310340725e-06 -8.035001540715982e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 7.086915607363054e-05 -1.24817953995664e-05 -1.2440054779998454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0005667265870732902 -1.6815460641308816e-05 -1.6776746632037758e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0010324167668869073 -2.0938980758392104e-05 -2.0921022326133257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0014583558450226451 -2.4770980081785818e-05 -2.477365438793074e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018323828109606862 -2.825582397502905e-05 -2.8264732052814776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002141478414047406 -3.135159965303527e-05 -3.13532975772704e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002377733996062046 -3.4033266629252806e-05 -3.402350504398257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002545761544937593 -3.6295348827801616e-05 -3.6277719409596394e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026571305053808697 -3.815075181363243e-05 -3.8132381729485546e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027227070709906105 -3.962681470979789e-05 -3.961553001126988e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027522001989606615 -4.076136468610215e-05 -4.076338790686575e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027537719890516755 -4.1599249336905336e-05 -4.161657884824907e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002734148558697284 -4.2187994975212106e-05 -4.221677458979112e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002699090257694202 -4.25735624749646e-05 -4.260455678709845e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002653472702504007 -4.2797947041776974e-05 -4.2818199472479125e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002601367719493355 -4.289797016313141e-05 -4.2893035427039555e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002546138133867013 -4.2904697545053966e-05 -4.286115538868363e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002490638160995808 -4.28430940685393e-05 -4.275127457118248e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024372497296736373 -4.2733498243167196e-05 -4.2588974006165374e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023877767814936895 -4.25938509721625e-05 -4.2397017649688766e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002343555822164231 -4.24404750044754e-05 -4.219539214596135e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023055608797809424 -4.228811977498935e-05 -4.20012578468704e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.002274487913481147 -4.214971741339191e-05 -4.182890184503886e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002250820898939984 -4.203606470043394e-05 -4.168971968372861e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022348817692504756 -4.195552868593971e-05 -4.15922239469379e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022268661113385526 -4.191381561441093e-05 -4.154206748037076e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz deleted file mode 100644 index 50ace9491..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_13.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005024426040259796 2.8686726741888226e-06 2.6469126501308115e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005071403988660258 2.9048577059566247e-06 2.6808381623801835e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.000516588312566185 2.977817475783001e-06 2.7492791780473794e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005308912773264665 3.0887173737479546e-06 2.8534051448551167e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005502073421313537 3.239268766787812e-06 2.994941323527885e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005747482821186893 3.431682687903399e-06 3.1761316930348017e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006047801123772066 3.6686042220312566e-06 3.3996862014831985e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006406232236091526 3.95302477105015e-06 3.668709170618649e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006826517518472576 4.2881682826765885e-06 3.986604753586422e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007312916639658101 4.677346509240946e-06 4.356954333602753e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007870168779506473 5.123777754532523e-06 4.78335962656702e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008503425339054551 5.63036302911191e-06 5.2692441628037735e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009218142799394961 6.1994133158261184e-06 5.817604816188375e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0010019921275550895 6.8323219478245365e-06 6.430704306978881e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0010914270559517427 7.529177136160777e-06 7.1096953324722805e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0011906280981942277 8.28831174193595e-06 7.85416751006156e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.00130001712458495 9.105790685588757e-06 8.661610012356833e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014198679601881226 9.974841104517437e-06 9.526786159755047e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0015502258626696735 1.0885236802315383e-05 1.0441022142878613e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0016908028010536107 1.1822656546783873e-05 1.1391421248121996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018408435193222668 1.2768057570705677e-05 1.2360031788515571e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0019989572136935503 1.3697145277154821e-05 1.3323025093482907e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002162910072234717 1.4579927056366942e-05 1.4249936219826118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002329375332282899 1.538044764364261e-05 1.5103076072157341e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002493640499527814 1.60567822201367e-05 1.5837253315130727e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.00264927675611573 1.6561351806372133e-05 1.63999781287526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0027877844070542694 1.684154876131065e-05 1.6732336599945773e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0028982416885010107 1.684068444406175e-05 1.677074496465203e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029670035778884846 1.6499214903929076e-05 1.6449773843059335e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002977554517577292 1.5755922860535075e-05 1.5706118286978626e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002914608031081911 1.4548644615016319e-05 1.4483628497011172e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002771149673560017 1.2819240844934588e-05 1.2738502157693332e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0025457807211763236 1.052797467683211e-05 1.0445102983459248e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002243465597485435 7.66997929523316e-06 7.604153503716971e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018745101730033022 4.289312342468005e-06 4.251759643489563e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.001446629244691539 4.760447127881709e-07 4.629237842956729e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0009693106106058877 -3.663162277408698e-06 -3.6579971841077306e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.00046058582033767584 -8.013435944819156e-06 -7.988281435270896e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 5.35231319255871e-05 -1.2434753552421815e-05 -1.2392872306537908e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0005500802125203363 -1.6774049084599648e-05 -1.6734103473081265e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0010168238308207252 -2.0906826850824367e-05 -2.088722768447498e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.001444160881341922 -2.4750206288971343e-05 -2.4751929814886084e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018201056935841665 -2.8248188528334628e-05 -2.8257110143152774e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0021315494973209257 -3.13584034521496e-05 -3.136067072137998e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0023703337123034836 -3.4055104781784085e-05 -3.404587782355555e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025405656832899093 -3.633196391413301e-05 -3.631452588729258e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026537812699476 -3.8201169459812945e-05 -3.81825446849699e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027208766007720203 -3.968951217997939e-05 -3.967756752910668e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002751600346823238 -4.0834425628658074e-05 -4.08355660533161e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002754172657519255 -4.168050852054217e-05 -4.169708583922383e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027353551552480614 -4.227529742162438e-05 -4.230385452323226e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027009372617390537 -4.2664941478570435e-05 -4.2696591459338855e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002655821658814672 -4.289172422827721e-05 -4.291375548156579e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026041045951507164 -4.299281489153181e-05 -4.299088935610814e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002549169360625221 -4.2999677706578186e-05 -4.296030725511857e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002493878064275719 -4.293771453175107e-05 -4.28509509741498e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024406307136531713 -4.2827511902073825e-05 -4.268858907814042e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002391249397313139 -4.268713532556824e-05 -4.249615016052657e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023470849516700238 -4.253298416373844e-05 -4.2293774213896426e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023091225351506146 -4.237986836369591e-05 -4.209876450960418e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022780665742032553 -4.224077514935349e-05 -4.1925537133253934e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002254407295248447 -4.212655187010201e-05 -4.178559795882941e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002238471017992932 -4.204560861322914e-05 -4.168754674928444e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002230456111806505 -4.2003683292790585e-05 -4.163709681835145e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz deleted file mode 100644 index a51198f79..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_14.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005015938746143956 2.87558802193352e-06 2.6547250254215914e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005062815292819459 2.9118808028046157e-06 2.6887603509872905e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005157090573134215 2.985044539457277e-06 2.7574094006503352e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005299811823912312 3.0962217236060176e-06 2.861818443429621e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005492556463900472 3.247090116898185e-06 3.0036786649829943e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005737438265249286 3.4398173834201874e-06 3.1851900520131577e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006037112612179744 3.6769968449008205e-06 3.4090099036243915e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006394778037056096 3.96156142682705e-06 3.678182810889544e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.000681417017726164 4.296671856018914e-06 3.9960480176042745e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.000729954299860277 4.685574220564699e-06 4.366119051074569e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007855630511490494 5.131421347957681e-06 4.791929396896865e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008487580186245226 5.637051915710057e-06 5.276836902546535e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009200846767432672 6.204720990380122e-06 5.8237785940890224e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0010001032105714897 6.8357759896228105e-06 6.434966849087272e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0010893652889352526 7.5302730963026546e-06 7.111517594480629e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0011883813709622055 8.286531204540768e-06 7.853001712759228e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0012975757735003484 9.100623789701002e-06 8.656912524277924e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.001417226149894866 9.965813891865357e-06 9.518045604892302e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0015473834204898754 1.0871943966138837e-05 1.0427793085181646e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0016877676088774864 1.1804800650799714e-05 1.1373363768956956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018376345778755342 1.2745492300549948e-05 1.2336956029057081e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.001995608496446892 1.366990684297668e-05 1.3294935194009447e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002159475274148501 1.4548262454972826e-05 1.421707367771858e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0023259335818651226 1.534483729215135e-05 1.5065958913259685e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0024903030267257056 1.6017952675174465e-05 1.5796705664806725e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0026461943735549406 1.652027451579139e-05 1.6357143435471243e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002785155443085408 1.679943997407331e-05 1.6688670382729357e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0028963196791137683 1.6799013135773562e-05 1.6727981231435108e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029661035547825275 1.6459704912657718e-05 1.640985452275463e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029780489655666185 1.572056397196409e-05 1.5671081421431307e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002916735939768416 1.4519718418051556e-05 1.4455458418723835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002775010757216965 1.2799022651287329e-05 1.2718978514524036e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0025513580332757685 1.0518229905004417e-05 1.0435572629732307e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002250597818240371 7.671406309306046e-06 7.605216518290555e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018830063505718845 4.301097114594078e-06 4.262953375737638e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.001456350573688394 4.963216249309957e-07 4.827385788256597e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0009800121346233421 -3.636550637817744e-06 -3.6317978763414327e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0004717775693961828 -7.9832360116044e-06 -7.958477117265842e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 4.241541809501877e-05 -1.2404618840728673e-05 -1.236265393097385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.000539415114753953 -1.674745494939541e-05 -1.670668052834535e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.001006828061444739 -2.0886132645683862e-05 -2.0865377854536418e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0014350523559197275 -2.4736781926867813e-05 -2.4737739304393465e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018122150286835898 -2.8243153064503235e-05 -2.825190429412207e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002125153792305446 -3.1362593626461805e-05 -3.136504186454782e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0023655566514559387 -3.406891374201719e-05 -3.405984172134076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002537204550808117 -3.6355240684654166e-05 -3.6337730183533945e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026516067728754875 -3.823330141275961e-05 -3.821430996288399e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002719678492109154 -3.9729533247367905e-05 -3.9716953578673784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027511934993735008 -4.0881116193086874e-05 -4.0881468255766956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027544090677929047 -4.173248557713099e-05 -4.1748346190038104e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027361099502343825 -4.2331178705271364e-05 -4.235934857761754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027021041854150235 -4.272346201533625e-05 -4.2755281584594725e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026573117974225038 -4.2951801658513554e-05 -4.2974721587717135e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026058446906088153 -4.305358762863413e-05 -4.305334530256399e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025510994403958186 -4.3060536251472885e-05 -4.3023609457381587e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.00249594332777559 -4.2998330662782065e-05 -4.291460145667712e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024427875925635695 -4.288772396381453e-05 -4.2752211305001355e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023934659847826465 -4.274686499588852e-05 -4.255947339226269e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002349338552395867 -4.2592203698431916e-05 -4.235662587985618e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002311397609959354 -4.2438589341221565e-05 -4.2161063400894864e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.002280353029073178 -4.229904458427117e-05 -4.1987284472483475e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022566990566462324 -4.218444915118095e-05 -4.184686548036336e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002240764834306593 -4.210324063351315e-05 -4.1748461914521925e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002232750521591687 -4.2061177172937965e-05 -4.1697825748751715e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz deleted file mode 100644 index b7c941ca3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_15.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005010508174177688 2.880141698218864e-06 2.659473977688845e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.000505731984652697 2.9165006244063527e-06 2.6935837424852152e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005151464703787807 2.9897893405538334e-06 2.7623741807585497e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005293988647536939 3.1011358199240455e-06 2.8669765879716553e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005486467129722798 3.252196517279274e-06 3.009060136138709e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005731011373683852 3.445111599920587e-06 3.1907963882121183e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006030273709696027 3.682441572206831e-06 3.4148086204597325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006387449225388285 3.967082289029679e-06 3.6841028151652482e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006806269888151341 4.302154403481119e-06 4.001976244905471e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.000729098600334379 4.690862388412898e-06 4.371898537812508e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0007846328257909343 5.136317586446236e-06 4.79735900450369e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008477441585479468 5.641319199038137e-06 5.281672917397186e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.000918977959018366 6.208086907157791e-06 5.827738436774011e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0009988945193813033 6.837939113614044e-06 6.437735137135464e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0010880459444634087 7.530911831388253e-06 7.112754811907943e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0011869435989032466 8.285315288705059e-06 7.852355739007727e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0012960133558410697 9.097228643060683e-06 8.654033267744839e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014155353062609184 9.959938044394604e-06 9.512602982672253e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001545563978430439 1.0863329935542299e-05 1.0419498574645277e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0016858245300475914 1.1793259956895301e-05 1.1361995735164115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018355799135251 1.2730933064142816e-05 1.2322388239061923e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0019934638471937574 1.3652353832777404e-05 1.327716496813784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0021572748213821357 1.4527875142456375e-05 1.419624969787255e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.00232372773480264 1.5321924323752095e-05 1.5042406394156668e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002488162680816023 1.5992980016810927e-05 1.5770945439676976e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0026442156899678317 1.6493864662326865e-05 1.6329900654495044e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002783464919479201 1.6772371847327867e-05 1.666087019012208e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0028950790706707545 1.6772226987116835e-05 1.670072767729067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029655139049724957 1.6434303297096218e-05 1.6384385883121654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029783486643399906 1.5697818002827464e-05 1.564869917256409e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029180801211318185 1.4501084972503415e-05 1.4437431513826034e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0027774641243684525 1.278595971759301e-05 1.2706447018830111e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0025549109073469346 1.0511875756533794e-05 1.0429403471172655e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002255148340938154 7.672223902097584e-06 7.605803920454809e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0018884306549855673 4.308586773280921e-06 4.2700161286752325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0014625602879105362 5.092949235752104e-07 4.95322033948823e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0009868523728680872 -3.619473763276723e-06 -3.6151168414875923e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.00047893685675401307 -7.96380218022102e-06 -7.939468591678524e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 3.530477438730657e-05 -1.2385160082413421e-05 -1.234335338491442e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0005325857262817188 -1.6730213289771892e-05 -1.668914214078875e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0010004251125810912 -2.0872637838105642e-05 -2.0851384007995674e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0014292142803359396 -2.4727920708622863e-05 -2.4728631793859303e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0018071524363355467 -2.8239643794679583e-05 -2.824853806932455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002121044644027006 -3.1364978424714566e-05 -3.1367801610784e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002362483296822944 -3.407745415914167e-05 -3.406873993639046e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025350393159975886 -3.63698506964063e-05 -3.6352542556684896e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002650202785526583 -3.8253598140928166e-05 -3.8234603200890495e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002718901028178075 -3.975490622398154e-05 -3.9742127033735385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.00275092379976032 -4.091079152569403e-05 -4.0910815084909634e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027545521060843865 -4.1765582694719316e-05 -4.178112421508513e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002736585679037901 -4.236681446831179e-05 -4.239483650135785e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027028444779164077 -4.276082636401755e-05 -4.2792813451773205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002658259634966319 -4.299019994442671e-05 -4.30137067027851e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002606953084952551 -4.309246511542289e-05 -4.3093278854867036e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025523299758952664 -4.309949772208943e-05 -4.306407803267972e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024972609662667327 -4.303716060816085e-05 -4.295528533873251e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002444164337346623 -4.2926316166392555e-05 -4.279286941471461e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023948813207254832 -4.278516747847537e-05 -4.25999328307637e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002350777874996688 -4.263019693114402e-05 -4.2396776848603205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023128509070616137 -4.247627868614102e-05 -4.2200854758938395e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022818137832638463 -4.233645769553823e-05 -4.202671798089454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022581633311467737 -4.222163402240049e-05 -4.188598814817942e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022422305037931006 -4.214026254701479e-05 -4.178735651218564e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022342166099583 -4.209811413723659e-05 -4.1736599857153466e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz deleted file mode 100644 index 4d85b81c3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.000995946940732114 1.2847118310773131e-05 1.25223901109508e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0010073235934696544 1.3116952253464381e-05 1.2799083282434357e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0010274724254745549 1.364561342660209e-05 1.3340809328173609e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0010566697097469972 1.4421713507666868e-05 1.4135839020159485e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0010952836935518779 1.5431826107900486e-05 1.5170331540947454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0011437691344682718 1.6659922700461783e-05 1.64273339356647e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0012026394286786459 1.808672355025993e-05 1.78863827327128e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0012724442468097427 1.9689392020887517e-05 1.9523348623834295e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0013537291227688675 2.14415170524358e-05 2.1310338185062342e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0014469730078959947 2.331308765111165e-05 2.3215611650629444e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.001552494462074089 2.5270444395479204e-05 2.5203492821952727e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.001670361980223584 2.7276268670240184e-05 2.723433828264363e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0018002705514515217 2.928954653681387e-05 2.9264510595111476e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0019413727789944582 3.126545428207561e-05 3.124633481703321e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0020920392533842263 3.315512433053712e-05 3.312807014401147e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002249596813797965 3.49053870440465e-05 3.485412116337597e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.002410061845931552 3.6458628718306565e-05 3.636553067206491e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002567788851742552 3.7752502458784324e-05 3.7600578946168843e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0027150784894391516 3.871901463558261e-05 3.849566174962929e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.002841823334693982 3.9282358007461575e-05 3.8986632974020037e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002935293180827677 3.936111905266932e-05 3.90115677322318e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.002980058913397073 3.8888608710571305e-05 3.85174874759924e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0029587972684100676 3.7816208520783274e-05 3.7462970918383874e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028602685133684385 3.611787966198854e-05 3.5821009080928976e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0026807833850996904 3.3796427131525095e-05 3.358275217280604e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0024223138556291844 3.089084994932132e-05 3.0761533040584476e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0020931871143031484 2.746231759307796e-05 2.7393045053664216e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0017031680956809691 2.3574351026404428e-05 2.353264112962232e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.001259701927905656 1.9288505772783137e-05 1.925313940148748e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0007743404751761105 1.4673728642198903e-05 1.4641768318451486e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.00026816074455682194 9.818845958287502e-06 9.796579828382828e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 0.00023387923693701017 4.831903016135119e-06 4.821644851233737e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 0.0007144181019564847 -1.759668970681805e-07 -1.7894136408536243e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.0011635261290279498 -5.1047345377472845e-06 -5.106831595933181e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0015720380956296238 -9.870294675489847e-06 -9.873840141274804e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0019269077873443083 -1.440245852792286e-05 -1.4404567275163629e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.002215980420826777 -1.8642559438712185e-05 -1.8637590630773857e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0024330854182575807 -2.2542598943303877e-05 -2.2525572626039226e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.002585335259682001 -2.6066331004380102e-05 -2.6034508216242675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0026834287636017785 -2.9189495388530844e-05 -2.9142820257854955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0027373166696183383 -3.1899217480737535e-05 -3.1840272526023294e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.002755856743892175 -3.4192975450922266e-05 -3.4126479573192686e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002746332667103179 -3.607742675072874e-05 -3.6009124363074235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0027149064338237955 -3.7567287253580034e-05 -3.7502050321377695e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026668875249400963 -3.86834268950018e-05 -3.862443747359418e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002606781727346182 -3.945129104796499e-05 -3.9399951676096143e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0025383721582174054 -3.9899784038128914e-05 -3.9855857729203544e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002465036021933325 -4.006036289172995e-05 -4.0022242873927605e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0023897406461582307 -3.996624928958404e-05 -3.993131992570386e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002314764512054771 -3.9651816988616824e-05 -3.961689559382643e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0022418137607852556 -3.915206262731336e-05 -3.9113870594521316e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002172138196530023 -3.85020538801498e-05 -3.8457708640680507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0021066240364247387 -3.773647249941525e-05 -3.768390415990358e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.00204587657184847 -3.6889510946341015e-05 -3.6827512401023804e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.001990292007603325 -3.599464584223598e-05 -3.592268258046486e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0019401134849993554 -3.508427986940895e-05 -3.500217860456577e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.001895470992237714 -3.4189036544354485e-05 -3.40969443447469e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0018564187971443686 -3.333729151252998e-05 -3.323569736489425e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0018229615545610031 -3.25548448968505e-05 -3.2444539975216745e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0017950674926261016 -3.1864593370138274e-05 -3.174661458525921e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0017726850384046653 -3.128624766479068e-05 -3.1161824976986154e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0017557565170963315 -3.0836141896709966e-05 -3.0706659294743935e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0017442289732561228 -3.052719413015544e-05 -3.0394171101580306e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.00173805812754183 -3.0369119000559546e-05 -3.0234221778420206e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz deleted file mode 100644 index 6c34c387b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0006661627426084955 1.299322741719885e-06 8.486632965682031e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0006736203177326395 1.497899757115428e-06 1.0461673803527849e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0006882743902044398 1.8899190504687431e-06 1.4361487398898314e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0007103238204917994 2.472149171274805e-06 2.0156116039982047e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0007400546041993537 3.241962690231506e-06 2.782245082863717e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007778389710570596 4.1966965651431e-06 3.733705687889961e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0008241304939680431 5.333127835787868e-06 4.867191544815488e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0008794581801034968 6.647077145460133e-06 6.179113743092872e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0009444153407598186 8.133049233086236e-06 7.664731678415455e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0010196411913479988 9.783784850834847e-06 9.31768721395016e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.001105791757678193 1.158969711839799e-05 1.112939589176849e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0012035021559542104 1.3538224819413943e-05 1.3088314130393282e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0013133314855658313 1.5613053870588743e-05 1.51790185112188e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0014356838683232927 1.779317324403374e-05 1.7381053092935506e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0015706953445715724 2.0051753776558693e-05 1.9667537171810336e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0017180850374610365 2.2354961332445546e-05 2.2003680472277185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0018769635952640385 2.4660771239839693e-05 2.4345320096575417e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0020455749662279814 2.6917613241394232e-05 2.663745004874759e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0022209628369422776 2.906270460395576e-05 2.8812950893481297e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0023985578084991226 3.101982954057571e-05 3.079187930134932e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0025716852915548026 3.269904848834898e-05 3.248242208385083e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0027309885366821364 3.4005795940322986e-05 3.378606782640819e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0028638339582261908 3.484096462029447e-05 3.460279557534109e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002953839121323517 3.5099317661914836e-05 3.48379228334654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002980740585245394 3.467851701380327e-05 3.440815258862433e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002923955469576159 3.3498668015094396e-05 3.324879842581182e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002773698055883887 3.1519160314411446e-05 3.132290813545767e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002528628657477337 2.876145461045292e-05 2.8633414575073776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0021958780350829063 2.530944540637657e-05 2.5230528789484805e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0017884508820552834 2.1265251387577046e-05 2.1203970851283687e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0013161239646989236 1.6725514880238014e-05 1.6672299716735116e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0007926725520451611 1.1813609616879643e-05 1.1777212968652322e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00024394259354955486 6.6912351562272475e-06 6.674922810234435e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.00029867561660538273 1.5255994314335312e-06 1.5217452105770629e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.000814356363221777 -3.5406247524256023e-06 -3.539820526707105e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0012909169818621938 -8.393698711887899e-06 -8.39027302082721e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0017156850039047515 -1.294424709596985e-05 -1.2936966319258656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0020715512718613685 -1.7125114093342707e-05 -1.7113587169885308e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.002345426101721663 -2.0890871467947052e-05 -2.0876603237886223e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.002538024705273825 -2.4217557184894494e-05 -2.4203289805699843e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0026623043903946037 -2.7100600194492886e-05 -2.708952041688563e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0027310216971635675 -2.955191790337768e-05 -2.95463764363197e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002755579530937514 -3.159656860847808e-05 -3.159598662100166e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002745353307440473 -3.326784886651621e-05 -3.3267349339593594e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002708138561329728 -3.4602915064079304e-05 -3.4593128895066684e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002650631675838399 -3.5639535490316953e-05 -3.560768066924209e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002578495407916654 -3.641361890462909e-05 -3.634573145490446e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0024965454421030605 -3.695704936497094e-05 -3.6841422307107986e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002409255246869896 -3.729799063719435e-05 -3.712796280867126e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002320278719604749 -3.746326686424537e-05 -3.723763278757383e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.00223236014060723 -3.7479306536170204e-05 -3.7201491670204874e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002147516768453708 -3.737220655849852e-05 -3.7048976818222367e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002067194193655212 -3.716742393948792e-05 -3.6807533023244285e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.001992396434788857 -3.688940814984794e-05 -3.650235841960991e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0019237929270720755 -3.656124360324924e-05 -3.615626505223288e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.001861806926575169 -3.6204346260697125e-05 -3.578962274894795e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0018066966557873407 -3.58381842837294e-05 -3.54203735479778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0017585872730437025 -3.548015215137123e-05 -3.5064110193234876e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.001717505097484141 -3.5145415893532845e-05 -3.473415650648596e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0016834157830890831 -3.4846713470150064e-05 -3.4441647380244516e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0016562533205116213 -3.459441432491512e-05 -3.4195681407199194e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0016359417451642406 -3.439673634618233e-05 -3.4003531301879695e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0016224110065471385 -3.426007486991565e-05 -3.387092897552858e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.00161560750854093 -3.418948390067063e-05 -3.380249455569414e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz deleted file mode 100644 index 800d4b5b7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0006573943792988745 -3.140760837270497e-07 -6.222607452965509e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0006637712577484452 -2.446539238741459e-07 -5.564292987712703e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0006765928164273125 -1.046552394567855e-07 -4.2352817921019477e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0006959934867447893 1.0887070094900696e-07 -2.2047425200167359e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0007221737248905291 4.004344020504196e-07 5.744502644044571e-08 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007553987419722869 7.758913918571025e-07 4.1637858986711884e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0007959961573930623 1.242200255911014e-06 8.636983657830755e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0008443519776989326 1.8071326467676923e-06 1.4077417455104843e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0009009040907217388 2.478916829126363e-06 2.05748801427133e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.000966132195493487 3.265798028351364e-06 2.8221501252781394e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0010405427549973216 4.1755028824737465e-06 3.7106636212155745e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.001124647142713511 5.214601263479685e-06 4.731058030655225e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0012189306619422335 6.38775011672266e-06 5.889684772003614e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0013238095021412479 7.696805929385364e-06 7.190274575223812e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0014395719542465294 9.139795815519762e-06 8.63279902497174e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.001566299313943833 1.070975371023016e-05 1.021212874504754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.001703760913507557 1.2393423878442098e-05 1.1916484399556557e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0018512766823069891 1.4169804170896336e-05 1.3725668552062838e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0020075395397762923 1.6008494832452953e-05 1.560910746560281e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0021703890206580053 1.786777096692475e-05 1.752377747830946e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0023365272121711003 1.969298234511901e-05 1.941234904399088e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0025011690592462764 2.1417939399010947e-05 2.120263125564473e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0026576223126161293 2.2965136917857675e-05 2.2807758175404827e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002796798319966615 2.4246491856986605e-05 2.4128216073081875e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0029066630115245785 2.5164571848976868e-05 2.5056585285859707e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0029717281275603424 2.5612872559266948e-05 2.5485209378224893e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.00297291901180176 2.5474622938078986e-05 2.531455712197206e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002893661305723237 2.4638269368037224e-05 2.4460939194430512e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027265611409637725 2.302730751537161e-05 2.286918364349324e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0024709098731925893 2.063725803893552e-05 2.0530121267606266e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0021338724926251345 1.7551475913070124e-05 1.7493688114877744e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0017265257170289362 1.388961332779212e-05 1.3859199517667487e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0012575236145201743 9.771675378968246e-06 9.759736929873768e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0007407597550888701 5.3458507666825835e-06 5.3537106353254045e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.00020194986279681055 7.923889501736287e-07 8.120920974631071e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0003290906384718016 -3.719861728177673e-06 -3.7014908357272976e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0008332017970642462 -8.060008865398444e-06 -8.047381954376352e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.001298573721028659 -1.2128731519547158e-05 -1.2118427855338347e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0017129966758153954 -1.5851823940311054e-05 -1.5841065989318884e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.002060687712877846 -1.918045319017859e-05 -1.9170456586465777e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0023300749883803287 -2.209144756100828e-05 -2.208535948958329e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0025217855176501583 -2.4584846476776446e-05 -2.458590132171048e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002648227049786999 -2.668015229380808e-05 -2.668992000775898e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002721682880842317 -2.8412042514671354e-05 -2.842803608808697e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0027531183619754433 -2.982395979117185e-05 -2.9837491900671616e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027516791406434864 -3.096145512237277e-05 -3.095773042816492e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002724844600548215 -3.1867395499489155e-05 -3.182767961036381e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002679009430549051 -3.25782505004268e-05 -3.2484048967211405e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002619572604084478 -3.3121641811726e-05 -3.296044697508123e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0025510283362653696 -3.35200168320077e-05 -3.3287872636318235e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0024772554593579556 -3.3793987808243744e-05 -3.349493383333481e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0024016924013622993 -3.396348237756299e-05 -3.360762363903796e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002326989925555739 -3.4047852671291675e-05 -3.364901488117621e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002255119928122554 -3.406558444526327e-05 -3.363905998097459e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002187522009297111 -3.403393692893703e-05 -3.359454987077843e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0021252248696903447 -3.396870961596365e-05 -3.3529243717207504e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0020689451841023965 -3.388419125794612e-05 -3.345410850619276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0020191669178406093 -3.379231922509735e-05 -3.3377451335428004e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.001976204385768399 -3.3702211117744845e-05 -3.330519628652797e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.001940251756883146 -3.3620373369572286e-05 -3.324132070780587e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.001911421240402869 -3.355117633490198e-05 -3.318832375371174e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0018897721161409244 -3.3497388932234984e-05 -3.314766428380607e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0018753321155383382 -3.346067446463541e-05 -3.312013990245618e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0018681110499048287 -3.3442007135775494e-05 -3.310619932867364e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz deleted file mode 100644 index 10a27b01d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005798738748063234 1.3400796485211798e-06 1.0510923466452559e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005855338034234288 1.3858765394493182e-06 1.0939283256300762e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005969158491041137 1.4789289592555548e-06 1.1810824484768415e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0006141443855970103 1.622134620954696e-06 1.3155276697145314e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0006374059535114372 1.819738047386226e-06 1.5016345190500632e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0006669489806128471 2.0771979581391343e-06 1.7450387679690685e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0007030829234517967 2.4009881875294663e-06 2.052468379489313e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0007461763744743196 2.798347472017112e-06 2.4315205634969395e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.000796653511499898 3.2769775012108635e-06 2.8903822361831394e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0008549880602836483 3.844676832934451e-06 3.437488171745859e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0009216936857299255 4.5089053575303654e-06 4.081108596104356e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.000997309411875265 5.276274166936779e-06 4.828857243940598e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.001082378284690866 6.15195556467091e-06 5.687109148324339e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0011774170228918749 7.139008646684142e-06 6.660316865673392e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0012828738430743507 8.23761694109144e-06 7.75021409984656e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.001399070994601771 9.44423733569689e-06 8.954898644971348e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0015261278109829862 1.0750659948234113e-05 1.0267789728499797e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0016638593122160147 1.214297068739942e-05 1.167645725301236e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0018116446421251311 1.360039358076517e-05 1.3161328505329169e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001968259028159152 1.5093953794094579e-05 1.469428697020356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0021316627289074295 1.658546033950029e-05 1.6237356958393657e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0022987409395433525 1.802866322942657e-05 1.7742148040890118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0024649903862723403 1.936915247417613e-05 1.9149331635780926e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0026241521892066723 2.0544550766443217e-05 2.0388737729173213e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0027677977124707497 2.1485169886571094e-05 2.1380436661703136e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002884886243474058 2.2115030198142578e-05 2.2037265095012093e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0029613296180673815 2.2350450065326e-05 2.2268868190266983e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029796706643066273 2.2096963887488912e-05 2.19877832128051e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029224770798977444 2.1255959878827744e-05 2.111671841185701e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0027810033051086573 1.9744861526651976e-05 1.95970541926209e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002552933833682221 1.752302412387663e-05 1.7401108149403368e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002243017687954956 1.4620487933037572e-05 1.4546820435424323e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0018620133686361362 1.1135263779056477e-05 1.1103594092106781e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0014181524852191357 7.187139655323514e-06 7.180414441984124e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0009221065791136955 2.9019471926174063e-06 2.9133971383777482e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.00039468149325981176 -1.5656099033639911e-06 -1.5422023628850293e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.00013527459746948568 -6.047481018112683e-06 -6.026658514084265e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0006444145199426463 -1.0401918506172573e-05 -1.0394440121460208e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0011200796126556866 -1.4524743730661057e-05 -1.4527374769282466e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0015514125373083617 -1.8337096495372206e-05 -1.8340100432516704e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.001923798272395325 -2.1782080037875933e-05 -2.1779270163107847e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0022236747077778443 -2.482582398140177e-05 -2.481759225070718e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002445123994558664 -2.745757160768373e-05 -2.74480327711658e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0025972391348213085 -2.9686567350052728e-05 -2.968136600807301e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026924622945384774 -3.1538325589362324e-05 -3.154220141064436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002742112801034011 -3.305062735536587e-05 -3.306442519725114e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002756042652413882 -3.426799121253812e-05 -3.428642556490236e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027422448779806366 -3.523574614656204e-05 -3.524740937327505e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002707477888275495 -3.599615964533593e-05 -3.59851437763252e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0026574981685827176 -3.6585916448271617e-05 -3.653466590847871e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002597135738463964 -3.7034135521745456e-05 -3.692757609985916e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002530404633145033 -3.736273006952158e-05 -3.7192065489641724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002460836042918638 -3.759022737526769e-05 -3.735354117194595e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0023913966888603195 -3.773369378281141e-05 -3.743479015159922e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002324326529916518 -3.780930168820651e-05 -3.745593687074624e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0022612828714269903 -3.783230389956433e-05 -3.743440008176061e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0022034702736018924 -3.7816846468431865e-05 -3.738491990856768e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0021517471055084525 -3.777571957558894e-05 -3.7319678866619365e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0021067115438248235 -3.7720153614835734e-05 -3.7248503673452893e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002068769929968776 -3.765970673411736e-05 -3.7179117890049994e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0020381902009752612 -3.760223189405937e-05 -3.71174159202215e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002015142787042901 -3.7553901393058784e-05 -3.706773130670716e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.001999730976710072 -3.7519254029333286e-05 -3.7033073874853394e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.001992012334985504 -3.75012269702245e-05 -3.701531351994541e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz deleted file mode 100644 index f47cf171b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005556885706950719 2.2203773907024316e-06 1.964880525406959e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005610101055059186 2.2525438735887703e-06 1.99427762591036e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005717116345607183 2.3181586505581297e-06 2.054368740442565e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005879102027149095 2.4197582854651925e-06 2.1477319139887753e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0006097816095774789 2.5610624805417633e-06 2.2781596899374044e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0006375604514887433 2.7468672588184523e-06 2.4505601600364404e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006715397657133575 2.9828931949174035e-06 2.6708237825988824e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0007120698887209613 3.2755913355447824e-06 2.945651015119344e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0007595559976953898 3.631904125196117e-06 3.2823358100809226e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0008144536287493574 4.0589742525467655e-06 3.6884995737629615e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0008772612478620273 4.5637961306293865e-06 4.171768568346201e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.000948508681802885 5.152804530574086e-06 4.739386734955249e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0010287398864215439 5.83139486559862e-06 5.397754648179808e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0011184881295408535 6.6033702851314365e-06 6.151884675401607e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0012182411887856064 7.470312084762229e-06 7.004762496231633e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.001328393609991449 8.430872664210141e-06 7.956606924245112e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0014491824492474173 9.479992972738312e-06 9.004022832712938e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0015806022595258116 1.0608046605873013e-05 1.013904580437044e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001722294440527712 1.1799910937455896e-05 1.1348084974070254e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0018734055554773528 1.3033955612390882e-05 1.2610781145830873e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002032409012448128 1.4281188836456904e-05 1.3898884891683064e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.00219688489878945 1.550543288336556e-05 1.517549088668353e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0023632541838768694 1.666309908574916e-05 1.6394371286760403e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0025264666038949646 1.7703277739621425e-05 1.7499733372559983e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0026796471909616773 1.8568292200571867e-05 1.8426653338804193e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0028137157413162285 1.919470746641146e-05 1.910243934229526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0029170079185087314 1.951347827892805e-05 1.944893897080754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.00297494756629791 1.944954379064285e-05 1.938612532907339e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029700703018002363 1.8921993044607296e-05 1.8837638269355974e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002888273518066801 1.7847470989257442e-05 1.7737242335850856e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002723584063749613 1.6156400599204548e-05 1.6035792113417933e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0024757796516435776 1.381470924802583e-05 1.371132544309345e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.002151569427702062 1.0845930158269242e-05 1.0781190918255596e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0017612394719091786 7.336932337953826e-06 7.309530657157396e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0013123418892228636 3.401819330743974e-06 3.398478868872414e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0008163808636006968 -8.389974694236916e-07 -8.245333582312431e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.00029545095372222326 -5.241894627777446e-06 -5.214270352903683e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.00022280967458669163 -9.645058134516727e-06 -9.618940941891343e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0007184619391898704 -1.3908089771980808e-05 -1.389781121499251e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0011802046459274762 -1.7930041897834417e-05 -1.793499420115143e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0015976564340773568 -2.163760321747493e-05 -2.1645885507981526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0019564734446475608 -2.4976235089799196e-05 -2.4977532324243857e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0022441956149284676 -2.7911937325813274e-05 -2.7904187968563013e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002456261038287493 -3.0432809919013105e-05 -3.042010837924859e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026021666313050906 -3.254706879411353e-05 -3.253605552331365e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002693787107571219 -3.427910101959347e-05 -3.427631276702494e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.00274194161296216 -3.566540360865225e-05 -3.567469961209497e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027560654577470397 -3.675040910205282e-05 -3.67701160716418e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027438426979223434 -3.758068050153107e-05 -3.7602727325346384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002711781834031619 -3.820060472398985e-05 -3.821154859433118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0026654349088459845 -3.8649827842622885e-05 -3.863307809506439e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.00260946944109088 -3.896163540693718e-05 -3.8900583831540984e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0025477605736860076 -3.91617452000493e-05 -3.904377611560507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002483632251240763 -3.927033745258793e-05 -3.908920689182906e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002419937620450691 -3.930520841322768e-05 -3.906076095494864e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002358855387283829 -3.9282990993488944e-05 -3.89797511333252e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0023020051761811133 -3.921943820215331e-05 -3.88648941990206e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0022505715644158555 -3.9129274106480295e-05 -3.873230752381725e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0022054058374680724 -3.902591316838712e-05 -3.859556999178627e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002167107907927712 -3.8921194882798466e-05 -3.8465844083984e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.002136091004806356 -3.8825178660859614e-05 -3.835204007679833e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002112631596539191 -3.87460057181314e-05 -3.826099753285527e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002096906696902642 -3.8689816908968776e-05 -3.8197659714617814e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002089020305269083 -3.866070875315571e-05 -3.816521961707794e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz deleted file mode 100644 index af32876f4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005341799191742056 2.528729395457259e-06 2.2843251590314188e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005392594264211114 2.5626813266381058e-06 2.3157144607034965e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005494746652647084 2.6315911364349903e-06 2.3795069700371724e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005649382790812176 2.737451135184968e-06 2.4777209746841693e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005858196462749343 2.883185065357291e-06 2.613328757344375e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0006123451658145842 3.072565879363372e-06 2.7901816884053807e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006447982716527849 3.3100974546552657e-06 3.0129088902330343e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006835188302995044 3.6008622423637284e-06 3.2867848101256906e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0007289014480886013 3.950331908349389e-06 3.617560979254643e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007813920570711525 4.364134110436746e-06 4.011256736440254e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0008414819528012676 4.8477699698347935e-06 4.473902173547854e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.000909698214673639 5.406276450776353e-06 5.011225550120251e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009865891405361137 6.043827679864423e-06 5.6282761893369055e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0010727029629680393 6.7632696833817e-06 6.328973165035695e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0011685576777258802 7.565584153303786e-06 7.1155699973020736e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0012745993024767031 8.4492792930247e-06 7.988026897721177e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0013911453019502683 9.409708586452817e-06 8.943284411945791e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0015183092851139947 1.0438319892131793e-05 9.974435705669425e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0016559024477615953 1.1521838346558353e-05 1.1069801763901811e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001803306687678845 1.2641382919946434e-05 1.2211923683776024e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0019593140098662903 1.3771700101258085e-05 1.3376552367002866e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.002121927009115305 1.4881137228858089e-05 1.4531881096123078e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0022881162408792347 1.5931341081587426e-05 1.5637847504909472e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0024535327187691328 1.6877228699573833e-05 1.6645761304312574e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002612178379463741 1.7667367626431828e-05 1.7498467503262208e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002756045151296605 1.824480044003447e-05 1.8131266004956533e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002874745490703179 1.8547496050854097e-05 1.847366172005185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002955175229632299 1.850871594819514e-05 1.845220938760739e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002981274389123195 1.8057979021895146e-05 1.7994818318265727e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029362065710581003 1.712137240631365e-05 1.7036326662395834e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002810975559057597 1.5628768002147053e-05 1.5524229384517334e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0026027477972221068 1.3530978456565972e-05 1.3425664693158388e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.002314894207841287 1.0819003115386993e-05 1.0737115099613657e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0019571944817724737 7.540771198621337e-06 7.494785934327264e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0015380810756086486 3.7934334405587924e-06 3.7768778551101084e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0010661948411799771 -3.107979858963243e-07 -3.076569880951395e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0005576303314330333 -4.650725768465112e-06 -4.629677718847978e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -3.811834485577763e-05 -9.078920471559183e-06 -9.046394071376231e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.00046715084076301384 -1.3440198662487907e-05 -1.3413703151906955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0009442450337607283 -1.7610033014718877e-05 -1.7602644967221068e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0013830941168828234 -2.150304147944736e-05 -2.1510558958128612e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0017719526405952655 -2.5056645287149295e-05 -2.5065332080262358e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002096724550288671 -2.822508206962096e-05 -2.82247457491685e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002347799124571942 -3.0981977849403894e-05 -3.09715581259567e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0025274306203842494 -3.332208504059983e-05 -3.3306451067743665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0026472330335020953 -3.525875367182979e-05 -3.524509406063409e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002718463763518788 -3.6819913619479286e-05 -3.681519227554453e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002751233973655458 -3.8044152246585514e-05 -3.805262982004621e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.00275409438214225 -3.897681368800042e-05 -3.899731548307118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027340597415644275 -3.9664662977938646e-05 -3.9689818538783065e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002697140704330497 -4.015200989941063e-05 -4.016929874613115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002648434437030802 -4.0478505752199866e-05 -4.047235351656056e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0025922045452599976 -4.067787732725365e-05 -4.0632428754583384e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002531986691550053 -4.07769935889819e-05 -4.0679536555661624e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0024708495192549283 -4.079691968243692e-05 -4.0640463626217696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002411323036018874 -4.0755979399736074e-05 -4.053927453648071e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0023553132518188773 -4.067111823578258e-05 -4.0397443323482226e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002304230723780349 -4.0558207194131176e-05 -4.023384134762345e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0022591025514275007 -4.043190135772524e-05 -4.0064721450547226e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0022206633254376806 -4.030535854197189e-05 -3.990374388319428e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0021894274440124504 -4.0189951653848414e-05 -3.976204743858949e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002165745227450868 -4.00950283261079e-05 -3.96483508532013e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0021498450305805464 -4.00277316233797e-05 -3.9569063854720414e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002141863187007643 -3.999287743955127e-05 -3.95283876704229e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz deleted file mode 100644 index 601357297..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005222083811403552 2.6830240201577335e-06 2.447934703956349e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005271413350370604 2.717336292692958e-06 2.4797990040568335e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005370619686279147 2.786808519838617e-06 2.5443801096347715e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.000552079964318251 2.893118135916574e-06 2.643372088112822e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005723603548236973 3.038727415073332e-06 2.779271012848862e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005981239391705474 3.226815388773008e-06 2.9553152162735608e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006296474979968376 3.461180678461379e-06 3.175403305706599e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006672634875947294 3.7461149513436617e-06 3.443985972075632e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0007113587733696075 4.086243607220592e-06 3.765927151881114e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007623718166216597 4.486327739556486e-06 4.146329355910423e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0008207875460143531 4.9510218735415045e-06 4.590316634802374e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008871289183032482 5.4845815494827e-06 5.102767596682506e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009619438927651459 6.0905146213547645e-06 5.687989751978106e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.001045786201308589 6.771170520798833e-06 6.3493257279677285e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0011391878839614935 7.527262824876623e-06 7.088681710813076e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0012426210733071047 8.357322736886398e-06 7.905969433275606e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0013564459550220753 9.257084110758073e-06 8.798455059826183e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014808412216955377 1.021880359995459e-05 9.760011712883262e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0016157127129574483 1.1230522917454305e-05 1.0780278917198076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0017605753721466307 1.2275281602885084e-05 1.1843741861642175e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0019144032799360523 1.3330402493554324e-05 1.2928788290634783e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0020754425631462473 1.4367241591295575e-05 1.4006907815487816e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0022409827561227663 1.5350823633658875e-05 1.5041959192679132e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0024070842073137845 1.6239716256457646e-05 1.5989699048169118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0025682630759221387 1.6986256959412163e-05 1.679775310238259e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0027171422901222765 1.753718552533667e-05 1.740623261410691e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0028440877030837084 1.7834212443074914e-05 1.7749121829612556e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002936864868750974 1.7814705001364243e-05 1.7756680485073005e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002980374480560669 1.7412892384332345e-05 1.7359155556498947e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029573352331963092 1.656054348100351e-05 1.6491720219258905e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0028562879335776153 1.5189441485559739e-05 1.5100077887098332e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0026729241523598046 1.3244740753815438e-05 1.3146190252917635e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0024086860287022816 1.0702522242941165e-05 1.0616368723506302e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0020718016029518133 7.587040906350614e-06 7.531160152431374e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0016718322565315465 3.977461032923577e-06 3.952450948676346e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0012164902724934872 -1.9338471098823118e-08 -2.2846590355943842e-08 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0007186157295741638 -4.289972926620369e-06 -4.2750145675432824e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.00020152983386637616 -8.700979551621902e-06 -8.66876798239749e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0003082002447052054 -1.3096945383433241e-05 -1.3061550524648615e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0007934218318175666 -1.7338945192524718e-05 -1.731894447012819e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.001243669147065049 -2.132786461197224e-05 -2.1328421489244392e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0016486979149528773 -2.4996744472106022e-05 -2.500641761769791e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0019944909254626065 -2.8294597787247787e-05 -2.8299477885546346e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0022697700761541316 -3.118763441423089e-05 -3.118153076491496e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0024717142675525047 -3.3662033672068366e-05 -3.3647246282214544e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0026103974092558636 -3.572384695096096e-05 -3.570684133887486e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002697287645736818 -3.73953087586162e-05 -3.7383690935217986e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027428164232704434 -3.871080666049193e-05 -3.871095116148062e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002756064336819952 -3.9713226920032106e-05 -3.9727610203828805e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027444401753899178 -4.044956435203612e-05 -4.0474703531557466e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027142327997152728 -4.09661101977067e-05 -4.0992718012800444e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0026708046320381585 -4.13055531125111e-05 -4.1320084439462405e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002618662906372297 -4.1505409207023935e-05 -4.149237590230654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002561548500621235 -4.159713610515156e-05 -4.154191598096561e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002502604954128216 -4.160556664174132e-05 -4.149761763630125e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024445453816704602 -4.1550867802280855e-05 -4.138533888865924e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0023894679767542002 -4.145101448745692e-05 -4.122824216595387e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023389363339109525 -4.1322646301287806e-05 -4.104684779849231e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0022940976489000376 -4.118114642999456e-05 -4.0859002264476546e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002255779263214009 -4.104041553844019e-05 -4.067985718893193e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022245657811436324 -4.09125635037272e-05 -4.0521886702526014e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022008591256843044 -4.080761895780723e-05 -4.039493936050051e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0021849237356505284 -4.0733294714533733e-05 -4.0306308689625026e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002176918771346905 -4.0694817464973067e-05 -4.0260803872231446e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz deleted file mode 100644 index b72e77de5..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instanton_forces_9.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005141374393608493 2.7629691984934267e-06 2.533236065422531e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005189750426139968 2.7979658722525624e-06 2.5658603114724373e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005287040139219999 2.8687036467743355e-06 2.6318560693850298e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005434321363129479 2.9766551669192192e-06 2.732707345943744e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005633216533563655 3.1239825361774977e-06 2.870601713023465e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005885897667518309 3.313478078981724e-06 3.0483796880238037e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006195089771908168 3.5484799031719e-06 3.2694645737053547e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0006564069636009654 3.83276104806179e-06 3.5377690840575863e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0006996655826867616 4.170388633494051e-06 3.8575744558738995e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0007497184306305841 4.5655474336939234e-06 4.233376903203288e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0008070462344112337 5.022322361175679e-06 4.669695011138328e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0008721691231923457 5.544433866521019e-06 5.1708305982377045e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0009456345617246765 6.134920043808879e-06 5.740574483902344e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.001027999398751883 6.7957595697745655e-06 6.381847855053336e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0011198040863016736 7.5274306572703745e-06 7.0962696959957855e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0012215366557895616 8.328403376612774e-06 7.883641520884867e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.001333583496171431 9.194565809095998e-06 8.741342519254384e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0014561633820014174 1.011858812283061e-05 9.663631572521648e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001589240579966057 1.1089233254267655e-05 1.064085883689629e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001732412289307778 1.2090626906656952e-05 1.1658598981867985e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018847652644850537 1.3101577408143594e-05 1.2696752007975937e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.002044696424604827 1.4095214655269755e-05 1.3728733323658187e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002209692882222161 1.503859098283293e-05 1.4720727683769519e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002376068584510884 1.5892497744844933e-05 1.5631166785752557e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0025386583095753376 1.6611597705878373e-05 1.641059428253173e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.00269047598643181 1.7144932237819035e-05 1.700210858242785e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002822354324119027 1.7436518885941e-05 1.7342534619761592e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029225978004712373 1.742616076877185e-05 1.73645561935675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002976702324791788 1.7050701366777103e-05 1.700006355019032e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029675305936859306 1.6244983444291747e-05 1.6184699309490723e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.00288196095702296 1.4942952683023848e-05 1.486330790301216e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002714683640268041 1.308771008280339e-05 1.299527673330801e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0024659585788384853 1.0648013629395595e-05 1.0561634007599463e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0021427478653679097 7.635336517137226e-06 7.574331150526892e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0017551844073643342 4.115101633069244e-06 4.084718257030562e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0013107273868722387 1.8897050115401721e-07 1.813825050968801e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0008206223608390761 -4.032719768235681e-06 -4.021931678953153e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0003062061311613247 -8.424988608780262e-06 -8.395006777302684e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0002058228104762058 -1.2836915957050432e-05 -1.2797765847804475e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0006958952564231907 -1.7121989243802167e-05 -1.7093682538374466e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.001153057331144704 -2.117111900281479e-05 -2.1164827999635607e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.00156756066126319 -2.4912681402505334e-05 -2.492073886915347e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0019260002907571612 -2.829340216470027e-05 -2.830082260535403e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0022162547540858306 -3.127558639562304e-05 -3.127278133451484e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0024328770845726336 -3.384024304346523e-05 -3.382710865985965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025840242689861726 -3.598852575314275e-05 -3.597056796551603e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026812839487587357 -3.773874518177743e-05 -3.7723565918169115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002735281805978919 -3.912233859093778e-05 -3.911715129073219e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002755392792131488 -4.0180076740446434e-05 -4.0189279722264067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002749334885137103 -4.095835004536972e-05 -4.098094452733649e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002723578424198285 -4.1504208912567226e-05 -4.1533230348508575e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0026836578832849494 -4.186190197118068e-05 -4.18855494111419e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002634239237318412 -4.2071001779665165e-05 -4.2074674529869505e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002579205579830223 -4.216543801830769e-05 -4.213425697635269e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002521778056556903 -4.2172887033292896e-05 -4.209459747460904e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024647457908851464 -4.21152211168035e-05 -4.1982713414004744e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024103337994446257 -4.201123785557918e-05 -4.18227829824631e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002360207480150757 -4.1878061322991994e-05 -4.1636292732958e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023155940748557174 -4.173145930270709e-05 -4.1442019997458036e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002277382849313454 -4.158570230298675e-05 -4.12559923500627e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.00224620534815149 -4.1453267415756806e-05 -4.1091474241824e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022224980381916723 -4.134452849354315e-05 -4.095898776940539e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022065495370183555 -4.126749237544906e-05 -4.086635654398032e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0021985343113196066 -4.122760095155585e-05 -4.081875626229774e-05 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 b/drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 deleted file mode 100644 index 35f8223ca..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.instantonfric_FINAL.hess_15 +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_00 b/drivers/py/pes/friction/frictionH/060K/inst.raw_00 deleted file mode 100644 index b0611f6a3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_00 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 -{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} - #*EXTRAS*# Step: 1 Bead: 0 -{"friction": [[0.00013423764728277205, -2.348553637133703e-05, -2.3249318245248094e-05], [-2.348553637133703e-05, 0.00013443905315219606, -2.3370860165126848e-05], [-2.3249318245248094e-05, -2.3370860165126848e-05, 0.00013438946863385249]]} - #*EXTRAS*# Step: 2 Bead: 0 -{"friction": [[0.00013575229882282363, -1.5190825886546166e-05, -1.4688053747849838e-05], [-1.5190825886546166e-05, 0.00013584922333986188, -1.5052148480681862e-05], [-1.4688053747849838e-05, -1.5052148480681862e-05, 0.00013626830389509913]]} - #*EXTRAS*# Step: 3 Bead: 0 -{"friction": [[0.0001371461313605444, -7.6138455177672514e-06, -7.155165180438593e-06], [-7.6138455177672514e-06, 0.00013717564146078164, -7.509255010627289e-06], [-7.155165180438593e-06, -7.509255010627289e-06, 0.0001378738772975121]]} - #*EXTRAS*# Step: 4 Bead: 0 -{"friction": [[0.0001376909459037285, -5.029032704727686e-06, -4.673346570088041e-06], [-5.029032704727686e-06, 0.00013770983627563985, -4.947851967879184e-06], [-4.673346570088041e-06, -4.947851967879184e-06, 0.00013845751050799916]]} - #*EXTRAS*# Step: 5 Bead: 0 -{"friction": [[0.00013770582140571047, -4.961428005926094e-06, -4.609086083728716e-06], [-4.961428005926094e-06, 0.00013772453208725052, -4.88093750174026e-06], [-4.609086083728716e-06, -4.88093750174026e-06, 0.00013847316030156636]]} - #*EXTRAS*# Step: 6 Bead: 0 -{"friction": [[0.0001378382987707843, -4.365987040591944e-06, -4.044555358583953e-06], [-4.365987040591944e-06, 0.0001378556495428131, -4.291745681540963e-06], [-4.044555358583953e-06, -4.291745681540963e-06, 0.00013861192122795624]]} - #*EXTRAS*# Step: 7 Bead: 0 -{"friction": [[0.00013787999158690196, -4.181020414403456e-06, -3.869724738291976e-06], [-4.181020414403456e-06, 0.00013789700195002702, -4.108782178618286e-06], [-3.869724738291976e-06, -4.108782178618286e-06, 0.0001386553694775391]]} - #*EXTRAS*# Step: 8 Bead: 0 -{"friction": [[0.00013791721778029628, -4.0168349059974526e-06, -3.714749393673453e-06], [-4.0168349059974526e-06, 0.00013793395880981737, -3.946399244761727e-06], [-3.714749393673453e-06, -3.946399244761727e-06, 0.00013869407566294647]]} - #*EXTRAS*# Step: 9 Bead: 0 -{"friction": [[0.00013793799834706263, -3.9255752814151975e-06, -3.6286958232796008e-06], [-3.9255752814151975e-06, 0.00013795460306934335, -3.856151498891053e-06], [-3.6286958232796008e-06, -3.856151498891053e-06, 0.00013871564701568853]]} - #*EXTRAS*# Step: 10 Bead: 0 -{"friction": [[0.00013795203282752005, -3.8640998694949004e-06, -3.5707623591766514e-06], [-3.8640998694949004e-06, 0.0001379685511381923, -3.79536172394137e-06], [-3.5707623591766514e-06, -3.79536172394137e-06, 0.0001387302013603479]]} - #*EXTRAS*# Step: 11 Bead: 0 -{"friction": [[0.00013796080729782463, -3.825729501167846e-06, -3.53461701001706e-06], [-3.825729501167846e-06, 0.00013797727388437092, -3.757420933634416e-06], [-3.53461701001706e-06, -3.757420933634416e-06, 0.0001387392950688923]]} - #*EXTRAS*# Step: 12 Bead: 0 -{"friction": [[0.00013796647662811659, -3.800964119256224e-06, -3.511293554462288e-06], [-3.800964119256224e-06, 0.00013798291073333202, -3.732933480082611e-06], [-3.511293554462288e-06, -3.732933480082611e-06, 0.0001387451683062371]]} - #*EXTRAS*# Step: 13 Bead: 0 -{"friction": [[0.000137970088937315, -3.7851952101671225e-06, -3.496445150911942e-06], [-3.7851952101671225e-06, 0.000137986502729977, -3.7173418089810484e-06], [-3.496445150911942e-06, -3.7173418089810484e-06, 0.00013874890957506228]]} - #*EXTRAS*# Step: 14 Bead: 0 -{"friction": [[0.00013797240431558724, -3.7750922325792497e-06, -3.4869329072347104e-06], [-3.7750922325792497e-06, 0.00013798880524530167, -3.7073524972095786e-06], [-3.4869329072347104e-06, -3.7073524972095786e-06, 0.00013875130721878427]]} - #*EXTRAS*# Step: 15 Bead: 0 -{"friction": [[0.00013797388437386437, -3.7686359120512866e-06, -3.4808544950052107e-06], [-3.7686359120512866e-06, 0.00013799027714531302, -3.7009688604690436e-06], [-3.4808544950052107e-06, -3.7009688604690436e-06, 0.0001387528397026003]]} - #*EXTRAS*# Step: 16 Bead: 0 -{"friction": [[0.00013797483150163595, -3.7645050816462428e-06, -3.4769656180582017e-06], [-3.7645050816462428e-06, 0.00013799121907862047, -3.6968845526256393e-06], [-3.4769656180582017e-06, -3.6968845526256393e-06, 0.00013875382031300449]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_01 b/drivers/py/pes/friction/frictionH/060K/inst.raw_01 deleted file mode 100644 index 690a0ba47..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_01 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 -{"friction": [[0.0001318960708675288, -3.145359585337808e-05, -3.140499284046311e-05], [-3.145359585337808e-05, 0.00013214032682715794, -3.1420093958772926e-05], [-3.140499284046311e-05, -3.1420093958772926e-05, 0.00013167914079224472]]} - #*EXTRAS*# Step: 1 Bead: 1 -{"friction": [[0.00013421219818083975, -2.3605689047036214e-05, -2.3374290140305082e-05], [-2.3605689047036214e-05, 0.00013441500713185748, -2.3491833407910672e-05], [-2.3374290140305082e-05, -2.3491833407910672e-05, 0.00013435815019284246]]} - #*EXTRAS*# Step: 2 Bead: 1 -{"friction": [[0.00013573156450987525, -1.531122246133872e-05, -1.4810488159437588e-05], [-1.531122246133872e-05, 0.0001358299027784595, -1.5172430443879968e-05], [-1.4810488159437588e-05, -1.5172430443879968e-05, 0.00013624312450119847]]} - #*EXTRAS*# Step: 3 Bead: 1 -{"friction": [[0.00013712779840587168, -7.704633406618396e-06, -7.2432029676650376e-06], [-7.704633406618396e-06, 0.00013715781044139786, -7.5993272238622495e-06], [-7.2432029676650376e-06, -7.5993272238622495e-06, 0.00013785385777348626]]} - #*EXTRAS*# Step: 4 Bead: 1 -{"friction": [[0.00013767831127657328, -5.086572824476252e-06, -4.728066803940873e-06], [-5.086572824476252e-06, 0.00013769735862466465, -5.004807717050321e-06], [-4.728066803940873e-06, -5.004807717050321e-06, 0.00013844420710205075]]} - #*EXTRAS*# Step: 5 Bead: 1 -{"friction": [[0.00013769500088790595, -5.010588947814341e-06, -4.6558118404509825e-06], [-5.010588947814341e-06, 0.00013771384172842844, -4.929596127837761e-06], [-4.6558118404509825e-06, -4.929596127837761e-06, 0.0001384617779617171]]} - #*EXTRAS*# Step: 6 Bead: 1 -{"friction": [[0.00013782856683117385, -4.4093276387752435e-06, -4.085557628520318e-06], [-4.4093276387752435e-06, 0.0001378460030153187, -4.3346211515787955e-06], [-4.085557628520318e-06, -4.3346211515787955e-06, 0.00013860176447469952]]} - #*EXTRAS*# Step: 7 Bead: 1 -{"friction": [[0.00013787080283125152, -4.2216870213216404e-06, -3.908141071202103e-06], [-4.2216870213216404e-06, 0.00013788788468120576, -4.149005870458964e-06], [-3.908141071202103e-06, -4.149005870458964e-06, 0.00013864580277650641]]} - #*EXTRAS*# Step: 8 Bead: 1 -{"friction": [[0.00013790841378145038, -4.055583065666455e-06, -3.7513058560917236e-06], [-4.055583065666455e-06, 0.00013792521558389558, -3.984719917314708e-06], [-3.7513058560917236e-06, -3.984719917314708e-06, 0.00013868492901939597]]} - #*EXTRAS*# Step: 9 Bead: 1 -{"friction": [[0.0001379294302841245, -3.9631687121073085e-06, -3.6641371615835034e-06], [-3.9631687121073085e-06, 0.00013794608999531557, -3.893327236509839e-06], [-3.6641371615835034e-06, -3.893327236509839e-06, 0.00013870675595400254]]} - #*EXTRAS*# Step: 10 Bead: 1 -{"friction": [[0.0001379436183742693, -3.900942529069543e-06, -3.6054789210239987e-06], [-3.900942529069543e-06, 0.00013796018794874098, -3.83179308955976e-06], [-3.6054789210239987e-06, -3.83179308955976e-06, 0.00013872147658957804]]} - #*EXTRAS*# Step: 11 Bead: 1 -{"friction": [[0.0001379524904757413, -3.862097368035428e-06, -3.5688757070827457e-06], [-3.862097368035428e-06, 0.00013796900604495836, -3.7933816105998145e-06], [-3.5688757070827457e-06, -3.7933816105998145e-06, 0.00013873067576881967]]} - #*EXTRAS*# Step: 12 Bead: 1 -{"friction": [[0.0001379582225625487, -3.837027282171246e-06, -3.5452585150372925e-06], [-3.837027282171246e-06, 0.00013797470420217437, -3.7685920993052055e-06], [-3.5452585150372925e-06, -3.7685920993052055e-06, 0.00013873661675538375]]} - #*EXTRAS*# Step: 13 Bead: 1 -{"friction": [[0.00013796187499285674, -3.821063900763913e-06, -3.530222707167836e-06], [-3.821063900763913e-06, 0.00013797833540600532, -3.7528076527859285e-06], [-3.530222707167836e-06, -3.7528076527859285e-06, 0.00013874040130667877]]} - #*EXTRAS*# Step: 14 Bead: 1 -{"friction": [[0.0001379642160712024, -3.8108364518266074e-06, -3.5205905370555803e-06], [-3.8108364518266074e-06, 0.00013798066303964958, -3.742694958251714e-06], [-3.5205905370555803e-06, -3.742694958251714e-06, 0.0001387428266661096]]} - #*EXTRAS*# Step: 15 Bead: 1 -{"friction": [[0.00013796571257119976, -3.8043005508814134e-06, -3.514435460718382e-06], [-3.8043005508814134e-06, 0.00013798215101104406, -3.7362324383158968e-06], [-3.514435460718382e-06, -3.7362324383158968e-06, 0.00013874437687645187]]} - #*EXTRAS*# Step: 16 Bead: 1 -{"friction": [[0.00013796667022043812, -3.8001188130614423e-06, -3.5104975456983384e-06], [-3.8001188130614423e-06, 0.00013798310322949036, -3.7320976695151757e-06], [-3.5104975456983384e-06, -3.7320976695151757e-06, 0.0001387453688288128]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_02 b/drivers/py/pes/friction/frictionH/060K/inst.raw_02 deleted file mode 100644 index 29712b2f3..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_02 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 -{"friction": [[0.00013182249801045433, -3.1627039924819494e-05, -3.157597998104187e-05], [-3.1627039924819494e-05, 0.00013206576277603182, -3.1595838794370805e-05], [-3.157597998104187e-05, -3.1595838794370805e-05, 0.0001315990850259919]]} - #*EXTRAS*# Step: 1 Bead: 2 -{"friction": [[0.00013416900800073794, -2.3807653696517653e-05, -2.358433734495794e-05], [-2.3807653696517653e-05, 0.00013437414992859416, -2.369520713456347e-05], [-2.358433734495794e-05, -2.369520713456347e-05, 0.00013430507960848526]]} - #*EXTRAS*# Step: 2 Bead: 2 -{"friction": [[0.00013569622167241053, -1.551660843299909e-05, -1.5019520532352334e-05], [-1.551660843299909e-05, 0.00013579698951373382, -1.537765223496821e-05], [-1.5019520532352334e-05, -1.537765223496821e-05, 0.0001362001284347798]]} - #*EXTRAS*# Step: 3 Bead: 2 -{"friction": [[0.00013709539583038705, -7.865718909077805e-06, -7.399551213118173e-06], [-7.865718909077805e-06, 0.000137126319254703, -7.759160858863718e-06], [-7.399551213118173e-06, -7.759160858863718e-06, 0.00013781840939080508]]} - #*EXTRAS*# Step: 4 Bead: 2 -{"friction": [[0.00013765352991564829, -5.199751249925924e-06, -4.835769581552853e-06], [-5.199751249925924e-06, 0.00013767289683673582, -5.116845052560431e-06], [-4.835769581552853e-06, -5.116845052560431e-06, 0.00013841808412039025]]} - #*EXTRAS*# Step: 5 Bead: 2 -{"friction": [[0.00013767327963907036, -5.109518353158603e-06, -4.7498946158095616e-06], [-5.109518353158603e-06, 0.0001376923906192341, -5.027521010267586e-06], [-4.7498946158095616e-06, -5.027521010267586e-06, 0.00013843890627086457]]} - #*EXTRAS*# Step: 6 Bead: 2 -{"friction": [[0.0001378090247068655, -4.496547804090528e-06, -4.1681142369068245e-06], [-4.496547804090528e-06, 0.00013782663926166817, -4.420910155772545e-06], [-4.1681142369068245e-06, -4.420910155772545e-06, 0.0001385813519303408]]} - #*EXTRAS*# Step: 7 Bead: 2 -{"friction": [[0.00013785235005580183, -4.30352138928369e-06, -3.9854843772290815e-06], [-4.30352138928369e-06, 0.00013786958149502337, -4.2299532371294874e-06], [-3.9854843772290815e-06, -4.2299532371294874e-06, 0.00013862657577925306]]} - #*EXTRAS*# Step: 8 Bead: 2 -{"friction": [[0.0001378907319832182, -4.133557019483402e-06, -3.824903255476108e-06], [-4.133557019483402e-06, 0.00013790766130770355, -4.0618375129126275e-06], [-3.824903255476108e-06, -4.0618375129126275e-06, 0.00013866654527912176]]} - #*EXTRAS*# Step: 9 Bead: 2 -{"friction": [[0.00013791222153992024, -4.038818162384249e-06, -3.7354878480972996e-06], [-4.038818162384249e-06, 0.00013792899683633502, -3.968139814694238e-06], [-3.7354878480972996e-06, -3.968139814694238e-06, 0.00013868888553103761]]} - #*EXTRAS*# Step: 10 Bead: 2 -{"friction": [[0.0001379267176097774, -3.975080823853663e-06, -3.6753695432488504e-06], [-3.975080823853663e-06, 0.00013794339508472038, -3.905107246632902e-06], [-3.6753695432488504e-06, -3.905107246632902e-06, 0.00013870394012607592]]} - #*EXTRAS*# Step: 11 Bead: 2 -{"friction": [[0.00013793578548403917, -3.935279935344475e-06, -3.637843911415166e-06], [-3.935279935344475e-06, 0.00013795240424567214, -3.865748210962321e-06], [-3.637843911415166e-06, -3.865748210962321e-06, 0.00013871335114125615]]} - #*EXTRAS*# Step: 12 Bead: 2 -{"friction": [[0.0001379416434151117, -3.9095965082902505e-06, -3.6136349684178526e-06], [-3.9095965082902505e-06, 0.00013795822525800537, -3.840350627646778e-06], [-3.6136349684178526e-06, -3.840350627646778e-06, 0.0001387194282015226]]} - #*EXTRAS*# Step: 13 Bead: 2 -{"friction": [[0.00013794537630303582, -3.893241665325648e-06, -3.5982216182689935e-06], [-3.893241665325648e-06, 0.0001379619350328975, -3.824178098975292e-06], [-3.5982216182689935e-06, -3.824178098975292e-06, 0.00013872329968787068]]} - #*EXTRAS*# Step: 14 Bead: 2 -{"friction": [[0.00013794776892036962, -3.882763662703983e-06, -3.5883478467009877e-06], [-3.882763662703983e-06, 0.0001379643130046078, -3.8138170188573057e-06], [-3.5883478467009877e-06, -3.8138170188573057e-06, 0.0001387257807161704]]} - #*EXTRAS*# Step: 15 Bead: 2 -{"friction": [[0.00013794929839317028, -3.8760675701452695e-06, -3.582038323916065e-06], [-3.8760675701452695e-06, 0.00013796583318427853, -3.807195696020668e-06], [-3.582038323916065e-06, -3.807195696020668e-06, 0.0001387273665318023]]} - #*EXTRAS*# Step: 16 Bead: 2 -{"friction": [[0.00013795027714269808, -3.871783357993848e-06, -3.5780016174998872e-06], [-3.871783357993848e-06, 0.00013796680601512723, -3.8029593421627264e-06], [-3.5780016174998872e-06, -3.8029593421627264e-06, 0.00013872838126558352]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_03 b/drivers/py/pes/friction/frictionH/060K/inst.raw_03 deleted file mode 100644 index 1b8a49453..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_03 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 -{"friction": [[0.00013171780647812666, -3.186828910318049e-05, -3.181299933918628e-05], [-3.186828910318049e-05, 0.0001319594795236481, -3.184031805657655e-05], [-3.181299933918628e-05, -3.184031805657655e-05, 0.00013148559226403892]]} - #*EXTRAS*# Step: 1 Bead: 3 -{"friction": [[0.0001341073054254621, -2.4091918826671486e-05, -2.38799248192029e-05], [-2.4091918826671486e-05, 0.0001343156734060211, -2.3981518631629152e-05], [-2.38799248192029e-05, -2.3981518631629152e-05, 0.00013422944390107609]]} - #*EXTRAS*# Step: 2 Bead: 3 -{"friction": [[0.0001356459621644533, -1.5808944485075542e-05, -1.5317410469091326e-05], [-1.5808944485075542e-05, 0.0001357502254732159, -1.5669822806364226e-05], [-1.5317410469091326e-05, -1.5669822806364226e-05, 0.00013613882449957463]]} - #*EXTRAS*# Step: 3 Bead: 3 -{"friction": [[0.00013704858835151458, -8.09982393646933e-06, -7.6270948629997415e-06], [-8.09982393646933e-06, 0.00013708088341545045, -7.991487566659908e-06], [-7.6270948629997415e-06, -7.991487566659908e-06, 0.00013776705416370654]]} - #*EXTRAS*# Step: 4 Bead: 3 -{"friction": [[0.00013761635512817485, -5.370331120688832e-06, -4.998274065256625e-06], [-5.370331120688832e-06, 0.00013763623069557024, -5.2857260077085855e-06], [-4.998274065256625e-06, -5.2857260077085855e-06, 0.00013837882178726406]]} - #*EXTRAS*# Step: 5 Bead: 3 -{"friction": [[0.00013764050036780585, -5.259428966355928e-06, -4.892597873339387e-06], [-5.259428966355928e-06, 0.0001376600415548423, -5.1759255393440015e-06], [-4.892597873339387e-06, -5.1759255393440015e-06, 0.00013840433318992323]]} - #*EXTRAS*# Step: 6 Bead: 3 -{"friction": [[0.00013777951704774323, -4.62873034737059e-06, -4.293336437723489e-06], [-4.62873034737059e-06, 0.0001377974184018706, -4.5516939579244145e-06], [-4.293336437723489e-06, -4.5516939579244145e-06, 0.0001385504856729999]]} - #*EXTRAS*# Step: 7 Bead: 3 -{"friction": [[0.00013782448357032125, -4.427530952936149e-06, -4.102782981314627e-06], [-4.427530952936149e-06, 0.00013784195626635742, -4.3526295890126455e-06], [-4.102782981314627e-06, -4.3526295890126455e-06, 0.00013859750126340328]]} - #*EXTRAS*# Step: 8 Bead: 3 -{"friction": [[0.00013786402545591187, -4.251717218417898e-06, -3.936517440200816e-06], [-4.251717218417898e-06, 0.00013788116131019357, -4.178709905316281e-06], [-3.936517440200816e-06, -4.178709905316281e-06, 0.00013863874341182728]]} - #*EXTRAS*# Step: 9 Bead: 3 -{"friction": [[0.00013788622745084406, -4.153453999202411e-06, -3.8436906893443965e-06], [-4.153453999202411e-06, 0.00013790319043292305, -4.0815168034275855e-06], [-3.8436906893443965e-06, -4.0815168034275855e-06, 0.0001386618589704395]]} - #*EXTRAS*# Step: 10 Bead: 3 -{"friction": [[0.00013790118732845096, -4.087425899284604e-06, -3.7813559390482727e-06], [-4.087425899284604e-06, 0.00013791804036488933, -4.016212405956493e-06], [-3.7813559390482727e-06, -4.016212405956493e-06, 0.00013867741791452715]]} - #*EXTRAS*# Step: 11 Bead: 3 -{"friction": [[0.0001379105500990275, -4.0461760643877775e-06, -3.7424299123029473e-06], [-4.0461760643877775e-06, 0.00013792733698882805, -3.9754165805040554e-06], [-3.7424299123029473e-06, -3.9754165805040554e-06, 0.00013868714889881485]]} - #*EXTRAS*# Step: 12 Bead: 3 -{"friction": [[0.0001379165975998007, -4.019562791819492e-06, -3.7173226174559855e-06], [-4.019562791819492e-06, 0.000137933342851277, -3.949096993389073e-06], [-3.7173226174559855e-06, -3.949096993389073e-06, 0.00013869343149434978]]} - #*EXTRAS*# Step: 13 Bead: 3 -{"friction": [[0.00013792045169693705, -4.002614463428573e-06, -3.7013360999725105e-06], [-4.002614463428573e-06, 0.00013793717085604587, -3.932336009932304e-06], [-3.7013360999725105e-06, -3.932336009932304e-06, 0.00013869743430006243]]} - #*EXTRAS*# Step: 14 Bead: 3 -{"friction": [[0.0001379229219598502, -3.991756602187793e-06, -3.69109554200351e-06], [-3.991756602187793e-06, 0.00013793962457667224, -3.921598299087858e-06], [-3.69109554200351e-06, -3.921598299087858e-06, 0.0001386999994198825]]} - #*EXTRAS*# Step: 15 Bead: 3 -{"friction": [[0.00013792450110888487, -3.984817644788738e-06, -3.684551545761487e-06], [-3.984817644788738e-06, 0.00013794119322504053, -3.914736179147696e-06], [-3.684551545761487e-06, -3.914736179147696e-06, 0.00013870163902059615]]} - #*EXTRAS*# Step: 16 Bead: 3 -{"friction": [[0.0001379255116481648, -3.980378072060427e-06, -3.680364858862378e-06], [-3.980378072060427e-06, 0.00013794219707502083, -3.910345788880799e-06], [-3.680364858862378e-06, -3.910345788880799e-06, 0.0001387026881680756]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_04 b/drivers/py/pes/friction/frictionH/060K/inst.raw_04 deleted file mode 100644 index 10a0c9b1f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_04 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 -{"friction": [[0.00013158007460812243, -3.217616690285429e-05, -3.2114038906784815e-05], [-3.217616690285429e-05, 0.000131819341634194, -3.215236678795705e-05], [-3.2114038906784815e-05, -3.215236678795705e-05, 0.00013133701434974246]]} - #*EXTRAS*# Step: 1 Bead: 4 -{"friction": [[0.00013402596589135048, -2.445897241083669e-05, -2.4261466286692028e-05], [-2.445897241083669e-05, 0.000134238391017754, -2.435132318714053e-05], [-2.4261466286692028e-05, -2.435132318714053e-05, 0.00013413007921958227]]} - #*EXTRAS*# Step: 2 Bead: 4 -{"friction": [[0.00013558035653235046, -1.619078144869508e-05, -1.5707129815061076e-05], [-1.619078144869508e-05, 0.00013568924777082483, -1.605156444346024e-05], [-1.5707129815061076e-05, -1.605156444346024e-05, 0.0001360585299848262]]} - #*EXTRAS*# Step: 3 Bead: 4 -{"friction": [[0.00013698693977136814, -8.410700532733241e-06, -7.929847247333982e-06], [-8.410700532733241e-06, 0.00013702114172870622, -8.300077941603389e-06], [-7.929847247333982e-06, -8.300077941603389e-06, 0.0001376991451454236]]} - #*EXTRAS*# Step: 4 Bead: 4 -{"friction": [[0.00013756644128827046, -5.600887075498122e-06, -5.218253396070243e-06], [-5.600887075498122e-06, 0.00013758705567076668, -5.514025724742836e-06], [-5.218253396070243e-06, -5.514025724742836e-06, 0.00013832596149248019]]} - #*EXTRAS*# Step: 5 Bead: 4 -{"friction": [[0.0001375964318955127, -5.462148054110503e-06, -5.085832442561333e-06], [-5.462148054110503e-06, 0.00013761659463747272, -5.37663889685109e-06], [-5.085832442561333e-06, -5.37663889685109e-06, 0.00013835774234699836]]} - #*EXTRAS*# Step: 6 Bead: 4 -{"friction": [[0.00013773981364965417, -4.807511949092367e-06, -4.462909265687072e-06], [-4.807511949092367e-06, 0.00013775813439169965, -4.728607587469339e-06], [-4.462909265687072e-06, -4.728607587469339e-06, 0.00013850886913433955]]} - #*EXTRAS*# Step: 7 Bead: 4 -{"friction": [[0.00013778698104651717, -4.595239363889967e-06, -4.261596771375986e-06], [-4.595239363889967e-06, 0.00013780480785947506, -4.5185559539245416e-06], [-4.261596771375986e-06, -4.5185559539245416e-06, 0.00013855829839521937]]} - #*EXTRAS*# Step: 8 Bead: 4 -{"friction": [[0.00013782807559174236, -4.4115170133151105e-06, -4.087629250445344e-06], [-4.4115170133151105e-06, 0.00013784551614732867, -4.336787072609965e-06], [-4.087629250445344e-06, -4.336787072609965e-06, 0.0001386012516397715]]} - #*EXTRAS*# Step: 9 Bead: 4 -{"friction": [[0.0001378512325592193, -4.308484486327402e-06, -3.990176698472619e-06], [-4.308484486327402e-06, 0.0001378684733169179, -4.234862723556853e-06], [-3.990176698472619e-06, -4.234862723556853e-06, 0.00013862541074022026]]} - #*EXTRAS*# Step: 10 Bead: 4 -{"friction": [[0.00013786681410085183, -4.2393572125690814e-06, -3.924837315878018e-06], [-4.2393572125690814e-06, 0.00013788392760278305, -4.16648404984495e-06], [-3.924837315878018e-06, -4.16648404984495e-06, 0.00013864164841749445]]} - #*EXTRAS*# Step: 11 Bead: 4 -{"friction": [[0.00013787657226515087, -4.19614679438362e-06, -3.884012669867443e-06], [-4.19614679438362e-06, 0.00013789360899737804, -4.123743646437485e-06], [-3.884012669867443e-06, -4.123743646437485e-06, 0.00013865181010203677]]} - #*EXTRAS*# Step: 12 Bead: 4 -{"friction": [[0.0001378828739546768, -4.168275375313441e-06, -3.857687470585437e-06], [-4.168275375313441e-06, 0.00013789986230344388, -4.096176241451027e-06], [-3.857687470585437e-06, -4.096176241451027e-06, 0.0001386583693657478]]} - #*EXTRAS*# Step: 13 Bead: 4 -{"friction": [[0.0001378868905953724, -4.150523987049385e-06, -3.840923883198975e-06], [-4.150523987049385e-06, 0.00013790384859256358, -4.078618826759461e-06], [-3.840923883198975e-06, -4.078618826759461e-06, 0.00013866254895104302]]} - #*EXTRAS*# Step: 14 Bead: 4 -{"friction": [[0.00013788946498655198, -4.139152128910127e-06, -3.830186058806337e-06], [-4.139152128910127e-06, 0.00013790640372980797, -4.067371373085801e-06], [-3.830186058806337e-06, -4.067371373085801e-06, 0.00013866522727545868]]} - #*EXTRAS*# Step: 15 Bead: 4 -{"friction": [[0.00013789111075756782, -4.131884540573933e-06, -3.823324175659879e-06], [-4.131884540573933e-06, 0.000137908037273583, -4.060183347700094e-06], [-3.823324175659879e-06, -4.060183347700094e-06, 0.00013866693928378968]]} - #*EXTRAS*# Step: 16 Bead: 4 -{"friction": [[0.00013789216393167466, -4.127234742082154e-06, -3.818934153074344e-06], [-4.127234742082154e-06, 0.00013790908265648577, -4.055584477207085e-06], [-3.818934153074344e-06, -4.055584477207085e-06, 0.0001386680347608504]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_05 b/drivers/py/pes/friction/frictionH/060K/inst.raw_05 deleted file mode 100644 index af3427240..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_05 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 -{"friction": [[0.00013140687508940286, -3.2549089934313045e-05, -3.247646875118131e-05], [-3.2549089934313045e-05, 0.00013164265398424839, -3.25304116398176e-05], [-3.247646875118131e-05, -3.25304116398176e-05, 0.0001311512838181544]]} - #*EXTRAS*# Step: 1 Bead: 5 -{"friction": [[0.00013392341429703758, -2.4909337334287973e-05, -2.4729323817478538e-05], [-2.4909337334287973e-05, 0.00013414063220962155, -2.480522966465632e-05], [-2.4729323817478538e-05, -2.480522966465632e-05, 0.00013400538272629968]]} - #*EXTRAS*# Step: 2 Bead: 5 -{"friction": [[0.00013549881073491587, -1.6665278770724668e-05, -1.619238056838109e-05], [-1.6665278770724668e-05, 0.00013561354325466237, -1.6526134283560228e-05], [-1.619238056838109e-05, -1.6526134283560228e-05, 0.00013595832490855675]]} - #*EXTRAS*# Step: 3 Bead: 5 -{"friction": [[0.0001369099181112485, -8.803171711662813e-06, -8.313014401748177e-06], [-8.803171711662813e-06, 0.0001369466647782674, -8.689785841452845e-06], [-8.313014401748177e-06, -8.689785841452845e-06, 0.00013761386108267123]]} - #*EXTRAS*# Step: 4 Bead: 5 -{"friction": [[0.00013750335008310457, -5.89483311551549e-06, -5.499276464229538e-06], [-5.89483311551549e-06, 0.00013752499140817944, -5.805162054582552e-06], [-5.499276464229538e-06, -5.805162054582552e-06, 0.00013825890592898224]]} - #*EXTRAS*# Step: 5 Bead: 5 -{"friction": [[0.00013754077423236568, -5.720129883386304e-06, -5.332178089722472e-06], [-5.720129883386304e-06, 0.0001375617937617585, -5.6321196936610635e-06], [-5.332178089722472e-06, -5.6321196936610635e-06, 0.00013829871429053104]]} - #*EXTRAS*# Step: 6 Bead: 5 -{"friction": [[0.00013768961311797854, -5.0350972386330206e-06, -4.679112750825537e-06], [-5.0350972386330206e-06, 0.00013770851985974851, -4.953854776485155e-06], [-4.679112750825537e-06, -4.953854776485155e-06, 0.0001384561076582171]]} - #*EXTRAS*# Step: 7 Bead: 5 -{"friction": [[0.00013773955047169799, -4.80870058606456e-06, -4.464037466770495e-06], [-4.80870058606456e-06, 0.00013775787412287428, -4.729783897115178e-06], [-4.464037466770495e-06, -4.729783897115178e-06, 0.000138508592946185]]} - #*EXTRAS*# Step: 8 Bead: 5 -{"friction": [[0.00013778259454640327, -4.6149170597076255e-06, -4.280244472882557e-06], [-4.6149170597076255e-06, 0.00013780046500213393, -4.538026139233866e-06], [-4.280244472882557e-06, -4.538026139233866e-06, 0.0001385537073715922]]} - #*EXTRAS*# Step: 9 Bead: 5 -{"friction": [[0.000137806952748325, -4.505810295791428e-06, -4.176884782478642e-06], [-4.505810295791428e-06, 0.00013782458675378232, -4.4300741443607636e-06], [-4.176884782478642e-06, -4.4300741443607636e-06, 0.00013857918631933884]]} - #*EXTRAS*# Step: 10 Bead: 5 -{"friction": [[0.00013782331621288446, -4.432737112710233e-06, -4.107709894908343e-06], [-4.432737112710233e-06, 0.00013784079942074384, -4.357780066135241e-06], [-4.107709894908343e-06, -4.357780066135241e-06, 0.0001385962822740279]]} - #*EXTRAS*# Step: 11 Bead: 5 -{"friction": [[0.00013783357191172446, -4.387029955996895e-06, -4.064461220013463e-06], [-4.387029955996895e-06, 0.00013785096388599775, -4.312562564937565e-06], [-4.064461220013463e-06, -4.312562564937565e-06, 0.0001386069887507768]]} - #*EXTRAS*# Step: 12 Bead: 5 -{"friction": [[0.00013784019348067007, -4.35755638294656e-06, -4.036581172509351e-06], [-4.35755638294656e-06, 0.00013785752788706242, -4.283405688028381e-06], [-4.036581172509351e-06, -4.283405688028381e-06, 0.0001386138979783455]]} - #*EXTRAS*# Step: 13 Bead: 5 -{"friction": [[0.00013784441470022062, -4.338782304996927e-06, -4.0188254961769415e-06], [-4.338782304996927e-06, 0.00013786171295360308, -4.264833727072013e-06], [-4.0188254961769415e-06, -4.264833727072013e-06, 0.00013861830119638686]]} - #*EXTRAS*# Step: 14 Bead: 5 -{"friction": [[0.0001378471201553272, -4.326755874324704e-06, -4.007452813779088e-06], [-4.326755874324704e-06, 0.0001378643954609158, -4.252936928505525e-06], [-4.007452813779088e-06, -4.252936928505525e-06, 0.0001386211227325271]]} - #*EXTRAS*# Step: 15 Bead: 5 -{"friction": [[0.00013784884978623857, -4.319069769326809e-06, -4.000185081874505e-06], [-4.319069769326809e-06, 0.00013786611051234447, -4.245333736384734e-06], [-4.000185081874505e-06, -4.245333736384734e-06, 0.0001386229263444407]]} - #*EXTRAS*# Step: 16 Bead: 5 -{"friction": [[0.00013784995662798204, -4.31415224386569e-06, -3.995535458954869e-06], [-4.31415224386569e-06, 0.00013786720806160146, -4.240469284630536e-06], [-3.995535458954869e-06, -4.240469284630536e-06, 0.00013862408043431799]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_06 b/drivers/py/pes/friction/frictionH/060K/inst.raw_06 deleted file mode 100644 index 0a7becd4e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_06 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 -{"friction": [[0.0001311956103908458, -3.29848470674875e-05, -3.289701440835983e-05], [-3.29848470674875e-05, 0.00013142653940500336, -3.297224398384808e-05], [-3.289701440835983e-05, -3.297224398384808e-05, 0.00013092623268750358]]} - #*EXTRAS*# Step: 1 Bead: 6 -{"friction": [[0.00013379754738756933, -2.544336620256607e-05, -2.5283541235990818e-05], [-2.544336620256607e-05, 0.00013402015037169526, -2.5343693185848085e-05], [-2.5283541235990818e-05, -2.5343693185848085e-05, 0.0001338532609342757]]} - #*EXTRAS*# Step: 2 Bead: 6 -{"friction": [[0.0001354005408940594, -1.723598162677344e-05, -1.6777359961614436e-05], [-1.723598162677344e-05, 0.0001355224161928526, -1.7097205151167636e-05], [-1.6777359961614436e-05, -1.7097205151167636e-05, 0.00013583703505356534]]} - #*EXTRAS*# Step: 3 Bead: 6 -{"friction": [[0.00013681692943362544, -9.283028492345667e-06, -8.78292600373361e-06], [-9.283028492345667e-06, 0.00013685699186556386, -9.166451265365982e-06], [-8.78292600373361e-06, -9.166451265365982e-06, 0.0001375102298500599]]} - #*EXTRAS*# Step: 4 Bead: 6 -{"friction": [[0.00013742656368641927, -6.25643554302692e-06, -5.845841035678323e-06], [-6.25643554302692e-06, 0.00013744959784629403, -6.163411185282463e-06], [-5.845841035678323e-06, -6.163411185282463e-06, 0.00013817692418401675]]} - #*EXTRAS*# Step: 5 Bead: 6 -{"friction": [[0.00013747316574997005, -6.036469924334205e-06, -5.6349103574555905e-06], [-6.036469924334205e-06, 0.00013749533569004692, -5.945471831913888e-06], [-5.6349103574555905e-06, -5.945471831913888e-06, 0.0001382267284198196]]} - #*EXTRAS*# Step: 6 Bead: 6 -{"friction": [[0.00013762854824775383, -5.314275735928797e-06, -4.944848886793821e-06], [-5.314275735928797e-06, 0.00013764825309295193, -5.230226139709081e-06], [-4.944848886793821e-06, -5.230226139709081e-06, 0.00013839170958846754]]} - #*EXTRAS*# Step: 7 Bead: 6 -{"friction": [[0.0001376818345698643, -5.070516121837466e-06, -4.712794550557321e-06], [-5.070516121837466e-06, 0.00013770083774032905, -4.9889137970960025e-06], [-4.712794550557321e-06, -4.9889137970960025e-06, 0.00013844791792203725]]} - #*EXTRAS*# Step: 8 Bead: 6 -{"friction": [[0.0001377272289712876, -4.864403126914076e-06, -4.516919505127056e-06], [-4.864403126914076e-06, 0.00013774569073775813, -4.784910111662872e-06], [-4.516919505127056e-06, -4.784910111662872e-06, 0.00013849565745275368]]} - #*EXTRAS*# Step: 9 Bead: 6 -{"friction": [[0.0001377530385564088, -4.7478425622156085e-06, -4.406287137848918e-06], [-4.7478425622156085e-06, 0.00013777121530928057, -4.669558592185811e-06], [-4.406287137848918e-06, -4.669558592185811e-06, 0.0001385227422195074]]} - #*EXTRAS*# Step: 10 Bead: 6 -{"friction": [[0.00013777034671191228, -4.669929051115223e-06, -4.332392137920812e-06], [-4.669929051115223e-06, 0.00013778834150541543, -4.592459767670383e-06], [-4.332392137920812e-06, -4.592459767670383e-06, 0.00013854088217322562]]} - #*EXTRAS*# Step: 11 Bead: 6 -{"friction": [[0.00013778120383086624, -4.6211584672524236e-06, -4.28615978271252e-06], [-4.6211584672524236e-06, 0.0001377990882209774, -4.544201797664805e-06], [-4.28615978271252e-06, -4.544201797664805e-06, 0.0001385522515649031]]} - #*EXTRAS*# Step: 12 Bead: 6 -{"friction": [[0.00013778821211229674, -4.589719168563079e-06, -4.25636603499518e-06], [-4.589719168563079e-06, 0.00013780602676097844, -4.513094031348049e-06], [-4.25636603499518e-06, -4.513094031348049e-06, 0.0001385595866469089]]} - #*EXTRAS*# Step: 13 Bead: 6 -{"friction": [[0.0001377926806969983, -4.569690242231278e-06, -4.237389244134223e-06], [-4.569690242231278e-06, 0.00013781045150024568, -4.493276755678555e-06], [-4.237389244134223e-06, -4.493276755678555e-06, 0.0001385642620231786]]} - #*EXTRAS*# Step: 14 Bead: 6 -{"friction": [[0.00013779554463805383, -4.556860641450573e-06, -4.225235151000526e-06], [-4.556860641450573e-06, 0.0001378132875951081, -4.480582909396338e-06], [-4.225235151000526e-06, -4.480582909396338e-06, 0.0001385672578518146]]} - #*EXTRAS*# Step: 15 Bead: 6 -{"friction": [[0.00013779737568103969, -4.5486609997867384e-06, -4.217467876694222e-06], [-4.5486609997867384e-06, 0.00013781510093891964, -4.472470104998137e-06], [-4.217467876694222e-06, -4.472470104998137e-06, 0.00013856917295205308]]} - #*EXTRAS*# Step: 16 Bead: 6 -{"friction": [[0.00013779854742535517, -4.543414960688636e-06, -4.212498722243818e-06], [-4.543414960688636e-06, 0.00013781626139954025, -4.467279653674658e-06], [-4.212498722243818e-06, -4.467279653674658e-06, 0.0001385703983792827]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_07 b/drivers/py/pes/friction/frictionH/060K/inst.raw_07 deleted file mode 100644 index d9330d9a7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_07 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 -{"friction": [[0.00013094354884002888, -3.34806356918497e-05, -3.337184485038292e-05], [-3.34806356918497e-05, 0.00013116798657021497, -3.347505294528034e-05], [-3.337184485038292e-05, -3.347505294528034e-05, 0.00013065962767836692]]} - #*EXTRAS*# Step: 1 Bead: 7 -{"friction": [[0.0001336455756449247, -2.6061221935753395e-05, -2.592375063293343e-05], [-2.6061221935753395e-05, 0.00013387394817920302, -2.5966994213336938e-05], [-2.592375063293343e-05, -2.5966994213336938e-05, 0.00013367099476153948]]} - #*EXTRAS*# Step: 2 Bead: 7 -{"friction": [[0.00013528448767963097, -1.790675287571595e-05, -1.7466671351673417e-05], [-1.790675287571595e-05, 0.00013541489436186326, -1.776880150731231e-05], [-1.7466671351673417e-05, -1.776880150731231e-05, 0.00013569315202618896]]} - #*EXTRAS*# Step: 3 Bead: 7 -{"friction": [[0.00013670732952222726, -9.857017672499874e-06, -9.347060015143981e-06], [-9.857017672499874e-06, 0.0001367516466341297, -9.736894693050155e-06], [-9.347060015143981e-06, -9.736894693050155e-06, 0.00013738712543597575]]} - #*EXTRAS*# Step: 4 Bead: 7 -{"friction": [[0.00013733549832113486, -6.690838581171217e-06, -6.263425019846885e-06], [-6.690838581171217e-06, 0.00013736039251903502, -6.593936768300574e-06], [-6.263425019846885e-06, -6.593936768300574e-06, 0.00013807915467407597]]} - #*EXTRAS*# Step: 5 Bead: 7 -{"friction": [[0.00013739319262262887, -6.414918658028865e-06, -5.9980309129128655e-06], [-6.414918658028865e-06, 0.0001374168818913002, -6.320460567413704e-06], [-5.9980309129128655e-06, -6.320460567413704e-06, 0.0001381411656655885]]} - #*EXTRAS*# Step: 6 Bead: 7 -{"friction": [[0.00013755619345895482, -5.648439958416892e-06, -5.2636730539858215e-06], [-5.648439958416892e-06, 0.00013757696753264188, -5.561118982686943e-06], [-5.2636730539858215e-06, -5.561118982686943e-06, 0.00013831508810924177]]} - #*EXTRAS*# Step: 7 Bead: 7 -{"friction": [[0.0001376134170444619, -5.3838539013022804e-06, -5.011165777057693e-06], [-5.3838539013022804e-06, 0.00013763333431951775, -5.299115182651091e-06], [-5.011165777057693e-06, -5.299115182651091e-06, 0.00013837571484746043]]} - #*EXTRAS*# Step: 8 Bead: 7 -{"friction": [[0.00013766156539978474, -5.1630059992353115e-06, -4.800791788156751e-06], [-5.1630059992353115e-06, 0.00013768082699694764, -5.080469063280605e-06], [-4.800791788156751e-06, -5.080469063280605e-06, 0.0001384265589860766]]} - #*EXTRAS*# Step: 9 Bead: 7 -{"friction": [[0.0001376890800326767, -5.037523262435468e-06, -4.681419498700208e-06], [-5.037523262435468e-06, 0.0001377079933345031, -4.956256116909054e-06], [-4.681419498700208e-06, -4.956256116909054e-06, 0.0001384555465169593]]} - #*EXTRAS*# Step: 10 Bead: 7 -{"friction": [[0.00013770749792156784, -4.953818264799446e-06, -4.601854879384859e-06], [-4.953818264799446e-06, 0.00013772618869801125, -4.873405701442467e-06], [-4.601854879384859e-06, -4.873405701442467e-06, 0.00013847492319747122]]} - #*EXTRAS*# Step: 11 Bead: 7 -{"friction": [[0.0001377190619769193, -4.901381191240156e-06, -4.552037804628818e-06], [-4.901381191240156e-06, 0.00013773761736102845, -4.821507057468019e-06], [-4.552037804628818e-06, -4.821507057468019e-06, 0.00013848707820845598]]} - #*EXTRAS*# Step: 12 Bead: 7 -{"friction": [[0.00013772652487945347, -4.8675892816448785e-06, -4.519945019813919e-06], [-4.8675892816448785e-06, 0.00013774499465173557, -4.788063381589297e-06], [-4.519945019813919e-06, -4.788063381589297e-06, 0.00013849491798617809]]} - #*EXTRAS*# Step: 13 Bead: 7 -{"friction": [[0.0001377312843289995, -4.8460584122878485e-06, -4.499501151868575e-06], [-4.8460584122878485e-06, 0.00013774970022335385, -4.766754905718086e-06], [-4.499501151868575e-06, -4.766754905718086e-06, 0.00013849991594923233]]} - #*EXTRAS*# Step: 14 Bead: 7 -{"friction": [[0.0001377343346417768, -4.832267479026501e-06, -4.486408258100472e-06], [-4.832267479026501e-06, 0.00013775271630067523, -4.753106629363754e-06], [-4.486408258100472e-06, -4.753106629363754e-06, 0.00013850311837328478]]} - #*EXTRAS*# Step: 15 Bead: 7 -{"friction": [[0.00013773628494961353, -4.823453158025755e-06, -4.478040815333197e-06], [-4.823453158025755e-06, 0.00013775464483957995, -4.74438357166544e-06], [-4.478040815333197e-06, -4.74438357166544e-06, 0.00013850516563086235]]} - #*EXTRAS*# Step: 16 Bead: 7 -{"friction": [[0.00013773753302509227, -4.817813900372436e-06, -4.472687763357605e-06], [-4.817813900372436e-06, 0.0001377558790335947, -4.738802737840148e-06], [-4.472687763357605e-06, -4.738802737840148e-06, 0.00013850647562253606]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_08 b/drivers/py/pes/friction/frictionH/060K/inst.raw_08 deleted file mode 100644 index 787a3153c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_08 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 -{"friction": [[0.00013064797267198423, -3.4032980337971224e-05, -3.389659333410311e-05], [-3.4032980337971224e-05, 0.00013086402099283612, -3.4035338460508096e-05], [-3.389659333410311e-05, -3.4035338460508096e-05, 0.00013034931536429637]]} - #*EXTRAS*# Step: 1 Bead: 8 -{"friction": [[0.00013346384001734014, -2.6762756873480406e-05, -2.6648948294302946e-05], [-2.6762756873480406e-05, 0.00013369807151647232, -2.6675114275945702e-05], [-2.6648948294302946e-05, -2.6675114275945702e-05, 0.0001334550924355645]]} - #*EXTRAS*# Step: 2 Bead: 8 -{"friction": [[0.00013514920402701955, -1.8681580580151673e-05, -1.826508808967502e-05], [-1.8681580580151673e-05, 0.0001352896022864443, -1.854511092233064e-05], [-1.826508808967502e-05, -1.854511092233064e-05, 0.00013552473729892632]]} - #*EXTRAS*# Step: 3 Bead: 8 -{"friction": [[0.00013658044132874373, -1.0532744637358344e-05, -1.001398748208733e-05], [-1.0532744637358344e-05, 0.00013663015757899678, -1.0408828553336886e-05], [-1.001398748208733e-05, -1.0408828553336886e-05, 0.0001372432705826552]]} - #*EXTRAS*# Step: 4 Bead: 8 -{"friction": [[0.00013722952262366984, -7.204076509686937e-06, -6.758531216928825e-06], [-7.204076509686937e-06, 0.00013725687333069318, -7.102806794648862e-06], [-6.758531216928825e-06, -7.102806794648862e-06, 0.00013796461047514]]} - #*EXTRAS*# Step: 5 Bead: 8 -{"friction": [[0.00013730040051261909, -6.8598921851358676e-06, -6.426298925429998e-06], [-6.8598921851358676e-06, 0.00013732607309241372, -6.761526085643723e-06], [-6.426298925429998e-06, -6.761526085643723e-06, 0.00013804131181483883]]} - #*EXTRAS*# Step: 6 Bead: 8 -{"friction": [[0.00013747207457939043, -6.0416023978654805e-06, -5.6398280324369435e-06], [-6.0416023978654805e-06, 0.00013749426408549885, -5.950556545899629e-06], [-5.6398280324369435e-06, -5.950556545899629e-06, 0.0001382255640113382]]} - #*EXTRAS*# Step: 7 Bead: 8 -{"friction": [[0.00013753383099074482, -5.752466842742327e-06, -5.36309068901538e-06], [-5.752466842742327e-06, 0.000137554963086956, -5.66414723153736e-06], [-5.36309068901538e-06, -5.66414723153736e-06, 0.0001382913359339186]]} - #*EXTRAS*# Step: 8 Bead: 8 -{"friction": [[0.00013758513766832362, -5.514321683465695e-06, -5.135613648294122e-06], [-5.514321683465695e-06, 0.00013760546775549277, -5.428302068898255e-06], [-5.135613648294122e-06, -5.428302068898255e-06, 0.00013834578097959036]]} - #*EXTRAS*# Step: 9 Bead: 8 -{"friction": [[0.00013761461352672832, -5.378346260640632e-06, -5.0059150005524146e-06], [-5.378346260640632e-06, 0.00013763451379032444, -5.293661938623747e-06], [-5.0059150005524146e-06, -5.293661938623747e-06, 0.00013837698016210353]]} - #*EXTRAS*# Step: 10 Bead: 8 -{"friction": [[0.0001376343078220217, -5.287833351761814e-06, -4.919655202714642e-06], [-5.287833351761814e-06, 0.00013765393334729879, -5.204046746590474e-06], [-4.919655202714642e-06, -5.204046746590474e-06, 0.0001383977939087055]]} - #*EXTRAS*# Step: 11 Bead: 8 -{"friction": [[0.00013764668558639042, -5.231084825035216e-06, -4.865603822136857e-06], [-5.231084825035216e-06, 0.0001376661435100691, -5.147864670666446e-06], [-4.865603822136857e-06, -5.147864670666446e-06, 0.00013841086223316892]]} - #*EXTRAS*# Step: 12 Bead: 8 -{"friction": [[0.00013765467186043745, -5.194526552278638e-06, -4.830795589589828e-06], [-5.194526552278638e-06, 0.00013767402371390466, -5.111672787978373e-06], [-4.830795589589828e-06, -5.111672787978373e-06, 0.00013841928876240687]]} - #*EXTRAS*# Step: 13 Bead: 8 -{"friction": [[0.00013765976624370983, -5.171229424021291e-06, -4.808618803774097e-06], [-5.171229424021291e-06, 0.00013767905128095215, -5.088609747720607e-06], [-4.808618803774097e-06, -5.088609747720607e-06, 0.00013842466181579523]]} - #*EXTRAS*# Step: 14 Bead: 8 -{"friction": [[0.00013766303118691395, -5.156307965124954e-06, -4.794416998497349e-06], [-5.156307965124954e-06, 0.00013768227374779852, -5.073838464879621e-06], [-4.794416998497349e-06, -5.073838464879621e-06, 0.0001384281044711423]]} - #*EXTRAS*# Step: 15 Bead: 8 -{"friction": [[0.00013766511885569956, -5.1467707596760025e-06, -4.7853406227169794e-06], [-5.1467707596760025e-06, 0.00013768433439768533, -5.064397346716989e-06], [-4.7853406227169794e-06, -5.064397346716989e-06, 0.0001384303054107221]]} - #*EXTRAS*# Step: 16 Bead: 8 -{"friction": [[0.00013766645484822597, -5.140669058414833e-06, -4.779534100527535e-06], [-5.140669058414833e-06, 0.00013768565315741487, -5.058357161248459e-06], [-4.779534100527535e-06, -5.058357161248459e-06, 0.00013843171374230943]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_09 b/drivers/py/pes/friction/frictionH/060K/inst.raw_09 deleted file mode 100644 index a68c05505..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_09 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 -{"friction": [[0.00013030641560764987, -3.4637552590400345e-05, -3.4466313676195334e-05], [-3.4637552590400345e-05, 0.0001305119734329694, -3.464872341487375e-05], [-3.4466313676195334e-05, -3.464872341487375e-05, 0.00012999345633835313]]} - #*EXTRAS*# Step: 1 Bead: 9 -{"friction": [[0.00013324760201863632, -2.7547287952704127e-05, -2.745713276857384e-05], [-2.7547287952704127e-05, 0.00013348736991993047, -2.746750510471413e-05], [-2.745713276857384e-05, -2.746750510471413e-05, 0.00013320113079484775]]} - #*EXTRAS*# Step: 2 Bead: 9 -{"friction": [[0.00013499269979524978, -1.9564249321977466e-05, -1.9177145684223304e-05], [-1.9564249321977466e-05, 0.00013514458282816628, -1.9430158287639176e-05], [-1.9177145684223304e-05, -1.9430158287639176e-05, 0.00013532929865753293]]} - #*EXTRAS*# Step: 3 Bead: 9 -{"friction": [[0.00013643556922191414, -1.1318473549900948e-05, -1.0793214024115789e-05], [-1.1318473549900948e-05, 0.00013649207305291473, -1.1190668064869072e-05], [-1.0793214024115789e-05, -1.1190668064869072e-05, 0.00013707723845023654]]} - #*EXTRAS*# Step: 4 Bead: 9 -{"friction": [[0.00013710797974783413, -7.803064949085999e-06, -7.338718206841832e-06], [-7.803064949085999e-06, 0.00013713854553500042, -7.696991079250247e-06], [-7.338718206841832e-06, -7.696991079250247e-06, 0.00013783218606710094]]} - #*EXTRAS*# Step: 5 Bead: 9 -{"friction": [[0.00013719430807212504, -7.376475963856894e-06, -6.9252599735936125e-06], [-7.376475963856894e-06, 0.00013722254603283846, -7.273791055060373e-06], [-6.9252599735936125e-06, -7.273791055060373e-06, 0.00013792636103232087]]} - #*EXTRAS*# Step: 6 Bead: 9 -{"friction": [[0.0001373756810911033, -6.498408353307459e-06, -6.078277981379461e-06], [-6.498408353307459e-06, 0.00013739972634884792, -6.403203793821034e-06], [-6.078277981379461e-06, -6.403203793821034e-06, 0.00013812236940336864]]} - #*EXTRAS*# Step: 7 Bead: 9 -{"friction": [[0.0001374425697215263, -6.180708461795537e-06, -5.7731849416039865e-06], [-6.180708461795537e-06, 0.00013746530043454676, -6.088376919382487e-06], [-5.7731849416039865e-06, -6.088376919382487e-06, 0.00013819404726394068]]} - #*EXTRAS*# Step: 8 Bead: 9 -{"friction": [[0.00013749743669160108, -5.922529563874119e-06, -5.525787632280334e-06], [-5.922529563874119e-06, 0.00013751917966241053, -5.832597634657298e-06], [-5.525787632280334e-06, -5.832597634657298e-06, 0.00013825260701981403]]} - #*EXTRAS*# Step: 9 Bead: 9 -{"friction": [[0.00013752913076356418, -5.774376822291396e-06, -5.384039911486536e-06], [-5.774376822291396e-06, 0.0001375503397824534, -5.685848078008783e-06], [-5.384039911486536e-06, -5.685848078008783e-06, 0.00013828633929371977]]} - #*EXTRAS*# Step: 10 Bead: 9 -{"friction": [[0.00013755026866604022, -5.675966643942407e-06, -5.289972417306982e-06], [-5.675966643942407e-06, 0.00013757113631801473, -5.588380504064165e-06], [-5.289972417306982e-06, -5.588380504064165e-06, 0.00013830879842034076]]} - #*EXTRAS*# Step: 11 Bead: 9 -{"friction": [[0.00013756356749858068, -5.61421478950384e-06, -5.230981566374915e-06], [-5.61421478950384e-06, 0.00013758422638647817, -5.527224421170974e-06], [-5.230981566374915e-06, -5.527224421170974e-06, 0.00013832291299268937]]} - #*EXTRAS*# Step: 12 Bead: 9 -{"friction": [[0.0001375721463121495, -5.574446305635254e-06, -5.193005889289942e-06], [-5.574446305635254e-06, 0.00013759267298077914, -5.4878413679954094e-06], [-5.193005889289942e-06, -5.4878413679954094e-06, 0.00013833201170509828]]} - #*EXTRAS*# Step: 13 Bead: 9 -{"friction": [[0.00013757762000089017, -5.5490992991426455e-06, -5.1688075700327595e-06], [-5.5490992991426455e-06, 0.00013759806330873966, -5.462740736743647e-06], [-5.1688075700327595e-06, -5.462740736743647e-06, 0.00013833781453331202]]} - #*EXTRAS*# Step: 14 Bead: 9 -{"friction": [[0.00013758112803702956, -5.532865753261733e-06, -5.153312164969049e-06], [-5.532865753261733e-06, 0.00013760151832916973, -5.44666527497735e-06], [-5.153312164969049e-06, -5.44666527497735e-06, 0.00013834153245717722]]} - #*EXTRAS*# Step: 15 Bead: 9 -{"friction": [[0.00013758337129876158, -5.52248953757241e-06, -5.143408763920244e-06], [-5.52248953757241e-06, 0.00013760372785673723, -5.436390223703002e-06], [-5.143408763920244e-06, -5.436390223703002e-06, 0.00013834390950324366]]} - #*EXTRAS*# Step: 16 Bead: 9 -{"friction": [[0.0001375848068830465, -5.515851097540263e-06, -5.137073230801556e-06], [-5.515851097540263e-06, 0.00013760514192120597, -5.4298165550417216e-06], [-5.137073230801556e-06, -5.4298165550417216e-06, 0.0001383454305269793]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_10 b/drivers/py/pes/friction/frictionH/060K/inst.raw_10 deleted file mode 100644 index 669f0caf4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_10 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 -{"friction": [[0.00012991703273927124, -3.528883604745308e-05, -3.507531490942497e-05], [-3.528883604745308e-05, 0.00013010988907306278, -3.530960766886239e-05], [-3.507531490942497e-05, -3.530960766886239e-05, 0.00012959089167726413]]} - #*EXTRAS*# Step: 1 Bead: 10 -{"friction": [[0.00013299083465382724, -2.8413198796397015e-05, -2.8344731735154055e-05], [-2.8413198796397015e-05, 0.0001332352507916902, -2.8342680233595343e-05], [-2.8344731735154055e-05, -2.8342680233595343e-05, 0.0001329036171050276]]} - #*EXTRAS*# Step: 2 Bead: 10 -{"friction": [[0.00013481223629847953, -2.0557798063311087e-05, -2.0206465584359883e-05], [-2.0557798063311087e-05, 0.0001349770562483932, -2.042726365585097e-05], [-2.0206465584359883e-05, -2.042726365585097e-05, 0.00013510364139172312]]} - #*EXTRAS*# Step: 3 Bead: 10 -{"friction": [[0.00013627200230662074, -1.2222762327442306e-05, -1.1694844974630433e-05], [-1.2222762327442306e-05, 0.00013633696034209518, -1.2091178554884389e-05], [-1.1694844974630433e-05, -1.2091178554884389e-05, 0.00013688745084880982]]} - #*EXTRAS*# Step: 4 Bead: 10 -{"friction": [[0.00013697021159715477, -8.495555820507278e-06, -8.012601146556129e-06], [-8.495555820507278e-06, 0.00013700495083204594, -8.384324142458883e-06], [-8.012601146556129e-06, -8.384324142458883e-06, 0.00013768066443250852]]} - #*EXTRAS*# Step: 5 Bead: 10 -{"friction": [[0.00013707442109572556, -7.97041698272725e-06, -7.5012676133261295e-06], [-7.97041698272725e-06, 0.00013710595107870575, -7.86305760859994e-06], [-7.5012676133261295e-06, -7.86305760859994e-06, 0.00013779541851925584]]} - #*EXTRAS*# Step: 6 Bead: 10 -{"friction": [[0.00013726648057175482, -7.024140748206934e-06, -6.584738746274003e-06], [-7.024140748206934e-06, 0.00013729293841098045, -6.924376015250607e-06], [-6.584738746274003e-06, -6.924376015250607e-06, 0.00013800465206576057]]} - #*EXTRAS*# Step: 7 Bead: 10 -{"friction": [[0.00013733909998848447, -6.673542148475188e-06, -6.246772376578716e-06], [-6.673542148475188e-06, 0.00013736391626208833, -6.5767915650297055e-06], [-6.246772376578716e-06, -6.5767915650297055e-06, 0.00013808303290538214]]} - #*EXTRAS*# Step: 8 Bead: 10 -{"friction": [[0.0001373979227220545, -6.39240545217779e-06, -5.976400668664537e-06], [-6.39240545217779e-06, 0.00013742151728005463, -6.298149692159457e-06], [-5.976400668664537e-06, -6.298149692159457e-06, 0.0001381462390071276]]} - #*EXTRAS*# Step: 9 Bead: 10 -{"friction": [[0.00013743209040494888, -6.230266747617993e-06, -5.820728793536944e-06], [-6.230266747617993e-06, 0.00013745501900164686, -6.137481238296592e-06], [-5.820728793536944e-06, -6.137481238296592e-06, 0.00013818283865360513]]} - #*EXTRAS*# Step: 10 Bead: 10 -{"friction": [[0.00013745483807246566, -6.122790656775038e-06, -5.717643842149765e-06], [-6.122790656775038e-06, 0.00013747734089645318, -6.030992371351242e-06], [-5.717643842149765e-06, -6.030992371351242e-06, 0.00013820715958492993]]} - #*EXTRAS*# Step: 11 Bead: 10 -{"friction": [[0.00013746916494187673, -6.0552924797932334e-06, -5.652946104813637e-06], [-6.0552924797932334e-06, 0.0001374914067776091, -5.964119348832339e-06], [-5.652946104813637e-06, -5.964119348832339e-06, 0.00013822245867721222]]} - #*EXTRAS*# Step: 12 Bead: 10 -{"friction": [[0.00013747840525655695, -6.011837117120213e-06, -5.611311108823194e-06], [-6.011837117120213e-06, 0.00013750048169061733, -5.921068561281474e-06], [-5.611311108823194e-06, -5.921068561281474e-06, 0.0001382323184405087]]} - #*EXTRAS*# Step: 13 Bead: 10 -{"friction": [[0.00013748430253002385, -5.984135544403714e-06, -5.5847771048763575e-06], [-5.984135544403714e-06, 0.00013750627459894294, -5.893625752117605e-06], [-5.5847771048763575e-06, -5.893625752117605e-06, 0.0001382386079490778]]} - #*EXTRAS*# Step: 14 Bead: 10 -{"friction": [[0.00013748808207323946, -5.966394845710215e-06, -5.567787062994072e-06], [-5.966394845710215e-06, 0.00013750998774398324, -5.8760511222376265e-06], [-5.567787062994072e-06, -5.8760511222376265e-06, 0.00013824263760579982]]} - #*EXTRAS*# Step: 15 Bead: 10 -{"friction": [[0.00013749049913507904, -5.955054842834195e-06, -5.5569280810454855e-06], [-5.955054842834195e-06, 0.00013751236254346826, -5.864817415456545e-06], [-5.5569280810454855e-06, -5.864817415456545e-06, 0.0001382452140993823]]} - #*EXTRAS*# Step: 16 Bead: 10 -{"friction": [[0.00013749204597200926, -5.947799830199992e-06, -5.549981300857601e-06], [-5.947799830199992e-06, 0.00013751388241576928, -5.857630466758874e-06], [-5.549981300857601e-06, -5.857630466758874e-06, 0.00013824686275501727]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_11 b/drivers/py/pes/friction/frictionH/060K/inst.raw_11 deleted file mode 100644 index 12d639e0c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_11 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 -{"friction": [[0.00012947879542120336, -3.5980173125907095e-05, -3.571737595016751e-05], [-3.5980173125907095e-05, 0.00012965675992702663, -3.6011208770852356e-05], [-3.571737595016751e-05, -3.6011208770852356e-05, 0.00012914132189854633]]} - #*EXTRAS*# Step: 1 Bead: 11 -{"friction": [[0.0001326858520976646, -2.9357956137011075e-05, -2.930642017832087e-05], [-2.9357956137011075e-05, 0.00013293326919544825, -2.92982218670855e-05], [-2.930642017832087e-05, -2.92982218670855e-05, 0.00013255568217263044]]} - #*EXTRAS*# Step: 2 Bead: 11 -{"friction": [[0.00013460394736649993, -2.1664319528673927e-05, -2.135536679269862e-05], [-2.1664319528673927e-05, 0.00013478299754269792, -2.15388387882594e-05], [-2.135536679269862e-05, -2.15388387882594e-05, 0.00013484355234396088]]} - #*EXTRAS*# Step: 3 Bead: 11 -{"friction": [[0.00013608892090281343, -1.3254257681215665e-05, -1.2729382792127866e-05], [-1.3254257681215665e-05, 0.00013616430288727917, -1.311928225838203e-05], [-1.2729382792127866e-05, -1.311928225838203e-05, 0.00013667208286877606]]} - #*EXTRAS*# Step: 4 Bead: 11 -{"friction": [[0.000136815570715924, -9.290088717506661e-06, -8.789851562515098e-06], [-9.290088717506661e-06, 0.00013685568358874173, -9.17346607673873e-06], [-8.789851562515098e-06, -9.17346607673873e-06, 0.00013750871013063886]]} - #*EXTRAS*# Step: 5 Bead: 11 -{"friction": [[0.0001369402449167474, -8.648098453481923e-06, -8.16149087717138e-06], [-8.648098453481923e-06, 0.00013697596795511483, -8.535787979749678e-06], [-8.16149087717138e-06, -8.535787979749678e-06, 0.00013764750023824023]]} - #*EXTRAS*# Step: 6 Bead: 11 -{"friction": [[0.000137143934357179, -7.624712044871703e-06, -7.165699493726026e-06], [-7.624712044871703e-06, 0.00013717350408804185, -7.52003549338761e-06], [-7.165699493726026e-06, -7.52003549338761e-06, 0.00013787147956890924]]} - #*EXTRAS*# Step: 7 Bead: 11 -{"friction": [[0.0001372228770735339, -7.236539828419029e-06, -6.789910648009215e-06], [-7.236539828419029e-06, 0.00013725039248233846, -7.135001626003808e-06], [-6.789910648009215e-06, -7.135001626003808e-06, 0.00013795739945362967]]} - #*EXTRAS*# Step: 8 Bead: 11 -{"friction": [[0.00013728603983131002, -6.929325648036051e-06, -6.493253382771666e-06], [-6.929325648036051e-06, 0.00013731204088918858, -6.8303654061475505e-06], [-6.493253382771666e-06, -6.8303654061475505e-06, 0.00013802580166693225]]} - #*EXTRAS*# Step: 9 Bead: 11 -{"friction": [[0.00013732293196765604, -6.751261489442938e-06, -6.321615731965527e-06], [-6.751261489442938e-06, 0.00013734810088538053, -6.653833434196048e-06], [-6.321615731965527e-06, -6.653833434196048e-06, 0.00013806561592438098]]} - #*EXTRAS*# Step: 10 Bead: 11 -{"friction": [[0.00013734745254562742, -6.633467137415726e-06, -6.208197226582125e-06], [-6.633467137415726e-06, 0.00013737208949853724, -6.537067952831773e-06], [-6.208197226582125e-06, -6.537067952831773e-06, 0.00013809202318423272]]} - #*EXTRAS*# Step: 11 Bead: 11 -{"friction": [[0.00013736291277983805, -6.559425497954375e-06, -6.136956969676965e-06], [-6.559425497954375e-06, 0.00013738722293706062, -6.463679250480552e-06], [-6.136956969676965e-06, -6.463679250480552e-06, 0.00013810865039260854]]} - #*EXTRAS*# Step: 12 Bead: 11 -{"friction": [[0.00013737288254547688, -6.511771792876651e-06, -6.091127052678041e-06], [-6.511771792876651e-06, 0.00013739698547790563, -6.416448318977075e-06], [-6.091127052678041e-06, -6.416448318977075e-06, 0.00013811936349391986]]} - #*EXTRAS*# Step: 13 Bead: 11 -{"friction": [[0.00013737924707643223, -6.481388603373112e-06, -6.061915190669898e-06], [-6.481388603373112e-06, 0.0001374032191567493, -6.386335720161172e-06], [-6.061915190669898e-06, -6.386335720161172e-06, 0.00013812619879793476]]} - #*EXTRAS*# Step: 14 Bead: 11 -{"friction": [[0.00013738332616336198, -6.461931344663083e-06, -6.043211528026926e-06], [-6.461931344663083e-06, 0.00013740721496693594, -6.367052170714423e-06], [-6.043211528026926e-06, -6.367052170714423e-06, 0.0001381305780707983]]} - #*EXTRAS*# Step: 15 Bead: 11 -{"friction": [[0.000137385934997236, -6.449493586437809e-06, -6.031256920077626e-06], [-6.449493586437809e-06, 0.00013740977078042645, -6.35472562699983e-06], [-6.031256920077626e-06, -6.35472562699983e-06, 0.00013813337826409965]]} - #*EXTRAS*# Step: 16 Bead: 11 -{"friction": [[0.00013738760459928323, -6.4415362815611295e-06, -6.023609303523303e-06], [-6.4415362815611295e-06, 0.00013741140654880354, -6.346839544799323e-06], [-6.023609303523303e-06, -6.346839544799323e-06, 0.00013813517007536328]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_12 b/drivers/py/pes/friction/frictionH/060K/inst.raw_12 deleted file mode 100644 index 3a75aa25d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_12 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 -{"friction": [[0.0001289917032280999, -3.670377679754094e-05, -3.638593541360157e-05], [-3.670377679754094e-05, 0.00012915277647290737, -3.674556669422962e-05], [-3.638593541360157e-05, -3.674556669422962e-05, 0.0001286455046890979]]} - #*EXTRAS*# Step: 1 Bead: 12 -{"friction": [[0.00013232287205658676, -3.037809997386349e-05, -3.0334866679513425e-05], [-3.037809997386349e-05, 0.00013257064158619865, -3.0330758384483965e-05], [-3.0334866679513425e-05, -3.0330758384483965e-05, 0.000132148722318531]]} - #*EXTRAS*# Step: 2 Bead: 12 -{"friction": [[0.00013436232726476543, -2.2884678208415067e-05, -2.2624310793560876e-05], [-2.2884678208415067e-05, 0.00013455656320890215, -2.2766097704799904e-05], [-2.2624310793560876e-05, -2.2766097704799904e-05, 0.000134543381338873]]} - #*EXTRAS*# Step: 3 Bead: 12 -{"friction": [[0.00013588522181634324, -1.4421375973392095e-05, -1.3907367651037295e-05], [-1.4421375973392095e-05, 0.00013597330527119348, -1.4283751149908914e-05], [-1.3907367651037295e-05, -1.4283751149908914e-05, 0.0001364289022728591]]} - #*EXTRAS*# Step: 4 Bead: 12 -{"friction": [[0.00013664341688134792, -1.0195891508497838e-05, -9.681145611900458e-06], [-1.0195891508497838e-05, 0.0001366903897908657, -1.0073814654490859e-05], [-9.681145611900458e-06, -1.0073814654490859e-05, 0.0001373148476090624]]} - #*EXTRAS*# Step: 5 Bead: 12 -{"friction": [[0.00013679129061969057, -9.416489873956488e-06, -8.913898648827799e-06], [-9.416489873956488e-06, 0.00013683231458908, -9.299061754505972e-06], [-8.913898648827799e-06, -9.299061754505972e-06, 0.00013748152598926178]]} - #*EXTRAS*# Step: 6 Bead: 12 -{"friction": [[0.00013700751226063422, -8.30663720035087e-06, -7.828428872261193e-06], [-8.30663720035087e-06, 0.00013704106511602883, -8.196770327607462e-06], [-7.828428872261193e-06, -8.196770327607462e-06, 0.0001377218413135304]]} - #*EXTRAS*# Step: 7 Bead: 12 -{"friction": [[0.0001370933603432058, -7.875864667889367e-06, -7.409404682158363e-06], [-7.875864667889367e-06, 0.0001371243420577128, -7.769228540097764e-06], [-7.409404682158363e-06, -7.769228540097764e-06, 0.00013781617978741103]]} - #*EXTRAS*# Step: 8 Bead: 12 -{"friction": [[0.00013716123164710838, -7.539257142755845e-06, -7.0828795508629226e-06], [-7.539257142755845e-06, 0.00013719033572540828, -7.4352600661193795e-06], [-7.0828795508629226e-06, -7.4352600661193795e-06, 0.00013789034697978512]]} - #*EXTRAS*# Step: 9 Bead: 12 -{"friction": [[0.00013720109136185164, -7.34319468653344e-06, -6.893057034036405e-06], [-7.34319468653344e-06, 0.000137229155627522, -7.240780935884585e-06], [-6.893057034036405e-06, -7.240780935884585e-06, 0.00013793373632005226]]} - #*EXTRAS*# Step: 10 Bead: 12 -{"friction": [[0.00013722754282013912, -7.21374433164884e-06, -6.767875468082854e-06], [-7.21374433164884e-06, 0.00013725494246135818, -7.112394561952773e-06], [-6.767875468082854e-06, -7.112394561952773e-06, 0.0001379624625616038]]} - #*EXTRAS*# Step: 11 Bead: 12 -{"friction": [[0.00013724423869732126, -7.132306607236829e-06, -6.689184093436364e-06], [-7.132306607236829e-06, 0.00013727122919740797, -7.031633758745635e-06], [-6.689184093436364e-06, -7.031633758745635e-06, 0.00013798056678943055]]} - #*EXTRAS*# Step: 12 Bead: 12 -{"friction": [[0.00013725500393368492, -7.0799073913194e-06, -6.6385768380008965e-06], [-7.0799073913194e-06, 0.0001372817348588873, -6.979673179262425e-06], [-6.6385768380008965e-06, -6.979673179262425e-06, 0.0001379922289063694]]} - #*EXTRAS*# Step: 13 Bead: 12 -{"friction": [[0.00013726187819696902, -7.0464925520222154e-06, -6.606314913247175e-06], [-7.0464925520222154e-06, 0.00013728844509869548, -6.94653931885648e-06], [-6.606314913247175e-06, -6.94653931885648e-06, 0.00013799967130673983]]} - #*EXTRAS*# Step: 14 Bead: 12 -{"friction": [[0.0001372662841061676, -7.02509457645824e-06, -6.585659402858268e-06], [-7.02509457645824e-06, 0.00013729274658871903, -6.925321790575215e-06], [-6.585659402858268e-06, -6.925321790575215e-06, 0.0001380044394802936]]} - #*EXTRAS*# Step: 15 Bead: 12 -{"friction": [[0.0001372691022046474, -7.011415636302243e-06, -6.572456799803697e-06], [-7.011415636302243e-06, 0.00013729549818851318, -6.911758414730545e-06], [-6.572456799803697e-06, -6.911758414730545e-06, 0.00013800748852453142]]} - #*EXTRAS*# Step: 16 Bead: 12 -{"friction": [[0.00013727090577938476, -7.002664260661745e-06, -6.564010868639748e-06], [-7.002664260661745e-06, 0.00013729725932280548, -6.903081059975305e-06], [-6.564010868639748e-06, -6.903081059975305e-06, 0.0001380094395909746]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_13 b/drivers/py/pes/friction/frictionH/060K/inst.raw_13 deleted file mode 100644 index a3853bef7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_13 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 -{"friction": [[0.00012845706441002837, -3.745063354531244e-05, -3.70741901275435e-05], [-3.745063354531244e-05, 0.00012859965202404274, -3.75034377235823e-05], [-3.70741901275435e-05, -3.75034377235823e-05, 0.00012810552361980438]]} - #*EXTRAS*# Step: 1 Bead: 13 -{"friction": [[0.00013188953554751334, -3.146913611374767e-05, -3.142033235991329e-05], [-3.146913611374767e-05, 0.00013213370780751463, -3.143583961717038e-05], [-3.142033235991329e-05, -3.143583961717038e-05, 0.00013167201947931348]]} - #*EXTRAS*# Step: 2 Bead: 13 -{"friction": [[0.0001340795657752404, -2.4218078198327182e-05, -2.4011082989593534e-05], [-2.4218078198327182e-05, 0.00013428934256581586, -2.4108609757907764e-05], [-2.4011082989593534e-05, -2.4108609757907764e-05, 0.00013419551247792358]]} - #*EXTRAS*# Step: 3 Bead: 13 -{"friction": [[0.0001356592199261579, -1.573180698268421e-05, -1.5238766453980848e-05], [-1.573180698268421e-05, 0.0001357625567552464, -1.559272118263123e-05], [-1.5238766453980848e-05, -1.559272118263123e-05, 0.00013615501362565133]]} - #*EXTRAS*# Step: 4 Bead: 13 -{"friction": [[0.00013645308234984263, -1.122270694403571e-05, -1.0698028670620889e-05], [-1.122270694403571e-05, 0.00013650873044093156, -1.1095345408784575e-05], [-1.0698028670620889e-05, -1.1095345408784575e-05, 0.00013709741208239604]]} - #*EXTRAS*# Step: 5 Bead: 13 -{"friction": [[0.00013662706755689782, -1.028306384127028e-05, -9.767208648942414e-06], [-1.028306384127028e-05, 0.0001366747405989479, -1.0160501163250383e-05], [-9.767208648942414e-06, -1.0160501163250383e-05, 0.0001372962996357886]]} - #*EXTRAS*# Step: 6 Bead: 13 -{"friction": [[0.0001368567022838553, -9.076980285850606e-06, -8.580956510835619e-06], [-9.076980285850606e-06, 0.00013689531367872985, -8.961748134081892e-06], [-8.580956510835619e-06, -8.961748134081892e-06, 0.0001375546451248301]]} - #*EXTRAS*# Step: 7 Bead: 13 -{"friction": [[0.0001369500264237354, -8.598231275519284e-06, -8.112800249274347e-06], [-8.598231275519284e-06, 0.00013698542531958286, -8.486271182738479e-06], [-8.112800249274347e-06, -8.486271182738479e-06, 0.00013765833367313773]]} - #*EXTRAS*# Step: 8 Bead: 13 -{"friction": [[0.00013702295620845897, -8.228727963830209e-06, -7.752548903146429e-06], [-8.228727963830209e-06, 0.00013705603019133444, -8.119433185803642e-06], [-7.752548903146429e-06, -8.119433185803642e-06, 0.0001377388567337728]]} - #*EXTRAS*# Step: 9 Bead: 13 -{"friction": [[0.0001370660162885877, -8.012464458304396e-06, -7.542139159816209e-06], [-8.012464458304396e-06, 0.00013709779300478467, -7.904786003904244e-06], [-7.542139159816209e-06, -7.904786003904244e-06, 0.00013778619593550408]]} - #*EXTRAS*# Step: 10 Bead: 13 -{"friction": [[0.00013709454949440767, -7.86993703602206e-06, -7.403647732388023e-06], [-7.86993703602206e-06, 0.00013712549714028425, -7.763346513758998e-06], [-7.403647732388023e-06, -7.763346513758998e-06, 0.00013781748238326873]]} - #*EXTRAS*# Step: 11 Bead: 13 -{"friction": [[0.00013711257892421396, -7.7801961148641e-06, -7.316520869611668e-06], [-7.7801961148641e-06, 0.00013714301517220765, -7.674299838413195e-06], [-7.316520869611668e-06, -7.674299838413195e-06, 0.00013783721803627507]]} - #*EXTRAS*# Step: 12 Bead: 13 -{"friction": [[0.00013712420284097142, -7.722469081966275e-06, -7.260505173686606e-06], [-7.722469081966275e-06, 0.00013715431447906866, -7.6170231588403715e-06], [-7.260505173686606e-06, -7.6170231588403715e-06, 0.00013784992832706103]]} - #*EXTRAS*# Step: 13 Bead: 13 -{"friction": [[0.0001371316275376846, -7.68564989148603e-06, -7.224789706086899e-06], [-7.68564989148603e-06, 0.00013716153391927921, -7.58049275161821e-06], [-7.224789706086899e-06, -7.58049275161821e-06, 0.00013785804135542183]]} - #*EXTRAS*# Step: 14 Bead: 13 -{"friction": [[0.0001371363864157451, -7.662072478711794e-06, -7.2019240667047715e-06], [-7.662072478711794e-06, 0.0001371661620911798, -7.557100893240508e-06], [-7.2019240667047715e-06, -7.557100893240508e-06, 0.00013786323913892487]]} - #*EXTRAS*# Step: 15 Bead: 13 -{"friction": [[0.00013713943055079818, -7.646999583043214e-06, -7.187308248875878e-06], [-7.646999583043214e-06, 0.000137169122966028, -7.54214687909083e-06], [-7.187308248875878e-06, -7.54214687909083e-06, 0.0001378665630972903]]} - #*EXTRAS*# Step: 16 Bead: 13 -{"friction": [[0.00013714137884570307, -7.637356367797478e-06, -7.177958296321102e-06], [-7.637356367797478e-06, 0.00013717101811597964, -7.5325798263279965e-06], [-7.177958296321102e-06, -7.5325798263279965e-06, 0.0001378686901017286]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_14 b/drivers/py/pes/friction/frictionH/060K/inst.raw_14 deleted file mode 100644 index e243dedc2..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_14 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 -{"friction": [[0.0001278780787535134, -3.82100307641886e-05, -3.7774858450361775e-05], [-3.82100307641886e-05, 0.00012800126167604204, -3.8273806917358165e-05], [-3.7774858450361775e-05, -3.8273806917358165e-05, 0.0001275253587009841]]} - #*EXTRAS*# Step: 1 Bead: 14 -{"friction": [[0.00013137078977257556, -3.2624940995155573e-05, -3.25498962909749e-05], [-3.2624940995155573e-05, 0.00013160578360822762, -3.260731339474759e-05], [-3.25498962909749e-05, -3.260731339474759e-05, 0.00013111273204259827]]} - #*EXTRAS*# Step: 2 Bead: 14 -{"friction": [[0.00013374478328643185, -2.5661182260503057e-05, -2.5509375856580467e-05], [-2.5661182260503057e-05, 0.00013396948007718206, -2.556339063378455e-05], [-2.5509375856580467e-05, -2.556339063378455e-05, 0.00013378980239580967]]} - #*EXTRAS*# Step: 3 Bead: 14 -{"friction": [[0.00013540819044204994, -1.7191626808076683e-05, -1.673184484825904e-05], [-1.7191626808076683e-05, 0.00013552950645998835, -1.7052810730826303e-05], [-1.673184484825904e-05, -1.7052810730826303e-05, 0.00013584649578752232]]} - #*EXTRAS*# Step: 4 Bead: 14 -{"friction": [[0.0001362437826395187, -1.2380497098284417e-05, -1.185263231695649e-05], [-1.2380497098284417e-05, 0.00013631028248581106, -1.2248331146973155e-05], [-1.185263231695649e-05, -1.2248331146973155e-05, 0.00013685445625756008]]} - #*EXTRAS*# Step: 5 Bead: 14 -{"friction": [[0.00013644705004819285, -1.1255669411550215e-05, -1.0730784511964865e-05], [-1.1255669411550215e-05, 0.00013650299180488024, -1.1128154125782506e-05], [-1.0730784511964865e-05, -1.1128154125782506e-05, 0.00013709046658308473]]} - #*EXTRAS*# Step: 6 Bead: 14 -{"friction": [[0.0001366910083365231, -9.943265960473648e-06, -9.432017545977411e-06], [-9.943265960473648e-06, 0.00013673599137623173, -9.822635849102834e-06], [-9.432017545977411e-06, -9.822635849102834e-06, 0.00013736870269931542]]} - #*EXTRAS*# Step: 7 Bead: 14 -{"friction": [[0.00013679237492042403, -9.410835526043185e-06, -8.908347306262705e-06], [-9.410835526043185e-06, 0.00013683335780874758, -9.293443131593616e-06], [-8.908347306262705e-06, -9.293443131593616e-06, 0.00013748274107063538]]} - #*EXTRAS*# Step: 8 Bead: 14 -{"friction": [[0.00013687069595131007, -9.004770389134832e-06, -8.510244157797807e-06], [-9.004770389134832e-06, 0.00013690880850569025, -8.890018629033262e-06], [-8.510244157797807e-06, -8.890018629033262e-06, 0.00013757023992532172]]} - #*EXTRAS*# Step: 9 Bead: 14 -{"friction": [[0.00013691717809970563, -8.765984582495752e-06, -8.276663494936957e-06], [-8.765984582495752e-06, 0.00013695367714590685, -8.652854637587062e-06], [-8.276663494936957e-06, -8.652854637587062e-06, 0.00013762192105447741]]} - #*EXTRAS*# Step: 10 Bead: 14 -{"friction": [[0.00013694793591004952, -8.60888280674614e-06, -8.123199036605814e-06], [-8.60888280674614e-06, 0.0001369834038359969, -8.496847686857384e-06], [-8.123199036605814e-06, -8.496847686857384e-06, 0.00013765601901106225]]} - #*EXTRAS*# Step: 11 Bead: 14 -{"friction": [[0.00013696739166711372, -8.509881214329787e-06, -8.026576679676384e-06], [-8.509881214329787e-06, 0.00013700222231173456, -8.398547342608335e-06], [-8.026576679676384e-06, -8.398547342608335e-06, 0.00013767754679049388]]} - #*EXTRAS*# Step: 12 Bead: 14 -{"friction": [[0.00013697993410570955, -8.446211474531963e-06, -7.964472737987686e-06], [-8.446211474531963e-06, 0.00013701436003617207, -8.335333206818991e-06], [-7.964472737987686e-06, -8.335333206818991e-06, 0.00013769140834012528]]} - #*EXTRAS*# Step: 13 Bead: 14 -{"friction": [[0.00013698794777866337, -8.405594136129314e-06, -7.924868892687207e-06], [-8.405594136129314e-06, 0.00013702211763241264, -8.295008403140615e-06], [-7.924868892687207e-06, -8.295008403140615e-06, 0.0001377002580193388]]} - #*EXTRAS*# Step: 14 Bead: 14 -{"friction": [[0.00013699308438334956, -8.379584990169755e-06, -7.899514716520752e-06], [-8.379584990169755e-06, 0.00013702709112258058, -8.269187352534887e-06], [-7.899514716520752e-06, -8.269187352534887e-06, 0.0001377059277036576]]} - #*EXTRAS*# Step: 15 Bead: 14 -{"friction": [[0.00013699637043761828, -8.362956640867231e-06, -7.883307556826771e-06], [-8.362956640867231e-06, 0.00013703027324691783, -8.252679573420974e-06], [-7.883307556826771e-06, -8.252679573420974e-06, 0.00013770955364770867]]} - #*EXTRAS*# Step: 16 Bead: 14 -{"friction": [[0.00013699847363036487, -8.352318221659146e-06, -7.872939607331777e-06], [-8.352318221659146e-06, 0.000137032310092565, -8.242118421293213e-06], [-7.872939607331777e-06, -8.242118421293213e-06, 0.00013771187391628344]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_15 b/drivers/py/pes/friction/frictionH/060K/inst.raw_15 deleted file mode 100644 index 99d24738b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_15 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 -{"friction": [[0.00012726027358761464, -3.896940372900226e-05, -3.8480234708173996e-05], [-3.896940372900226e-05, 0.00012736412762627062, -3.9043725441288e-05], [-3.8480234708173996e-05, -3.9043725441288e-05, 0.00012691129785582055]]} - #*EXTRAS*# Step: 1 Bead: 15 -{"friction": [[0.00013075563007134403, -3.383515887941949e-05, -3.370914581896609e-05], [-3.383515887941949e-05, 0.00013097481875553555, -3.3834659660389763e-05], [-3.370914581896609e-05, -3.3834659660389763e-05, 0.00013046207017740528]]} - #*EXTRAS*# Step: 2 Bead: 15 -{"friction": [[0.00013334304006582646, -2.7207533011997012e-05, -2.7107546612817397e-05], [-2.7207533011997012e-05, 0.0001335805527481861, -2.7124283004988266e-05], [-2.7107546612817397e-05, -2.7124283004988266e-05, 0.00013331282823855403]]} - #*EXTRAS*# Step: 3 Bead: 15 -{"friction": [[0.00013512758882667922, -1.880446315902926e-05, -1.8391909782546642e-05], [-1.880446315902926e-05, 0.00013526958137225612, -1.8668280572179135e-05], [-1.8391909782546642e-05, -1.8668280572179135e-05, 0.00013549777543054507]]} - #*EXTRAS*# Step: 4 Bead: 15 -{"friction": [[0.00013601441856726082, -1.3679059093255272e-05, -1.3157250691019724e-05], [-1.3679059093255272e-05, 0.00013609431801553487, -1.3542972891772954e-05], [-1.3157250691019724e-05, -1.3542972891772954e-05, 0.0001365835661920177]]} - #*EXTRAS*# Step: 5 Bead: 15 -{"friction": [[0.00013625059945418568, -1.2342350057704083e-05, -1.1814458709699892e-05], [-1.2342350057704083e-05, 0.00013631672464772593, -1.2210322803739529e-05], [-1.1814458709699892e-05, -1.2210322803739529e-05, 0.00013686243327888536]]} - #*EXTRAS*# Step: 6 Bead: 15 -{"friction": [[0.00013650992464440398, -1.0913345526217244e-05, -1.0390943830229813e-05], [-1.0913345526217244e-05, 0.0001365628618779277, -1.0787475263383961e-05], [-1.0390943830229813e-05, -1.0787475263383961e-05, 0.00013716269475026968]]} - #*EXTRAS*# Step: 7 Bead: 15 -{"friction": [[0.00013661991824969366, -1.0321244745951809e-05, -9.804919391385312e-06], [-1.0321244745951809e-05, 0.0001366679001097015, -1.0198471447139221e-05], [-9.804919391385312e-06, -1.0198471447139221e-05, 0.00013728818132706817]]} - #*EXTRAS*# Step: 8 Bead: 15 -{"friction": [[0.00013670395602328455, -9.874828404959758e-06, -9.364600153793568e-06], [-9.874828404959758e-06, 0.00013674841008933742, -9.754600149927545e-06], [-9.364600153793568e-06, -9.754600149927545e-06, 0.0001373833194979909]]} - #*EXTRAS*# Step: 9 Bead: 15 -{"friction": [[0.0001367540742158623, -9.61110235342023e-06, -9.105096780258365e-06], [-9.61110235342023e-06, 0.0001367965305508375, -9.49246217163632e-06], [-9.105096780258365e-06, -9.49246217163632e-06, 0.00013743975862121985]]} - #*EXTRAS*# Step: 10 Bead: 15 -{"friction": [[0.0001367871929118243, -9.43786639380244e-06, -8.93488769625713e-06], [-9.43786639380244e-06, 0.00013682837246411678, -9.320303474092856e-06], [-8.93488769625713e-06, -9.320303474092856e-06, 0.00013747693312111782]]} - #*EXTRAS*# Step: 11 Bead: 15 -{"friction": [[0.0001368081632097493, -9.328604529662604e-06, -8.827638651487792e-06], [-9.328604529662604e-06, 0.0001368485520917207, -9.211734930210104e-06], [-8.827638651487792e-06, -9.211734930210104e-06, 0.00013750042206048924]]} - #*EXTRAS*# Step: 12 Bead: 15 -{"friction": [[0.00013682168089355947, -9.258349772223948e-06, -8.75872064997521e-06], [-9.258349772223948e-06, 0.00013686156738582789, -9.141931638871224e-06], [-8.75872064997521e-06, -9.141931638871224e-06, 0.00013751554308142824]]} - #*EXTRAS*# Step: 13 Bead: 15 -{"friction": [[0.00013683032003667495, -9.213522622307818e-06, -8.714763868037366e-06], [-9.213522622307818e-06, 0.00013686988843783447, -9.097394869733063e-06], [-8.714763868037366e-06, -9.097394869733063e-06, 0.0001375251986497308]]} - #*EXTRAS*# Step: 14 Bead: 15 -{"friction": [[0.00013683585778763387, -9.18481791441584e-06, -8.686623633999523e-06], [-9.18481791441584e-06, 0.00013687522351332992, -9.068877051942377e-06], [-8.686623633999523e-06, -9.068877051942377e-06, 0.00013753138455388085]]} - #*EXTRAS*# Step: 15 Bead: 15 -{"friction": [[0.00013683940077880073, -9.166465184025984e-06, -8.668634731478581e-06], [-9.166465184025984e-06, 0.00013687863733586103, -9.050644199594586e-06], [-8.668634731478581e-06, -9.050644199594586e-06, 0.00013753534084219902]]} - #*EXTRAS*# Step: 16 Bead: 15 -{"friction": [[0.00013684166848964378, -9.154723425381994e-06, -8.657126940654715e-06], [-9.154723425381994e-06, 0.00013688082257664428, -9.038979295328312e-06], [-8.657126940654715e-06, -9.038979295328312e-06, 0.00013753787251985326]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_16 b/drivers/py/pes/friction/frictionH/060K/inst.raw_16 deleted file mode 100644 index 45b150085..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_16 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 16 -{"friction": [[0.00012661143308844656, -3.971479929521334e-05, -3.9182795101576245e-05], [-3.971479929521334e-05, 0.00012669737778386712, -3.979877417067022e-05], [-3.9182795101576245e-05, -3.979877417067022e-05, 0.00012627184388542937]]} - #*EXTRAS*# Step: 1 Bead: 16 -{"friction": [[0.0001300419988045457, -3.508387351803022e-05, -3.488413934101739e-05], [-3.508387351803022e-05, 0.0001302389999237797, -3.510161417158304e-05], [-3.488413934101739e-05, -3.510161417158304e-05, 0.00012971975066989813]]} - #*EXTRAS*# Step: 2 Bead: 16 -{"friction": [[0.00013285398820577342, -2.8847766639930128e-05, -2.8788060599403377e-05], [-2.8847766639930128e-05, 0.00013310007533029407, -2.8782123038680572e-05], [-2.8788060599403377e-05, -2.8782123038680572e-05, 0.00013274678793138373]]} - #*EXTRAS*# Step: 3 Bead: 16 -{"friction": [[0.00013480980842908326, -2.0570959032683117e-05, -2.0220116681172875e-05], [-2.0570959032683117e-05, 0.00013497479915151073, -2.0440477977134185e-05], [-2.0220116681172875e-05, -2.0440477977134185e-05, 0.000135100605970232]]} - #*EXTRAS*# Step: 4 Bead: 16 -{"friction": [[0.00013576320010202616, -1.5127558857927765e-05, -1.462374568036721e-05], [-1.5127558857927765e-05, 0.00013585938487788998, -1.4988947117862188e-05], [-1.462374568036721e-05, -1.4988947117862188e-05, 0.0001362815287202465]]} - #*EXTRAS*# Step: 5 Bead: 16 -{"friction": [[0.00013603681326419272, -1.3551092909970786e-05, -1.302825194582925e-05], [-1.3551092909970786e-05, 0.00013611533872728862, -1.341532370513671e-05], [-1.302825194582925e-05, -1.341532370513671e-05, 0.00013661022590483315]]} - #*EXTRAS*# Step: 6 Bead: 16 -{"friction": [[0.0001363128692689068, -1.1995205964190262e-05, -1.1467480360335515e-05], [-1.1995205964190262e-05, 0.00013637563749867743, -1.1864502369957449e-05], [-1.1467480360335515e-05, -1.1864502369957449e-05, 0.0001369351017299129]]} - #*EXTRAS*# Step: 7 Bead: 16 -{"friction": [[0.00013643214227161145, -1.1337237677561275e-05, -1.08118710681256e-05], [-1.1337237677561275e-05, 0.00013648881468102204, -1.1209346187837481e-05], [-1.08118710681256e-05, -1.1209346187837481e-05, 0.00013707328757969533]]} - #*EXTRAS*# Step: 8 Bead: 16 -{"friction": [[0.0001365222399869598, -1.0846619437280269e-05, -1.0324789107255714e-05], [-1.0846619437280269e-05, 0.00013657460334593835, -1.0721082255719091e-05], [-1.0324789107255714e-05, -1.0721082255719091e-05, 0.00013717679962937444]]} - #*EXTRAS*# Step: 9 Bead: 16 -{"friction": [[0.00013657621148275092, -1.0555473576486237e-05, -1.0036472438054398e-05], [-1.0555473576486237e-05, 0.00013662611649791558, -1.043143709688365e-05], [-1.0036472438054398e-05, -1.043143709688365e-05, 0.00013723845013589284]]} - #*EXTRAS*# Step: 10 Bead: 16 -{"friction": [[0.00013661182666341315, -1.0364503131152832e-05, -9.847656626998193e-06], [-1.0364503131152832e-05, 0.00013666015999732074, -1.024149279793435e-05], [-9.847656626998193e-06, -1.024149279793435e-05, 0.00013727898746005164]]} - #*EXTRAS*# Step: 11 Bead: 16 -{"friction": [[0.00013663439834091584, -1.024395277111157e-05, -9.728589107674408e-06], [-1.024395277111157e-05, 0.00013668175640740203, -1.0121607213874932e-05], [-9.728589107674408e-06, -1.0121607213874932e-05, 0.00013730461923487124]]} - #*EXTRAS*# Step: 12 Bead: 16 -{"friction": [[0.00013664894672125034, -1.0166451773594741e-05, -9.652091788315611e-06], [-1.0166451773594741e-05, 0.00013669568474029007, -1.004454054512357e-05], [-9.652091788315611e-06, -1.004454054512357e-05, 0.00013732111565967512]]} - #*EXTRAS*# Step: 13 Bead: 16 -{"friction": [[0.00013665824687450817, -1.0116990636080336e-05, -9.603291859512763e-06], [-1.0116990636080336e-05, 0.0001367045920348143, -9.995359437209905e-06], [-9.603291859512763e-06, -9.995359437209905e-06, 0.00013733165115639817]]} - #*EXTRAS*# Step: 14 Bead: 16 -{"friction": [[0.00013666420852162246, -1.0085318403106406e-05, -9.572051497443943e-06], [-1.0085318403106406e-05, 0.0001367103032886487, -9.963867682046814e-06], [-9.572051497443943e-06, -9.963867682046814e-06, 0.00013733840061471355]]} - #*EXTRAS*# Step: 15 Bead: 16 -{"friction": [[0.00013666802301626476, -1.0065067094900253e-05, -9.552079797660432e-06], [-1.0065067094900253e-05, 0.00013671395816178625, -9.943732247192215e-06], [-9.552079797660432e-06, -9.943732247192215e-06, 0.00013734271751280952]]} - #*EXTRAS*# Step: 16 Bead: 16 -{"friction": [[0.00013667046456739446, -1.0052110467045353e-05, -9.539303481494854e-06], [-1.0052110467045353e-05, 0.00013671629778523763, -9.930849948674365e-06], [-9.539303481494854e-06, -9.930849948674365e-06, 0.0001373454799552708]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_17 b/drivers/py/pes/friction/frictionH/060K/inst.raw_17 deleted file mode 100644 index 3fd949b34..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_17 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 17 -{"friction": [[0.00012594185509922254, -4.0430818480279955e-05, -3.987531491748839e-05], [-4.0430818480279955e-05, 0.0001260130421325445, -4.052299864131734e-05], [-3.987531491748839e-05, -4.052299864131734e-05, 0.00012561795751016416]]} - #*EXTRAS*# Step: 1 Bead: 17 -{"friction": [[0.0001292330233438706, -3.6350781754656434e-05, -3.606013317947199e-05], [-3.6350781754656434e-05, 0.00012940248479960308, -3.63873291496811e-05], [-3.606013317947199e-05, -3.63873291496811e-05, 0.0001288906648071318]]} - #*EXTRAS*# Step: 2 Bead: 17 -{"friction": [[0.00013225045162150537, -3.0569446914486834e-05, -3.052641201540585e-05], [-3.0569446914486834e-05, 0.00013249790819660405, -3.0524511681098596e-05], [-3.052641201540585e-05, -3.0524511681098596e-05, 0.00013206839277799757]]} - #*EXTRAS*# Step: 3 Bead: 17 -{"friction": [[0.0001344425002112759, -2.2487755759273258e-05, -2.2211465701507164e-05], [-2.2487755759273258e-05, 0.00013463187670572927, -2.2366779029739933e-05], [-2.2211465701507164e-05, -2.2366779029739933e-05, 0.00013464273433599105]]} - #*EXTRAS*# Step: 4 Bead: 17 -{"friction": [[0.00013548701775889643, -1.6733851523151897e-05, -1.6262592646678197e-05], [-1.6733851523151897e-05, 0.00013560260210227236, -1.6594735037362445e-05], [-1.6262592646678197e-05, -1.6594735037362445e-05, 0.00013594379888811497]]} - #*EXTRAS*# Step: 5 Bead: 17 -{"friction": [[0.0001358042596159704, -1.4889495312579095e-05, -1.438195090430603e-05], [-1.4889495312579095e-05, 0.00013589768090185644, -1.4751164215924579e-05], [-1.438195090430603e-05, -1.4751164215924579e-05, 0.0001363312549208322]]} - #*EXTRAS*# Step: 6 Bead: 17 -{"friction": [[0.00013609905040345982, -1.319670940479757e-05, -1.2671499127153465e-05], [-1.319670940479757e-05, 0.00013617383014264027, -1.306189732086529e-05], [-1.2671499127153465e-05, -1.306189732086529e-05, 0.00013668407907252997]]} - #*EXTRAS*# Step: 7 Bead: 17 -{"friction": [[0.00013622841752999648, -1.2466582571482739e-05, -1.1938810099540148e-05], [-1.2466582571482739e-05, 0.00013629576698105005, -1.233410854767926e-05], [-1.1938810099540148e-05, -1.233410854767926e-05, 0.00013683646025317427]]} - #*EXTRAS*# Step: 8 Bead: 17 -{"friction": [[0.00013632498607158152, -1.1927939212127352e-05, -1.140033121336755e-05], [-1.1927939212127352e-05, 0.0001363871148862876, -1.1797504907876863e-05], [-1.140033121336755e-05, -1.1797504907876863e-05, 0.0001369492001155031]]} - #*EXTRAS*# Step: 9 Bead: 17 -{"friction": [[0.0001363830555118439, -1.160688393634611e-05, -1.1080223546214069e-05], [-1.160688393634611e-05, 0.00013644218300017813, -1.1477792069853034e-05], [-1.1080223546214069e-05, -1.1477792069853034e-05, 0.00013701657701858082]]} - #*EXTRAS*# Step: 10 Bead: 17 -{"friction": [[0.0001364213157039717, -1.1396570770986937e-05, -1.087088019764848e-05], [-1.1396570770986937e-05, 0.0001364785231164496, -1.1268409446484133e-05], [-1.087088019764848e-05, -1.1268409446484133e-05, 0.00013706079868497462]]} - #*EXTRAS*# Step: 11 Bead: 17 -{"friction": [[0.0001364455819897545, -1.1263695155766039e-05, -1.0738760989940923e-05], [-1.1263695155766039e-05, 0.00013650159538798788, -1.1136142584743052e-05], [-1.0738760989940923e-05, -1.1136142584743052e-05, 0.0001370887757747922]]} - #*EXTRAS*# Step: 12 Bead: 17 -{"friction": [[0.00013646121990892591, -1.1178280483844804e-05, -1.0653891615211222e-05], [-1.1178280483844804e-05, 0.00013651647366126984, -1.1051127740505903e-05], [-1.0653891615211222e-05, -1.1051127740505903e-05, 0.00013710677622123465]]} - #*EXTRAS*# Step: 13 Bead: 17 -{"friction": [[0.0001364712185029339, -1.1123756690272338e-05, -1.0599740160709681e-05], [-1.1123756690272338e-05, 0.00013652599058962064, -1.099686265413028e-05], [-1.0599740160709681e-05, -1.099686265413028e-05, 0.0001371182735475757]]} - #*EXTRAS*# Step: 14 Bead: 17 -{"friction": [[0.0001364776278948441, -1.1088841933877804e-05, -1.0565073781948351e-05], [-1.1088841933877804e-05, 0.00013653209287796202, -1.0962114986733196e-05], [-1.0565073781948351e-05, -1.0962114986733196e-05, 0.00013712563882491393]]} - #*EXTRAS*# Step: 15 Bead: 17 -{"friction": [[0.00013648172911771728, -1.1066515827609075e-05, -1.054291057622375e-05], [-1.1066515827609075e-05, 0.00013653599827240264, -1.093989630736619e-05], [-1.054291057622375e-05, -1.093989630736619e-05, 0.0001371303497120099]]} - #*EXTRAS*# Step: 16 Bead: 17 -{"friction": [[0.0001364843542342276, -1.1052231476956996e-05, -1.0528732119685582e-05], [-1.1052231476956996e-05, 0.0001365384983214574, -1.092568092727965e-05], [-1.0528732119685582e-05, -1.092568092727965e-05, 0.00013713336425054732]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_18 b/drivers/py/pes/friction/frictionH/060K/inst.raw_18 deleted file mode 100644 index 190b14285..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_18 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 18 -{"friction": [[0.00012526486252094083, -4.1100303058221635e-05, -4.0550714905083066e-05], [-4.1100303058221635e-05, 0.00012532660471124878, -4.119858624384984e-05], [-4.0550714905083066e-05, -4.119858624384984e-05, 0.00012496354601260095]]} - #*EXTRAS*# Step: 1 Bead: 18 -{"friction": [[0.00012833823977072883, -3.7610486278497233e-05, -3.722149994422753e-05], [-3.7610486278497233e-05, 0.00012847677430923645, -3.766562462271395e-05], [-3.722149994422753e-05, -3.766562462271395e-05, 0.00012798607670308964]]} - #*EXTRAS*# Step: 2 Bead: 18 -{"friction": [[0.0001314971004449298, -3.235670417063397e-05, -3.228979458436936e-05], [-3.235670417063397e-05, 0.00013173475655464667, -3.2335374332141396e-05], [-3.228979458436936e-05, -3.2335374332141396e-05, 0.00013124789004719247]]} - #*EXTRAS*# Step: 3 Bead: 18 -{"friction": [[0.00013400635235862976, -2.45461752307615e-05, -2.4352083470184842e-05], [-2.45461752307615e-05, 0.00013421972209270273, -2.44391974920892e-05], [-2.4352083470184842e-05, -2.44391974920892e-05, 0.0001341061794138949]]} - #*EXTRAS*# Step: 4 Bead: 18 -{"friction": [[0.00013518042889920244, -1.8503582430742367e-05, -1.8081477138038666e-05], [-1.8503582430742367e-05, 0.0001353185217799309, -1.8366722230688185e-05], [-1.8081477138038666e-05, -1.8366722230688185e-05, 0.0001355636630167696]]} - #*EXTRAS*# Step: 5 Bead: 18 -{"friction": [[0.00013555053811370655, -1.6364334371615422e-05, -1.5884494878346004e-05], [-1.6364334371615422e-05, 0.0001356615547743042, -1.6225119326370997e-05], [-1.5884494878346004e-05, -1.6225119326370997e-05, 0.000136021938280242]]} - #*EXTRAS*# Step: 6 Bead: 18 -{"friction": [[0.00013586722726749166, -1.4525250231271924e-05, -1.4012574925462243e-05], [-1.4525250231271924e-05, 0.00013595648382141553, -1.4387451031634226e-05], [-1.4012574925462243e-05, -1.4387451031634226e-05, 0.00013640724655493165]]} - #*EXTRAS*# Step: 7 Bead: 18 -{"friction": [[0.00013600783152680447, -1.3716741248189751e-05, -1.3195254634843638e-05], [-1.3716741248189751e-05, 0.00013608813769597434, -1.3580564597696365e-05], [-1.3195254634843638e-05, -1.3580564597696365e-05, 0.00013657571614939703]]} - #*EXTRAS*# Step: 8 Bead: 18 -{"friction": [[0.00013611143899513702, -1.312639785310445e-05, -1.260080397603263e-05], [-1.312639785310445e-05, 0.00013618548613857618, -1.2991789494204778e-05], [-1.260080397603263e-05, -1.2991789494204778e-05, 0.0001366987379915751]]} - #*EXTRAS*# Step: 9 Bead: 18 -{"friction": [[0.00013617392363862667, -1.2773005107948865e-05, -1.2245922719739702e-05], [-1.2773005107948865e-05, 0.00013624434317366404, -1.2639489908652432e-05], [-1.2245922719739702e-05, -1.2639489908652432e-05, 0.0001367724596446654]]} - #*EXTRAS*# Step: 10 Bead: 18 -{"friction": [[0.00013621501645793776, -1.2541778311190603e-05, -1.2014123053782835e-05], [-1.2541778311190603e-05, 0.00013628311270093502, -1.2409040770321993e-05], [-1.2014123053782835e-05, -1.2409040770321993e-05, 0.00013682074673710993]]} - #*EXTRAS*# Step: 11 Bead: 18 -{"friction": [[0.00013624109224865164, -1.239556026665989e-05, -1.1867708403355572e-05], [-1.239556026665989e-05, 0.00013630774034510747, -1.2263339916604668e-05], [-1.1867708403355572e-05, -1.2263339916604668e-05, 0.00013685130678304364]]} - #*EXTRAS*# Step: 12 Bead: 18 -{"friction": [[0.00013625789124632667, -1.2301576091305348e-05, -1.1773666107220831e-05], [-1.2301576091305348e-05, 0.0001363236172377059, -1.216969856634114e-05], [-1.1773666107220831e-05, -1.216969856634114e-05, 0.00013687096134960822]]} - #*EXTRAS*# Step: 13 Bead: 18 -{"friction": [[0.00013626863334128072, -1.2241567760608181e-05, -1.171364873017892e-05], [-1.2241567760608181e-05, 0.00013633377417379553, -1.210991337809977e-05], [-1.171364873017892e-05, -1.210991337809977e-05, 0.0001368835157182638]]} - #*EXTRAS*# Step: 14 Bead: 18 -{"friction": [[0.00013627551901780537, -1.2203139627677653e-05, -1.167522632456817e-05], [-1.2203139627677653e-05, 0.00013634028660811245, -1.2071629880350777e-05], [-1.167522632456817e-05, -1.2071629880350777e-05, 0.00013689155743091302]]} - #*EXTRAS*# Step: 15 Bead: 18 -{"friction": [[0.00013627992511577595, -1.217856505453781e-05, -1.1650660137795105e-05], [-1.217856505453781e-05, 0.00013634445462846223, -1.2047148512240657e-05], [-1.1650660137795105e-05, -1.2047148512240657e-05, 0.00013689670096013034]]} - #*EXTRAS*# Step: 16 Bead: 18 -{"friction": [[0.0001362827453605403, -1.216284172368861e-05, -1.1634944108110554e-05], [-1.216284172368861e-05, 0.0001363471227957872, -1.2031485107121281e-05], [-1.1634944108110554e-05, -1.2031485107121281e-05, 0.00013689999227237663]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_19 b/drivers/py/pes/friction/frictionH/060K/inst.raw_19 deleted file mode 100644 index 4d5af75d6..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_19 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 19 -{"friction": [[0.00012459632602131336, -4.170492542491858e-05, -4.120187097266213e-05], [-4.170492542491858e-05, 0.00012465628415804492, -4.1806390624578615e-05], [-4.120187097266213e-05, -4.1806390624578615e-05, 0.00012432488906652224]]} - #*EXTRAS*# Step: 1 Bead: 19 -{"friction": [[0.00012737514691066066, -3.8831975972658615e-05, -3.835200305068976e-05], [-3.8831975972658615e-05, 0.00012748245331564668, -3.890443226980349e-05], [-3.835200305068976e-05, -3.890443226980349e-05, 0.00012702509131795944]]} - #*EXTRAS*# Step: 2 Bead: 19 -{"friction": [[0.00013056371513976987, -3.418528092134356e-05, -3.404055026720772e-05], [-3.418528092134356e-05, 0.00013077724553918366, -3.4189848233424744e-05], [-3.404055026720772e-05, -3.4189848233424744e-05, 0.00013026127236826898]]} - #*EXTRAS*# Step: 3 Bead: 19 -{"friction": [[0.00013347229646797784, -2.6730988452118543e-05, -2.6616154827821612e-05], [-2.6730988452118543e-05, 0.0001337062801232049, -2.6643038523072606e-05], [-2.6616154827821612e-05, -2.6643038523072606e-05, 0.0001334650886812493]]} - #*EXTRAS*# Step: 4 Bead: 19 -{"friction": [[0.0001348340856662566, -2.0439096706516972e-05, -2.0083361277669606e-05], [-2.0439096706516972e-05, 0.0001349973643011436, -2.0308088471247244e-05], [-2.0083361277669606e-05, -2.0308088471247244e-05, 0.00013513096036123912]]} - #*EXTRAS*# Step: 5 Bead: 19 -{"friction": [[0.00013527158530635258, -1.7981026076545074e-05, -1.7543108291491857e-05], [-1.7981026076545074e-05, 0.00013540294423364493, -1.7843192178958153e-05], [-1.7543108291491857e-05, -1.7843192178958153e-05, 0.00013567711848954975]]} - #*EXTRAS*# Step: 6 Bead: 19 -{"friction": [[0.0001356153120108408, -1.5987317982323938e-05, -1.549937882263404e-05], [-1.5987317982323938e-05, 0.00013572172874288567, -1.5848134728436318e-05], [-1.549937882263404e-05, -1.5848134728436318e-05, 0.00013610134925392454]]} - #*EXTRAS*# Step: 7 Bead: 19 -{"friction": [[0.00013576890015841464, -1.5094487449900917e-05, -1.4590138313740641e-05], [-1.5094487449900917e-05, 0.0001358646991310732, -1.495591152587845e-05], [-1.4590138313740641e-05, -1.495591152587845e-05, 0.0001362884399744548]]} - #*EXTRAS*# Step: 8 Bead: 19 -{"friction": [[0.00013588042156139238, -1.4449075376273e-05, -1.3935416815000705e-05], [-1.4449075376273e-05, 0.00013596881719162962, -1.4311403069276172e-05], [-1.3935416815000705e-05, -1.4311403069276172e-05, 0.00013642312803424444]]} - #*EXTRAS*# Step: 9 Bead: 19 -{"friction": [[0.00013594778918990427, -1.4061073799854021e-05, -1.3542897672339578e-05], [-1.4061073799854021e-05, 0.0001360318557621689, -1.3924131752988994e-05], [-1.3542897672339578e-05, -1.3924131752988994e-05, 0.00013650398444447684]]} - #*EXTRAS*# Step: 10 Bead: 19 -{"friction": [[0.00013599198700427214, -1.3807460045783828e-05, -1.328678105927552e-05], [-1.3807460045783828e-05, 0.00013607327626730738, -1.3671071050449758e-05], [-1.328678105927552e-05, -1.3671071050449758e-05, 0.00013655681780615008]]} - #*EXTRAS*# Step: 11 Bead: 19 -{"friction": [[0.0001360200358910923, -1.3646939620791668e-05, -1.3124863289613076e-05], [-1.3646939620791668e-05, 0.00013609958941912208, -1.3510931556836012e-05], [-1.3124863289613076e-05, -1.3510931556836012e-05, 0.00013659025753077434]]} - #*EXTRAS*# Step: 12 Bead: 19 -{"friction": [[0.00013603809679509915, -1.3543765609822126e-05, -1.3020868346571515e-05], [-1.3543765609822126e-05, 0.0001361165439238566, -1.3408015016019237e-05], [-1.3020868346571515e-05, -1.3408015016019237e-05, 0.00013661175252142733]]} - #*EXTRAS*# Step: 13 Bead: 19 -{"friction": [[0.00013604964537260804, -1.3477872803273392e-05, -1.2954483054488914e-05], [-1.3477872803273392e-05, 0.00013612738972322374, -1.3342291811784259e-05], [-1.2954483054488914e-05, -1.3342291811784259e-05, 0.0001366254816129177]]} - #*EXTRAS*# Step: 14 Bead: 19 -{"friction": [[0.0001360570470305401, -1.3435674242518404e-05, -1.2911982174123592e-05], [-1.3435674242518404e-05, 0.0001361343428947732, -1.330020398116565e-05], [-1.2911982174123592e-05, -1.330020398116565e-05, 0.00013663427448905262]]} - #*EXTRAS*# Step: 15 Bead: 19 -{"friction": [[0.00013606178315754558, -1.3408686242505361e-05, -1.2884806191366222e-05], [-1.3408686242505361e-05, 0.00013613879284387083, -1.327328766381683e-05], [-1.2884806191366222e-05, -1.327328766381683e-05, 0.0001366398982304427]]} - #*EXTRAS*# Step: 16 Bead: 19 -{"friction": [[0.0001360648145243259, -1.339141820193649e-05, -1.286742007091546e-05], [-1.339141820193649e-05, 0.00013614164136930315, -1.3256065842931632e-05], [-1.286742007091546e-05, -1.3256065842931632e-05, 0.00013664349665439612]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_20 b/drivers/py/pes/friction/frictionH/060K/inst.raw_20 deleted file mode 100644 index 264c27391..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_20 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 20 -{"friction": [[0.0001239405986518248, -4.2236453288719934e-05, -4.1819804194371584e-05], [-4.2236453288719934e-05, 0.0001240048715323352, -4.2336200609474876e-05], [-4.1819804194371584e-05, -4.2336200609474876e-05, 0.00012370560188273736]]} - #*EXTRAS*# Step: 1 Bead: 20 -{"friction": [[0.0001263698903614625, -3.997924586102009e-05, -3.943597826949985e-05], [-3.997924586102009e-05, 0.00012645000382207543, -4.006640205237424e-05], [-3.943597826949985e-05, -4.006640205237424e-05, 0.00012603524116116342]]} - #*EXTRAS*# Step: 2 Bead: 20 -{"friction": [[0.00012945795216066054, -3.6012057900183475e-05, -3.57468985178587e-05], [-3.6012057900183475e-05, 0.00012963519840012352, -3.604356775499563e-05], [-3.57468985178587e-05, -3.604356775499563e-05, 0.00012912002488962534]]} - #*EXTRAS*# Step: 3 Bead: 20 -{"friction": [[0.0001327981173459688, -2.902012665669255e-05, -2.896344928765683e-05], [-2.902012665669255e-05, 0.00013304473296985516, -2.8956457237429775e-05], [-2.896344928765683e-05, -2.8956457237429775e-05, 0.00013268309392014144]]} - #*EXTRAS*# Step: 4 Bead: 20 -{"friction": [[0.00013443240368045766, -2.2538189056742836e-05, -2.2263918087254478e-05], [-2.2538189056742836e-05, 0.00013462240242744154, -2.2417508693865614e-05], [-2.2263918087254478e-05, -2.2417508693865614e-05, 0.00013463020735664493]]} - #*EXTRAS*# Step: 5 Bead: 20 -{"friction": [[0.0001349606159430793, -1.9742963745262314e-05, -1.9362101322306297e-05], [-1.9742963745262314e-05, 0.00013511482925796604, -1.9609443824807053e-05], [-1.9362101322306297e-05, -1.9609443824807053e-05, 0.00013528918749633549]]} - #*EXTRAS*# Step: 6 Bead: 20 -{"friction": [[0.00013533973999439592, -1.7587957090700136e-05, -1.7138835485650377e-05], [-1.7587957090700136e-05, 0.00013546607570201803, -1.744956064581296e-05], [-1.7138835485650377e-05, -1.744956064581296e-05, 0.00013576173267293968]]} - #*EXTRAS*# Step: 7 Bead: 20 -{"friction": [[0.00013550910109193037, -1.6605429866689432e-05, -1.6131118252914837e-05], [-1.6605429866689432e-05, 0.0001356230916804898, -1.6466264558273954e-05], [-1.6131118252914837e-05, -1.6466264558273954e-05, 0.0001359709931535253]]} - #*EXTRAS*# Step: 8 Bead: 20 -{"friction": [[0.0001356299564973054, -1.590208611816635e-05, -1.5412409963292034e-05], [-1.590208611816635e-05, 0.00013573534236607055, -1.5762928559838774e-05], [-1.5412409963292034e-05, -1.5762928559838774e-05, 0.00013611926304712442]]} - #*EXTRAS*# Step: 9 Bead: 20 -{"friction": [[0.0001357029519826426, -1.547748290593427e-05, -1.4979683966871741e-05], [-1.547748290593427e-05, 0.00013580325529201375, -1.5338554936065634e-05], [-1.4979683966871741e-05, -1.5338554936065634e-05, 0.00013620832346743136]]} - #*EXTRAS*# Step: 10 Bead: 20 -{"friction": [[0.00013575068673849844, -1.5200183818281656e-05, -1.469756741040556e-05], [-1.5200183818281656e-05, 0.00013584772085842943, -1.506149701772251e-05], [-1.469756741040556e-05, -1.506149701772251e-05, 0.00013626634741082744]]} - #*EXTRAS*# Step: 11 Bead: 20 -{"friction": [[0.00013578096569431814, -1.5024506822692827e-05, -1.4519042257684271e-05], [-1.5024506822692827e-05, 0.0001358759502995395, -1.4886010060460648e-05], [-1.4519042257684271e-05, -1.4886010060460648e-05, 0.0001363030607813231]]} - #*EXTRAS*# Step: 12 Bead: 20 -{"friction": [[0.00013580044618954738, -1.4911589004026887e-05, -1.4404378418090232e-05], [-1.4911589004026887e-05, 0.0001358941225902813, -1.4773229631179725e-05], [-1.4404378418090232e-05, -1.4773229631179725e-05, 0.00013632664228321317]]} - #*EXTRAS*# Step: 13 Bead: 20 -{"friction": [[0.00013581289932053535, -1.4839453336112244e-05, -1.433116231310426e-05], [-1.4839453336112244e-05, 0.00013590574381358973, -1.4701187971615155e-05], [-1.433116231310426e-05, -1.4701187971615155e-05, 0.00013634170094760405]]} - #*EXTRAS*# Step: 14 Bead: 20 -{"friction": [[0.00013582087862429757, -1.4793253604797753e-05, -1.4284285013225085e-05], [-1.4793253604797753e-05, 0.00013591319189937753, -1.4655051002895917e-05], [-1.4284285013225085e-05, -1.4655051002895917e-05, 0.00013635134309178837]]} - #*EXTRAS*# Step: 15 Bead: 20 -{"friction": [[0.00013582598378229413, -1.4763703906792923e-05, -1.425430785495804e-05], [-1.4763703906792923e-05, 0.00013591795793919928, -1.462554249389313e-05], [-1.425430785495804e-05, -1.462554249389313e-05, 0.0001363575093980782]]} - #*EXTRAS*# Step: 16 Bead: 20 -{"friction": [[0.00013582925104267015, -1.4744796052373444e-05, -1.4235128910728572e-05], [-1.4744796052373444e-05, 0.00013592100847783565, -1.4606661422838058e-05], [-1.4235128910728572e-05, -1.4606661422838058e-05, 0.00013636145466058098]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_21 b/drivers/py/pes/friction/frictionH/060K/inst.raw_21 deleted file mode 100644 index 139787118..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_21 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 21 -{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} - #*EXTRAS*# Step: 1 Bead: 21 -{"friction": [[0.00012535779220705377, -4.1011705964083915e-05, -4.045913785209357e-05], [-4.1011705964083915e-05, 0.00012542042648807614, -4.1109301544847376e-05], [-4.045913785209357e-05, -4.1109301544847376e-05, 0.00012505294416429144]]} - #*EXTRAS*# Step: 2 Bead: 21 -{"friction": [[0.00012820961979982722, -3.778113800426238e-05, -3.737883371333145e-05], [-3.778113800426238e-05, 0.00012834380280959926, -3.783875546898979e-05], [-3.737883371333145e-05, -3.783875546898979e-05, 0.0001278570069695347]]} - #*EXTRAS*# Step: 3 Bead: 21 -{"friction": [[0.0001319247670215818, -3.138504684079235e-05, -3.1337284489599855e-05], [-3.138504684079235e-05, 0.00013216938034488234, -3.135064069440188e-05], [-3.1337284489599855e-05, -3.135064069440188e-05, 0.00013171043363380117]]} - #*EXTRAS*# Step: 4 Bead: 21 -{"friction": [[0.0001339503267156999, -2.4792483301932613e-05, -2.4607966679358617e-05], [-2.4792483301932613e-05, 0.00013416632193940267, -2.468743920740109e-05], [-2.4607966679358617e-05, -2.468743920740109e-05, 0.0001340380423195001]]} - #*EXTRAS*# Step: 5 Bead: 21 -{"friction": [[0.00013460656103164655, -2.165073274032449e-05, -2.1341247370781026e-05], [-2.165073274032449e-05, 0.00013478543853515465, -2.1525182988457172e-05], [-2.1341247370781026e-05, -2.1525182988457172e-05, 0.00013484681025999564]]} - #*EXTRAS*# Step: 6 Bead: 21 -{"friction": [[0.0001350345139306028, -1.9330120117285333e-05, -1.8934981565640615e-05], [-1.9330120117285333e-05, 0.0001351833450817515, -1.919532648141686e-05], [-1.8934981565640615e-05, -1.919532648141686e-05, 0.0001353815576095785]]} - #*EXTRAS*# Step: 7 Bead: 21 -{"friction": [[0.00013522415397928224, -1.825343462577004e-05, -1.782363331079008e-05], [-1.825343462577004e-05, 0.00013535901632819277, -1.811607614732945e-05], [-1.782363331079008e-05, -1.811607614732945e-05, 0.0001356181209073743]]} - #*EXTRAS*# Step: 8 Bead: 21 -{"friction": [[0.00013535667258518093, -1.7490045019112235e-05, -1.70382291439126e-05], [-1.7490045019112235e-05, 0.00013548176368043008, -1.7351531126411512e-05], [-1.70382291439126e-05, -1.7351531126411512e-05, 0.00013578272207437475]]} - #*EXTRAS*# Step: 9 Bead: 21 -{"friction": [[0.00013543651448142844, -1.7027276732266403e-05, -1.6563269009400243e-05], [-1.7027276732266403e-05, 0.00013555576402235998, -1.688833008335975e-05], [-1.6563269009400243e-05, -1.688833008335975e-05, 0.00013588149875017335]]} - #*EXTRAS*# Step: 10 Bead: 21 -{"friction": [[0.00013548849463548713, -1.6725264882764618e-05, -1.6253799572278733e-05], [-1.6725264882764618e-05, 0.00013560397221306633, -1.6586144648180732e-05], [-1.6253799572278733e-05, -1.6586144648180732e-05, 0.0001359456184933696]]} - #*EXTRAS*# Step: 11 Bead: 21 -{"friction": [[0.00013552142431715202, -1.6533743380038443e-05, -1.6057760235320963e-05], [-1.6533743380038443e-05, 0.0001356345281304798, -1.639455756962692e-05], [-1.6057760235320963e-05, -1.639455756962692e-05, 0.0001359861554012421]]} - #*EXTRAS*# Step: 12 Bead: 21 -{"friction": [[0.00013554258247240394, -1.6410632673185766e-05, -1.5931833919573617e-05], [-1.6410632673185766e-05, 0.00013565416833545533, -1.6271422936645613e-05], [-1.5931833919573617e-05, -1.6271422936645613e-05, 0.00013601216564166192]]} - #*EXTRAS*# Step: 13 Bead: 21 -{"friction": [[0.00013555610049883945, -1.6331961835443716e-05, -1.5851400564242624e-05], [-1.6331961835443716e-05, 0.0001356667197099155, -1.619274427590195e-05], [-1.5851400564242624e-05, -1.619274427590195e-05, 0.0001360287686193702]]} - #*EXTRAS*# Step: 14 Bead: 21 -{"friction": [[0.00013556475822534394, -1.6281572152723717e-05, -1.579989713437438e-05], [-1.6281572152723717e-05, 0.00013567475968780286, -1.614235264038751e-05], [-1.579989713437438e-05, -1.614235264038751e-05, 0.000136039395849301]]} - #*EXTRAS*# Step: 15 Bead: 21 -{"friction": [[0.00013557029612614482, -1.624933916878676e-05, -1.576695795810795e-05], [-1.624933916878676e-05, 0.00013567990301344536, -1.611011965932404e-05], [-1.576695795810795e-05, -1.611011965932404e-05, 0.00013604619094143212]]} - #*EXTRAS*# Step: 16 Bead: 21 -{"friction": [[0.00013557383973637361, -1.6228713408330747e-05, -1.5745882871971713e-05], [-1.6228713408330747e-05, 0.00013568319437712455, -1.6089494413200116e-05], [-1.5745882871971713e-05, -1.6089494413200116e-05, 0.00013605053793653437]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_22 b/drivers/py/pes/friction/frictionH/060K/inst.raw_22 deleted file mode 100644 index 2e722c270..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_22 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 22 -{"friction": [[0.000122630467543474, -4.3096070467800976e-05, -4.2912418060752e-05], [-4.3096070467800976e-05, 0.00012269691709164998, -4.316425275719657e-05], [-4.2912418060752e-05, -4.316425275719657e-05, 0.00012247956068148197]]} - #*EXTRAS*# Step: 1 Bead: 22 -{"friction": [[0.00012438066833177133, -4.188685041013491e-05, -4.140824686814723e-05], [-4.188685041013491e-05, 0.0001244416138256371, -4.198843671953771e-05], [-4.140824686814723e-05, -4.198843671953771e-05, 0.0001241205156988537]]} - #*EXTRAS*# Step: 2 Bead: 22 -{"friction": [[0.00012686905064442495, -3.9425023755072084e-05, -3.8908010493452814e-05], [-3.9425023755072084e-05, 0.00012696174977762438, -3.950535181124683e-05], [-3.8908010493452814e-05, -3.950535181124683e-05, 0.00012652506317068984]]} - #*EXTRAS*# Step: 3 Bead: 22 -{"friction": [[0.00013078056797792792, -3.378880113611108e-05, -3.366514142378169e-05], [-3.378880113611108e-05, 0.00013100047094856323, -3.3787634404300685e-05], [-3.366514142378169e-05, -3.3787634404300685e-05, 0.00013048823189075026]]} - #*EXTRAS*# Step: 4 Bead: 22 -{"friction": [[0.0001333491115393587, -2.7185575838628054e-05, -2.708493144215687e-05], [-2.7185575838628054e-05, 0.0001335864707734607, -2.710210507303154e-05], [-2.708493144215687e-05, -2.710210507303154e-05, 0.00013331995486665608]]} - #*EXTRAS*# Step: 5 Bead: 22 -{"friction": [[0.00013419183654865186, -2.3701209472474907e-05, -2.3473636483654068e-05], [-2.3701209472474907e-05, 0.0001343957529658621, -2.3588015614735733e-05], [-2.3473636483654068e-05, -2.3588015614735733e-05, 0.00013433311773006625]]} - #*EXTRAS*# Step: 6 Bead: 22 -{"friction": [[0.00013468980515124834, -2.121392030493787e-05, -2.0887455876305765e-05], [-2.121392030493787e-05, 0.00013486309997083146, -2.1086243918513555e-05], [-2.0887455876305765e-05, -2.1086243918513555e-05, 0.00013495066333504713]]} - #*EXTRAS*# Step: 7 Bead: 22 -{"friction": [[0.00013490695375694607, -2.003994969036443e-05, -1.9669654628907933e-05], [-2.003994969036443e-05, 0.0001350650383180699, -1.9907445458335472e-05], [-1.9669654628907933e-05, -1.9907445458335472e-05, 0.00013522208426630024]]} - #*EXTRAS*# Step: 8 Bead: 22 -{"friction": [[0.00013505491129129927, -1.921543493090665e-05, -1.8816421438659548e-05], [-1.921543493090665e-05, 0.00013520224844931926, -1.9080316012487527e-05], [-1.8816421438659548e-05, -1.9080316012487527e-05, 0.00013540704094933145]]} - #*EXTRAS*# Step: 9 Bead: 22 -{"friction": [[0.00013514358574834282, -1.871354766151498e-05, -1.8298074913287735e-05], [-1.871354766151498e-05, 0.0001352843985487778, -1.8577151311092665e-05], [-1.8298074913287735e-05, -1.8577151311092665e-05, 0.00013551773048639716]]} - #*EXTRAS*# Step: 10 Bead: 22 -{"friction": [[0.00013520097189127875, -1.8386181646109514e-05, -1.7960436053193588e-05], [-1.8386181646109514e-05, 0.00013533754714220827, -1.8249080233328046e-05], [-1.7960436053193588e-05, -1.8249080233328046e-05, 0.00013558925634209526]]} - #*EXTRAS*# Step: 11 Bead: 22 -{"friction": [[0.00013523724280298694, -1.817836679968282e-05, -1.774630085752114e-05], [-1.817836679968282e-05, 0.0001353711380863948, -1.8040870316658815e-05], [-1.774630085752114e-05, -1.8040870316658815e-05, 0.00013563440984439053]]} - #*EXTRAS*# Step: 12 Bead: 22 -{"friction": [[0.00013526050298581655, -1.8044765505317703e-05, -1.760872157886197e-05], [-1.8044765505317703e-05, 0.00013539268016254038, -1.7907036570243968e-05], [-1.760872157886197e-05, -1.7907036570243968e-05, 0.00013566334137447722]]} - #*EXTRAS*# Step: 13 Bead: 22 -{"friction": [[0.0001352753497760747, -1.7959362906355993e-05, -1.7520811816198265e-05], [-1.7959362906355993e-05, 0.0001354064308243387, -1.7821494208303585e-05], [-1.7520811816198265e-05, -1.7821494208303585e-05, 0.00013568179722279935]]} - #*EXTRAS*# Step: 14 Bead: 22 -{"friction": [[0.0001352848518706819, -1.7904655389570143e-05, -1.746451307263769e-05], [-1.7904655389570143e-05, 0.0001354152316810853, -1.776670077937454e-05], [-1.746451307263769e-05, -1.776670077937454e-05, 0.00013569360450082387]]} - #*EXTRAS*# Step: 15 Bead: 22 -{"friction": [[0.00013529092745852755, -1.7869656313556854e-05, -1.742850213126348e-05], [-1.7869656313556854e-05, 0.000135420859043026, -1.7731648222905217e-05], [-1.742850213126348e-05, -1.7731648222905217e-05, 0.0001357011520603089]]} - #*EXTRAS*# Step: 16 Bead: 22 -{"friction": [[0.00013529481407190526, -1.7847259301157786e-05, -1.7405460113058365e-05], [-1.7847259301157786e-05, 0.00013542445898536044, -1.770921759333625e-05], [-1.7405460113058365e-05, -1.770921759333625e-05, 0.00013570597949811168]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_23 b/drivers/py/pes/friction/frictionH/060K/inst.raw_23 deleted file mode 100644 index 956271864..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_23 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 23 -{"friction": [[0.00012194919365104008, -4.3442200516587006e-05, -4.336434695504495e-05], [-4.3442200516587006e-05, 0.0001219973420398065, -4.3472479799487785e-05], [-4.336434695504495e-05, -4.3472479799487785e-05, 0.00012184015749727416]]} - #*EXTRAS*# Step: 1 Bead: 23 -{"friction": [[0.00012344247165202107, -4.259543523160764e-05, -4.2263448574749006e-05], [-4.259543523160764e-05, 0.00012351061675975453, -4.268858016658597e-05], [-4.2263448574749006e-05, -4.268858016658597e-05, 0.000123238586581904]]} - #*EXTRAS*# Step: 2 Bead: 23 -{"friction": [[0.00012550937283810728, -4.0864911331136064e-05, -4.030907443354633e-05], [-4.0864911331136064e-05, 0.00012557376009170282, -4.096127722178642e-05], [-4.030907443354633e-05, -4.096127722178642e-05, 0.0001251990690468549]]} - #*EXTRAS*# Step: 3 Bead: 23 -{"friction": [[0.00012936102026264154, -3.615921790662068e-05, -3.588306948599871e-05], [-3.615921790662068e-05, 0.00012953491835771648, -3.619291656938274e-05], [-3.588306948599871e-05, -3.619291656938274e-05, 0.00012902107986457372]]} - #*EXTRAS*# Step: 4 Bead: 23 -{"friction": [[0.0001325713399755933, -2.969130280920452e-05, -2.96437358116706e-05], [-2.969130280920452e-05, 0.00013281922767066282, -2.9635535185567243e-05], [-2.96437358116706e-05, -2.9635535185567243e-05, 0.00013242648944586426]]} - #*EXTRAS*# Step: 5 Bead: 23 -{"friction": [[0.0001336892708747946, -2.588654342790826e-05, -2.574287923014827e-05], [-2.588654342790826e-05, 0.0001339160663551512, -2.5790742294514604e-05], [-2.574287923014827e-05, -2.5790742294514604e-05, 0.00013372324054229396]]} - #*EXTRAS*# Step: 6 Bead: 23 -{"friction": [[0.00013428997807481575, -2.323580300454674e-05, -2.2989552108067756e-05], [-2.323580300454674e-05, 0.0001344884336871972, -2.3119463682552122e-05], [-2.2989552108067756e-05, -2.3119463682552122e-05, 0.00013445397504960142]]} - #*EXTRAS*# Step: 7 Bead: 23 -{"friction": [[0.00013454604775190685, -2.1963245492796887e-05, -2.1666070324207658e-05], [-2.1963245492796887e-05, 0.0001347288798037862, -2.1839326729325123e-05], [-2.1666070324207658e-05, -2.1839326729325123e-05, 0.00013477143215949789]]} - #*EXTRAS*# Step: 8 Bead: 23 -{"friction": [[0.0001347154337631298, -2.1077884172622977e-05, -2.0746195674178643e-05], [-2.1077884172622977e-05, 0.00013488697902497946, -2.0949582004102927e-05], [-2.0746195674178643e-05, -2.0949582004102927e-05, 0.00013498266729807968]]} - #*EXTRAS*# Step: 9 Bead: 23 -{"friction": [[0.00013481611865212025, -2.053674053534832e-05, -2.01846246551588e-05], [-2.053674053534832e-05, 0.0001349806653143807, -2.040612110386143e-05], [-2.01846246551588e-05, -2.040612110386143e-05, 0.00013510849536848895]]} - #*EXTRAS*# Step: 10 Bead: 23 -{"friction": [[0.0001348807778884315, -2.0183897772674578e-05, -1.981880815708119e-05], [-2.0183897772674578e-05, 0.0001350407372482183, -2.0051915754899918e-05], [-1.981880815708119e-05, -2.0051915754899918e-05, 0.00013518934935084786]]} - #*EXTRAS*# Step: 11 Bead: 23 -{"friction": [[0.0001349215048814425, -1.9959664346121504e-05, -1.9586489237769978e-05], [-1.9959664346121504e-05, 0.00013507854324242892, -1.9826877338041046e-05], [-1.9586489237769978e-05, -1.9826877338041046e-05, 0.0001352402812115684]]} - #*EXTRAS*# Step: 12 Bead: 23 -{"friction": [[0.00013494755391469843, -1.9815480195861314e-05, -1.9437175958492894e-05], [-1.9815480195861314e-05, 0.000135102712735021, -1.9682200606778163e-05], [-1.9437175958492894e-05, -1.9682200606778163e-05, 0.00013527285504668702]]} - #*EXTRAS*# Step: 13 Bead: 23 -{"friction": [[0.00013496415716432038, -1.9723279488697198e-05, -1.934172518666015e-05], [-1.9723279488697198e-05, 0.00013511811381395722, -1.958969518723911e-05], [-1.934172518666015e-05, -1.958969518723911e-05, 0.0001352936151525363]]} - #*EXTRAS*# Step: 14 Bead: 23 -{"friction": [[0.00013497477286834576, -1.9664209235413694e-05, -1.928058524167134e-05], [-1.9664209235413694e-05, 0.00013512795928148898, -1.9530433927742633e-05], [-1.928058524167134e-05, -1.9530433927742633e-05, 0.00013530688757860477]]} - #*EXTRAS*# Step: 15 Bead: 23 -{"friction": [[0.000134981556516536, -1.9626414162288698e-05, -1.924147112230769e-05], [-1.9626414162288698e-05, 0.00013513425010830033, -1.9492518369358335e-05], [-1.924147112230769e-05, -1.9492518369358335e-05, 0.0001353153684180537]]} - #*EXTRAS*# Step: 16 Bead: 23 -{"friction": [[0.00013498589438579357, -1.960222632853448e-05, -1.9216441287917022e-05], [-1.960222632853448e-05, 0.0001351382725902024, -1.946825413544425e-05], [-1.9216441287917022e-05, -1.946825413544425e-05, 0.00013532079134656762]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_24 b/drivers/py/pes/friction/frictionH/060K/inst.raw_24 deleted file mode 100644 index 52f4723db..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_24 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 24 -{"friction": [[0.0001212275207465149, -4.375126119893523e-05, -4.373820812440936e-05], [-4.375126119893523e-05, 0.00012123144588354693, -4.372279618309253e-05], [-4.373820812440936e-05, -4.372279618309253e-05, 0.00012115544091225404]]} - #*EXTRAS*# Step: 1 Bead: 24 -{"friction": [[0.0001225092445451383, -4.31622301792747e-05, -4.2999544165001186e-05], [-4.31622301792747e-05, 0.00012257383392490657, -4.322487922874107e-05], [-4.2999544165001186e-05, -4.322487922874107e-05, 0.00012236610993908312]]} - #*EXTRAS*# Step: 2 Bead: 24 -{"friction": [[0.00012421959614248118, -4.201824699380241e-05, -4.156057578201465e-05], [-4.201824699380241e-05, 0.00012428161237322603, -4.2119519875940854e-05], [-4.156057578201465e-05, -4.2119519875940854e-05, 0.00012396834099875703]]} - #*EXTRAS*# Step: 3 Bead: 24 -{"friction": [[0.0001277364830849899, -3.838854290242978e-05, -3.794007712512542e-05], [-3.838854290242978e-05, 0.0001278550843484508, -3.8454845303128744e-05], [-3.794007712512542e-05, -3.8454845303128744e-05, 0.00012738417166002197]]} - #*EXTRAS*# Step: 4 Bead: 24 -{"friction": [[0.0001315355094443387, -3.2273576088787664e-05, -3.220893847577936e-05], [-3.2273576088787664e-05, 0.00013177392556609088, -3.225110661921095e-05], [-3.220893847577936e-05, -3.225110661921095e-05, 0.00013128911141789795]]} - #*EXTRAS*# Step: 5 Bead: 24 -{"friction": [[0.00013305813843087736, -2.8192774754319324e-05, -2.8119290203796184e-05], [-2.8192774754319324e-05, 0.00013330153102134102, -2.811984047505774e-05], [-2.8119290203796184e-05, -2.811984047505774e-05, 0.00013298118525406424]]} - #*EXTRAS*# Step: 6 Bead: 24 -{"friction": [[0.00013381090181462853, -2.538767459171664e-05, -2.5225777699017188e-05], [-2.538767459171664e-05, 0.00013403295953355918, -2.5287527266207106e-05], [-2.5225777699017188e-05, -2.5287527266207106e-05, 0.00013386935155505091]]} - #*EXTRAS*# Step: 7 Bead: 24 -{"friction": [[0.0001341235421583582, -2.4017603061795224e-05, -2.380265632450398e-05], [-2.4017603061795224e-05, 0.00013433107352519145, -2.3906660775897728e-05], [-2.380265632450398e-05, -2.3906660775897728e-05, 0.00013424932581654057]]} - #*EXTRAS*# Step: 8 Bead: 24 -{"friction": [[0.0001343236190239994, -2.3073378337304825e-05, -2.282059672209276e-05], [-2.3073378337304825e-05, 0.00013452013259552072, -2.295598814215042e-05], [-2.282059672209276e-05, -2.295598814215042e-05, 0.00013449551596238137]]} - #*EXTRAS*# Step: 9 Bead: 24 -{"friction": [[0.00013444127464674107, -2.2493884404135924e-05, -2.2217839625658955e-05], [-2.2493884404135924e-05, 0.00013463072682802222, -2.2372943562996256e-05], [-2.2217839625658955e-05, -2.2372943562996256e-05, 0.00013464121353114902]]} - #*EXTRAS*# Step: 10 Bead: 24 -{"friction": [[0.0001345161360433974, -2.21161076101343e-05, -2.1824994087829502e-05], [-2.21161076101343e-05, 0.00013470088829719938, -2.199301982011484e-05], [-2.1824994087829502e-05, -2.199301982011484e-05, 0.00013473421564159542]]} - #*EXTRAS*# Step: 11 Bead: 24 -{"friction": [[0.00013456307515856528, -2.1875747758977706e-05, -2.1575114133610822e-05], [-2.1875747758977706e-05, 0.00013474480375997569, -2.175136315666072e-05], [-2.1575114133610822e-05, -2.175136315666072e-05, 0.00013479263101094294]]} - #*EXTRAS*# Step: 12 Bead: 24 -{"friction": [[0.00013459299757830956, -2.1721154081994953e-05, -2.1414432057755514e-05], [-2.1721154081994953e-05, 0.0001347727693551652, -2.15959638924929e-05], [-2.1414432057755514e-05, -2.15959638924929e-05, 0.00013482990558293448]]} - #*EXTRAS*# Step: 13 Bead: 24 -{"friction": [[0.0001346120337865254, -2.1622257690092793e-05, -2.1311656847119772e-05], [-2.1622257690092793e-05, 0.0001347905491981536, -2.1496563864720214e-05], [-2.1311656847119772e-05, -2.1496563864720214e-05, 0.0001348536326188236]]} - #*EXTRAS*# Step: 14 Bead: 24 -{"friction": [[0.00013462418942330193, -2.1558887449835894e-05, -2.1245808203806543e-05], [-2.1558887449835894e-05, 0.0001348018980296702, -2.143287571575068e-05], [-2.1245808203806543e-05, -2.143287571575068e-05, 0.0001348687887607984]]} - #*EXTRAS*# Step: 15 Bead: 24 -{"friction": [[0.00013463195109350565, -2.151833516559182e-05, -2.1203672931096517e-05], [-2.151833516559182e-05, 0.00013480914271076885, -2.139212196481093e-05], [-2.1203672931096517e-05, -2.139212196481093e-05, 0.0001348784683438238]]} - #*EXTRAS*# Step: 16 Bead: 24 -{"friction": [[0.00013463691182477878, -2.149238082187886e-05, -2.117670670324929e-05], [-2.149238082187886e-05, 0.00013481377228107368, -2.1366039485759367e-05], [-2.117670670324929e-05, -2.1366039485759367e-05, 0.00013488465567498782]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_25 b/drivers/py/pes/friction/frictionH/060K/inst.raw_25 deleted file mode 100644 index 5d6b1eaae..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_25 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 25 -{"friction": [[0.00012044952884396826, -4.403666137295798e-05, -4.402490059939584e-05], [-4.403666137295798e-05, 0.00012037593919233641, -4.3926210514548074e-05], [-4.402490059939584e-05, -4.3926210514548074e-05, 0.00012040610370999929]]} - #*EXTRAS*# Step: 1 Bead: 25 -{"friction": [[0.00012153653681983755, -4.362495949592709e-05, -4.359153976736546e-05], [-4.362495949592709e-05, 0.00012156286703430973, -4.362399569102738e-05], [-4.359153976736546e-05, -4.362399569102738e-05, 0.00012144980712419094]]} - #*EXTRAS*# Step: 2 Bead: 25 -{"friction": [[0.0001230023843048611, -4.287951327063969e-05, -4.262845271196275e-05], [-4.287951327063969e-05, 0.00012307156313931184, -4.296161280073764e-05], [-4.262845271196275e-05, -4.296161280073764e-05, 0.00012282721492859887]]} - #*EXTRAS*# Step: 3 Bead: 25 -{"friction": [[0.00012602369577714053, -4.034615929616824e-05, -3.9792156272290865e-05], [-4.034615929616824e-05, 0.00012609643562764048, -4.043744298933057e-05], [-3.9792156272290865e-05, -4.043744298933057e-05, 0.0001256975402721834]]} - #*EXTRAS*# Step: 4 Bead: 25 -{"friction": [[0.00013016662107639395, -3.487572542694021e-05, -3.46895518602407e-05], [-3.487572542694021e-05, 0.0001303676947248532, -3.4890396426973564e-05], [-3.46895518602407e-05, -3.4890396426973564e-05, 0.000129848568005846]]} - #*EXTRAS*# Step: 5 Bead: 25 -{"friction": [[0.0001322394569582092, -3.0598164498592625e-05, -3.0555118858507354e-05], [-3.0598164498592625e-05, 0.0001324868554692541, -3.055359256548341e-05], [-3.0555118858507354e-05, -3.055359256548341e-05, 0.0001320562214407449]]} - #*EXTRAS*# Step: 6 Bead: 25 -{"friction": [[0.00013321644297450768, -2.765605198415085e-05, -2.756889811727259e-05], [-2.765605198415085e-05, 0.0001334568840023085, -2.7577399272112362e-05], [-2.756889811727259e-05, -2.7577399272112362e-05, 0.00013316479560648034]]} - #*EXTRAS*# Step: 7 Bead: 25 -{"friction": [[0.00013361234079690477, -2.6192503130152418e-05, -2.6059612991407524e-05], [-2.6192503130152418e-05, 0.00013384186886587215, -2.609947540429443e-05], [-2.6059612991407524e-05, -2.609947540429443e-05, 0.0001336313432534449]]} - #*EXTRAS*# Step: 8 Bead: 25 -{"friction": [[0.0001338570523542825, -2.519345045794079e-05, -2.5024263702218505e-05], [-2.519345045794079e-05, 0.00013407717803182094, -2.5091670505977916e-05], [-2.5024263702218505e-05, -2.5091670505977916e-05, 0.00013392504878940623]]} - #*EXTRAS*# Step: 9 Bead: 25 -{"friction": [[0.00013399921338611034, -2.4577789811526045e-05, -2.4384932913257807e-05], [-2.4577789811526045e-05, 0.0001342129236687229, -2.4471057208106958e-05], [-2.4384932913257807e-05, -2.4471057208106958e-05, 0.0001340974862282814]]} - #*EXTRAS*# Step: 10 Bead: 25 -{"friction": [[0.00013408874595886063, -2.4176439392951697e-05, -2.396779636183741e-05], [-2.4176439392951697e-05, 0.00013429805938857637, -2.406666182960466e-05], [-2.396779636183741e-05, -2.406666182960466e-05, 0.00013420673672919246]]} - #*EXTRAS*# Step: 11 Bead: 25 -{"friction": [[0.0001341445873270174, -2.3920761071037604e-05, -2.3701958494061954e-05], [-2.3920761071037604e-05, 0.00013435102120982437, -2.3809119923672093e-05], [-2.3701958494061954e-05, -2.3809119923672093e-05, 0.0001342751183922475]]} - #*EXTRAS*# Step: 12 Bead: 25 -{"friction": [[0.00013418004849309693, -2.375626017091283e-05, -2.3530889599991965e-05], [-2.375626017091283e-05, 0.00013438459986888488, -2.3643451505679738e-05], [-2.3530889599991965e-05, -2.3643451505679738e-05, 0.0001343186359730924]]} - #*EXTRAS*# Step: 13 Bead: 25 -{"friction": [[0.00013420255821544136, -2.365097999729425e-05, -2.3421395803187722e-05], [-2.365097999729425e-05, 0.000134405893166766, -2.3537437100114013e-05], [-2.3421395803187722e-05, -2.3537437100114013e-05, 0.00013434629606047738]]} - #*EXTRAS*# Step: 14 Bead: 25 -{"friction": [[0.00013421691021698085, -2.3583506287114166e-05, -2.3351218164486548e-05], [-2.3583506287114166e-05, 0.00013441946095957042, -2.346949815762897e-05], [-2.3351218164486548e-05, -2.346949815762897e-05, 0.00013436394634996644]]} - #*EXTRAS*# Step: 15 Bead: 25 -{"friction": [[0.0001342260658730024, -2.354032100339811e-05, -2.3306301062616623e-05], [-2.354032100339811e-05, 0.00013442811285161477, -2.342601729999058e-05], [-2.3306301062616623e-05, -2.342601729999058e-05, 0.00013437521190632224]]} - #*EXTRAS*# Step: 16 Bead: 25 -{"friction": [[0.00013423191399738815, -2.351267905872793e-05, -2.3277550168717117e-05], [-2.351267905872793e-05, 0.0001344336377827095, -2.3398187062492438e-05], [-2.3277550168717117e-05, -2.3398187062492438e-05, 0.00013438241006312002]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_26 b/drivers/py/pes/friction/frictionH/060K/inst.raw_26 deleted file mode 100644 index 3d5d56cb7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_26 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 26 -{"friction": [[0.00011962164781834676, -4.428729526742142e-05, -4.422423780727485e-05], [-4.428729526742142e-05, 0.00011944812410604063, -4.4082117571065435e-05], [-4.422423780727485e-05, -4.4082117571065435e-05, 0.00011959886778569174]]} - #*EXTRAS*# Step: 1 Bead: 26 -{"friction": [[0.00012047581918875771, -4.402777868222472e-05, -4.4016928730177005e-05], [-4.402777868222472e-05, 0.00012040521060484018, -4.392029012564913e-05], [-4.4016928730177005e-05, -4.392029012564913e-05, 0.00012043159263550454]]} - #*EXTRAS*# Step: 2 Bead: 26 -{"friction": [[0.00012177105383005219, -4.352327908232164e-05, -4.346682783159071e-05], [-4.352327908232164e-05, 0.00012181087804981829, -4.354084631089246e-05], [-4.346682783159071e-05, -4.354084631089246e-05, 0.00012167199812647979]]} - #*EXTRAS*# Step: 3 Bead: 26 -{"friction": [[0.0001243839370599069, -4.188414373516916e-05, -4.140513822437185e-05], [-4.188414373516916e-05, 0.00012444486341466618, -4.1985732601397385e-05], [-4.140513822437185e-05, -4.1985732601397385e-05, 0.000124123607889392]]} - #*EXTRAS*# Step: 4 Bead: 26 -{"friction": [[0.0001285053984151157, -3.7384994647424015e-05, -3.701371310823259e-05], [-3.7384994647424015e-05, 0.0001286496425053405, -3.7436837407600435e-05], [-3.701371310823259e-05, -3.7436837407600435e-05, 0.00012815416822667874]]} - #*EXTRAS*# Step: 5 Bead: 26 -{"friction": [[0.00013115246117307954, -3.3071487635000564e-05, -3.298026587111625e-05], [-3.3071487635000564e-05, 0.00013138232921736616, -3.306010340155387e-05], [-3.298026587111625e-05, -3.306010340155387e-05, 0.0001308804536039917]]} - #*EXTRAS*# Step: 6 Bead: 26 -{"friction": [[0.00013245417768129836, -3.0021174353157708e-05, -2.9976367552237963e-05], [-3.0021174353157708e-05, 0.00013270219862420647, -2.9969411932142155e-05], [-2.9976367552237963e-05, -2.9969411932142155e-05, 0.00013229508539007955]]} - #*EXTRAS*# Step: 7 Bead: 26 -{"friction": [[0.00013297267741268454, -2.847189659807676e-05, -2.84047026966323e-05], [-2.847189659807676e-05, 0.0001332173466168814, -2.8402027839595697e-05], [-2.84047026966323e-05, -2.8402027839595697e-05, 0.00013288274046155922]]} - #*EXTRAS*# Step: 8 Bead: 26 -{"friction": [[0.00013328244370777945, -2.7424418924097923e-05, -2.7330786224643974e-05], [-2.7424418924097923e-05, 0.0001335214222906992, -2.73433711356701e-05], [-2.7330786224643974e-05, -2.73433711356701e-05, 0.0001332418373128221]]} - #*EXTRAS*# Step: 9 Bead: 26 -{"friction": [[0.0001334602352291442, -2.677627353424501e-05, -2.6662899631286075e-05], [-2.677627353424501e-05, 0.00013369457165078155, -2.668876195908431e-05], [-2.6662899631286075e-05, -2.668876195908431e-05, 0.00013345083275211219]]} - #*EXTRAS*# Step: 10 Bead: 26 -{"friction": [[0.0001335710630426156, -2.635367341754933e-05, -2.6226316065560635e-05], [-2.635367341754933e-05, 0.00013380197362180505, -2.626213931985757e-05], [-2.6226316065560635e-05, -2.626213931985757e-05, 0.0001335822008567369]]} - #*EXTRAS*# Step: 11 Bead: 26 -{"friction": [[0.00013363980964140873, -2.608409574216872e-05, -2.5947427277955544e-05], [-2.608409574216872e-05, 0.00013386838537225154, -2.5990076023978284e-05], [-2.5947427277955544e-05, -2.5990076023978284e-05, 0.00013366411012153662]]} - #*EXTRAS*# Step: 12 Bead: 26 -{"friction": [[0.00013368329310827035, -2.5910580684793436e-05, -2.5767775025209228e-05], [-2.5910580684793436e-05, 0.00013391030822681974, -2.5814994485704863e-05], [-2.5767775025209228e-05, -2.5814994485704863e-05, 0.0001337160853591214]]} - #*EXTRAS*# Step: 13 Bead: 26 -{"friction": [[0.00013371083066408774, -2.5799477984744106e-05, -2.5652687746447836e-05], [-2.5799477984744106e-05, 0.00013393682372613708, -2.5702902569321306e-05], [-2.5652687746447836e-05, -2.5702902569321306e-05, 0.00013374906697492502]]} - #*EXTRAS*# Step: 14 Bead: 26 -{"friction": [[0.00013372836053968066, -2.5728256735064985e-05, -2.5578890803771986e-05], [-2.5728256735064985e-05, 0.00013395368931745034, -2.563105288227006e-05], [-2.5578890803771986e-05, -2.563105288227006e-05, 0.000133770089134363]]} - #*EXTRAS*# Step: 15 Bead: 26 -{"friction": [[0.00013373953255663983, -2.5682664552630687e-05, -2.5531641301395925e-05], [-2.5682664552630687e-05, 0.0001339644324246853, -2.5585060744802952e-05], [-2.5531641301395925e-05, -2.5585060744802952e-05, 0.00013378349763865435]]} - #*EXTRAS*# Step: 16 Bead: 26 -{"friction": [[0.00013374666403789774, -2.5653479068278266e-05, -2.5501391491673066e-05], [-2.5653479068278266e-05, 0.00013397128785618215, -2.555562019172331e-05], [-2.5501391491673066e-05, -2.555562019172331e-05, 0.00013379206113878504]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_27 b/drivers/py/pes/friction/frictionH/060K/inst.raw_27 deleted file mode 100644 index 5c0aa4ee0..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_27 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 27 -{"friction": [[0.00011875913034376447, -4.4483228394450665e-05, -4.434026563858943e-05], [-4.4483228394450665e-05, 0.00011848148125785116, -4.418642315217651e-05], [-4.434026563858943e-05, -4.418642315217651e-05, 0.0001187506872749722]]} - #*EXTRAS*# Step: 1 Bead: 27 -{"friction": [[0.0001193275220035658, -4.436202299442392e-05, -4.4273362244287376e-05], [-4.436202299442392e-05, 0.00011911761394086419, -4.41240760750693e-05], [-4.4273362244287376e-05, -4.41240760750693e-05, 0.0001193102997694]]} - #*EXTRAS*# Step: 2 Bead: 27 -{"friction": [[0.00012042263519450914, -4.4045691087736736e-05, -4.4032942263030244e-05], [-4.4045691087736736e-05, 0.00012034597742111694, -4.3932201964317e-05], [-4.4032942263030244e-05, -4.3932201964317e-05, 0.00012038001933624408]]} - #*EXTRAS*# Step: 3 Bead: 27 -{"friction": [[0.00012287166322537234, -4.2958020423255444e-05, -4.273101607003128e-05], [-4.2958020423255444e-05, 0.00012294034332972038, -4.3035737746281895e-05], [-4.273101607003128e-05, -4.3035737746281895e-05, 0.00012270506554498572]]} - #*EXTRAS*# Step: 4 Bead: 27 -{"friction": [[0.0001266702653750837, -3.9649329739638723e-05, -3.912049138286094e-05], [-3.9649329739638723e-05, 0.00012675770652759537, -3.973249430986833e-05], [-3.912049138286094e-05, -3.973249430986833e-05, 0.00012632959313286818]]} - #*EXTRAS*# Step: 5 Bead: 27 -{"friction": [[0.0001297540192518111, -3.5550819920972944e-05, -3.531909652361076e-05], [-3.5550819920972944e-05, 0.00012994139187567997, -3.5575475367560756e-05], [-3.531909652361076e-05, -3.5575475367560756e-05, 0.0001294232526113186]]} - #*EXTRAS*# Step: 6 Bead: 27 -{"friction": [[0.00013145084672000625, -3.245582648126374e-05, -3.2386052648890345e-05], [-3.245582648126374e-05, 0.00013168755615978095, -3.2435860364011944e-05], [-3.2386052648890345e-05, -3.2435860364011944e-05, 0.00013119832637238836]]} - #*EXTRAS*# Step: 7 Bead: 27 -{"friction": [[0.00013214802975001623, -3.0833661117443215e-05, -3.079011525676546e-05], [-3.0833661117443215e-05, 0.00013239483996974153, -3.079208927121242e-05], [-3.079011525676546e-05, -3.079208927121242e-05, 0.00013195525079814788]]} - #*EXTRAS*# Step: 8 Bead: 27 -{"friction": [[0.00013255191159500539, -2.9746771378047567e-05, -2.9699752160237765e-05], [-2.9746771378047567e-05, 0.00013279984535930747, -2.969167173267517e-05], [-2.9699752160237765e-05, -2.969167173267517e-05, 0.0001324046456583253]]} - #*EXTRAS*# Step: 9 Bead: 27 -{"friction": [[0.0001327812832165919, -2.9071500556477113e-05, -2.9015674147429855e-05], [-2.9071500556477113e-05, 0.00013302804100731147, -2.900842397367403e-05], [-2.9015674147429855e-05, -2.900842397367403e-05, 0.0001326639401069571]]} - #*EXTRAS*# Step: 10 Bead: 27 -{"friction": [[0.0001329229349671334, -2.863105948971545e-05, -2.85671793538337e-05], [-2.863105948971545e-05, 0.0001331682479542353, -2.856296639104107e-05], [-2.85671793538337e-05, -2.856296639104107e-05, 0.00013282565528619647]]} - #*EXTRAS*# Step: 11 Bead: 27 -{"friction": [[0.00013301036686760452, -2.834969391147519e-05, -2.827981918301931e-05], [-2.834969391147519e-05, 0.00013325449988645698, -2.827847540403538e-05], [-2.827981918301931e-05, -2.827847540403538e-05, 0.00013292609816023526]]} - #*EXTRAS*# Step: 12 Bead: 27 -{"friction": [[0.00013306546620426234, -2.8168501687399698e-05, -2.8094442390994245e-05], [-2.8168501687399698e-05, 0.00013330873914765558, -2.809530376269825e-05], [-2.8094442390994245e-05, -2.809530376269825e-05, 0.0001329896482101425]]} - #*EXTRAS*# Step: 13 Bead: 27 -{"friction": [[0.00013310028417274334, -2.8052421655014122e-05, -2.7975554780925855e-05], [-2.8052421655014122e-05, 0.00013334296634619333, -2.797796945882417e-05], [-2.7975554780925855e-05, -2.797796945882417e-05, 0.0001330299076810414]]} - #*EXTRAS*# Step: 14 Bead: 27 -{"friction": [[0.0001331224157106281, -2.7977990557434884e-05, -2.7899273101919326e-05], [-2.7977990557434884e-05, 0.00013336470312359713, -2.7902739835777912e-05], [-2.7899273101919326e-05, -2.7902739835777912e-05, 0.00013305553914640892]]} - #*EXTRAS*# Step: 15 Bead: 27 -{"friction": [[0.0001331365075002417, -2.793033385755404e-05, -2.7850411303995947e-05], [-2.793033385755404e-05, 0.00013337853570907, -2.785457421237243e-05], [-2.7850411303995947e-05, -2.785457421237243e-05, 0.00013307187616588096]]} - #*EXTRAS*# Step: 16 Bead: 27 -{"friction": [[0.00013314549733315804, -2.789982329085089e-05, -2.7819121048130398e-05], [-2.789982329085089e-05, 0.0001333873569787371, -2.7823738792861484e-05], [-2.7819121048130398e-05, -2.7823738792861484e-05, 0.00013308230515647184]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_28 b/drivers/py/pes/friction/frictionH/060K/inst.raw_28 deleted file mode 100644 index bbccac632..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_28 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 28 -{"friction": [[0.00011787887860218989, -4.4603875439562205e-05, -4.437898686966099e-05], [-4.4603875439562205e-05, 0.00011751277754076018, -4.4235677964967273e-05], [-4.437898686966099e-05, -4.4235677964967273e-05, 0.00011788043866959533]]} - #*EXTRAS*# Step: 1 Bead: 28 -{"friction": [[0.00011813070470070375, -4.457834475821074e-05, -4.437540230734559e-05], [-4.457834475821074e-05, 0.00011778703080460533, -4.422741364903215e-05], [-4.437540230734559e-05, -4.422741364903215e-05, 0.00011812972976088878]]} - #*EXTRAS*# Step: 2 Bead: 28 -{"friction": [[0.00011894300132092769, -4.444749524652311e-05, -4.4322467903880206e-05], [-4.444749524652311e-05, 0.00011868668278726409, -4.416891074916062e-05], [-4.4322467903880206e-05, -4.416891074916062e-05, 0.00011893196649687474]]} - #*EXTRAS*# Step: 3 Bead: 28 -{"friction": [[0.00012132841601883246, -4.371089877270033e-05, -4.369251332339663e-05], [-4.371089877270033e-05, 0.00012134024783078066, -4.369179408863733e-05], [-4.369251332339663e-05, -4.369179408863733e-05, 0.00012125176394766864]]} - #*EXTRAS*# Step: 4 Bead: 28 -{"friction": [[0.0001248455065352969, -4.148650901814821e-05, -4.096076150309929e-05], [-4.148650901814821e-05, 0.00012490517198860806, -4.1587203346948567e-05], [-4.096076150309929e-05, -4.1587203346948567e-05, 0.00012456200080670756]]} - #*EXTRAS*# Step: 5 Bead: 28 -{"friction": [[0.00012810090271783315, -3.7923498463932324e-05, -3.751016979993151e-05], [-3.7923498463932324e-05, 0.0001282314412316355, -3.798317253830447e-05], [-3.751016979993151e-05, -3.798317253830447e-05, 0.0001277480888809426]]} - #*EXTRAS*# Step: 6 Bead: 28 -{"friction": [[0.00013014470900049582, -3.49126028318509e-05, -3.472406041183395e-05], [-3.49126028318509e-05, 0.00013034507140026593, -3.492781699614722e-05], [-3.472406041183395e-05, -3.492781699614722e-05, 0.0001298258951253752]]} - #*EXTRAS*# Step: 7 Bead: 28 -{"friction": [[0.00013106318014226658, -3.3248385372432774e-05, -3.314988027217958e-05], [-3.3248385372432774e-05, 0.000131290784649917, -3.323950040320252e-05], [-3.314988027217958e-05, -3.323950040320252e-05, 0.00013078591883416637]]} - #*EXTRAS*# Step: 8 Bead: 28 -{"friction": [[0.00013159884634417025, -3.213482090093772e-05, -3.2073707899698295e-05], [-3.213482090093772e-05, 0.00013183846151753234, -3.2110457560645584e-05], [-3.2073707899698295e-05, -3.2110457560645584e-05, 0.00013135721656993302]]} - #*EXTRAS*# Step: 9 Bead: 28 -{"friction": [[0.00013190196322288911, -3.143956191017395e-05, -3.139113694134558e-05], [-3.143956191017395e-05, 0.0001321462939139898, -3.1405874653996936e-05], [-3.139113694134558e-05, -3.1405874653996936e-05, 0.00013168556319627554]]} - #*EXTRAS*# Step: 10 Bead: 28 -{"friction": [[0.0001320877206626414, -3.098584672313091e-05, -3.094157508022235e-05], [-3.098584672313091e-05, 0.00013233404180755846, -3.094623313654997e-05], [-3.094157508022235e-05, -3.094623313654997e-05, 0.00013188887834846455]]} - #*EXTRAS*# Step: 11 Bead: 28 -{"friction": [[0.00013220192456721958, -3.069554922795803e-05, -3.0652386622206855e-05], [-3.069554922795803e-05, 0.0001324491042187683, -3.065221342677394e-05], [-3.0652386622206855e-05, -3.065221342677394e-05, 0.00013201471944518118]]} - #*EXTRAS*# Step: 12 Bead: 28 -{"friction": [[0.0001322736775728441, -3.050849591429529e-05, -3.046544844430937e-05], [-3.050849591429529e-05, 0.00013252124771713096, -3.046279145507286e-05], [-3.046544844430937e-05, -3.046279145507286e-05, 0.00013209412517286375]]} - #*EXTRAS*# Step: 13 Bead: 28 -{"friction": [[0.00013231893878343633, -3.0388591027140075e-05, -3.0345380591906997e-05], [-3.0388591027140075e-05, 0.0001325666944457183, -3.0341380721745423e-05], [-3.0345380591906997e-05, -3.0341380721745423e-05, 0.00013214435236303477]]} - #*EXTRAS*# Step: 14 Bead: 28 -{"friction": [[0.00013234767297370253, -3.0311684788507026e-05, -3.0268275124770536e-05], [-3.0311684788507026e-05, 0.00013259552156394153, -3.0263513850694503e-05], [-3.0268275124770536e-05, -3.0263513850694503e-05, 0.00013217629573733113]]} - #*EXTRAS*# Step: 15 Bead: 28 -{"friction": [[0.00013236595500697295, -3.0262432131024292e-05, -3.0218856688966543e-05], [-3.0262432131024292e-05, 0.00013261385256296487, -3.0213648134576503e-05], [-3.0218856688966543e-05, -3.0213648134576503e-05, 0.00013219664266735833]]} - #*EXTRAS*# Step: 16 Bead: 28 -{"friction": [[0.0001323776121296924, -3.023089572196217e-05, -3.0187198653826767e-05], [-3.023089572196217e-05, 0.0001326255367529502, -3.0181720072367504e-05], [-3.0187198653826767e-05, -3.0181720072367504e-05, 0.0001322096258448926]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_29 b/drivers/py/pes/friction/frictionH/060K/inst.raw_29 deleted file mode 100644 index 9b6fc6b6b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_29 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 29 -{"friction": [[0.0001169988017405095, -4.4628706812311107e-05, -4.434812841942771e-05], [-4.4628706812311107e-05, 0.00011658072617402499, -4.422718506529086e-05], [-4.434812841942771e-05, -4.422718506529086e-05, 0.00011700820795224204]]} - #*EXTRAS*# Step: 1 Bead: 29 -{"friction": [[0.00011692860364519255, -4.46259375021065e-05, -4.434289196062407e-05], [-4.46259375021065e-05, 0.00011650856832696371, -4.422393145283681e-05], [-4.434289196062407e-05, -4.422393145283681e-05, 0.00011693861572399676]]} - #*EXTRAS*# Step: 2 Bead: 29 -{"friction": [[0.00011741109028397437, -4.46302567917649e-05, -4.437074095211232e-05], [-4.46302567917649e-05, 0.00011701155113704522, -4.42385067268331e-05], [-4.437074095211232e-05, -4.42385067268331e-05, 0.00011741693477777579]]} - #*EXTRAS*# Step: 3 Bead: 29 -{"friction": [[0.00011958987907136912, -4.429574361634451e-05, -4.423005127666648e-05], [-4.429574361634451e-05, 0.00011941241292812724, -4.4086976099700915e-05], [-4.423005127666648e-05, -4.4086976099700915e-05, 0.00011956773791920831]]} - #*EXTRAS*# Step: 4 Bead: 29 -{"friction": [[0.0001231804793903084, -4.276826254224514e-05, -4.248423494921946e-05], [-4.276826254224514e-05, 0.00012324967530780533, -4.2855493764435625e-05], [-4.248423494921946e-05, -4.2855493764435625e-05, 0.0001229936287556039]]} - #*EXTRAS*# Step: 5 Bead: 29 -{"friction": [[0.00012631074897209233, -4.004293482285742e-05, -3.94973600091662e-05], [-4.004293482285742e-05, 0.0001263895163315975, -4.0130833179487585e-05], [-3.94973600091662e-05, -4.0130833179487585e-05, 0.00012597743155948622]]} - #*EXTRAS*# Step: 6 Bead: 29 -{"friction": [[0.00012857125803449962, -3.729497263484096e-05, -3.6930776004932744e-05], [-3.729497263484096e-05, 0.00012871776559630644, -3.734549430497054e-05], [-3.6930776004932744e-05, -3.734549430497054e-05, 0.00012822050510570942]]} - #*EXTRAS*# Step: 7 Bead: 29 -{"friction": [[0.0001296870560416613, -3.565674468209571e-05, -3.5417490532921645e-05], [-3.565674468209571e-05, 0.0001298721547498471, -3.5682972825625904e-05], [-3.5417490532921645e-05, -3.5682972825625904e-05, 0.00012935453273480406]]} - #*EXTRAS*# Step: 8 Bead: 29 -{"friction": [[0.00013035793578345487, -3.454847342907612e-05, -3.4382652575311744e-05], [-3.454847342907612e-05, 0.00013056512104841984, -3.45583389134542e-05], [-3.4382652575311744e-05, -3.45583389134542e-05, 0.00013004696109175518]]} - #*EXTRAS*# Step: 9 Bead: 29 -{"friction": [[0.00013074895196810835, -3.3847538320278155e-05, -3.3720891769966095e-05], [-3.3847538320278155e-05, 0.00013096794850799015, -3.384721749129757e-05], [-3.3720891769966095e-05, -3.384721749129757e-05, 0.00013045506714060666]]} - #*EXTRAS*# Step: 10 Bead: 29 -{"friction": [[0.0001309915798528324, -3.338802771436791e-05, -3.328343510278873e-05], [-3.338802771436791e-05, 0.00013121730654528223, -3.3381125461645546e-05], [-3.328343510278873e-05, -3.3381125461645546e-05, 0.00013071028172415318]]} - #*EXTRAS*# Step: 11 Bead: 29 -{"friction": [[0.00013114167698358492, -3.309302305732928e-05, -3.3000940588495514e-05], [-3.309302305732928e-05, 0.00013137127642437864, -3.308194232237275e-05], [-3.3000940588495514e-05, -3.308194232237275e-05, 0.00013086902150523936]]} - #*EXTRAS*# Step: 12 Bead: 29 -{"friction": [[0.0001312361934801847, -3.29026539689337e-05, -3.281792641748531e-05], [-3.29026539689337e-05, 0.00013146809969847564, -3.28888978679011e-05], [-3.281792641748531e-05, -3.28888978679011e-05, 0.00013096934492786113]]} - #*EXTRAS*# Step: 13 Bead: 29 -{"friction": [[0.00013129587871608286, -3.2780495148273824e-05, -3.2700181964125756e-05], [-3.2780495148273824e-05, 0.00013152918407720052, -3.276503138723642e-05], [-3.2700181964125756e-05, -3.276503138723642e-05, 0.00013103285050672828]]} - #*EXTRAS*# Step: 14 Bead: 29 -{"friction": [[0.00013133378456270414, -3.2702099911170686e-05, -3.262449171631374e-05], [-3.2702099911170686e-05, 0.00013156795399800637, -3.2685544119056665e-05], [-3.262449171631374e-05, -3.2685544119056665e-05, 0.00013107324657900575]]} - #*EXTRAS*# Step: 15 Bead: 29 -{"friction": [[0.0001313579064847583, -3.2651874856466496e-05, -3.257594651588804e-05], [-3.2651874856466496e-05, 0.00013159261549442453, -3.263462105099414e-05], [-3.257594651588804e-05, -3.263462105099414e-05, 0.00013109897967601683]]} - #*EXTRAS*# Step: 16 Bead: 29 -{"friction": [[0.00013137328823072003, -3.261970883460103e-05, -3.254483438683766e-05], [-3.261970883460103e-05, 0.00013160833702892388, -3.260200866362256e-05], [-3.254483438683766e-05, -3.260200866362256e-05, 0.00013111539973731335]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_30 b/drivers/py/pes/friction/frictionH/060K/inst.raw_30 deleted file mode 100644 index cb15179e1..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_30 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 30 -{"friction": [[0.00011613512964090057, -4.4542480960535e-05, -4.4255686347443705e-05], [-4.4542480960535e-05, 0.00011571790314066553, -4.415921694916118e-05], [-4.4255686347443705e-05, -4.415921694916118e-05, 0.00011615221676811073]]} - #*EXTRAS*# Step: 1 Bead: 30 -{"friction": [[0.00011575897154320233, -4.447060824352395e-05, -4.419592799146512e-05], [-4.447060824352395e-05, 0.00011535746416609618, -4.410997632419228e-05], [-4.419592799146512e-05, -4.410997632419228e-05, 0.00011577956674846523]]} - #*EXTRAS*# Step: 2 Bead: 30 -{"friction": [[0.00011591022236211386, -4.450192388528662e-05, -4.422140801901887e-05], [-4.450192388528662e-05, 0.00011550139345811448, -4.413125099549748e-05], [-4.422140801901887e-05, -4.413125099549748e-05, 0.00011592939462460905]]} - #*EXTRAS*# Step: 3 Bead: 30 -{"friction": [[0.00011772166257957501, -4.461588894119972e-05, -4.4378338351162186e-05], [-4.461588894119972e-05, 0.00011734303438162406, -4.4238456339390354e-05], [-4.4378338351162186e-05, -4.4238456339390354e-05, 0.00011772471239219435]]} - #*EXTRAS*# Step: 4 Bead: 30 -{"friction": [[0.0001215243377015859, -4.363010297646558e-05, -4.359770947492865e-05], [-4.363010297646558e-05, 0.00012154988450304211, -4.362811959777788e-05], [-4.359770947492865e-05, -4.362811959777788e-05, 0.00012143822186902066]]} - #*EXTRAS*# Step: 5 Bead: 30 -{"friction": [[0.00012456234417278531, -4.173403823322342e-05, -4.1234550432460786e-05], [-4.173403823322342e-05, 0.00012462241748754225, -4.183555942797928e-05], [-4.1234550432460786e-05, -4.183555942797928e-05, 0.00012429263525022885]]} - #*EXTRAS*# Step: 6 Bead: 30 -{"friction": [[0.00012682824825785758, -3.9471455772809754e-05, -3.8951878289022816e-05], [-3.9471455772809754e-05, 0.00012691984375003837, -3.955237825505439e-05], [-3.8951878289022816e-05, -3.955237825505439e-05, 0.00012648489811913755]]} - #*EXTRAS*# Step: 7 Bead: 30 -{"friction": [[0.00012807642286260374, -3.7955319539971494e-05, -3.753954005764631e-05], [-3.7955319539971494e-05, 0.00012820614544184922, -3.801545174554209e-05], [-3.753954005764631e-05, -3.801545174554209e-05, 0.00012772358621374394]]} - #*EXTRAS*# Step: 8 Bead: 30 -{"friction": [[0.000128852113824639, -3.690330587616891e-05, -3.6569892456550665e-05], [-3.690330587616891e-05, 0.00012900833620732593, -3.694805159710403e-05], [-3.6569892456550665e-05, -3.694805159710403e-05, 0.00012850410892393754]]} - #*EXTRAS*# Step: 9 Bead: 30 -{"friction": [[0.00012931721638910484, -3.6225124555209584e-05, -3.594401100915313e-05], [-3.6225124555209584e-05, 0.0001294895978219521, -3.625980344545412e-05], [-3.594401100915313e-05, -3.625980344545412e-05, 0.00012897641800064172]]} - #*EXTRAS*# Step: 10 Bead: 30 -{"friction": [[0.0001296105187152246, -3.577664703457526e-05, -3.5528757733220545e-05], [-3.577664703457526e-05, 0.0001297930055272022, -3.5804656652818016e-05], [-3.5528757733220545e-05, -3.5804656652818016e-05, 0.0001292760870351291]]} - #*EXTRAS*# Step: 11 Bead: 30 -{"friction": [[0.0001297941294827854, -3.5486906397888764e-05, -3.525968057820502e-05], [-3.5486906397888764e-05, 0.00012998285858892647, -3.551061350227416e-05], [-3.525968057820502e-05, -3.551061350227416e-05, 0.00012946445460721977]]} - #*EXTRAS*# Step: 12 Bead: 30 -{"friction": [[0.00012991060062556066, -3.5299286950114334e-05, -3.5085051823463605e-05], [-3.5299286950114334e-05, 0.000130103242139112, -3.5320213312376376e-05], [-3.5085051823463605e-05, -3.5320213312376376e-05, 0.00012958426746657558]]} - #*EXTRAS*# Step: 13 Bead: 30 -{"friction": [[0.0001299845171467507, -3.51786088826155e-05, -3.497255400665127e-05], [-3.51786088826155e-05, 0.00013017961878755135, -3.5197749539387014e-05], [-3.497255400665127e-05, -3.5197749539387014e-05, 0.00012966044008057504]]} - #*EXTRAS*# Step: 14 Bead: 30 -{"friction": [[0.00013003160918319376, -3.5101055090425746e-05, -3.4900181311631305e-05], [-3.5101055090425746e-05, 0.00013022826790833012, -3.511904952762073e-05], [-3.4900181311631305e-05, -3.511904952762073e-05, 0.00012970902559057826]]} - #*EXTRAS*# Step: 15 Bead: 30 -{"friction": [[0.00013006163887227976, -3.505132309967148e-05, -3.485373958505037e-05], [-3.505132309967148e-05, 0.00013025928608030045, -3.506858312037787e-05], [-3.485373958505037e-05, -3.506858312037787e-05, 0.00012974003080831178]]} - #*EXTRAS*# Step: 16 Bead: 30 -{"friction": [[0.0001300808129798318, -3.501945459538228e-05, -3.4823966058867656e-05], [-3.501945459538228e-05, 0.0001302790894584044, -3.503624425876368e-05], [-3.4823966058867656e-05, -3.503624425876368e-05, 0.00012975983733100308]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_31 b/drivers/py/pes/friction/frictionH/060K/inst.raw_31 deleted file mode 100644 index 718e44b5d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_31 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 31 -{"friction": [[0.00011529316548301044, -4.435439121512612e-05, -4.41050010482841e-05], [-4.435439121512612e-05, 0.00011492181793038626, -4.403170578939231e-05], [-4.41050010482841e-05, -4.403170578939231e-05, 0.00011531825069130156]]} - #*EXTRAS*# Step: 1 Bead: 31 -{"friction": [[0.00011463151720805868, -4.414077344111367e-05, -4.3942771043665696e-05], [-4.414077344111367e-05, 0.00011431917427686955, -4.388629439664982e-05], [-4.3942771043665696e-05, -4.388629439664982e-05, 0.00011466327320499583]]} - #*EXTRAS*# Step: 2 Bead: 31 -{"friction": [[0.00011447483125937992, -4.4082368427699694e-05, -4.3898541438228974e-05], [-4.4082368427699694e-05, 0.00011417857612750851, -4.384577650200786e-05], [-4.3898541438228974e-05, -4.384577650200786e-05, 0.00011450821969368034]]} - #*EXTRAS*# Step: 3 Bead: 31 -{"friction": [[0.00011587507685862038, -4.449493432711425e-05, -4.42156622996814e-05], [-4.449493432711425e-05, 0.00011546783275634489, -4.412648570925547e-05], [-4.42156622996814e-05, -4.412648570925547e-05, 0.00011589457826653105]]} - #*EXTRAS*# Step: 4 Bead: 31 -{"friction": [[0.00011965689825143423, -4.427781598137865e-05, -4.4217639448266493e-05], [-4.427781598137865e-05, 0.00011948774897856446, -4.407663287740825e-05], [-4.4217639448266493e-05, -4.407663287740825e-05, 0.00011963339775328734]]} - #*EXTRAS*# Step: 5 Bead: 31 -{"friction": [[0.0001229554558155162, -4.290800095914028e-05, -4.2665603166535156e-05], [-4.290800095914028e-05, 0.00012302450714339442, -4.298858879630991e-05], [-4.2665603166535156e-05, -4.298858879630991e-05, 0.00012278336601729254]]} - #*EXTRAS*# Step: 6 Bead: 31 -{"friction": [[0.00012507110543021115, -4.128155016028529e-05, -4.074075821614363e-05], [-4.128155016028529e-05, 0.00012513147234981362, -4.1381094907845826e-05], [-4.074075821614363e-05, -4.1381094907845826e-05, 0.0001247776269516911]]} - #*EXTRAS*# Step: 7 Bead: 31 -{"friction": [[0.00012634027613233793, -4.001118922605477e-05, -3.9466743184175846e-05], [-4.001118922605477e-05, 0.00012641971134178854, -4.0098718898431264e-05], [-3.9466743184175846e-05, -4.0098718898431264e-05, 0.0001260062877419076]]} - #*EXTRAS*# Step: 8 Bead: 31 -{"friction": [[0.00012716558596881212, -3.908142566512955e-05, -3.858500669211196e-05], [-3.908142566512955e-05, 0.00012726665108535372, -3.9157250910330746e-05], [-3.858500669211196e-05, -3.9157250910330746e-05, 0.0001268176315619704]]} - #*EXTRAS*# Step: 9 Bead: 31 -{"friction": [[0.00012767631510709806, -3.846357708898833e-05, -3.800961412246017e-05], [-3.846357708898833e-05, 0.0001277929940122162, -3.8530933687846757e-05], [-3.800961412246017e-05, -3.8530933687846757e-05, 0.00012732425870932407]]} - #*EXTRAS*# Step: 10 Bead: 31 -{"friction": [[0.00012800391826177265, -3.804906838500175e-05, -3.762610171551901e-05], [-3.804906838500175e-05, 0.00012813123508466592, -3.8110546720814236e-05], [-3.762610171551901e-05, -3.8110546720814236e-05, 0.00012765106216773518]]} - #*EXTRAS*# Step: 11 Bead: 31 -{"friction": [[0.0001282114584348212, -3.77787156630745e-05, -3.737659971522195e-05], [-3.77787156630745e-05, 0.00012834570335929835, -3.7836298038622585e-05], [-3.737659971522195e-05, -3.7836298038622585e-05, 0.0001278588504093753]]} - #*EXTRAS*# Step: 12 Bead: 31 -{"friction": [[0.0001283440561839969, -3.7602711120388415e-05, -3.721433362718197e-05], [-3.7602711120388415e-05, 0.00012848278842791851, -3.765773618481378e-05], [-3.721433362718197e-05, -3.765773618481378e-05, 0.00012799191893070935]]} - #*EXTRAS*# Step: 13 Bead: 31 -{"friction": [[0.00012842861116504027, -3.748910620892902e-05, -3.710963978946907e-05], [-3.748910620892902e-05, 0.00012857022565674613, -3.75424731287441e-05], [-3.710963978946907e-05, -3.75424731287441e-05, 0.0001280769031312665]]} - #*EXTRAS*# Step: 14 Bead: 31 -{"friction": [[0.00012848264215968805, -3.74159430875871e-05, -3.7042227168662206e-05], [-3.74159430875871e-05, 0.0001286261058405799, -3.746823935370866e-05], [-3.7042227168662206e-05, -3.746823935370866e-05, 0.00012813126157022088]]} - #*EXTRAS*# Step: 15 Bead: 31 -{"friction": [[0.0001285171639429838, -3.736896215164047e-05, -3.699894204757306e-05], [-3.736896215164047e-05, 0.0001286618118733782, -3.7420569840319866e-05], [-3.699894204757306e-05, -3.7420569840319866e-05, 0.00012816601443000185]]} - #*EXTRAS*# Step: 16 Bead: 31 -{"friction": [[0.00012853923347178381, -3.7338830749452425e-05, -3.697118186700052e-05], [-3.7338830749452425e-05, 0.0001286846395383567, -3.738999639779636e-05], [-3.697118186700052e-05, -3.738999639779636e-05, 0.00012818824065970237]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_32 b/drivers/py/pes/friction/frictionH/060K/inst.raw_32 deleted file mode 100644 index be35432fd..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_32 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 32 -{"friction": [[0.00011447442737646712, -4.4082214189905e-05, -4.389842451436581e-05], [-4.4082214189905e-05, 0.00011417821453784439, -4.384566898769395e-05], [-4.389842451436581e-05, -4.384566898769395e-05, 0.0001145078200454766]]} - #*EXTRAS*# Step: 1 Bead: 32 -{"friction": [[0.0001135481329710347, -4.368209209846083e-05, -4.3590141079231984e-05], [-4.368209209846083e-05, 0.00011335577591735126, -4.355637430108674e-05], [-4.3590141079231984e-05, -4.355637430108674e-05, 0.00011359161488625723]]} - #*EXTRAS*# Step: 2 Bead: 32 -{"friction": [[0.00011310710831811503, -4.3462412800855617e-05, -4.341459224960964e-05], [-4.3462412800855617e-05, 0.00011296494931577472, -4.338762039848684e-05], [-4.341459224960964e-05, -4.338762039848684e-05, 0.00011315567132622761]]} - #*EXTRAS*# Step: 3 Bead: 32 -{"friction": [[0.000114122877153058, -4.394099795227437e-05, -4.379091941852661e-05], [-4.394099795227437e-05, 0.00011386480169547532, -4.374601601157903e-05], [-4.379091941852661e-05, -4.374601601157903e-05, 0.00011416000910337057]]} - #*EXTRAS*# Step: 4 Bead: 32 -{"friction": [[0.00011763200489681337, -4.4621337869212946e-05, -4.4376997346763915e-05], [-4.4621337869212946e-05, 0.00011724679282003752, -4.423921571673185e-05], [-4.4376997346763915e-05, -4.423921571673185e-05, 0.0001176358788214876]]} - #*EXTRAS*# Step: 5 Bead: 32 -{"friction": [[0.00012132082880657961, -4.3713962128213234e-05, -4.369602309317331e-05], [-4.3713962128213234e-05, 0.00012133208615046775, -4.369416631119117e-05], [-4.369602309317331e-05, -4.369416631119117e-05, 0.00012124452785204513]]} - #*EXTRAS*# Step: 6 Bead: 32 -{"friction": [[0.00012345437106952876, -4.258732409351493e-05, -4.225319488811502e-05], [-4.258732409351493e-05, 0.0001235224450277167, -4.268069432189849e-05], [-4.225319488811502e-05, -4.268069432189849e-05, 0.00012324971993130806]]} - #*EXTRAS*# Step: 7 Bead: 32 -{"friction": [[0.00012464170503096077, -4.166579265106377e-05, -4.115814801075808e-05], [-4.166579265106377e-05, 0.00012470153560971867, -4.1767163340740546e-05], [-4.115814801075808e-05, -4.1767163340740546e-05, 0.00012436799060681683]]} - #*EXTRAS*# Step: 8 Bead: 32 -{"friction": [[0.0001254342205043844, -4.093804231702306e-05, -4.0383586714178126e-05], [-4.093804231702306e-05, 0.0001254976939228206, -4.103503425936176e-05], [-4.0383586714178126e-05, -4.103503425936176e-05, 0.00012512657507825578]]} - #*EXTRAS*# Step: 9 Bead: 32 -{"friction": [[0.0001259455844456809, -4.042697800963286e-05, -3.987153358714144e-05], [-4.042697800963286e-05, 0.0001260168405360671, -4.0519118008059904e-05], [-3.987153358714144e-05, -4.0519118008059904e-05, 0.00012562158184563062]]} - #*EXTRAS*# Step: 10 Bead: 32 -{"friction": [[0.00012628087356355476, -4.007494935818084e-05, -3.952828010700978e-05], [-4.007494935818084e-05, 0.00012635897387442273, -4.016321695775363e-05], [-3.952828010700978e-05, -4.016321695775363e-05, 0.00012594824739011338]]} - #*EXTRAS*# Step: 11 Bead: 32 -{"friction": [[0.00012649635739398886, -3.9841656459958326e-05, -3.930392839382861e-05], [-3.9841656459958326e-05, 0.0001265794593085403, -3.9927176587710945e-05], [-3.930392839382861e-05, -3.9927176587710945e-05, 0.00012615902224894456]]} - #*EXTRAS*# Step: 12 Bead: 32 -{"friction": [[0.00012663520501424768, -3.968839562929149e-05, -3.915765155976088e-05], [-3.968839562929149e-05, 0.00012672175094876083, -3.9772044725396426e-05], [-3.915765155976088e-05, -3.9772044725396426e-05, 0.00012629517256622174]]} - #*EXTRAS*# Step: 13 Bead: 32 -{"friction": [[0.00012672423711283668, -3.9588902280104446e-05, -3.906310552137704e-05], [-3.9588902280104446e-05, 0.00012681307569836883, -3.9671311633625135e-05], [-3.906310552137704e-05, -3.9671311633625135e-05, 0.00012638261234831555]]} - #*EXTRAS*# Step: 14 Bead: 32 -{"friction": [[0.0001267813244081198, -3.95246033561947e-05, -3.900216284258119e-05], [-3.95246033561947e-05, 0.00012687166594302024, -3.9606201714604153e-05], [-3.900216284258119e-05, -3.9606201714604153e-05, 0.00012643873472045246]]} - #*EXTRAS*# Step: 15 Bead: 32 -{"friction": [[0.00012681787984912844, -3.948322242945563e-05, -3.896300434769971e-05], [-3.948322242945563e-05, 0.00012690919684545048, -3.9564294969396635e-05], [-3.896300434769971e-05, -3.9564294969396635e-05, 0.00012647469520752735]]} - #*EXTRAS*# Step: 16 Bead: 32 -{"friction": [[0.00012684128214441426, -3.945664561631158e-05, -3.8937879768652084e-05], [-3.945664561631158e-05, 0.00012693322885614164, -3.953737889211204e-05], [-3.8937879768652084e-05, -3.953737889211204e-05, 0.00012649772600037464]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_33 b/drivers/py/pes/friction/frictionH/060K/inst.raw_33 deleted file mode 100644 index 2ebef6afb..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_33 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 33 -{"friction": [[0.00011368019507082692, -4.37444711227787e-05, -4.363905558610621e-05], [-4.37444711227787e-05, 0.00011347259446525294, -4.36029403928641e-05], [-4.363905558610621e-05, -4.36029403928641e-05, 0.00011372219122617184]]} - #*EXTRAS*# Step: 1 Bead: 33 -{"friction": [[0.00011250999590699124, -4.314056579971767e-05, -4.314652498694465e-05], [-4.314056579971767e-05, 0.00011243006840844326, -4.312577384337824e-05], [-4.314652498694465e-05, -4.312577384337824e-05, 0.00011256574239802139]]} - #*EXTRAS*# Step: 2 Bead: 33 -{"friction": [[0.00011180733729136013, -4.273377403576957e-05, -4.2785381163104834e-05], [-4.273377403576957e-05, 0.00011178319237034686, -4.276670656431742e-05], [-4.2785381163104834e-05, -4.276670656431742e-05, 0.00011187195283205704]]} - #*EXTRAS*# Step: 3 Bead: 33 -{"friction": [[0.00011246767724056307, -4.311683723856096e-05, -4.3126181821144566e-05], [-4.311683723856096e-05, 0.00011239174134843541, -4.310572436716789e-05], [-4.3126181821144566e-05, -4.310572436716789e-05, 0.0001125239465761736]]} - #*EXTRAS*# Step: 4 Bead: 33 -{"friction": [[0.00011563858439807311, -4.4443402084246115e-05, -4.417423903404308e-05], [-4.4443402084246115e-05, 0.00011524381102366677, -4.409160553321496e-05], [-4.417423903404308e-05, -4.409160553321496e-05, 0.0001156603242930442]]} - #*EXTRAS*# Step: 5 Bead: 33 -{"friction": [[0.00011946692659731267, -4.432758660009099e-05, -4.42513794292664e-05], [-4.432758660009099e-05, 0.00011927421871130171, -4.4105030710393476e-05], [-4.42513794292664e-05, -4.4105030710393476e-05, 0.00011944716789083494]]} - #*EXTRAS*# Step: 6 Bead: 33 -{"friction": [[0.00012187677750786733, -4.347558343989079e-05, -4.340681129822877e-05], [-4.347558343989079e-05, 0.0001219217365920531, -4.350083732150723e-05], [-4.340681129822877e-05, -4.350083732150723e-05, 0.00012177185844485186]]} - #*EXTRAS*# Step: 7 Bead: 33 -{"friction": [[0.0001230810459790566, -4.283099131845855e-05, -4.2565373405784324e-05], [-4.283099131845855e-05, 0.0001231503188052962, -4.291547378564208e-05], [-4.2565373405784324e-05, -4.291547378564208e-05, 0.00012290071368178295]]} - #*EXTRAS*# Step: 8 Bead: 33 -{"friction": [[0.00012382236120977243, -4.2325251150378305e-05, -4.192756636132019e-05], [-4.2325251150378305e-05, 0.0001238876456558462, -4.2423920118493763e-05], [-4.192756636132019e-05, -4.2423920118493763e-05, 0.00012359453909308263]]} - #*EXTRAS*# Step: 9 Bead: 33 -{"friction": [[0.00012429227246151125, -4.195944325882244e-05, -4.149205889134215e-05], [-4.195944325882244e-05, 0.00012435377655076044, -4.206090425235662e-05], [-4.149205889134215e-05, -4.206090425235662e-05, 0.0001240369553433752]]} - #*EXTRAS*# Step: 10 Bead: 33 -{"friction": [[0.00012460200630023667, -4.170004298802925e-05, -4.1196403098802266e-05], [-4.170004298802925e-05, 0.00012466194680187353, -4.180149757641221e-05], [-4.1196403098802266e-05, -4.180149757641221e-05, 0.00012433028237054635]]} - #*EXTRAS*# Step: 11 Bead: 33 -{"friction": [[0.0001248033194611425, -4.1524088093217905e-05, -4.100174360125632e-05], [-4.1524088093217905e-05, 0.00012486296083457198, -4.162495372004358e-05], [-4.100174360125632e-05, -4.162495372004358e-05, 0.00012452178075950362]]} - #*EXTRAS*# Step: 12 Bead: 33 -{"friction": [[0.00012493425339288547, -4.140667760092328e-05, -4.0874373199493426e-05], [-4.140667760092328e-05, 0.00012499407669519099, -4.1506964136666044e-05], [-4.0874373199493426e-05, -4.1506964136666044e-05, 0.00012464671397942732]]} - #*EXTRAS*# Step: 13 Bead: 33 -{"friction": [[0.0001250188150401115, -4.132964666756911e-05, -4.079186563491397e-05], [-4.132964666756911e-05, 0.00012507893060230107, -4.1429490031334466e-05], [-4.079186563491397e-05, -4.1429490031334466e-05, 0.00012472756551744625]]} - #*EXTRAS*# Step: 14 Bead: 33 -{"friction": [[0.00012507329546785498, -4.1279528115967715e-05, -4.0738616190250885e-05], [-4.1279528115967715e-05, 0.0001251336740674384, -4.137905995765245e-05], [-4.0738616190250885e-05, -4.137905995765245e-05, 0.00012477972471041027]]} - #*EXTRAS*# Step: 15 Bead: 33 -{"friction": [[0.0001251082887021211, -4.1247136041264354e-05, -4.070437264215512e-05], [-4.1247136041264354e-05, 0.00012516886627938364, -4.134645737331276e-05], [-4.070437264215512e-05, -4.134645737331276e-05, 0.000124813255088454]]} - #*EXTRAS*# Step: 16 Bead: 33 -{"friction": [[0.00012513073411634388, -4.122627697552909e-05, -4.0682390309088815e-05], [-4.122627697552909e-05, 0.00012519145141838984, -4.13254590643392e-05], [-4.0682390309088815e-05, -4.13254590643392e-05, 0.00012483477362925055]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_34 b/drivers/py/pes/friction/frictionH/060K/inst.raw_34 deleted file mode 100644 index 331ad34ec..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_34 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 34 -{"friction": [[0.0001129115705507499, -4.335986330177095e-05, -4.33306885948054e-05], [-4.335986330177095e-05, 0.00011279080035366944, -4.3306160132593466e-05], [-4.33306885948054e-05, -4.3306160132593466e-05, 0.00011296244664467974]]} - #*EXTRAS*# Step: 1 Bead: 34 -{"friction": [[0.00011151765722836434, -4.2558407210384785e-05, -4.262200855089147e-05], [-4.2558407210384785e-05, 0.00011150975006612961, -4.2602649141142284e-05], [-4.262200855089147e-05, -4.2602649141142284e-05, 0.00011158582895218405]]} - #*EXTRAS*# Step: 2 Bead: 34 -{"friction": [[0.00011057367820025296, -4.19532183999747e-05, -4.203170760985738e-05], [-4.19532183999747e-05, 0.00011059517146040529, -4.200708393066487e-05], [-4.203170760985738e-05, -4.200708393066487e-05, 0.00011065024944335155]]} - #*EXTRAS*# Step: 3 Bead: 34 -{"friction": [[0.00011090694041565945, -4.2173023685135434e-05, -4.2250135662324524e-05], [-4.2173023685135434e-05, 0.00011092177597184436, -4.22276123837225e-05], [-4.2250135662324524e-05, -4.22276123837225e-05, 0.00011098134801952008]]} - #*EXTRAS*# Step: 4 Bead: 34 -{"friction": [[0.0001137573229235061, -4.378012991267756e-05, -4.3666851465123504e-05], [-4.378012991267756e-05, 0.00011354082947833922, -4.362930354461434e-05], [-4.3666851465123504e-05, -4.362930354461434e-05, 0.00011379845881205776]]} - #*EXTRAS*# Step: 5 Bead: 34 -{"friction": [[0.00011747661529656782, -4.462829330640185e-05, -4.4373030517934144e-05], [-4.462829330640185e-05, 0.00011708103171046958, -4.4239101948357973e-05], [-4.4373030517934144e-05, -4.4239101948357973e-05, 0.00011748188273735256]]} - #*EXTRAS*# Step: 6 Bead: 34 -{"friction": [[0.00012012772056300088, -4.4140886006680425e-05, -4.4113885223341186e-05], [-4.4140886006680425e-05, 0.00012001637274922009, -4.399370120722718e-05], [-4.4113885223341186e-05, -4.399370120722718e-05, 0.00012009331831320232]]} - #*EXTRAS*# Step: 7 Bead: 34 -{"friction": [[0.00012151123637534083, -4.363561158622147e-05, -4.36043005589357e-05], [-4.363561158622147e-05, 0.00012153593270085727, -4.3632527131394604e-05], [-4.36043005589357e-05, -4.3632527131394604e-05, 0.00012142577667267012]]} - #*EXTRAS*# Step: 8 Bead: 34 -{"friction": [[0.00012229132670658885, -4.327600323560484e-05, -4.3149015218213066e-05], [-4.327600323560484e-05, 0.00012235114744084229, -4.332740801574163e-05], [-4.3149015218213066e-05, -4.332740801574163e-05, 0.00012216187039123941]]} - #*EXTRAS*# Step: 9 Bead: 34 -{"friction": [[0.00012276004715921409, -4.3022985463058543e-05, -4.281626075376298e-05], [-4.3022985463058543e-05, 0.00012282792233844674, -4.309652936091371e-05], [-4.281626075376298e-05, -4.309652936091371e-05, 0.0001226007392740291]]} - #*EXTRAS*# Step: 10 Bead: 34 -{"friction": [[0.00012305904209468547, -4.284466196848289e-05, -4.258311892441312e-05], [-4.284466196848289e-05, 0.0001231283031273061, -4.292849668354219e-05], [-4.258311892441312e-05, -4.292849668354219e-05, 0.00012288015381646666]]} - #*EXTRAS*# Step: 11 Bead: 34 -{"friction": [[0.0001232498499550907, -4.2723570118396216e-05, -4.24267349452701e-05], [-4.2723570118396216e-05, 0.00012331887659546085, -4.2812550265495797e-05], [-4.24267349452701e-05, -4.2812550265495797e-05, 0.00012305846387599735]]} - #*EXTRAS*# Step: 12 Bead: 34 -{"friction": [[0.00012337254242579955, -4.2642641728854974e-05, -4.232332378266544e-05], [-4.2642641728854974e-05, 0.00012344106971552362, -4.273438891280345e-05], [-4.232332378266544e-05, -4.273438891280345e-05, 0.00012317317514245555]]} - #*EXTRAS*# Step: 13 Bead: 34 -{"friction": [[0.00012345124249542804, -4.258945886757766e-05, -4.225589257642031e-05], [-4.258945886757766e-05, 0.0001235193353223871, -4.268277021145665e-05], [-4.225589257642031e-05, -4.268277021145665e-05, 0.00012324679268980733]]} - #*EXTRAS*# Step: 14 Bead: 34 -{"friction": [[0.00012350173427886193, -4.255481348501487e-05, -4.221219917081433e-05], [-4.255481348501487e-05, 0.0001235695091029036, -4.264904502213783e-05], [-4.221219917081433e-05, -4.264904502213783e-05, 0.00012329404252320282]]} - #*EXTRAS*# Step: 15 Bead: 34 -{"friction": [[0.0001235340874641743, -4.253239833781201e-05, -4.2184030430361255e-05], [-4.253239833781201e-05, 0.00012360164440453886, -4.262718617259746e-05], [-4.2184030430361255e-05, -4.262718617259746e-05, 0.00012332432707631264]]} - #*EXTRAS*# Step: 16 Bead: 34 -{"friction": [[0.00012355480932809174, -4.25179531645733e-05, -4.21659196807797e-05], [-4.25179531645733e-05, 0.000123622221447886, -4.261308386919763e-05], [-4.21659196807797e-05, -4.261308386919763e-05, 0.00012334372780919368]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_35 b/drivers/py/pes/friction/frictionH/060K/inst.raw_35 deleted file mode 100644 index b441dfea4..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_35 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 35 -{"friction": [[0.00011216920631531552, -4.2946540772708485e-05, -4.2977592964064865e-05], [-4.2946540772708485e-05, 0.00011211926994815254, -4.2958595375337326e-05], [-4.2977592964064865e-05, -4.2958595375337326e-05, 0.0001122292163872923]]} - #*EXTRAS*# Step: 1 Bead: 35 -{"friction": [[0.00011057015670993158, -4.195085838223167e-05, -4.2029341823790465e-05], [-4.195085838223167e-05, 0.00011059170115053509, -4.200469638245758e-05], [-4.2029341823790465e-05, -4.200469638245758e-05, 0.00011064674459340928]]} - #*EXTRAS*# Step: 2 Bead: 35 -{"friction": [[0.00010940174233347514, -4.1121836384169986e-05, -4.117952266456567e-05], [-4.1121836384169986e-05, 0.00010942316879269038, -4.115174410249787e-05], [-4.117952266456567e-05, -4.115174410249787e-05, 0.00010947368459920659]]} - #*EXTRAS*# Step: 3 Bead: 35 -{"friction": [[0.00010943261189348166, -4.1144971472545974e-05, -4.1203597447430455e-05], [-4.1144971472545974e-05, 0.00010945437690505304, -4.117572459510217e-05], [-4.1203597447430455e-05, -4.117572459510217e-05, 0.00010950499715983993]]} - #*EXTRAS*# Step: 4 Bead: 35 -{"friction": [[0.00011198949914361116, -4.2841732516888345e-05, -4.2883791527133844e-05], [-4.2841732516888345e-05, 0.00011195316403229059, -4.28651398578202e-05], [-4.2883791527133844e-05, -4.28651398578202e-05, 0.00011205180007307474]]} - #*EXTRAS*# Step: 5 Bead: 35 -{"friction": [[0.0001155276566558337, -4.441657053733629e-05, -4.4153141526675066e-05], [-4.441657053733629e-05, 0.00011513976467012645, -4.407353880981911e-05], [-4.4153141526675066e-05, -4.407353880981911e-05, 0.00011555046093054683]]} - #*EXTRAS*# Step: 6 Bead: 35 -{"friction": [[0.00011819023895948003, -4.457121541182645e-05, -4.437370388154715e-05], [-4.457121541182645e-05, 0.00011785225155725546, -4.42247765925165e-05], [-4.437370388154715e-05, -4.42247765925165e-05, 0.00011818863281198347]]} - #*EXTRAS*# Step: 7 Bead: 35 -{"friction": [[0.00011974345853640291, -4.425407360770912e-05, -4.420076853583592e-05], [-4.425407360770912e-05, 0.00011958504311819264, -4.4062743986205514e-05], [-4.420076853583592e-05, -4.4062743986205514e-05, 0.00011971813588623074]]} - #*EXTRAS*# Step: 8 Bead: 35 -{"friction": [[0.00012064584181719867, -4.396901917772264e-05, -4.396266857166995e-05], [-4.396901917772264e-05, 0.0001205940314855708, -4.388046600168675e-05], [-4.396266857166995e-05, -4.388046600168675e-05, 0.00012059617737953079]]} - #*EXTRAS*# Step: 9 Bead: 35 -{"friction": [[0.00012117751436886447, -4.377097553710874e-05, -4.376007474097051e-05], [-4.377097553710874e-05, 0.00012117730549984323, -4.373773611637462e-05], [-4.376007474097051e-05, -4.373773611637462e-05, 0.00012110762184072035]]} - #*EXTRAS*# Step: 10 Bead: 35 -{"friction": [[0.0001215056424442684, -4.363795883451625e-05, -4.360710377107234e-05], [-4.363795883451625e-05, 0.00012152997275455754, -4.363440232577509e-05], [-4.360710377107234e-05, -4.363440232577509e-05, 0.00012142046189954146]]} - #*EXTRAS*# Step: 11 Bead: 35 -{"friction": [[0.00012171035539513513, -4.355012504158419e-05, -4.350021993485647e-05], [-4.355012504158419e-05, 0.00012174696898121557, -4.356309151738122e-05], [-4.350021993485647e-05, -4.356309151738122e-05, 0.00012161458272492721]]} - #*EXTRAS*# Step: 12 Bead: 35 -{"friction": [[0.00012184004545863179, -4.3492292262526974e-05, -4.342792987121958e-05], [-4.3492292262526974e-05, 0.00012188328561718875, -4.351492262576895e-05], [-4.342792987121958e-05, -4.351492262576895e-05, 0.00012173718385259607]]} - #*EXTRAS*# Step: 13 Bead: 35 -{"friction": [[0.00012192246399986323, -4.345459171550446e-05, -4.338014903407884e-05], [-4.345459171550446e-05, 0.00012196946573816056, -4.348303873047144e-05], [-4.338014903407884e-05, -4.348303873047144e-05, 0.00012181495673390722]]} - #*EXTRAS*# Step: 14 Bead: 35 -{"friction": [[0.00012197502472240629, -4.343014781409978e-05, -4.334893410736218e-05], [-4.343014781409978e-05, 0.00012202424760156631, -4.3462172590748284e-05], [-4.334893410736218e-05, -4.3462172590748284e-05, 0.00012186450107519755]]} - #*EXTRAS*# Step: 15 Bead: 35 -{"friction": [[0.00012200857595084499, -4.341437687488957e-05, -4.3328706885318586e-05], [-4.341437687488957e-05, 0.00012205914561195342, -4.344863191286281e-05], [-4.3328706885318586e-05, -4.344863191286281e-05, 0.00012189610588990062]]} - #*EXTRAS*# Step: 16 Bead: 35 -{"friction": [[0.00012203001278518469, -4.34042309055869e-05, -4.331566039141969e-05], [-4.34042309055869e-05, 0.00012208141432096457, -4.343988910834879e-05], [-4.331566039141969e-05, -4.343988910834879e-05, 0.00012191629079825389]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_36 b/drivers/py/pes/friction/frictionH/060K/inst.raw_36 deleted file mode 100644 index ad81b03e5..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_36 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 36 -{"friction": [[0.00011145322627121049, -4.2518769308164815e-05, -4.2584527045753256e-05], [-4.2518769308164815e-05, 0.00011144842873098494, -4.2564924963892915e-05], [-4.2584527045753256e-05, -4.2564924963892915e-05, 0.00011152215281971272]]} - #*EXTRAS*# Step: 1 Bead: 36 -{"friction": [[0.00010966559906378145, -4.131735318725655e-05, -4.138252285472593e-05], [-4.131735318725655e-05, 0.00010968947931368976, -4.135435050689565e-05], [-4.138252285472593e-05, -4.135435050689565e-05, 0.00010974068343260462]]} - #*EXTRAS*# Step: 2 Bead: 36 -{"friction": [[0.00010828689339154656, -4.0237840940055385e-05, -4.0254733125379006e-05], [-4.0237840940055385e-05, 0.00010829190381642513, -4.024227503398736e-05], [-4.0254733125379006e-05, -4.024227503398736e-05, 0.00010832673557097196]]} - #*EXTRAS*# Step: 3 Bead: 36 -{"friction": [[0.00010803472732303432, -4.0024257852909585e-05, -4.0031359426412444e-05], [-4.0024257852909585e-05, 0.00010803629384306061, -4.0026513221606095e-05], [-4.0031359426412444e-05, -4.0026513221606095e-05, 0.00010806221753441469]]} - #*EXTRAS*# Step: 4 Bead: 36 -{"friction": [[0.00011032997078026068, -4.178799936757539e-05, -4.186515869311822e-05], [-4.178799936757539e-05, 0.00011035413948864857, -4.183910767221489e-05], [-4.186515869311822e-05, -4.183910767221489e-05, 0.00011040733855906848]]} - #*EXTRAS*# Step: 5 Bead: 36 -{"friction": [[0.00011368826567761034, -4.374822944955434e-05, -4.364199072506649e-05], [-4.374822944955434e-05, 0.00011347973379239564, -4.3605727684323016e-05], [-4.364199072506649e-05, -4.3605727684323016e-05, 0.00011373017155881563]]} - #*EXTRAS*# Step: 6 Bead: 36 -{"friction": [[0.00011623555482830233, -4.455823131113455e-05, -4.4269610476642605e-05], [-4.455823131113455e-05, 0.00011581559190113467, -4.417030549148699e-05], [-4.4269610476642605e-05, -4.417030549148699e-05, 0.00011625172257426339]]} - #*EXTRAS*# Step: 7 Bead: 36 -{"friction": [[0.00011782271837924666, -4.460852121293309e-05, -4.437900630789932e-05], [-4.460852121293309e-05, 0.000117452004036985, -4.4236881368582285e-05], [-4.437900630789932e-05, -4.4236881368582285e-05, 0.00011782481777479668]]} - #*EXTRAS*# Step: 8 Bead: 36 -{"friction": [[0.00011879298485089414, -4.447690680741198e-05, -4.433725491481219e-05], [-4.447690680741198e-05, 0.00011851920941980702, -4.418338766201658e-05], [-4.433725491481219e-05, -4.418338766201658e-05, 0.00011878408056711673]]} - #*EXTRAS*# Step: 9 Bead: 36 -{"friction": [[0.00011938572449176385, -4.434786333972444e-05, -4.4264463858600315e-05], [-4.434786333972444e-05, 0.000119182982759469, -4.411630738322281e-05], [-4.4264463858600315e-05, -4.411630738322281e-05, 0.00011936746379674874]]} - #*EXTRAS*# Step: 10 Bead: 36 -{"friction": [[0.00011975893045365748, -4.424976068093299e-05, -4.419765179432589e-05], [-4.424976068093299e-05, 0.00011960243139869854, -4.40601981029783e-05], [-4.419765179432589e-05, -4.40601981029783e-05, 0.00011973327398987868]]} - #*EXTRAS*# Step: 11 Bead: 36 -{"friction": [[0.00011999385168303931, -4.418173846084318e-05, -4.414644315080138e-05], [-4.418173846084318e-05, 0.00011986627075315657, -4.401914511224472e-05], [-4.414644315080138e-05, -4.401914511224472e-05, 0.00011996280653739656]]} - #*EXTRAS*# Step: 12 Bead: 36 -{"friction": [[0.00012014299815472209, -4.413612899446036e-05, -4.41100080608449e-05], [-4.413612899446036e-05, 0.00012003348706705606, -4.39907009240829e-05], [-4.41100080608449e-05, -4.39907009240829e-05, 0.00012010819871109152]]} - #*EXTRAS*# Step: 13 Bead: 36 -{"friction": [[0.000120237805493007, -4.410617918255955e-05, -4.408519016286835e-05], [-4.410617918255955e-05, 0.00012013960625854008, -4.397163391395846e-05], [-4.408519016286835e-05, -4.397163391395846e-05, 0.00012020047415098786]]} - #*EXTRAS*# Step: 14 Bead: 36 -{"friction": [[0.00012029823891646707, -4.4086704944933534e-05, -4.406867775462716e-05], [-4.4086704944933534e-05, 0.0001202071639809128, -4.395907285700918e-05], [-4.406867775462716e-05, -4.395907285700918e-05, 0.0001202592316816196]]} - #*EXTRAS*# Step: 15 Bead: 36 -{"friction": [[0.00012033679683492273, -4.4074125313986054e-05, -4.4057855115324214e-05], [-4.4074125313986054e-05, 0.00012025022814948598, -4.3950891009001604e-05], [-4.4057855115324214e-05, -4.3950891009001604e-05, 0.00012029669432194084]]} - #*EXTRAS*# Step: 16 Bead: 36 -{"friction": [[0.00012036142226497382, -4.406602849599611e-05, -4.4050824498053083e-05], [-4.406602849599611e-05, 0.0001202777144657621, -4.39455967244352e-05], [-4.4050824498053083e-05, -4.39455967244352e-05, 0.00012032060941895086]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_37 b/drivers/py/pes/friction/frictionH/060K/inst.raw_37 deleted file mode 100644 index 25aaa0e4a..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_37 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 37 -{"friction": [[0.00011076333879039023, -4.207916178846279e-05, -4.2157344930675944e-05], [-4.207916178846279e-05, 0.00011078149553564103, -4.213391549981982e-05], [-4.2157344930675944e-05, -4.213391549981982e-05, 0.0001108388141904826]]} - #*EXTRAS*# Step: 1 Bead: 37 -{"friction": [[0.0001088021687531608, -4.06583725598013e-05, -4.0695265468069316e-05], [-4.06583725598013e-05, 0.00010881522168647921, -4.067247013373706e-05], [-4.0695265468069316e-05, -4.067247013373706e-05, 0.00010886104307971991]]} - #*EXTRAS*# Step: 2 Bead: 37 -{"friction": [[0.00010722598132798967, -3.9303272232117253e-05, -3.9281920204113706e-05], [-3.9303272232117253e-05, 0.00010722150242766024, -3.93140767826227e-05], [-3.9281920204113706e-05, -3.93140767826227e-05, 0.0001071994543809502]]} - #*EXTRAS*# Step: 3 Bead: 37 -{"friction": [[0.0001067098610376435, -3.881285543032877e-05, -3.877627537420546e-05], [-3.881285543032877e-05, 0.00010670493533100018, -3.884000759832139e-05], [-3.877627537420546e-05, -3.884000759832139e-05, 0.00010663922189042249]]} - #*EXTRAS*# Step: 4 Bead: 37 -{"friction": [[0.00010876670474420533, -4.0630100214774646e-05, -4.066565084421107e-05], [-4.0630100214774646e-05, 0.00010877919784707635, -4.064336674173235e-05], [-4.066565084421107e-05, -4.064336674173235e-05, 0.00010882451701432759]]} - #*EXTRAS*# Step: 5 Bead: 37 -{"friction": [[0.00011196057559244039, -4.282470777202282e-05, -4.2868389530377934e-05], [-4.282470777202282e-05, 0.00011192628174474843, -4.284975805202977e-05], [-4.2868389530377934e-05, -4.284975805202977e-05, 0.00011202324565480105]]} - #*EXTRAS*# Step: 6 Bead: 37 -{"friction": [[0.00011437841948471593, -4.4045020199523975e-05, -4.387020325679274e-05], [-4.4045020199523975e-05, 0.00011409237010664695, -4.3819660336443154e-05], [-4.387020325679274e-05, -4.3819660336443154e-05, 0.00011441282274642562]]} - #*EXTRAS*# Step: 7 Bead: 37 -{"friction": [[0.00011591550582657196, -4.4502959517464244e-05, -4.422226264733018e-05], [-4.4502959517464244e-05, 0.00011550644488904984, -4.4131958076703863e-05], [-4.422226264733018e-05, -4.4131958076703863e-05, 0.00011593462868620167]]} - #*EXTRAS*# Step: 8 Bead: 37 -{"friction": [[0.000116871890663005, -4.462314372057326e-05, -4.433837100311939e-05], [-4.462314372057326e-05, 0.00011645054741314328, -4.422101553743704e-05], [-4.433837100311939e-05, -4.422101553743704e-05, 0.00011688239439623363]]} - #*EXTRAS*# Step: 9 Bead: 37 -{"friction": [[0.00011747506157882034, -4.462834660513471e-05, -4.43729804380026e-05], [-4.462834660513471e-05, 0.00011707938124914847, -4.423909160602527e-05], [-4.43729804380026e-05, -4.423909160602527e-05, 0.00011748034276590082]]} - #*EXTRAS*# Step: 10 Bead: 37 -{"friction": [[0.00011786255007506063, -4.460526637433737e-05, -4.437902148032213e-05], [-4.460526637433737e-05, 0.00011749509228808055, -4.423605197705671e-05], [-4.437902148032213e-05, -4.423605197705671e-05, 0.00011786426782669655]]} - #*EXTRAS*# Step: 11 Bead: 37 -{"friction": [[0.00011810987644041805, -4.458074184768974e-05, -4.437591877116652e-05], [-4.458074184768974e-05, 0.00011776424605024036, -4.422827462841242e-05], [-4.437591877116652e-05, -4.422827462841242e-05, 0.00011810911921989247]]} - #*EXTRAS*# Step: 12 Bead: 37 -{"friction": [[0.00011826823259110284, -4.4561259852990046e-05, -4.4370976541909915e-05], [-4.4561259852990046e-05, 0.00011793789829151705, -4.4220927351262865e-05], [-4.4370976541909915e-05, -4.4220927351262865e-05, 0.00011826577856976474]]} - #*EXTRAS*# Step: 13 Bead: 37 -{"friction": [[0.00011836946296301331, -4.454731377315063e-05, -4.43665761093658e-05], [-4.454731377315063e-05, 0.00011804938652313203, -4.421526430091897e-05], [-4.43665761093658e-05, -4.421526430091897e-05, 0.00011836587041163868]]} - #*EXTRAS*# Step: 14 Bead: 37 -{"friction": [[0.0001184342190448293, -4.453779559785145e-05, -4.436324448632558e-05], [-4.453779559785145e-05, 0.00011812088512322747, -4.421124653129016e-05], [-4.436324448632558e-05, -4.421124653129016e-05, 0.00011842987405313274]]} - #*EXTRAS*# Step: 15 Bead: 37 -{"friction": [[0.00011847563022713382, -4.4531467931360934e-05, -4.4360900091661085e-05], [-4.4531467931360934e-05, 0.00011816667797598816, -4.420851547812174e-05], [-4.4360900091661085e-05, -4.420851547812174e-05, 0.00011847079362375006]]} - #*EXTRAS*# Step: 16 Bead: 37 -{"friction": [[0.00011850211658024437, -4.452732313359407e-05, -4.43593124896401e-05], [-4.452732313359407e-05, 0.00011819599434756048, -4.420670253215203e-05], [-4.43593124896401e-05, -4.420670253215203e-05, 0.00011849696113129292]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_38 b/drivers/py/pes/friction/frictionH/060K/inst.raw_38 deleted file mode 100644 index 3e246a3dd..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_38 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 38 -{"friction": [[0.0001100992324223387, -4.1627963427024275e-05, -4.170223714900381e-05], [-4.1627963427024275e-05, 0.00011012443903750724, -4.167507154046895e-05], [-4.170223714900381e-05, -4.167507154046895e-05, 0.00011017661577495691]]} - #*EXTRAS*# Step: 1 Bead: 38 -{"friction": [[0.00010797822166390719, -3.997568162025075e-05, -3.9980628777077524e-05], [-3.997568162025075e-05, 0.00010797910385895855, -3.9977746366189664e-05], [-3.9980628777077524e-05, -3.9977746366189664e-05, 0.00010800264805168079]]} - #*EXTRAS*# Step: 2 Bead: 38 -{"friction": [[0.00010622859141981498, -3.83324812312236e-05, -3.828398461329088e-05], [-3.83324812312236e-05, 0.00010622472848692704, -3.838058211843928e-05], [-3.828398461329088e-05, -3.838058211843928e-05, 0.00010611191730695247]]} - #*EXTRAS*# Step: 3 Bead: 38 -{"friction": [[0.00010548351053186661, -3.754017780683661e-05, -3.747813392072135e-05], [-3.754017780683661e-05, 0.00010548231634382465, -3.76278886277703e-05], [-3.747813392072135e-05, -3.76278886277703e-05, 0.00010528979557106851]]} - #*EXTRAS*# Step: 4 Bead: 38 -{"friction": [[0.00010728742340338263, -3.936003476884347e-05, -3.934065386538075e-05], [-3.936003476884347e-05, 0.00010728314717599636, -3.936939920149188e-05], [-3.934065386538075e-05, -3.936939920149188e-05, 0.00010726570448785635]]} - #*EXTRAS*# Step: 5 Bead: 38 -{"friction": [[0.00011034097396388683, -4.17955424405184e-05, -4.187280123383222e-05], [-4.17955424405184e-05, 0.00011036505836798214, -4.1846810199531155e-05], [-4.187280123383222e-05, -4.1846810199531155e-05, 0.00011041832215569864]]} - #*EXTRAS*# Step: 6 Bead: 38 -{"friction": [[0.00011262961662263497, -4.32070295902113e-05, -4.3203060223428444e-05], [-4.32070295902113e-05, 0.00011253805115451801, -4.31813679791116e-05], [-4.3203060223428444e-05, -4.31813679791116e-05, 0.00011268389518632202]]} - #*EXTRAS*# Step: 7 Bead: 38 -{"friction": [[0.00011410810425189925, -4.3934766689694895e-05, -4.3786149678760065e-05], [-4.3934766689694895e-05, 0.0001138516801823856, -4.374156047488538e-05], [-4.3786149678760065e-05, -4.374156047488538e-05, 0.00011414539569488173]]} - #*EXTRAS*# Step: 8 Bead: 38 -{"friction": [[0.00011502451382171189, -4.427428583840689e-05, -4.4043871265232925e-05], [-4.427428583840689e-05, 0.00011467514085032939, -4.397760212366534e-05], [-4.4043871265232925e-05, -4.397760212366534e-05, 0.0001150522650271121]]} - #*EXTRAS*# Step: 9 Bead: 38 -{"friction": [[0.00011560384196007536, -4.443517922072682e-05, -4.4167746428913496e-05], [-4.443517922072682e-05, 0.0001152111555195164, -4.408606507923345e-05], [-4.4167746428913496e-05, -4.408606507923345e-05, 0.0001156259142181165]]} - #*EXTRAS*# Step: 10 Bead: 38 -{"friction": [[0.00011597756401372726, -4.451482694870301e-05, -4.423212255570915e-05], [-4.451482694870301e-05, 0.0001155659006518599, -4.4140082017454705e-05], [-4.423212255570915e-05, -4.4140082017454705e-05, 0.00011599610811953288]]} - #*EXTRAS*# Step: 11 Bead: 38 -{"friction": [[0.00011621773787723707, -4.455554432454077e-05, -4.426720201222038e-05], [-4.455554432454077e-05, 0.00011579821331435508, -4.416840070287829e-05], [-4.426720201222038e-05, -4.416840070287829e-05, 0.00011623406821565399]]} - #*EXTRAS*# Step: 12 Bead: 38 -{"friction": [[0.0001163723032315263, -4.4577300928514994e-05, -4.4287211134747264e-05], [-4.4577300928514994e-05, 0.0001159496683780635, -4.418403353514908e-05], [-4.4287211134747264e-05, -4.418403353514908e-05, 0.0001163872304481187]]} - #*EXTRAS*# Step: 13 Bead: 38 -{"friction": [[0.00011647150236981029, -4.4589400500925694e-05, -4.429900388709965e-05], [-4.4589400500925694e-05, 0.0001160477147706412, -4.419301160653321e-05], [-4.429900388709965e-05, -4.419301160653321e-05, 0.00011648553780446082]]} - #*EXTRAS*# Step: 14 Bead: 38 -{"friction": [[0.00011653512716477239, -4.459638669450393e-05, -4.430613850714085e-05], [-4.459638669450393e-05, 0.00011611095741576162, -4.419833961411281e-05], [-4.430613850714085e-05, -4.419833961411281e-05, 0.0001165485941758242]]} - #*EXTRAS*# Step: 15 Bead: 38 -{"friction": [[0.00011657588867293869, -4.460054253623699e-05, -4.431053379630133e-05], [-4.460054253623699e-05, 0.00011615162342234644, -4.420157724561482e-05], [-4.431053379630133e-05, -4.420157724561482e-05, 0.00011658899296846508]]} - #*EXTRAS*# Step: 16 Bead: 38 -{"friction": [[0.00011660199015783915, -4.460307202014005e-05, -4.4313276486872935e-05], [-4.460307202014005e-05, 0.00011617772567912665, -4.420357861220157e-05], [-4.4313276486872935e-05, -4.420357861220157e-05, 0.00011661486278062103]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_39 b/drivers/py/pes/friction/frictionH/060K/inst.raw_39 deleted file mode 100644 index 397a8481e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_39 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 39 -{"friction": [[0.00010946055557351727, -4.116585373381819e-05, -4.12253165138265e-05], [-4.116585373381819e-05, 0.00010948261620819361, -4.119736995851763e-05], [-4.12253165138265e-05, -4.119736995851763e-05, 0.0001095333241093075]]} - #*EXTRAS*# Step: 1 Bead: 39 -{"friction": [[0.00010719340598664404, -3.927304106053979e-05, -3.925065727466137e-05], [-3.927304106053979e-05, 0.0001071888340924219, -3.92846561133398e-05], [-3.925065727466137e-05, -3.92846561133398e-05, 0.00010716428848098425]]} - #*EXTRAS*# Step: 2 Bead: 39 -{"friction": [[0.00010530918590558142, -3.734542380005795e-05, -3.7281169032834236e-05], [-3.734542380005795e-05, 0.00010530851926660373, -3.744310660569101e-05], [-3.7281169032834236e-05, -3.744310660569101e-05, 0.00010509697252065629]]} - #*EXTRAS*# Step: 3 Bead: 39 -{"friction": [[0.0001043821854071719, -3.62400394285289e-05, -3.617127184122493e-05], [-3.62400394285289e-05, 0.00010438095010775549, -3.638985100450957e-05], [-3.617127184122493e-05, -3.638985100450957e-05, 0.00010407385820863376]]} - #*EXTRAS*# Step: 4 Bead: 39 -{"friction": [[0.0001059057217959516, -3.799678369009613e-05, -3.7941640642720854e-05], [-3.799678369009613e-05, 0.0001059029928935373, -3.806124133204723e-05], [-3.7941640642720854e-05, -3.806124133204723e-05, 0.0001057562687940198]]} - #*EXTRAS*# Step: 5 Bead: 39 -{"friction": [[0.00010881867855981858, -4.067150106141546e-05, -4.0709015889772977e-05], [-4.067150106141546e-05, 0.000108831991094114, -4.068599176958625e-05], [-4.0709015889772977e-05, -4.068599176958625e-05, 0.00010887803552282529]]} - #*EXTRAS*# Step: 6 Bead: 39 -{"friction": [[0.00011098817269188965, -4.222555879447791e-05, -4.230172887734836e-05], [-4.222555879447791e-05, 0.0001110008089308484, -4.227970638068516e-05], [-4.230172887734836e-05, -4.227970638068516e-05, 0.00011106189594725799]]} - #*EXTRAS*# Step: 7 Bead: 39 -{"friction": [[0.00011240536802410847, -4.308170275724056e-05, -4.3095902280999684e-05], [-4.308170275724056e-05, 0.00011233518087368257, -4.307583901560464e-05], [-4.3095902280999684e-05, -4.307583901560464e-05, 0.0001124624105681048]]} - #*EXTRAS*# Step: 8 Bead: 39 -{"friction": [[0.00011328033011213197, -4.355069718115289e-05, -4.348579396742203e-05], [-4.355069718115289e-05, 0.00011311868387872016, -4.3456355773087645e-05], [-4.348579396742203e-05, -4.3456355773087645e-05, 0.00011332687521725808]]} - #*EXTRAS*# Step: 9 Bead: 39 -{"friction": [[0.00011383398482276485, -4.38149944633401e-05, -4.3693917991270466e-05], [-4.38149944633401e-05, 0.00011360867658996934, -4.365490307081331e-05], [-4.3693917991270466e-05, -4.365490307081331e-05, 0.00011387427103918016]]} - #*EXTRAS*# Step: 10 Bead: 39 -{"friction": [[0.00011419052764438923, -4.396923319718068e-05, -4.381250083623759e-05], [-4.396923319718068e-05, 0.00011392493274756484, -4.376614156051633e-05], [-4.381250083623759e-05, -4.376614156051633e-05, 0.00011422693167507453]]} - #*EXTRAS*# Step: 11 Bead: 39 -{"friction": [[0.00011441967797054733, -4.406113279609225e-05, -4.3882435379757424e-05], [-4.406113279609225e-05, 0.00011412923469623969, -4.3830947567750155e-05], [-4.3882435379757424e-05, -4.3830947567750155e-05, 0.00011445364597360604]]} - #*EXTRAS*# Step: 12 Bead: 39 -{"friction": [[0.00011456708747766047, -4.4117104768345696e-05, -4.392485638537705e-05], [-4.4117104768345696e-05, 0.00011426128023081793, -4.3869920545709195e-05], [-4.392485638537705e-05, -4.3869920545709195e-05, 0.00011459951223104197]]} - #*EXTRAS*# Step: 13 Bead: 39 -{"friction": [[0.00011466168778433507, -4.415168797387245e-05, -4.3951029423535894e-05], [-4.415168797387245e-05, 0.00011434632497052779, -4.389382452846589e-05], [-4.3951029423535894e-05, -4.389382452846589e-05, 0.0001146931318177965]]} - #*EXTRAS*# Step: 14 Bead: 39 -{"friction": [[0.0001147223548302546, -4.417330597662555e-05, -4.3967383991809684e-05], [-4.417330597662555e-05, 0.00011440100170718687, -4.390870213136895e-05], [-4.3967383991809684e-05, -4.390870213136895e-05, 0.00011475317386337059]]} - #*EXTRAS*# Step: 15 Bead: 39 -{"friction": [[0.00011476121959946372, -4.4186922344446486e-05, -4.3977685036565616e-05], [-4.4186922344446486e-05, 0.00011443608870623986, -4.391804838090831e-05], [-4.3977685036565616e-05, -4.391804838090831e-05, 0.00011479163984688846]]} - #*EXTRAS*# Step: 16 Bead: 39 -{"friction": [[0.00011478610531529539, -4.4195545026180146e-05, -4.398420888846979e-05], [-4.4195545026180146e-05, 0.00011445858081007543, -4.392395741939098e-05], [-4.398420888846979e-05, -4.392395741939098e-05, 0.0001148162708692408]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_40 b/drivers/py/pes/friction/frictionH/060K/inst.raw_40 deleted file mode 100644 index e52a73d76..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_40 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 40 -{"friction": [[0.00010884671416050972, -4.069374642795891e-05, -4.0732312774585544e-05], [-4.069374642795891e-05, 0.00010886046575184648, -4.0708913362173936e-05], [-4.0732312774585544e-05, -4.0708913362173936e-05, 0.00010890687369275164]]} - #*EXTRAS*# Step: 1 Bead: 40 -{"friction": [[0.0001064529892925873, -3.855934644154066e-05, -3.851611816113914e-05], [-3.855934644154066e-05, 0.00010644850157988084, -3.859709529171976e-05], [-3.851611816113914e-05, -3.859709529171976e-05, 0.0001063582711399424]]} - #*EXTRAS*# Step: 2 Bead: 40 -{"friction": [[0.00010447704163414807, -3.635908381152948e-05, -3.629015678671782e-05], [-3.635908381152948e-05, 0.00010447626236277206, -3.6503893852748037e-05], [-3.629015678671782e-05, -3.6503893852748037e-05, 0.00010417811657219781]]} - #*EXTRAS*# Step: 3 Bead: 40 -{"friction": [[0.00010342222421027113, -3.494067862820951e-05, -3.488356133008459e-05], [-3.494067862820951e-05, 0.00010340696666247552, -3.5128716617487545e-05], [-3.488356133008459e-05, -3.5128716617487545e-05, 0.00010303231398545244]]} - #*EXTRAS*# Step: 4 Bead: 40 -{"friction": [[0.00010465862479116016, -3.658294386879851e-05, -3.651413503901892e-05], [-3.658294386879851e-05, 0.00010465840390752766, -3.6717850519508874e-05], [-3.651413503901892e-05, -3.6717850519508874e-05, 0.00010437808906171267]]} - #*EXTRAS*# Step: 5 Bead: 40 -{"friction": [[0.00010738192228649618, -3.9446683119442735e-05, -3.943039715577925e-05], [-3.9446683119442735e-05, 0.00010737803025674076, -3.945406491771937e-05], [-3.943039715577925e-05, -3.945406491771937e-05, 0.00010736739284848048]]} - #*EXTRAS*# Step: 6 Bead: 40 -{"friction": [[0.00010944638324781008, -4.1155269899330656e-05, -4.121430993655353e-05], [-4.1155269899330656e-05, 0.00010946829526130616, -4.118639939436827e-05], [-4.121430993655353e-05, -4.118639939436827e-05, 0.00010951895949279956]]} - #*EXTRAS*# Step: 7 Bead: 40 -{"friction": [[0.00011080553420440625, -4.210687425051959e-05, -4.218481976038426e-05], [-4.210687425051959e-05, 0.00011082278841265845, -4.216165807111229e-05], [-4.218481976038426e-05, -4.216165807111229e-05, 0.00011088071574599675]]} - #*EXTRAS*# Step: 8 Bead: 40 -{"friction": [[0.0001116395756547555, -4.263277610466597e-05, -4.269179451311441e-05], [-4.263277610466597e-05, 0.00011162529190943578, -4.267280996639046e-05], [-4.269179451311441e-05, -4.267280996639046e-05, 0.00011170627824325666]]} - #*EXTRAS*# Step: 9 Bead: 40 -{"friction": [[0.00011216748501401423, -4.294554471526128e-05, -4.2976709987115604e-05], [-4.294554471526128e-05, 0.00011211768654139926, -4.2957717600085096e-05], [-4.2976709987115604e-05, -4.2957717600085096e-05, 0.00011222751693184993]]} - #*EXTRAS*# Step: 10 Bead: 40 -{"friction": [[0.00011250674619214634, -4.313874755400084e-05, -4.314496915827705e-05], [-4.313874755400084e-05, 0.000112427127637154, -4.312424130425631e-05], [-4.314496915827705e-05, -4.312424130425631e-05, 0.0001125625327675532]]} - #*EXTRAS*# Step: 11 Bead: 40 -{"friction": [[0.00011272476686995288, -4.325922658917885e-05, -4.3247011997450526e-05], [-4.325922658917885e-05, 0.00011262360141098268, -4.322445733841386e-05], [-4.3247011997450526e-05, -4.322445733841386e-05, 0.00011277788824017996]]} - #*EXTRAS*# Step: 12 Bead: 40 -{"friction": [[0.00011286493953873556, -4.333497794594764e-05, -4.3310123941695696e-05], [-4.333497794594764e-05, 0.00011274914816633021, -4.3286122107271504e-05], [-4.3310123941695696e-05, -4.3286122107271504e-05, 0.00011291637283682106]]} - #*EXTRAS*# Step: 13 Bead: 40 -{"friction": [[0.00011295488251533501, -4.338283209233627e-05, -4.334959746090815e-05], [-4.338283209233627e-05, 0.00011282944242941347, -4.3324560169658516e-05], [-4.334959746090815e-05, -4.3324560169658516e-05, 0.00011300524300262928]]} - #*EXTRAS*# Step: 14 Bead: 40 -{"friction": [[0.0001130125519404606, -4.341319326958024e-05, -4.33744878424448e-05], [-4.341319326958024e-05, 0.00011288083095404138, -4.334874412594497e-05], [-4.33744878424448e-05, -4.334874412594497e-05, 0.0001130622287857531]]} - #*EXTRAS*# Step: 15 Bead: 40 -{"friction": [[0.00011304949336799923, -4.3432506447188e-05, -4.339026023960931e-05], [-4.3432506447188e-05, 0.00011291371395547994, -4.33640469273406e-05], [-4.339026023960931e-05, -4.33640469273406e-05, 0.0001130987340138238]]} - #*EXTRAS*# Step: 16 Bead: 40 -{"friction": [[0.00011307314587264887, -4.344481576736545e-05, -4.340028854369348e-05], [-4.344481576736545e-05, 0.00011293475455543487, -4.3373767657457024e-05], [-4.340028854369348e-05, -4.3373767657457024e-05, 0.00011312210793653401]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_41 b/drivers/py/pes/friction/frictionH/060K/inst.raw_41 deleted file mode 100644 index ef8be5f4a..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_41 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 41 -{"friction": [[0.00010825727003808276, -4.0213019041528475e-05, -4.022875126678125e-05], [-4.0213019041528475e-05, 0.00010826184840136975, -4.021709341324004e-05], [-4.022875126678125e-05, -4.021709341324004e-05, 0.00010829577020577766]]} - #*EXTRAS*# Step: 1 Bead: 41 -{"friction": [[0.00010576244829180019, -3.784415088796962e-05, -3.778643010616481e-05], [-3.784415088796962e-05, 0.00010576025688793631, -3.791630905540916e-05], [-3.778643010616481e-05, -3.791630905540916e-05, 0.00010559810766842389]]} - #*EXTRAS*# Step: 2 Bead: 41 -{"friction": [[0.00010373690972140701, -3.53874920437074e-05, -3.532433155323708e-05], [-3.53874920437074e-05, 0.00010372855849355927, -3.556627464511633e-05], [-3.532433155323708e-05, -3.556627464511633e-05, 0.0001033702398576833]]} - #*EXTRAS*# Step: 3 Bead: 41 -{"friction": [[0.00010260692703305216, -3.366471893474104e-05, -3.363511965732257e-05], [-3.366471893474104e-05, 0.00010255924938797093, -3.385215496716889e-05], [-3.363511965732257e-05, -3.385215496716889e-05, 0.00010218376499650189]]} - #*EXTRAS*# Step: 4 Bead: 41 -{"friction": [[0.00010357177601257707, -3.5155860672921846e-05, -3.50955675807967e-05], [-3.5155860672921846e-05, 0.00010356014705772904, -3.534002037040894e-05], [-3.50955675807967e-05, -3.534002037040894e-05, 0.00010319236378584369]]} - #*EXTRAS*# Step: 5 Bead: 41 -{"friction": [[0.00010604060845050878, -3.81383958599492e-05, -3.808589143124808e-05], [-3.81383958599492e-05, 0.00010603738424364503, -3.819583502497252e-05], [-3.808589143124808e-05, -3.819583502497252e-05, 0.00010590499612553794]]} - #*EXTRAS*# Step: 6 Bead: 41 -{"friction": [[0.00010799314680998776, -3.998853798979155e-05, -3.9994052291265675e-05], [-3.998853798979155e-05, 0.00010799420609947005, -3.999064163362388e-05], [-3.9994052291265675e-05, -3.999064163362388e-05, 0.00010801839327319492]]} - #*EXTRAS*# Step: 7 Bead: 41 -{"friction": [[0.00010930064846867448, -4.104558191043698e-05, -4.110008399710328e-05], [-4.104558191043698e-05, 0.00010932088410464479, -4.107271281574979e-05], [-4.110008399710328e-05, -4.107271281574979e-05, 0.00010937099266932653]]} - #*EXTRAS*# Step: 8 Bead: 41 -{"friction": [[0.00011009756399414933, -4.162679320162019e-05, -4.1701040713433146e-05], [-4.162679320162019e-05, 0.00011012277327551824, -4.1673868208897034e-05], [-4.1701040713433146e-05, -4.1673868208897034e-05, 0.00011017494457401959]]} - #*EXTRAS*# Step: 9 Bead: 41 -{"friction": [[0.00011060166944230142, -4.197194926907198e-05, -4.205046978525749e-05], [-4.197194926907198e-05, 0.00011062274225490577, -4.2026019862116116e-05], [-4.205046978525749e-05, -4.2026019862116116e-05, 0.00011067810340821175]]} - #*EXTRAS*# Step: 10 Bead: 41 -{"friction": [[0.00011092460484360461, -4.218448195682597e-05, -4.2261410136464234e-05], [-4.218448195682597e-05, 0.00011093898226179493, -4.223899677857198e-05], [-4.2261410136464234e-05, -4.223899677857198e-05, 0.00011099886832025922]]} - #*EXTRAS*# Step: 11 Bead: 41 -{"friction": [[0.00011113197331631678, -4.2317582064888355e-05, -4.239146554543009e-05], [-4.2317582064888355e-05, 0.00011114012173676864, -4.237028921079027e-05], [-4.239146554543009e-05, -4.237028921079027e-05, 0.00011120435917065584]]} - #*EXTRAS*# Step: 12 Bead: 41 -{"friction": [[0.00011126516936910068, -4.2401724204231824e-05, -4.24727577830298e-05], [-4.2401724204231824e-05, 0.00011126845445297173, -4.245229805255483e-05], [-4.24727577830298e-05, -4.245229805255483e-05, 0.00011133619075373824]]} - #*EXTRAS*# Step: 13 Bead: 41 -{"friction": [[0.00011135060351966278, -4.2455149530904036e-05, -4.252397160150355e-05], [-4.2455149530904036e-05, 0.00011135039714576412, -4.25039268384625e-05], [-4.252397160150355e-05, -4.25039268384625e-05, 0.00011142069512743773]]} - #*EXTRAS*# Step: 14 Bead: 41 -{"friction": [[0.00011140536388070902, -4.2489172336330806e-05, -4.255641532659432e-05], [-4.2489172336330806e-05, 0.00011140276232526135, -4.253661492078083e-05], [-4.255641532659432e-05, -4.253661492078083e-05, 0.00011147483987107472]]} - #*EXTRAS*# Step: 15 Bead: 41 -{"friction": [[0.00011144043602766423, -4.251087286229722e-05, -4.257703717402473e-05], [-4.251087286229722e-05, 0.00011143623476370413, -4.255738354859973e-05], [-4.257703717402473e-05, -4.255738354859973e-05, 0.00011150951038936989]]} - #*EXTRAS*# Step: 16 Bead: 41 -{"friction": [[0.00011146288890995997, -4.252472868856512e-05, -4.259017457187387e-05], [-4.252472868856512e-05, 0.00011145763630833868, -4.257061070720722e-05], [-4.259017457187387e-05, -4.257061070720722e-05, 0.00011153170332934535]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_42 b/drivers/py/pes/friction/frictionH/060K/inst.raw_42 deleted file mode 100644 index 5121478a7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_42 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 42 -{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} - #*EXTRAS*# Step: 1 Bead: 42 -{"friction": [[0.00010512525477911151, -3.7135737823050746e-05, -3.7069583722332596e-05], [-3.7135737823050746e-05, 0.00010512500570699283, -3.724403625503903e-05], [-3.7069583722332596e-05, -3.724403625503903e-05, 0.00010489351986399696]]} - #*EXTRAS*# Step: 2 Bead: 42 -{"friction": [[0.00010308970498390537, -3.444189887962235e-05, -3.439401392092446e-05], [-3.444189887962235e-05, 0.00010306373801166513, -3.4634420691001086e-05], [-3.439401392092446e-05, -3.4634420691001086e-05, 0.00010268078163841328]]} - #*EXTRAS*# Step: 3 Bead: 42 -{"friction": [[0.00010190643611943269, -3.242880957354569e-05, -3.243083335772634e-05], [-3.242880957354569e-05, 0.00010182050307135832, -3.258331868672591e-05], [-3.243083335772634e-05, -3.258331868672591e-05, 0.0001014998664790337]]} - #*EXTRAS*# Step: 4 Bead: 42 -{"friction": [[0.00010265544969555167, -3.3745673745378135e-05, -3.371402943050202e-05], [-3.3745673745378135e-05, 0.00010261021964570684, -3.393426439550907e-05], [-3.371402943050202e-05, -3.393426439550907e-05, 0.00010223288988134378]]} - #*EXTRAS*# Step: 5 Bead: 42 -{"friction": [[0.00010482754159787259, -3.678665849557969e-05, -3.6718434435205e-05], [-3.678665849557969e-05, 0.00010482752163159551, -3.691206435794058e-05], [-3.6718434435205e-05, -3.691206435794058e-05, 0.00010456447511975183]]} - #*EXTRAS*# Step: 6 Bead: 42 -{"friction": [[0.00010662474601485302, -3.872957026119587e-05, -3.869071619469362e-05], [-3.872957026119587e-05, 0.00010661992626704087, -3.876007224645631e-05], [-3.869071619469362e-05, -3.876007224645631e-05, 0.00010654626564864374]]} - #*EXTRAS*# Step: 7 Bead: 42 -{"friction": [[0.00010788067319534115, -3.989119898473427e-05, -3.989247790730107e-05], [-3.989119898473427e-05, 0.00010788046772664443, -3.9893219939555594e-05], [-3.989247790730107e-05, -3.9893219939555594e-05, 0.00010789954600711859]]} - #*EXTRAS*# Step: 8 Bead: 42 -{"friction": [[0.00010864482605491693, -4.0532188574956354e-05, -4.056306899693271e-05], [-4.0532188574956354e-05, 0.00010865538210675202, -4.05427541595167e-05], [-4.056306899693271e-05, -4.05427541595167e-05, 0.00010869871970741264]]} - #*EXTRAS*# Step: 9 Bead: 42 -{"friction": [[0.00010912805614874166, -4.091364372109721e-05, -4.0962368097479816e-05], [-4.091364372109721e-05, 0.00010914600808188657, -4.093606875448982e-05], [-4.0962368097479816e-05, -4.093606875448982e-05, 0.00010919512841512947]]} - #*EXTRAS*# Step: 10 Bead: 42 -{"friction": [[0.0001094366330552407, -4.1147979989278066e-05, -4.120672719997032e-05], [-4.1147979989278066e-05, 0.00010945844125144178, -4.1178843066000676e-05], [-4.120672719997032e-05, -4.1178843066000676e-05, 0.00010950907450837129]]} - #*EXTRAS*# Step: 11 Bead: 42 -{"friction": [[0.00010963459640974025, -4.1294640325747335e-05, -4.1358998767564434e-05], [-4.1294640325747335e-05, 0.00010965824398008219, -4.133082701483083e-05], [-4.1358998767564434e-05, -4.133082701483083e-05, 0.0001097093850409799]]} - #*EXTRAS*# Step: 12 Bead: 42 -{"friction": [[0.00010976160254658929, -4.138725284604769e-05, -4.1454808798477465e-05], [-4.138725284604769e-05, 0.00010978609751232352, -4.1426703592978584e-05], [-4.1454808798477465e-05, -4.1426703592978584e-05, 0.00010983748530503766]]} - #*EXTRAS*# Step: 13 Bead: 42 -{"friction": [[0.00010984302270309117, -4.144602480344348e-05, -4.1515448213877815e-05], [-4.144602480344348e-05, 0.00010986790563436933, -4.148747612824945e-05], [-4.1515448213877815e-05, -4.148747612824945e-05, 0.00010991944803329967]]} - #*EXTRAS*# Step: 14 Bead: 42 -{"friction": [[0.00010989518672371805, -4.148343489192419e-05, -4.155397546368845e-05], [-4.148343489192419e-05, 0.00010992024965284082, -4.152612247372378e-05], [-4.155397546368845e-05, -4.152612247372378e-05, 0.00010997189717817723]]} - #*EXTRAS*# Step: 15 Bead: 42 -{"friction": [[0.00010992858778644207, -4.150728954258721e-05, -4.157851178586154e-05], [-4.150728954258721e-05, 0.00010995373659854462, -4.155074804863291e-05], [-4.157851178586154e-05, -4.155074804863291e-05, 0.00011000545589522337]]} - #*EXTRAS*# Step: 16 Bead: 42 -{"friction": [[0.00010994996704775725, -4.1522517817380933e-05, -4.1594162293228696e-05], [-4.1522517817380933e-05, 0.00010997515846926766, -4.156646078191022e-05], [-4.1594162293228696e-05, -4.156646078191022e-05, 0.00011002692604575515]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_43 b/drivers/py/pes/friction/frictionH/060K/inst.raw_43 deleted file mode 100644 index 44496073e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_43 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 43 -{"friction": [[0.00010715217792801399, -3.923464312552263e-05, -3.921096682771662e-05], [-3.923464312552263e-05, 0.00010714750227249788, -3.92473297219389e-05], [-3.921096682771662e-05, -3.92473297219389e-05, 0.00010711974146902487]]} - #*EXTRAS*# Step: 1 Bead: 43 -{"friction": [[0.00010454305074822383, -3.644106269991503e-05, -3.637211548779993e-05], [-3.644106269991503e-05, 0.00010454251974005566, -3.658231785418943e-05], [-3.637211548779993e-05, -3.658231785418943e-05, 0.00010425075591069191]]} - #*EXTRAS*# Step: 2 Bead: 43 -{"friction": [[0.00010252745815866934, -3.353077923102774e-05, -3.3504604696066525e-05], [-3.353077923102774e-05, 0.00010247567332776365, -3.371600898606345e-05], [-3.3504604696066525e-05, -3.371600898606345e-05, 0.00010210375207214395]]} - #*EXTRAS*# Step: 3 Bead: 43 -{"friction": [[0.00010128586477060097, -3.124502290066867e-05, -3.127087033212352e-05], [-3.124502290066867e-05, 0.00010117053659333839, -3.134626497387675e-05], [-3.127087033212352e-05, -3.134626497387675e-05, 0.00010094159022058502]]} - #*EXTRAS*# Step: 4 Bead: 43 -{"friction": [[0.0001018772219533189, -3.237472242993008e-05, -3.2378048404515545e-05], [-3.237472242993008e-05, 0.00010178969822026577, -3.252720733188819e-05], [-3.2378048404515545e-05, -3.252720733188819e-05, 0.00010147249633129714]]} - #*EXTRAS*# Step: 5 Bead: 43 -{"friction": [[0.00010376528363084542, -3.542669263365644e-05, -3.536310348320248e-05], [-3.542669263365644e-05, 0.00010375742542476681, -3.560444835897472e-05], [-3.536310348320248e-05, -3.560444835897472e-05, 0.0001034009121849032]]} - #*EXTRAS*# Step: 6 Bead: 43 -{"friction": [[0.00010536908071083201, -3.7412765730816286e-05, -3.734922651303697e-05], [-3.7412765730816286e-05, 0.00010536824484283737, -3.750700779629536e-05], [-3.734922651303697e-05, -3.750700779629536e-05, 0.00010516322809194156]]} - #*EXTRAS*# Step: 7 Bead: 43 -{"friction": [[0.00010654456571406692, -3.865046819832964e-05, -3.860953604032163e-05], [-3.865046819832964e-05, 0.00010653988261999253, -3.868427487339966e-05], [-3.860953604032163e-05, -3.868427487339966e-05, 0.00010645857151382234]]} - #*EXTRAS*# Step: 8 Bead: 43 -{"friction": [[0.0001072726553803448, -3.934642219886736e-05, -3.9326564543261994e-05], [-3.934642219886736e-05, 0.00010726832712766751, -3.935612207760564e-05], [-3.9326564543261994e-05, -3.935612207760564e-05, 0.00010724979026488522]]} - #*EXTRAS*# Step: 9 Bead: 43 -{"friction": [[0.0001077370818054769, -3.9765393695025754e-05, -3.9761408185633054e-05], [-3.9765393695025754e-05, 0.00010773550488568549, -3.976802600199203e-05], [-3.9761408185633054e-05, -3.976802600199203e-05, 0.00010774717108245793]]} - #*EXTRAS*# Step: 10 Bead: 43 -{"friction": [[0.0001080332501436496, -4.00229913243921e-05, -4.003003633534549e-05], [-4.00229913243921e-05, 0.00010803479830441766, -4.002524022521354e-05], [-4.003003633534549e-05, -4.002524022521354e-05, 0.00010806066167116464]]} - #*EXTRAS*# Step: 11 Bead: 43 -{"friction": [[0.00010822310121314715, -4.018429992719905e-05, -4.019869630732803e-05], [-4.018429992719905e-05, 0.00010822718907203007, -4.0187991751868996e-05], [-4.019869630732803e-05, -4.0187991751868996e-05, 0.0001082600180271449]]} - #*EXTRAS*# Step: 12 Bead: 43 -{"friction": [[0.00010834476050372291, -4.028612385237115e-05, -4.0305285116106215e-05], [-4.028612385237115e-05, 0.00010835063132599846, -4.029133292410121e-05], [-4.0305285116106215e-05, -4.029133292410121e-05, 0.00010838714288628579]]} - #*EXTRAS*# Step: 13 Bead: 43 -{"friction": [[0.00010842271133516437, -4.035073748880891e-05, -4.037295716957075e-05], [-4.035073748880891e-05, 0.00010842977021850981, -4.0357133422498276e-05], [-4.037295716957075e-05, -4.0357133422498276e-05, 0.00010846834819175399]]} - #*EXTRAS*# Step: 14 Bead: 43 -{"friction": [[0.00010847262979347391, -4.0391859051456496e-05, -4.0416035130034516e-05], [-4.0391859051456496e-05, 0.00010848046346990081, -4.0399095626228064e-05], [-4.0416035130034516e-05, -4.0399095626228064e-05, 0.00010852025170218044]]} - #*EXTRAS*# Step: 15 Bead: 43 -{"friction": [[0.00010850458502692974, -4.041807849422016e-05, -4.044350492549152e-05], [-4.041807849422016e-05, 0.00010851291917174239, -4.042588427726886e-05], [-4.044350492549152e-05, -4.042588427726886e-05, 0.00010855343770837245]]} - #*EXTRAS*# Step: 16 Bead: 43 -{"friction": [[0.00010852503512470026, -4.043481523591691e-05, -4.046104071154139e-05], [-4.043481523591691e-05, 0.00010853369106173592, -4.0442997504852044e-05], [-4.046104071154139e-05, -4.0442997504852044e-05, 0.00010857465925562761]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_44 b/drivers/py/pes/friction/frictionH/060K/inst.raw_44 deleted file mode 100644 index 4d2bca79e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_44 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 44 -{"friction": [[0.00010664017028987908, -3.874471502576407e-05, -3.8706267883039e-05], [-3.874471502576407e-05, 0.00010663532824109419, -3.87745976441682e-05], [-3.8706267883039e-05, -3.87745976441682e-05, 0.00010656312142689027]]} - #*EXTRAS*# Step: 1 Bead: 44 -{"friction": [[0.00010401580066799551, -3.5765637172837496e-05, -3.569902664303221e-05], [-3.5765637172837496e-05, 0.00010401150363935715, -3.5933204405707024e-05], [-3.569902664303221e-05, -3.5933204405707024e-05, 0.00010367292263721634]]} - #*EXTRAS*# Step: 2 Bead: 44 -{"friction": [[0.00010203244773026804, -3.2659936801569464e-05, -3.265625263154466e-05], [-3.2659936801569464e-05, 0.00010195347220665959, -3.282259276303486e-05], [-3.265625263154466e-05, -3.282259276303486e-05, 0.00010161906373979083]]} - #*EXTRAS*# Step: 3 Bead: 44 -{"friction": [[0.0001007193685986567, -3.0121828356291172e-05, -3.0156049379748463e-05], [-3.0121828356291172e-05, 0.00010059299323697395, -3.015866971634974e-05], [-3.0156049379748463e-05, -3.015866971634974e-05, 0.00010047784616868131]]} - #*EXTRAS*# Step: 4 Bead: 44 -{"friction": [[0.0001011911564115652, -3.1059111909536e-05, -3.108750847774247e-05], [-3.1059111909536e-05, 0.0001010726141211161, -3.115048916461377e-05], [-3.108750847774247e-05, -3.115048916461377e-05, 0.00010086090415968688]]} - #*EXTRAS*# Step: 5 Bead: 44 -{"friction": [[0.00010286428343291861, -3.408686211238272e-05, -3.404689674694679e-05], [-3.408686211238272e-05, 0.00010282896792987195, -3.4278768596348275e-05], [-3.404689674694679e-05, -3.4278768596348275e-05, 0.00010244651734377347]]} - #*EXTRAS*# Step: 6 Bead: 44 -{"friction": [[0.00010425314152897805, -3.607566503211241e-05, -3.600737003609811e-05], [-3.607566503211241e-05, 0.0001042510796271058, -3.6232043874797995e-05], [-3.600737003609811e-05, -3.6232043874797995e-05, 0.00010393229537995276]]} - #*EXTRAS*# Step: 7 Bead: 44 -{"friction": [[0.00010532057524236721, -3.7358264208957125e-05, -3.729414190251846e-05], [-3.7358264208957125e-05, 0.00010531987752197044, -3.7455291818281894e-05], [-3.729414190251846e-05, -3.7455291818281894e-05, 0.00010510957155262027]]} - #*EXTRAS*# Step: 8 Bead: 44 -{"friction": [[0.00010599423016176674, -3.808992973610056e-05, -3.803649531452608e-05], [-3.808992973610056e-05, 0.00010599117391760137, -3.814975443479213e-05], [-3.803649531452608e-05, -3.814975443479213e-05, 0.00010585388044321263]]} - #*EXTRAS*# Step: 9 Bead: 44 -{"friction": [[0.0001064308859571348, -3.853722740483751e-05, -3.84934574347232e-05], [-3.853722740483751e-05, 0.00010642645114497857, -3.857595345362364e-05], [-3.84934574347232e-05, -3.857595345362364e-05, 0.00010633404050660571]]} - #*EXTRAS*# Step: 10 Bead: 44 -{"friction": [[0.00010671132023561743, -3.881427715858746e-05, -3.877773669201445e-05], [-3.881427715858746e-05, 0.00010670639308641367, -3.884137336640162e-05], [-3.877773669201445e-05, -3.884137336640162e-05, 0.00010664081425850258]]} - #*EXTRAS*# Step: 11 Bead: 44 -{"friction": [[0.00010689201391623618, -3.8988763413707155e-05, -3.895728019385685e-05], [-3.8988763413707155e-05, 0.00010688701503139892, -3.900933238940677e-05], [-3.895728019385685e-05, -3.900933238940677e-05, 0.00010683765160625773]]} - #*EXTRAS*# Step: 12 Bead: 44 -{"friction": [[0.00010700804418603533, -3.9099191823997367e-05, -3.907111511901329e-05], [-3.9099191823997367e-05, 0.00010700312200996536, -3.911601327351304e-05], [-3.907111511901329e-05, -3.911601327351304e-05, 0.00010696366337719108]]} - #*EXTRAS*# Step: 13 Bead: 44 -{"friction": [[0.00010708248513904225, -3.916938498234261e-05, -3.9143557860862764e-05], [-3.916938498234261e-05, 0.00010707766831867975, -3.918399670005289e-05], [-3.9143557860862764e-05, -3.918399670005289e-05, 0.00010704433827821563]]} - #*EXTRAS*# Step: 14 Bead: 44 -{"friction": [[0.00010713018481130852, -3.9214097013371214e-05, -3.918973733589378e-05], [-3.9214097013371214e-05, 0.00010712546003174798, -3.922737583494331e-05], [-3.918973733589378e-05, -3.922737583494331e-05, 0.00010709595973224419]]} - #*EXTRAS*# Step: 15 Bead: 44 -{"friction": [[0.00010716073160240975, -3.924262221981833e-05, -3.92192128559515e-05], [-3.924262221981833e-05, 0.00010715607621375361, -3.925508233892538e-05], [-3.92192128559515e-05, -3.925508233892538e-05, 0.00010712898739512425]]} - #*EXTRAS*# Step: 16 Bead: 44 -{"friction": [[0.00010718028442916238, -3.92608368417243e-05, -3.923804007465337e-05], [-3.92608368417243e-05, 0.00010717567783990247, -3.927278742423065e-05], [-3.923804007465337e-05, -3.927278742423065e-05, 0.00010715011545478958]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_45 b/drivers/py/pes/friction/frictionH/060K/inst.raw_45 deleted file mode 100644 index 4e86cdc1e..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_45 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 45 -{"friction": [[0.00010615791386994777, -3.8259948801847704e-05, -3.820990102880373e-05], [-3.8259948801847704e-05, 0.0001061542815691971, -3.831149517488624e-05], [-3.820990102880373e-05, -3.831149517488624e-05, 0.000106034172149726]]} - #*EXTRAS*# Step: 1 Bead: 45 -{"friction": [[0.00010354235205419792, -3.5113942340354194e-05, -3.505422924962381e-05], [-3.5113942340354194e-05, 0.00010353006137209655, -3.529894437889325e-05], [-3.505422924962381e-05, -3.529894437889325e-05, 0.00010316079131783398]]} - #*EXTRAS*# Step: 2 Bead: 45 -{"friction": [[0.00010158990977297511, -3.183349868368006e-05, -3.184890188488018e-05], [-3.183349868368006e-05, 0.00010148756142177106, -3.196344802653723e-05], [-3.184890188488018e-05, -3.196344802653723e-05, 0.00010120888762491]]} - #*EXTRAS*# Step: 3 Bead: 45 -{"friction": [[0.00010018875038753532, -2.906480857843254e-05, -2.9087730765034423e-05], [-2.906480857843254e-05, 0.00010007495713085022, -2.90329353894439e-05], [-2.9087730765034423e-05, -2.90329353894439e-05, 0.00010008454506624207]]} - #*EXTRAS*# Step: 4 Bead: 45 -{"friction": [[0.00010056345598044818, -2.9810340194121033e-05, -2.984343632542387e-05], [-2.9810340194121033e-05, 0.00010043813945351654, -2.9827580530622198e-05], [-2.984343632542387e-05, -2.9827580530622198e-05, 0.00010035821848160144]]} - #*EXTRAS*# Step: 5 Bead: 45 -{"friction": [[0.00010210335332488943, -3.278838636502624e-05, -3.2781448099931364e-05], [-3.278838636502624e-05, 0.00010202833385707311, -3.295520415596575e-05], [-3.2781448099931364e-05, -3.295520415596575e-05, 0.00010168692594433275]]} - #*EXTRAS*# Step: 6 Bead: 45 -{"friction": [[0.00010329218497155537, -3.474909417223701e-05, -3.469521898716443e-05], [-3.474909417223701e-05, 0.0001032731977375933, -3.493961903860623e-05], [-3.469521898716443e-05, -3.493961903860623e-05, 0.00010289406993994924]]} - #*EXTRAS*# Step: 7 Bead: 45 -{"friction": [[0.00010423354886509322, -3.605045682101098e-05, -3.5982260127764844e-05], [-3.605045682101098e-05, 0.00010423133906345728, -3.620780585065814e-05], [-3.5982260127764844e-05, -3.620780585065814e-05, 0.0001039108323727449]]} - #*EXTRAS*# Step: 8 Bead: 45 -{"friction": [[0.00010483908489127552, -3.680042620323891e-05, -3.673225815676051e-05], [-3.680042620323891e-05, 0.00010483906886802344, -3.6925175375952574e-05], [-3.673225815676051e-05, -3.6925175375952574e-05, 0.00010457722230730651]]} - #*EXTRAS*# Step: 9 Bead: 45 -{"friction": [[0.00010523795215181045, -3.726473786750674e-05, -3.719969350865754e-05], [-3.726473786750674e-05, 0.00010523746707756129, -3.736652614721553e-05], [-3.719969350865754e-05, -3.736652614721553e-05, 0.0001050181732771548]]} - #*EXTRAS*# Step: 10 Bead: 45 -{"friction": [[0.00010549588701365738, -3.7553861896376296e-05, -3.749198966564414e-05], [-3.7553861896376296e-05, 0.00010549465173017284, -3.7640870454003506e-05], [-3.749198966564414e-05, -3.7640870454003506e-05, 0.00010530348288856685]]} - #*EXTRAS*# Step: 11 Bead: 45 -{"friction": [[0.00010566300454966081, -3.77368330641816e-05, -3.767746352403932e-05], [-3.77368330641816e-05, 0.00010566118173486096, -3.781446206860914e-05], [-3.767746352403932e-05, -3.781446206860914e-05, 0.0001054882399366176]]} - #*EXTRAS*# Step: 12 Bead: 45 -{"friction": [[0.00010577062338650553, -3.785292258213887e-05, -3.779534251587365e-05], [-3.785292258213887e-05, 0.00010576840136734514, -3.7924635294822145e-05], [-3.779534251587365e-05, -3.7924635294822145e-05, 0.0001056071366862492]]} - #*EXTRAS*# Step: 13 Bead: 45 -{"friction": [[0.00010583981063831308, -3.792685434052792e-05, -3.787049620061222e-05], [-3.792685434052792e-05, 0.00010583732881175195, -3.799482561345527e-05], [-3.787049620061222e-05, -3.799482561345527e-05, 0.00010568353015737393]]} - #*EXTRAS*# Step: 14 Bead: 45 -{"friction": [[0.00010588419671747183, -3.797399975994023e-05, -3.791845446565284e-05], [-3.797399975994023e-05, 0.00010588154832309794, -3.8039599168880295e-05], [-3.791845446565284e-05, -3.8039599168880295e-05, 0.00010573251830536752]]} - #*EXTRAS*# Step: 15 Bead: 45 -{"friction": [[0.00010591264448771072, -3.80041002905466e-05, -3.7949087721920757e-05], [-3.80041002905466e-05, 0.00010590988974815205, -3.806819193957951e-05], [-3.7949087721920757e-05, -3.806819193957951e-05, 0.00010576390628262574]]} - #*EXTRAS*# Step: 16 Bead: 45 -{"friction": [[0.00010593086271246113, -3.802332976375978e-05, -3.796866314843513e-05], [-3.802332976375978e-05, 0.00010592804013250864, -3.8086461111016226e-05], [-3.796866314843513e-05, -3.8086461111016226e-05, 0.0001057840034278351]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_46 b/drivers/py/pes/friction/frictionH/060K/inst.raw_46 deleted file mode 100644 index 1a0887ef8..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_46 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 46 -{"friction": [[0.00010570677276922272, -3.778420803142114e-05, -3.7725549753719546e-05], [-3.778420803142114e-05, 0.0001057047887977086, -3.7859417660977375e-05], [-3.7725549753719546e-05, -3.7859417660977375e-05, 0.00010553660403377729]]} - #*EXTRAS*# Step: 1 Bead: 46 -{"friction": [[0.00010312068182388208, -3.448961136841816e-05, -3.444073715784168e-05], [-3.448961136841816e-05, 0.0001030958742800372, -3.468198192095972e-05], [-3.444073715784168e-05, -3.468198192095972e-05, 0.00010271324538096658]]} - #*EXTRAS*# Step: 2 Bead: 46 -{"friction": [[0.00010118870594557712, -3.105428811993952e-05, -3.108274541285152e-05], [-3.105428811993952e-05, 0.00010107008668698186, -3.114540474587346e-05], [-3.108274541285152e-05, -3.114540474587346e-05, 0.00010085883309608546]]} - #*EXTRAS*# Step: 3 Bead: 46 -{"friction": [[9.968233045865866e-05, -2.80771184889227e-05, -2.8067641990699267e-05], [-2.80771184889227e-05, 9.960661181690746e-05, -2.797709423026835e-05], [-2.8067641990699267e-05, -2.797709423026835e-05, 9.974359299421726e-05]]} - #*EXTRAS*# Step: 4 Bead: 46 -{"friction": [[9.99707557669177e-05, -2.8636054547941205e-05, -2.8647743653415935e-05], [-2.8636054547941205e-05, 9.987007008668562e-05, -2.8574889668780047e-05], [-2.8647743653415935e-05, -2.8574889668780047e-05, 9.993393659420326e-05]]} - #*EXTRAS*# Step: 5 Bead: 46 -{"friction": [[0.00010144063187069611, -3.1546332675361663e-05, -3.156724661264432e-05], [-3.1546332675361663e-05, 0.00010133146204474885, -3.166277638729108e-05], [-3.156724661264432e-05, -3.166277638729108e-05, 0.00010107610013894785]]} - #*EXTRAS*# Step: 6 Bead: 46 -{"friction": [[0.00010248419750378064, -3.345716411469634e-05, -3.3432888834879214e-05], [-3.345716411469634e-05, 0.0001024301307513911, -3.3641027859179616e-05], [-3.3432888834879214e-05, -3.3641027859179616e-05, 0.0001020604329771546]]} - #*EXTRAS*# Step: 7 Bead: 46 -{"friction": [[0.00010329714723657551, -3.475648491672512e-05, -3.470247742075372e-05], [-3.475648491672512e-05, 0.00010327831287759902, -3.494693137309133e-05], [-3.470247742075372e-05, -3.494693137309133e-05, 0.0001028993281705598]]} - #*EXTRAS*# Step: 8 Bead: 46 -{"friction": [[0.00010382635102082632, -3.551048701421213e-05, -3.5446036589264305e-05], [-3.551048701421213e-05, 0.00010381948879483968, -3.568593893862973e-05], [-3.5446036589264305e-05, -3.568593893862973e-05, 0.00010346702609829425]]} - #*EXTRAS*# Step: 9 Bead: 46 -{"friction": [[0.00010418086841561535, -3.59823408719403e-05, -3.591444408854958e-05], [-3.59823408719403e-05, 0.00010417822984372442, -3.614225991259169e-05], [-3.591444408854958e-05, -3.614225991259169e-05, 0.00010385316609913986]]} - #*EXTRAS*# Step: 10 Bead: 46 -{"friction": [[0.00010441175575530671, -3.6277309248118946e-05, -3.62084751995981e-05], [-3.6277309248118946e-05, 0.0001044106757169697, -3.642557619933238e-05], [-3.62084751995981e-05, -3.642557619933238e-05, 0.0001041063426659083]]} - #*EXTRAS*# Step: 11 Bead: 46 -{"friction": [[0.00010456219513787276, -3.6464708935239637e-05, -3.6395769512193725e-05], [-3.6464708935239637e-05, 0.00010456172614029575, -3.6604922819226556e-05], [-3.6395769512193725e-05, -3.6604922819226556e-05, 0.00010427183551520427]]} - #*EXTRAS*# Step: 12 Bead: 46 -{"friction": [[0.00010465935201701016, -3.6583830088930845e-05, -3.651502281566863e-05], [-3.6583830088930845e-05, 0.00010465913261351188, -3.6718696350295903e-05], [-3.651502281566863e-05, -3.6718696350295903e-05, 0.00010437889082790067]]} - #*EXTRAS*# Step: 13 Bead: 46 -{"friction": [[0.00010472194341555205, -3.66598052225658e-05, -3.659116341596077e-05], [-3.66598052225658e-05, 0.00010472183069211772, -3.6791177087529916e-05], [-3.659116341596077e-05, -3.6791177087529916e-05, 0.00010444792095636778]]} - #*EXTRAS*# Step: 14 Bead: 46 -{"friction": [[0.00010476214583505724, -3.670829375493973e-05, -3.6639790702226404e-05], [-3.670829375493973e-05, 0.00010476208083853802, -3.6837403793541606e-05], [-3.6639790702226404e-05, -3.6837403793541606e-05, 0.00010449228158515653]]} - #*EXTRAS*# Step: 15 Bead: 46 -{"friction": [[0.0001047879330882239, -3.6739269910907394e-05, -3.667086904645554e-05], [-3.6739269910907394e-05, 0.00010478789054841851, -3.686692275226453e-05], [-3.667086904645554e-05, -3.686692275226453e-05, 0.00010452074461239907]]} - #*EXTRAS*# Step: 16 Bead: 46 -{"friction": [[0.00010480445560189681, -3.675906570134224e-05, -3.6690735680612935e-05], [-3.675906570134224e-05, 0.0001048044242047548, -3.688578246046996e-05], [-3.6690735680612935e-05, -3.688578246046996e-05, 0.0001045389848744415]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_47 b/drivers/py/pes/friction/frictionH/060K/inst.raw_47 deleted file mode 100644 index 0c9897a5f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_47 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 47 -{"friction": [[0.00010528762108165504, -3.73210662070218e-05, -3.725656530783905e-05], [-3.73210662070218e-05, 0.0001052870117955876, -3.741999059478165e-05], [-3.725656530783905e-05, -3.741999059478165e-05, 0.00010507311718896647]]} - #*EXTRAS*# Step: 1 Bead: 47 -{"friction": [[0.00010274627639563953, -3.389551065734809e-05, -3.3860145084141096e-05], [-3.389551065734809e-05, 0.00010270548969082022, -3.408587195571511e-05], [-3.3860145084141096e-05, -3.408587195571511e-05, 0.00010232537340242907]]} - #*EXTRAS*# Step: 2 Bead: 47 -{"friction": [[0.00010082068108630414, -3.032409503989544e-05, -3.035816602401009e-05], [-3.032409503989544e-05, 0.00010069467353867162, -3.037330952175579e-05], [-3.035816602401009e-05, -3.037330952175579e-05, 0.0001005574317751368]]} - #*EXTRAS*# Step: 3 Bead: 47 -{"friction": [[9.920504068560729e-05, -2.7156468071478975e-05, -2.7098878774828026e-05], [-2.7156468071478975e-05, 9.918686903680222e-05, -2.6992935136534412e-05], [-2.7098878774828026e-05, -2.6992935136534412e-05, 9.944576956092008e-05]]} - #*EXTRAS*# Step: 4 Bead: 47 -{"friction": [[9.940277498268246e-05, -2.7539329161750653e-05, -2.7503362054672305e-05], [-2.7539329161750653e-05, 9.93586132212277e-05, -2.74019193440054e-05], [-2.7503362054672305e-05, -2.74019193440054e-05, 9.956703224640248e-05]]} - #*EXTRAS*# Step: 5 Bead: 47 -{"friction": [[0.00010084439524941145, -3.0371395580612684e-05, -3.0405336869925727e-05], [-3.0371395580612684e-05, 0.00010071858696790643, -3.0423459846632693e-05], [-3.0405336869925727e-05, -3.0423459846632693e-05, 0.00010057627179970382]]} - #*EXTRAS*# Step: 6 Bead: 47 -{"friction": [[0.00010179269519783546, -3.221720579593893e-05, -3.2224237484325155e-05], [-3.221720579593893e-05, 0.00010170063727123359, -3.236355131338419e-05], [-3.2224237484325155e-05, -3.236355131338419e-05, 0.00010139388097483068]]} - #*EXTRAS*# Step: 7 Bead: 47 -{"friction": [[0.00010250897479811667, -3.349938703688066e-05, -3.347402118425864e-05], [-3.349938703688066e-05, 0.00010245621870450947, -3.36840474013729e-05], [-3.347402118425864e-05, -3.36840474013729e-05, 0.00010208522289680759]]} - #*EXTRAS*# Step: 8 Bead: 47 -{"friction": [[0.00010296450019051039, -3.424640363274644e-05, -3.4202767202460804e-05], [-3.424640363274644e-05, 0.00010293353115209994, -3.443895896357693e-05], [-3.4202767202460804e-05, -3.443895896357693e-05, 0.00010255022262549286]]} - #*EXTRAS*# Step: 9 Bead: 47 -{"friction": [[0.00010327149167487319, -3.471820367841357e-05, -3.466488779131122e-05], [-3.471820367841357e-05, 0.00010325185753543282, -3.490904073470429e-05], [-3.466488779131122e-05, -3.490904073470429e-05, 0.00010287215775947507]]} - #*EXTRAS*# Step: 10 Bead: 47 -{"friction": [[0.00010347275029095793, -3.501397636629875e-05, -3.495572195041159e-05], [-3.501397636629875e-05, 0.0001034587939298016, -3.520081889515659e-05], [-3.495572195041159e-05, -3.520081889515659e-05, 0.00010308626669746085]]} - #*EXTRAS*# Step: 11 Bead: 47 -{"friction": [[0.000103604679432416, -3.520250007715493e-05, -3.514158365435959e-05], [-3.520250007715493e-05, 0.0001035937616309445, -3.538567451297996e-05], [-3.514158365435959e-05, -3.538567451297996e-05, 0.00010322771529658312]]} - #*EXTRAS*# Step: 12 Bead: 47 -{"friction": [[0.00010369014355731514, -3.532250434420895e-05, -3.526009061898425e-05], [-3.532250434420895e-05, 0.00010368093625296378, -3.550291622394546e-05], [-3.526009061898425e-05, -3.550291622394546e-05, 0.00010331975252030344]]} - #*EXTRAS*# Step: 13 Bead: 47 -{"friction": [[0.00010374532369365785, -3.5399134420000404e-05, -3.533584490757743e-05], [-3.5399134420000404e-05, 0.00010373712071270386, -3.5577615476804445e-05], [-3.533584490757743e-05, -3.5577615476804445e-05, 0.0001033793322506754]]} - #*EXTRAS*# Step: 14 Bead: 47 -{"friction": [[0.00010378081052701893, -3.5448071985329125e-05, -3.538425596341766e-05], [-3.5448071985329125e-05, 0.00010377321388698839, -3.562525389563364e-05], [-3.538425596341766e-05, -3.562525389563364e-05, 0.00010341770946960422]]} - #*EXTRAS*# Step: 15 Bead: 47 -{"friction": [[0.00010380359248853033, -3.5479349472316954e-05, -3.541521033617155e-05], [-3.5479349472316954e-05, 0.00010379636928860843, -3.565567458542703e-05], [-3.541521033617155e-05, -3.565567458542703e-05, 0.00010344237125116261]]} - #*EXTRAS*# Step: 16 Bead: 47 -{"friction": [[0.00010381819699915873, -3.549934324545063e-05, -3.543500303696491e-05], [-3.549934324545063e-05, 0.00010381120681602313, -3.5675109977851966e-05], [-3.543500303696491e-05, -3.5675109977851966e-05, 0.00010345819056574255]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_48 b/drivers/py/pes/friction/frictionH/060K/inst.raw_48 deleted file mode 100644 index 0723fdb46..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_48 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 48 -{"friction": [[0.00010490062451440705, -3.687350091212312e-05, -3.6805665261342465e-05], [-3.687350091212312e-05, 0.00010490061033065456, -3.69947368229772e-05], [-3.6805665261342465e-05, -3.69947368229772e-05, 0.0001046451982602587]]} - #*EXTRAS*# Step: 1 Bead: 48 -{"friction": [[0.00010241218749187014, -3.333354022513325e-05, -3.331247262865845e-05], [-3.333354022513325e-05, 0.00010235426035805363, -3.35148718125976e-05], [-3.331247262865845e-05, -3.35148718125976e-05, 0.00010198870964078345]]} - #*EXTRAS*# Step: 2 Bead: 48 -{"friction": [[0.00010047994921406065, -2.96436278916192e-05, -2.967540235593756e-05], [-2.96436278916192e-05, 0.0001003560631094302, -2.9650132463857295e-05], [-2.967540235593756e-05, -2.9650132463857295e-05, 0.00010029555401847941]]} - #*EXTRAS*# Step: 3 Bead: 48 -{"friction": [[9.877353267481574e-05, -2.6296523145280043e-05, -2.618522439671099e-05], [-2.6296523145280043e-05, 9.882088027899617e-05, -2.6077497201697387e-05], [-2.618522439671099e-05, -2.6077497201697387e-05, 9.918846004428267e-05]]} - #*EXTRAS*# Step: 4 Bead: 48 -{"friction": [[9.888003440097208e-05, -2.6513293046411083e-05, -2.641596744529621e-05], [-2.6513293046411083e-05, 9.891019458323802e-05, -2.630771999392694e-05], [-2.641596744529621e-05, -2.630771999392694e-05, 9.925124835351527e-05]]} - #*EXTRAS*# Step: 5 Bead: 48 -{"friction": [[0.0001002926078955002, -2.927063199407184e-05, -2.9297493818048076e-05], [-2.927063199407184e-05, 0.00010017427283758008, -2.925258204666208e-05], [-2.9297493818048076e-05, -2.925258204666208e-05, 0.0001001584833375123]]} - #*EXTRAS*# Step: 6 Bead: 48 -{"friction": [[0.00010118228218269887, -3.1041639755543175e-05, -3.1070254933904884e-05], [-3.1041639755543175e-05, 0.00010106346269848581, -3.1132071894849516e-05], [-3.1070254933904884e-05, -3.1132071894849516e-05, 0.00010085340790604885]]} - #*EXTRAS*# Step: 7 Bead: 48 -{"friction": [[0.00010183475213105653, -3.229576704591551e-05, -3.2300967415999325e-05], [-3.229576704591551e-05, 0.00010174493637136346, -3.2445219489107416e-05], [-3.2300967415999325e-05, -3.2445219489107416e-05, 0.00010143288877148483]]} - #*EXTRAS*# Step: 8 Bead: 48 -{"friction": [[0.00010223747837220154, -3.302806479858911e-05, -3.301495058421632e-05], [-3.302806479858911e-05, 0.00010216994705051909, -3.320191163011509e-05], [-3.301495058421632e-05, -3.320191163011509e-05, 0.00010181678529110152]]} - #*EXTRAS*# Step: 9 Bead: 48 -{"friction": [[0.000102505976416638, -3.34942860893554e-05, -3.346905182061658e-05], [-3.34942860893554e-05, 0.00010245306223493712, -3.367885208384535e-05], [-3.346905182061658e-05, -3.367885208384535e-05, 0.000102082220004412]]} - #*EXTRAS*# Step: 10 Bead: 48 -{"friction": [[0.00010268041444454005, -3.378707911292343e-05, -3.3754397561468144e-05], [-3.378707911292343e-05, 0.00010263642429977745, -3.3976207104015986e-05], [-3.3754397561468144e-05, -3.3976207104015986e-05, 0.00010225824213166934]]} - #*EXTRAS*# Step: 11 Bead: 48 -{"friction": [[0.00010279451974116389, -3.397419367701251e-05, -3.3936913599664164e-05], [-3.397419367701251e-05, 0.00010275601329657256, -3.416528939484107e-05], [-3.3936913599664164e-05, -3.416528939484107e-05, 0.00010237476816998179]]} - #*EXTRAS*# Step: 12 Bead: 48 -{"friction": [[0.00010286836803173804, -3.409341788894801e-05, -3.405329849590342e-05], [-3.409341788894801e-05, 0.0001028332352806251, -3.428536267494743e-05], [-3.405329849590342e-05, -3.428536267494743e-05, 0.00010245072966523856]]} - #*EXTRAS*# Step: 13 Bead: 48 -{"friction": [[0.00010291605558731851, -3.416962166570133e-05, -3.412773126579041e-05], [-3.416962166570133e-05, 0.00010288302176043987, -3.4361938932081395e-05], [-3.412773126579041e-05, -3.4361938932081395e-05, 0.00010250000015075995]]} - #*EXTRAS*# Step: 14 Bead: 48 -{"friction": [[0.00010294672807677494, -3.421830976625893e-05, -3.4175307510870735e-05], [-3.421830976625893e-05, 0.00010291500963698059, -3.441079413412964e-05], [-3.4175307510870735e-05, -3.441079413412964e-05, 0.00010253177871532054]]} - #*EXTRAS*# Step: 15 Bead: 48 -{"friction": [[0.0001029664236126996, -3.424943900930914e-05, -3.4205734392960515e-05], [-3.424943900930914e-05, 0.00010293553511074273, -3.44420008849487e-05], [-3.4205734392960515e-05, -3.44420008849487e-05, 0.00010255222010134212]]} - #*EXTRAS*# Step: 16 Bead: 48 -{"friction": [[0.00010297905134956256, -3.426934207992203e-05, -3.422519200204534e-05], [-3.426934207992203e-05, 0.00010294868880536898, -3.446194142502017e-05], [-3.422519200204534e-05, -3.446194142502017e-05, 0.00010256534051166263]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_49 b/drivers/py/pes/friction/frictionH/060K/inst.raw_49 deleted file mode 100644 index 3c2e0d031..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_49 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 49 -{"friction": [[0.00010454547171753977, -3.6444056165635773e-05, -3.637510960233212e-05], [-3.6444056165635773e-05, 0.00010454494879362924, -3.658517988655125e-05], [-3.637510960233212e-05, -3.658517988655125e-05, 0.00010425342130998133]]} - #*EXTRAS*# Step: 1 Bead: 49 -{"friction": [[0.00010211257595627723, -3.280500640034903e-05, -3.279764370768853e-05], [-3.280500640034903e-05, 0.00010203807193065473, -3.2972342949772675e-05], [-3.279764370768853e-05, -3.2972342949772675e-05, 0.00010169579348202292]]} - #*EXTRAS*# Step: 2 Bead: 49 -{"friction": [[0.00010016246114352229, -2.901284968861217e-05, -2.903463240241026e-05], [-2.901284968861217e-05, 0.00010004998899101943, -2.8977460124696344e-05], [-2.903463240241026e-05, -2.8977460124696344e-05, 0.00010006605631440637]]} - #*EXTRAS*# Step: 3 Bead: 49 -{"friction": [[9.839747190985914e-05, -2.54928134013641e-05, -2.532928934037445e-05], [-2.54928134013641e-05, 9.851013654734162e-05, -2.5228106623200587e-05], [-2.532928934037445e-05, -2.5228106623200587e-05, 9.896871658520104e-05]]} - #*EXTRAS*# Step: 4 Bead: 49 -{"friction": [[9.842337451690667e-05, -2.555061232986489e-05, -2.5390804429279854e-05], [-2.555061232986489e-05, 9.853132640214412e-05, -2.528894076132812e-05], [-2.5390804429279854e-05, -2.528894076132812e-05, 9.898381122857562e-05]]} - #*EXTRAS*# Step: 5 Bead: 49 -{"friction": [[9.977103840718073e-05, -2.8248143600011888e-05, -2.8245911679802298e-05], [-2.8248143600011888e-05, 9.968674672345859e-05, -2.8160053934878053e-05], [-2.8245911679802298e-05, -2.8160053934878053e-05, 9.980114032200482e-05]]} - #*EXTRAS*# Step: 6 Bead: 49 -{"friction": [[0.00010062787645744466, -2.9939035220358906e-05, -2.997280282306848e-05], [-2.9939035220358906e-05, 0.00010050187449722171, -2.9964449721743494e-05], [-2.997280282306848e-05, -2.9964449721743494e-05, 0.00010040722963255531]]} - #*EXTRAS*# Step: 7 Bead: 49 -{"friction": [[0.00010124123564694494, -3.115754762659955e-05, -3.1184644419997235e-05], [-3.115754762659955e-05, 0.00010112433593662723, -3.1254192283173354e-05], [-3.1184644419997235e-05, -3.1254192283173354e-05, 0.00010090341338396506]]} - #*EXTRAS*# Step: 8 Bead: 49 -{"friction": [[0.00010160885132825532, -3.186966587590332e-05, -3.188432554349781e-05], [-3.186966587590332e-05, 0.00010150742003995001, -3.2001243783857183e-05], [-3.188432554349781e-05, -3.2001243783857183e-05, 0.0001012259457437926]]} - #*EXTRAS*# Step: 9 Bead: 49 -{"friction": [[0.00010185120563935048, -3.232640113578066e-05, -3.2330878135532325e-05], [-3.232640113578066e-05, 0.00010176227476055784, -3.2477040976626464e-05], [-3.2330878135532325e-05, -3.2477040976626464e-05, 0.00010144820770670582]]} - #*EXTRAS*# Step: 10 Bead: 49 -{"friction": [[0.00010200702044850023, -3.261358844049192e-05, -3.261106554561141e-05], [-3.261358844049192e-05, 0.00010192663134453903, -3.2774677474388934e-05], [-3.261106554561141e-05, -3.2774677474388934e-05, 0.00010159486482971633]]} - #*EXTRAS*# Step: 11 Bead: 49 -{"friction": [[0.00010210842953887038, -3.2797536682337295e-05, -3.279036483114311e-05], [-3.2797536682337295e-05, 0.00010203369376291654, -3.296464064700175e-05], [-3.279036483114311e-05, -3.296464064700175e-05, 0.00010169180556268276]]} - #*EXTRAS*# Step: 12 Bead: 49 -{"friction": [[0.00010217380299432583, -3.291482487003572e-05, -3.290464179215675e-05], [-3.291482487003572e-05, 0.00010210272101878258, -3.3085472927280954e-05], [-3.290464179215675e-05, -3.3085472927280954e-05, 0.00010175489651475224]]} - #*EXTRAS*# Step: 13 Bead: 49 -{"friction": [[0.00010221592597788603, -3.298984806160176e-05, -3.297772511918078e-05], [-3.298984806160176e-05, 0.00010214719453104758, -3.316264025642074e-05], [-3.297772511918078e-05, -3.316264025642074e-05, 0.00010179579010919835]]} - #*EXTRAS*# Step: 14 Bead: 49 -{"friction": [[0.00010224297790625268, -3.303779811532473e-05, -3.302443116030994e-05], [-3.303779811532473e-05, 0.0001021757524675101, -3.321190945308088e-05], [-3.302443116030994e-05, -3.321190945308088e-05, 0.00010182215034787974]]} - #*EXTRAS*# Step: 15 Bead: 49 -{"friction": [[0.00010226033271521992, -3.306846398410719e-05, -3.3054300109170756e-05], [-3.306846398410719e-05, 0.00010219407147145082, -3.3243397730321056e-05], [-3.3054300109170756e-05, -3.3243397730321056e-05, 0.00010183910120187115]]} - #*EXTRAS*# Step: 16 Bead: 49 -{"friction": [[0.00010227145290240907, -3.308807371704193e-05, -3.3073399797377163e-05], [-3.308807371704193e-05, 0.0001022058085320992, -3.326352460775726e-05], [-3.3073399797377163e-05, -3.326352460775726e-05, 0.00010184997876775155]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_50 b/drivers/py/pes/friction/frictionH/060K/inst.raw_50 deleted file mode 100644 index d7a70a6b7..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_50 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 50 -{"friction": [[0.00010422157793290393, -3.6035021611147086e-05, -3.5966888494172815e-05], [-3.6035021611147086e-05, 0.00010421927471690661, -3.619295965410192e-05], [-3.5966888494172815e-05, -3.619295965410192e-05, 0.00010389772288898436]]} - #*EXTRAS*# Step: 1 Bead: 50 -{"friction": [[0.00010184286409641186, -3.231087751270343e-05, -3.231572170477077e-05], [-3.231087751270343e-05, 0.0001017534840941216, -3.246091735319335e-05], [-3.231572170477077e-05, -3.246091735319335e-05, 0.00010144043728980299]]} - #*EXTRAS*# Step: 2 Bead: 50 -{"friction": [[9.986564096886184e-05, -2.8431282856047567e-05, -2.843607677563736e-05], [-2.8431282856047567e-05, 9.97730610010615e-05, -2.835594198424407e-05], [-2.843607677563736e-05, -2.835594198424407e-05, 9.986345311413552e-05]]} - #*EXTRAS*# Step: 3 Bead: 50 -{"friction": [[9.808044547478142e-05, -2.474260497040455e-05, -2.4532701810930088e-05], [-2.474260497040455e-05, 9.825305387157817e-05, -2.4442611092722866e-05], [-2.4532701810930088e-05, -2.4442611092722866e-05, 9.878314938907566e-05]]} - #*EXTRAS*# Step: 4 Bead: 50 -{"friction": [[9.804282580830414e-05, -2.4647016299492422e-05, -2.4431544083885696e-05], [-2.4647016299492422e-05, 9.822280472410111e-05, -2.434311526444534e-05], [-2.4431544083885696e-05, -2.434311526444534e-05, 9.876090997698144e-05]]} - #*EXTRAS*# Step: 5 Bead: 50 -{"friction": [[9.928046578102524e-05, -2.7302998692466298e-05, -2.725391000581015e-05], [-2.7302998692466298e-05, 9.92520513363811e-05, -2.714939082438386e-05], [-2.725391000581015e-05, -2.714939082438386e-05, 9.949171995819893e-05]]} - #*EXTRAS*# Step: 6 Bead: 50 -{"friction": [[0.00010011276245628187, -2.8914798496965835e-05, -2.8934267561954046e-05], [-2.8914798496965835e-05, 0.00010000298017630164, -2.887274624923963e-05], [-2.8934267561954046e-05, -2.887274624923963e-05, 0.00010003135135167634]]} - #*EXTRAS*# Step: 7 Bead: 50 -{"friction": [[0.00010070493408416996, -3.0092993496150513e-05, -3.012718098213182e-05], [-3.0092993496150513e-05, 0.0001005785720822103, -3.012804724590641e-05], [-3.012718098213182e-05, -3.012804724590641e-05, 0.00010046662618761619]]} - #*EXTRAS*# Step: 8 Bead: 50 -{"friction": [[0.00010105054520866393, -3.078135380745269e-05, -3.0812770659302374e-05], [-3.078135380745269e-05, 0.00010092813737237016, -3.085735882247448e-05], [-3.0812770659302374e-05, -3.085735882247448e-05, 0.00010074342977187761]]} - #*EXTRAS*# Step: 9 Bead: 50 -{"friction": [[0.00010127610226880505, -3.122590875650482e-05, -3.125203657541698e-05], [-3.122590875650482e-05, 0.00010116042194024815, -3.132615308405544e-05], [-3.125203657541698e-05, -3.132615308405544e-05, 0.00010093321556631456]]} - #*EXTRAS*# Step: 10 Bead: 50 -{"friction": [[0.00010141963783795289, -3.150566076041346e-05, -3.152729444047112e-05], [-3.150566076041346e-05, 0.00010130957324371036, -3.162011204809938e-05], [-3.152729444047112e-05, -3.162011204809938e-05, 0.00010105766317638271]]} - #*EXTRAS*# Step: 11 Bead: 50 -{"friction": [[0.00010151258620180548, -3.168520990542833e-05, -3.170354932455329e-05], [-3.168520990542833e-05, 0.00010140660913335766, -3.1808310292156957e-05], [-3.170354932455329e-05, -3.1808310292156957e-05, 0.00010113973809477499]]} - #*EXTRAS*# Step: 12 Bead: 50 -{"friction": [[0.00010157226592221296, -3.179975230053877e-05, -3.181583982149026e-05], [-3.179975230053877e-05, 0.00010146907291930396, -3.19281671075682e-05], [-3.181583982149026e-05, -3.19281671075682e-05, 0.0001011930400636229]]} - #*EXTRAS*# Step: 13 Bead: 50 -{"friction": [[0.00010161063428735534, -3.1873066974763386e-05, -3.188765619188124e-05], [-3.1873066974763386e-05, 0.00010150928985614295, -3.200479716966899e-05], [-3.188765619188124e-05, -3.200479716966899e-05, 0.00010122755380597295]]} - #*EXTRAS*# Step: 14 Bead: 50 -{"friction": [[0.00010163523603689656, -3.191993753760366e-05, -3.193354678327291e-05], [-3.191993753760366e-05, 0.000101535099179572, -3.205375120705757e-05], [-3.193354678327291e-05, -3.205375120705757e-05, 0.00010124978409963043]]} - #*EXTRAS*# Step: 15 Bead: 50 -{"friction": [[0.00010165100401287871, -3.1949920006789815e-05, -3.196289365375916e-05], [-3.1949920006789815e-05, 0.00010155164977982365, -3.208505147312827e-05], [-3.196289365375916e-05, -3.208505147312827e-05, 0.00010126407299685324]]} - #*EXTRAS*# Step: 16 Bead: 50 -{"friction": [[0.00010166110101526962, -3.196909502854489e-05, -3.19816586977276e-05], [-3.196909502854489e-05, 0.00010156225135565583, -3.210506309768043e-05], [-3.19816586977276e-05, -3.210506309768043e-05, 0.0001012732395590608]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_51 b/drivers/py/pes/friction/frictionH/060K/inst.raw_51 deleted file mode 100644 index c3afa918b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_51 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 51 -{"friction": [[0.00010392810737404057, -3.564841585082599e-05, -3.5582711172999606e-05], [-3.564841585082599e-05, 0.0001039227172200635, -3.581976330672245e-05], [-3.5582711172999606e-05, -3.581976330672245e-05, 0.00010357747568088037]]} - #*EXTRAS*# Step: 1 Bead: 51 -{"friction": [[0.00010159950057720748, -3.185181944597111e-05, -3.186684729834325e-05], [-3.185181944597111e-05, 0.00010149761526160896, -3.1982595836817304e-05], [-3.186684729834325e-05, -3.1982595836817304e-05, 0.00010121751897000925]]} - #*EXTRAS*# Step: 2 Bead: 51 -{"friction": [[9.958909900009009e-05, -2.789777900535259e-05, -2.7880055002417155e-05], [-2.789777900535259e-05, 9.95231709371138e-05, -2.7785242086469034e-05], [-2.7880055002417155e-05, -2.7785242086469034e-05, 9.968395042460206e-05]]} - #*EXTRAS*# Step: 3 Bead: 51 -{"friction": [[9.78217089870107e-05, -2.404439877699718e-05, -2.3796302601172432e-05], [-2.404439877699718e-05, 9.804596309933551e-05, -2.3719233805716925e-05], [-2.3796302601172432e-05, -2.3719233805716925e-05, 9.862816350421207e-05]]} - #*EXTRAS*# Step: 4 Bead: 51 -{"friction": [[9.77405278754854e-05, -2.3800480966068397e-05, -2.354060447958986e-05], [-2.3800480966068397e-05, 9.798139686344618e-05, -2.3468444709559176e-05], [-2.354060447958986e-05, -2.3468444709559176e-05, 9.857812122444582e-05]]} - #*EXTRAS*# Step: 5 Bead: 51 -{"friction": [[9.883832725990797e-05, -2.6428843222474272e-05, -2.632609563401284e-05], [-2.6428843222474272e-05, 9.887514396599439e-05, -2.6217979705177336e-05], [-2.632609563401284e-05, -2.6217979705177336e-05, 9.922661537357304e-05]]} - #*EXTRAS*# Step: 6 Bead: 51 -{"friction": [[9.962749822488106e-05, -2.797161357889566e-05, -2.7957362021950412e-05], [-2.797161357889566e-05, 9.955744415964286e-05, -2.7864225829908813e-05], [-2.7957362021950412e-05, -2.7864225829908813e-05, 9.97084161708547e-05]]} - #*EXTRAS*# Step: 7 Bead: 51 -{"friction": [[0.00010021026592541625, -2.9107377345657472e-05, -2.9131189007792164e-05], [-2.9107377345657472e-05, 0.0001000954434032451, -2.9078377307351963e-05], [-2.9131189007792164e-05, -2.9078377307351963e-05, 0.00010009974440916409]]} - #*EXTRAS*# Step: 8 Bead: 51 -{"friction": [[0.00010054324161118794, -2.9769969204196133e-05, -2.9802792775049977e-05], [-2.9769969204196133e-05, 0.00010041821443323132, -2.9784624560543882e-05], [-2.9802792775049977e-05, -2.9784624560543882e-05, 0.00010034295979970767]]} - #*EXTRAS*# Step: 9 Bead: 51 -{"friction": [[0.00010075884608004766, -3.020067281117671e-05, -3.023491470121282e-05], [-3.020067281117671e-05, 0.00010063251906437104, -3.0242372436843226e-05], [-3.023491470121282e-05, -3.0242372436843226e-05, 0.00010050868356586719]]} - #*EXTRAS*# Step: 10 Bead: 51 -{"friction": [[0.00010089478789587937, -3.0471831879516735e-05, -3.050538313122385e-05], [-3.0471831879516735e-05, 0.00010076953984804766, -3.052988965326851e-05], [-3.050538313122385e-05, -3.052988965326851e-05, 0.0001006165734466744]]} - #*EXTRAS*# Step: 11 Bead: 51 -{"friction": [[0.00010098242631406213, -3.0646185011996586e-05, -3.067870174926936e-05], [-3.0646185011996586e-05, 0.0001008585779062183, -3.071445308804897e-05], [-3.067870174926936e-05, -3.071445308804897e-05, 0.00010068752545999048]]} - #*EXTRAS*# Step: 12 Bead: 51 -{"friction": [[0.0001010384879813515, -3.0757454157938243e-05, -3.078908378337422e-05], [-3.0757454157938243e-05, 0.00010091580361460243, -3.083210294493325e-05], [-3.078908378337422e-05, -3.083210294493325e-05, 0.00010073348655127778]]} - #*EXTRAS*# Step: 13 Bead: 51 -{"friction": [[0.00010107445596722977, -3.0828714177130266e-05, -3.085968668264369e-05], [-3.0828714177130266e-05, 0.00010095262316917772, -3.090739147342865e-05], [-3.085968668264369e-05, -3.090739147342865e-05, 0.00010076320919101726]]} - #*EXTRAS*# Step: 14 Bead: 51 -{"friction": [[0.00010109748442467893, -3.087428067454206e-05, -3.09047975909096e-05], [-3.087428067454206e-05, 0.00010097623831993084, -3.095550960872202e-05], [-3.09047975909096e-05, -3.095550960872202e-05, 0.00010078233526043724]]} - #*EXTRAS*# Step: 15 Bead: 51 -{"friction": [[0.00010111223094094355, -3.09034346906858e-05, -3.093364589690335e-05], [-3.09034346906858e-05, 0.00010099137713648245, -3.098628605532633e-05], [-3.093364589690335e-05, -3.098628605532633e-05, 0.00010079462220181947]]} - #*EXTRAS*# Step: 16 Bead: 51 -{"friction": [[0.0001011216682043396, -3.0922081677912555e-05, -3.095209160352582e-05], [-3.0922081677912555e-05, 0.00010100107215592385, -3.1005966558795484e-05], [-3.095209160352582e-05, -3.1005966558795484e-05, 0.00010080250152601363]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_52 b/drivers/py/pes/friction/frictionH/060K/inst.raw_52 deleted file mode 100644 index 0248cce00..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_52 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 52 -{"friction": [[0.00010366394327696455, -3.5285887569447394e-05, -3.522391444163986e-05], [-3.5285887569447394e-05, 0.00010365423205589712, -3.546717661556058e-05], [-3.522391444163986e-05, -3.546717661556058e-05, 0.00010329150520581095]]} - #*EXTRAS*# Step: 1 Bead: 52 -{"friction": [[0.00010137971738935573, -3.142814232946037e-05, -3.1451102768022846e-05], [-3.142814232946037e-05, 0.00010126800048912262, -3.153874370928429e-05], [-3.1451102768022846e-05, -3.153874370928429e-05, 0.00010102276928021121]]} - #*EXTRAS*# Step: 2 Bead: 52 -{"friction": [[9.93357944929949e-05, -2.7410070684412604e-05, -2.7367022899696978e-05], [-2.7410070684412604e-05, 9.930012079475498e-05, -2.7263775530006035e-05], [-2.7367022899696978e-05, -2.7263775530006035e-05, 9.952566022934459e-05]]} - #*EXTRAS*# Step: 3 Bead: 52 -{"friction": [[9.76175609700588e-05, -2.339749617873421e-05, -2.3120269406814896e-05], [-2.339749617873421e-05, 9.788387628951507e-05, -2.3056419767073376e-05], [-2.3120269406814896e-05, -2.3056419767073376e-05, 9.850012939991969e-05]]} - #*EXTRAS*# Step: 4 Bead: 52 -{"friction": [[9.751310161398863e-05, -2.3010564504919607e-05, -2.271942471523731e-05], [-2.3010564504919607e-05, 9.78011940029252e-05, -2.266361612288356e-05], [-2.271942471523731e-05, -2.266361612288356e-05, 9.843074074152643e-05]]} - #*EXTRAS*# Step: 5 Bead: 52 -{"friction": [[9.845527157098916e-05, -2.5621203741735716e-05, -2.5465951589750378e-05], [-2.5621203741735716e-05, 9.855746116242544e-05, -2.5363295791254894e-05], [-2.5465951589750378e-05, -2.5363295791254894e-05, 9.900239852764618e-05]]} - #*EXTRAS*# Step: 6 Bead: 52 -{"friction": [[9.917947608893624e-05, -2.7106626277552036e-05, -2.704608909068944e-05], [-2.7106626277552036e-05, 9.916486415593332e-05, -2.6939741752433517e-05], [-2.704608909068944e-05, -2.6939741752433517e-05, 9.94302733137955e-05]]} - #*EXTRAS*# Step: 7 Bead: 52 -{"friction": [[9.974794192495288e-05, -2.8203561701117104e-05, -2.8199502682521546e-05], [-2.8203561701117104e-05, 9.966580991354183e-05, -2.8112362456318632e-05], [-2.8199502682521546e-05, -2.8112362456318632e-05, 9.97860779479665e-05]]} - #*EXTRAS*# Step: 8 Bead: 52 -{"friction": [[0.000100074609905375, -2.883969265807147e-05, -2.885724271284861e-05], [-2.883969265807147e-05, 9.996706493717237e-05, -2.8792514408181942e-05], [-2.885724271284861e-05, -2.8792514408181942e-05, 0.00010000492651330525]]} - #*EXTRAS*# Step: 9 Bead: 52 -{"friction": [[0.00010028509410508422, -2.9255714081329458e-05, -2.9282320625274606e-05], [-2.9255714081329458e-05, 0.00010016705179855776, -2.9236668256038294e-05], [-2.9282320625274606e-05, -2.9236668256038294e-05, 0.00010015308564307156]]} - #*EXTRAS*# Step: 10 Bead: 52 -{"friction": [[0.00010041678575204521, -2.9517676715400762e-05, -2.9548101913287456e-05], [-2.9517676715400762e-05, 0.00010029440176976114, -2.9515968091117742e-05], [-2.9548101913287456e-05, -2.9515968091117742e-05, 0.00010024880062220468]]} - #*EXTRAS*# Step: 11 Bead: 52 -{"friction": [[0.00010050138174843617, -2.9686398054083988e-05, -2.9718561311985332e-05], [-2.9686398054083988e-05, 0.00010037706894539806, -2.9695672046773143e-05], [-2.9718561311985332e-05, -2.9695672046773143e-05, 0.00010031154424875213]]} - #*EXTRAS*# Step: 12 Bead: 52 -{"friction": [[0.00010055532515753637, -2.9794100854285308e-05, -2.9827090948770028e-05], [-2.9794100854285308e-05, 0.00010043012069783228, -2.9810302540792204e-05], [-2.9827090948770028e-05, -2.9810302540792204e-05, 0.00010035207408527163]]} - #*EXTRAS*# Step: 13 Bead: 52 -{"friction": [[0.00010058987415596834, -2.986311123372257e-05, -2.9896518747464187e-05], [-2.986311123372257e-05, 0.00010046423330558181, -2.9883715750335325e-05], [-2.9896518747464187e-05, -2.9883715750335325e-05, 0.00010037824667439686]]} - #*EXTRAS*# Step: 14 Bead: 52 -{"friction": [[0.00010061196581559928, -2.9907246340476335e-05, -2.9940875688919423e-05], [-2.9907246340476335e-05, 0.00010048610003506689, -2.9930651337553902e-05], [-2.9940875688919423e-05, -2.9930651337553902e-05, 0.00010039507035450281]]} - #*EXTRAS*# Step: 15 Bead: 52 -{"friction": [[0.00010062610170894928, -2.9935489271865783e-05, -2.9969242340033936e-05], [-2.9935489271865783e-05, 0.00010050011387458556, -2.99606799374882e-05], [-2.9969242340033936e-05, -2.99606799374882e-05, 0.00010040587155585479]]} - #*EXTRAS*# Step: 16 Bead: 52 -{"friction": [[0.00010063514351186697, -2.9953554921195183e-05, -2.9987379724816192e-05], [-2.9953554921195183e-05, 0.0001005090864862577, -2.9979885130413363e-05], [-2.9987379724816192e-05, -2.9979885130413363e-05, 0.00010041279518989028]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_53 b/drivers/py/pes/friction/frictionH/060K/inst.raw_53 deleted file mode 100644 index 805db799b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_53 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 53 -{"friction": [[0.00010342777205096691, -3.4948757364551355e-05, -3.48915119324289e-05], [-3.4948757364551355e-05, 0.00010341266127600232, -3.513667008856002e-05], [-3.48915119324289e-05, -3.513667008856002e-05, 0.0001030382318154365]]} - #*EXTRAS*# Step: 1 Bead: 53 -{"friction": [[0.0001011813874026259, -3.103987758716177e-05, -3.106851460775509e-05], [-3.103987758716177e-05, 0.0001010625402063414, -3.1130214238216904e-05], [-3.106851460775509e-05, -3.1130214238216904e-05, 0.00010085265267792885]]} - #*EXTRAS*# Step: 2 Bead: 53 -{"friction": [[9.91077096966672e-05, -2.6966143797481686e-05, -2.6897158817365743e-05], [-2.6966143797481686e-05, 9.910332108243037e-05, -2.6789887068105478e-05], [-2.6897158817365743e-05, -2.6789887068105478e-05, 9.938696841104092e-05]]} - #*EXTRAS*# Step: 3 Bead: 53 -{"friction": [[9.746244084800881e-05, -2.280172363673665e-05, -2.250428829831513e-05], [-2.280172363673665e-05, 9.776109648330735e-05, -2.2452781647492403e-05], [-2.250428829831513e-05, -2.2452781647492403e-05, 9.839552195165435e-05]]} - #*EXTRAS*# Step: 4 Bead: 53 -{"friction": [[9.735351943597568e-05, -2.2277895572195278e-05, -2.196870413396373e-05], [-2.2277895572195278e-05, 9.767466362736363e-05, -2.19276699660718e-05], [-2.196870413396373e-05, -2.19276699660718e-05, 9.831403133197474e-05]]} - #*EXTRAS*# Step: 5 Bead: 53 -{"friction": [[9.81347367182115e-05, -2.4877699996399277e-05, -2.467582229520593e-05], [-2.4877699996399277e-05, 9.829679905251022e-05, -2.4583465319669316e-05], [-2.467582229520593e-05, -2.4583465319669316e-05, 9.881512723082247e-05]]} - #*EXTRAS*# Step: 6 Bead: 53 -{"friction": [[9.878242950944426e-05, -2.6314777341568135e-05, -2.620466166171737e-05], [-2.6314777341568135e-05, 9.88283177016945e-05, -2.6096867910619694e-05], [-2.620466166171737e-05, -2.6096867910619694e-05, 9.919369149345864e-05]]} - #*EXTRAS*# Step: 7 Bead: 53 -{"friction": [[9.93204540590546e-05, -2.7380414417328086e-05, -2.7335708757746688e-05], [-2.7380414417328086e-05, 9.928677098115145e-05, -2.723208918345071e-05], [-2.7335708757746688e-05, -2.723208918345071e-05, 9.951622931633544e-05]]} - #*EXTRAS*# Step: 8 Bead: 53 -{"friction": [[9.96383248324306e-05, -2.7992437136421535e-05, -2.7979145739026198e-05], [-2.7992437136421535e-05, 9.956713088189292e-05, -2.788650235556343e-05], [-2.7979145739026198e-05, -2.788650235556343e-05, 9.971533899833806e-05]]} - #*EXTRAS*# Step: 9 Bead: 53 -{"friction": [[9.984632909987637e-05, -2.8393817432207427e-05, -2.8397238634744963e-05], [-2.8393817432207427e-05, 9.975536638045886e-05, -2.831587279434574e-05], [-2.8397238634744963e-05, -2.831587279434574e-05, 9.985064940508807e-05]]} - #*EXTRAS*# Step: 10 Bead: 53 -{"friction": [[9.997606095476824e-05, -2.8646426581457288e-05, -2.8658437869997936e-05], [-2.8646426581457288e-05, 9.98749973670603e-05, -2.858597696217655e-05], [-2.8658437869997936e-05, -2.858597696217655e-05, 9.993753005572131e-05]]} - #*EXTRAS*# Step: 11 Bead: 53 -{"friction": [[0.00010005918563976601, -2.88093721761132e-05, -2.8826110918522215e-05], [-2.88093721761132e-05, 9.995258800364756e-05, -2.8760119317182374e-05], [-2.8826110918522215e-05, -2.8760119317182374e-05, 9.999429663397172e-05]]} - #*EXTRAS*# Step: 12 Bead: 53 -{"friction": [[0.00010011205539527252, -2.8913405253643664e-05, -2.8932839887582476e-05], [-2.8913405253643664e-05, 0.00010000231321127458, -2.887125808931785e-05], [-2.8932839887582476e-05, -2.887125808931785e-05, 0.00010003085992437336]]} - #*EXTRAS*# Step: 13 Bead: 53 -{"friction": [[0.00010014587144142404, -2.898009355403116e-05, -2.9001127242790966e-05], [-2.898009355403116e-05, 0.00010003426910031352, -2.8942482011824316e-05], [-2.9001127242790966e-05, -2.8942482011824316e-05, 0.00010005443576820379]]} - #*EXTRAS*# Step: 14 Bead: 53 -{"friction": [[0.00010016747216024213, -2.9022748847299035e-05, -2.9044753240503206e-05], [-2.9022748847299035e-05, 0.00010005474278479738, -2.8988030003948203e-05], [-2.9044753240503206e-05, -2.8988030003948203e-05, 0.00010006957346143275]]} - #*EXTRAS*# Step: 15 Bead: 53 -{"friction": [[0.00010018128561645675, -2.905004873529288e-05, -2.9072653272828257e-05], [-2.905004873529288e-05, 0.00010006786036849015, -2.901717769874478e-05], [-2.9072653272828257e-05, -2.901717769874478e-05, 0.00010007928597779758]]} - #*EXTRAS*# Step: 16 Bead: 53 -{"friction": [[0.0001001901174952087, -2.9067512241049058e-05, -2.9090492096433183e-05], [-2.9067512241049058e-05, 0.00010007625745083602, -2.9035821743975355e-05], [-2.9090492096433183e-05, -2.9035821743975355e-05, 0.00010008550901884418]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_54 b/drivers/py/pes/friction/frictionH/060K/inst.raw_54 deleted file mode 100644 index e2b77013c..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_54 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 54 -{"friction": [[0.00010321820672526034, -3.463813479007007e-05, -3.4586315531130965e-05], [-3.463813479007007e-05, 0.00010319683609987853, -3.482966366715975e-05], [-3.4586315531130965e-05, -3.482966366715975e-05, 0.00010281585060269033]]} - #*EXTRAS*# Step: 1 Bead: 54 -{"friction": [[0.00010100293567762007, -3.068691770322139e-05, -3.0719129690069354e-05], [-3.068691770322139e-05, 0.00010087948954331636, -3.0757534154374416e-05], [-3.0719129690069354e-05, -3.0757534154374416e-05, 0.00010070428783763487]]} - #*EXTRAS*# Step: 2 Bead: 54 -{"friction": [[9.89054368569124e-05, -2.6564472436869192e-05, -2.6470416303354777e-05], [-2.6564472436869192e-05, 9.893159069408707e-05, -2.6362134844251836e-05], [-2.6470416303354777e-05, -2.6362134844251836e-05, 9.9266282221234e-05]]} - #*EXTRAS*# Step: 3 Bead: 54 -{"friction": [[9.7349769683163e-05, -2.225726771520433e-05, -2.194773654784395e-05], [-2.225726771520433e-05, 9.767167625067085e-05, -2.190710179615841e-05], [-2.194773654784395e-05, -2.190710179615841e-05, 9.83110215890771e-05]]} - #*EXTRAS*# Step: 4 Bead: 54 -{"friction": [[9.725254777708447e-05, -2.1603787155989207e-05, -2.1288605311021518e-05], [-2.1603787155989207e-05, 9.759344859381441e-05, -2.1259905436648432e-05], [-2.1288605311021518e-05, -2.1259905436648432e-05, 9.822340151739657e-05]]} - #*EXTRAS*# Step: 5 Bead: 54 -{"friction": [[9.787514979784292e-05, -2.4197436276884823e-05, -2.3957178174738958e-05], [-2.4197436276884823e-05, 9.80885638897034e-05, -2.3877104078358055e-05], [-2.3957178174738958e-05, -2.3877104078358055e-05, 9.866064932568723e-05]]} - #*EXTRAS*# Step: 6 Bead: 54 -{"friction": [[9.844256406611393e-05, -2.5593156048475405e-05, -2.5436091701303044e-05], [-2.5593156048475405e-05, 9.85470438258813e-05, -2.5333745340788826e-05], [-2.5436091701303044e-05, -2.5333745340788826e-05, 9.899499340564813e-05]]} - #*EXTRAS*# Step: 7 Bead: 54 -{"friction": [[9.893988721591826e-05, -2.6633589787725847e-05, -2.6543926629403237e-05], [-2.6633589787725847e-05, 9.896066673603342e-05, -2.643565535636988e-05], [-2.6543926629403237e-05, -2.643565535636988e-05, 9.92867105201158e-05]]} - #*EXTRAS*# Step: 8 Bead: 54 -{"friction": [[9.924072929634912e-05, -2.7225892392284503e-05, -2.717236252856746e-05], [-2.7225892392284503e-05, 9.921766216880017e-05, -2.706704905497217e-05], [-2.717236252856746e-05, -2.706704905497217e-05, 9.946746773445723e-05]]} - #*EXTRAS*# Step: 9 Bead: 54 -{"friction": [[9.944203473577762e-05, -2.761495307620058e-05, -2.7583012756389918e-05], [-2.761495307620058e-05, 9.93930557306191e-05, -2.7482766393362044e-05], [-2.7583012756389918e-05, -2.7482766393362044e-05, 9.959143536552707e-05]]} - #*EXTRAS*# Step: 10 Bead: 54 -{"friction": [[9.956898741348012e-05, -2.7859115965655727e-05, -2.7839532336628075e-05], [-2.7859115965655727e-05, 9.950527126021748e-05, -2.7743884916492312e-05], [-2.7839532336628075e-05, -2.7743884916492312e-05, 9.967118986858504e-05]]} - #*EXTRAS*# Step: 11 Bead: 54 -{"friction": [[9.9650892798636e-05, -2.8016614499937413e-05, -2.80044270950423e-05], [-2.8016614499937413e-05, 9.957838874082374e-05, -2.7912366989520265e-05], [-2.80044270950423e-05, -2.7912366989520265e-05, 9.972338923549824e-05]]} - #*EXTRAS*# Step: 12 Bead: 54 -{"friction": [[9.970309803356987e-05, -2.8117112643708406e-05, -2.8109386559800592e-05], [-2.8117112643708406e-05, 9.962530562815277e-05, -2.8019880210604488e-05], [-2.8109386559800592e-05, -2.8019880210604488e-05, 9.975699300565576e-05]]} - #*EXTRAS*# Step: 13 Bead: 54 -{"friction": [[9.973652476294535e-05, -2.8181539003617753e-05, -2.8176561191974045e-05], [-2.8181539003617753e-05, 9.96554794244346e-05, -2.8088803150377343e-05], [-2.8176561191974045e-05, -2.8088803150377343e-05, 9.977865317046678e-05]]} - #*EXTRAS*# Step: 14 Bead: 54 -{"friction": [[9.975788257376503e-05, -2.8222744348316703e-05, -2.821947691993967e-05], [-2.8222744348316703e-05, 9.967481467578284e-05, -2.8132883284981958e-05], [-2.821947691993967e-05, -2.8132883284981958e-05, 9.979255374857505e-05]]} - #*EXTRAS*# Step: 15 Bead: 54 -{"friction": [[9.977154248059024e-05, -2.8249117075170078e-05, -2.824692455472971e-05], [-2.8249117075170078e-05, 9.968720424423933e-05, -2.816109529086259e-05], [-2.824692455472971e-05, -2.816109529086259e-05, 9.980146969277388e-05]]} - #*EXTRAS*# Step: 16 Bead: 54 -{"friction": [[9.978027627349094e-05, -2.826598742816015e-05, -2.826447430646709e-05], [-2.826598742816015e-05, 9.969513542261014e-05, -2.8179141874100764e-05], [-2.826447430646709e-05, -2.8179141874100764e-05, 9.980718089499678e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_55 b/drivers/py/pes/friction/frictionH/060K/inst.raw_55 deleted file mode 100644 index 32c056864..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_55 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 55 -{"friction": [[0.0001030336955245592, -3.435497053307799e-05, -3.430893758166685e-05], [-3.435497053307799e-05, 0.00010300555227581691, -3.4547622358950575e-05], [-3.430893758166685e-05, -3.4547622358950575e-05, 0.00010262224478354004]]} - #*EXTRAS*# Step: 1 Bead: 55 -{"friction": [[0.00010084323851698672, -3.0369088844643668e-05, -3.0403037269591273e-05], [-3.0369088844643668e-05, 0.00010071741954785476, -3.0421014530895674e-05], [-3.0403037269591273e-05, -3.0421014530895674e-05, 0.00010057535095624512]]} - #*EXTRAS*# Step: 2 Bead: 55 -{"friction": [[9.872861954109439e-05, -2.620392956771059e-05, -2.6086616622463943e-05], [-2.620392956771059e-05, 9.878339862040572e-05, -2.5979288915981047e-05], [-2.6086616622463943e-05, -2.5979288915981047e-05, 9.916208422109301e-05]]} - #*EXTRAS*# Step: 3 Bead: 55 -{"friction": [[9.727256038123935e-05, -2.176454047024342e-05, -2.144981033296398e-05], [-2.176454047024342e-05, 9.7609738580856e-05, -2.141831872937291e-05], [-2.144981033296398e-05, -2.141831872937291e-05, 9.824357424802705e-05]]} - #*EXTRAS*# Step: 4 Bead: 55 -{"friction": [[9.719944207474689e-05, -2.0990124963094387e-05, -2.067892925219908e-05], [-2.0990124963094387e-05, 9.75486946250711e-05, -2.0659860191048528e-05], [-2.067892925219908e-05, -2.0659860191048528e-05, 9.815452394978559e-05]]} - #*EXTRAS*# Step: 5 Bead: 55 -{"friction": [[9.767165463135103e-05, -2.3580525836210872e-05, -2.3310836462196283e-05], [-2.3580525836210872e-05, 9.792674090528685e-05, -2.3243192121646128e-05], [-2.3310836462196283e-05, -2.3243192121646128e-05, 9.85348279938594e-05]]} - #*EXTRAS*# Step: 6 Bead: 55 -{"friction": [[9.816041453990958e-05, -2.494050461095045e-05, -2.474241525327793e-05], [-2.494050461095045e-05, 9.831752737060797e-05, -2.4649040101068896e-05], [-2.474241525327793e-05, -2.4649040101068896e-05, 9.883021070134415e-05]]} - #*EXTRAS*# Step: 7 Bead: 55 -{"friction": [[9.861233182845656e-05, -2.5960412067907193e-05, -2.58272218024581e-05], [-2.5960412067907193e-05, 9.868683484524019e-05, -2.572141525955759e-05], [-2.58272218024581e-05, -2.572141525955759e-05, 9.90940135238982e-05]]} - #*EXTRAS*# Step: 8 Bead: 55 -{"friction": [[9.889153371173634e-05, -2.6536484450618504e-05, -2.644064202299371e-05], [-2.6536484450618504e-05, 9.89198757448243e-05, -2.6332374831793928e-05], [-2.644064202299371e-05, -2.6332374831793928e-05, 9.925805097775005e-05]]} - #*EXTRAS*# Step: 9 Bead: 55 -{"friction": [[9.908202991662435e-05, -2.6915651277525225e-05, -2.684358375312845e-05], [-2.6915651277525225e-05, 9.908138004180094e-05, -2.6736054835089458e-05], [-2.684358375312845e-05, -2.6736054835089458e-05, 9.937153979536133e-05]]} - #*EXTRAS*# Step: 10 Bead: 55 -{"friction": [[9.920326821346101e-05, -2.715301550097698e-05, -2.709522288511609e-05], [-2.715301550097698e-05, 9.918534195466327e-05, -2.698924997929247e-05], [-2.709522288511609e-05, -2.698924997929247e-05, 9.944469392068833e-05]]} - #*EXTRAS*# Step: 11 Bead: 55 -{"friction": [[9.928207092943393e-05, -2.7306109484565944e-05, -2.7257198420527072e-05], [-2.7306109484565944e-05, 9.925344280585467e-05, -2.7152713399492733e-05], [-2.7257198420527072e-05, -2.7152713399492733e-05, 9.949270174441089e-05]]} - #*EXTRAS*# Step: 12 Bead: 55 -{"friction": [[9.933250359838599e-05, -2.740371052926841e-05, -2.7360308205932366e-05], [-2.740371052926841e-05, 9.929725549394364e-05, -2.7256979713061154e-05], [-2.7360308205932366e-05, -2.7256979713061154e-05, 9.952363571003751e-05]]} - #*EXTRAS*# Step: 13 Bead: 55 -{"friction": [[9.936489120277991e-05, -2.7466263775532264e-05, -2.7426323845516763e-05], [-2.7466263775532264e-05, 9.932548917846205e-05, -2.7323824281930674e-05], [-2.7426323845516763e-05, -2.7323824281930674e-05, 9.954359303700285e-05]]} - #*EXTRAS*# Step: 14 Bead: 55 -{"friction": [[9.938562156934706e-05, -2.750625837114144e-05, -2.746850285644841e-05], [-2.750625837114144e-05, 9.93436015864439e-05, -2.7366569854952853e-05], [-2.746850285644841e-05, -2.7366569854952853e-05, 9.95564062442568e-05]]} - #*EXTRAS*# Step: 15 Bead: 55 -{"friction": [[9.939889605917562e-05, -2.7531852517328048e-05, -2.7495482521910943e-05], [-2.7531852517328048e-05, 9.935521666883056e-05, -2.7393927228830775e-05], [-2.7495482521910943e-05, -2.7393927228830775e-05, 9.956462747629897e-05]]} - #*EXTRAS*# Step: 16 Bead: 55 -{"friction": [[9.940738970819511e-05, -2.754822283368826e-05, -2.7512733871010748e-05], [-2.754822283368826e-05, 9.936265556631575e-05, -2.7411426407049646e-05], [-2.7512733871010748e-05, -2.7411426407049646e-05, 9.956989463941387e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_56 b/drivers/py/pes/friction/frictionH/060K/inst.raw_56 deleted file mode 100644 index 33611fa66..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_56 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 56 -{"friction": [[0.00010287248283727404, -3.41000175745236e-05, -3.4059743381936934e-05], [-3.41000175745236e-05, 0.00010283753372188608, -3.4291999923335146e-05], [-3.4059743381936934e-05, -3.4291999923335146e-05, 0.00010245497440254835]]} - #*EXTRAS*# Step: 1 Bead: 56 -{"friction": [[0.00010070149523632192, -3.0086123566959233e-05, -3.0120300993066578e-05], [-3.0086123566959233e-05, 0.00010057513889767838, -3.0120750573944634e-05], [-3.0120300993066578e-05, -3.0120750573944634e-05, 0.00010046395753331524]]} - #*EXTRAS*# Step: 2 Bead: 56 -{"friction": [[9.857626175405478e-05, -2.5883644892532035e-05, -2.574544667487532e-05], [-2.5883644892532035e-05, 9.865701952424236e-05, -2.564025302704883e-05], [-2.574544667487532e-05, -2.564025302704883e-05, 9.907294993945184e-05]]} - #*EXTRAS*# Step: 3 Bead: 56 -{"friction": [[9.722384452567074e-05, -2.1324044072463934e-05, -2.1009581669045634e-05], [-2.1324044072463934e-05, 9.756969048652943e-05, -2.0985476697449218e-05], [-2.1009581669045634e-05, -2.0985476697449218e-05, 9.819042056527153e-05]]} - #*EXTRAS*# Step: 4 Bead: 56 -{"friction": [[9.718055360277684e-05, -2.0440150386777664e-05, -2.013930975013855e-05], [-2.0440150386777664e-05, 9.753000320802163e-05, -2.0127540932950795e-05], [-2.013930975013855e-05, -2.0127540932950795e-05, 9.810338986309521e-05]]} - #*EXTRAS*# Step: 5 Bead: 56 -{"friction": [[9.751744479232603e-05, -2.3027725844187386e-05, -2.2737142259634234e-05], [-2.3027725844187386e-05, 9.780463085269791e-05, -2.2680978271728978e-05], [-2.2737142259634234e-05, -2.2680978271728978e-05, 9.843370432262026e-05]]} - #*EXTRAS*# Step: 6 Bead: 56 -{"friction": [[9.793275622083307e-05, -2.4356692774141935e-05, -2.4124929574380776e-05], [-2.4356692774141935e-05, 9.81345806792338e-05, -2.4041805969323683e-05], [-2.4124929574380776e-05, -2.4041805969323683e-05, 9.869534349758338e-05]]} - #*EXTRAS*# Step: 7 Bead: 56 -{"friction": [[9.833858804108849e-05, -2.5359735933573093e-05, -2.5187712770459785e-05], [-2.5359735933573093e-05, 9.846207509253663e-05, -2.5088203728540942e-05], [-2.5187712770459785e-05, -2.5088203728540942e-05, 9.893439057787623e-05]]} - #*EXTRAS*# Step: 8 Bead: 56 -{"friction": [[9.859441227516191e-05, -2.592235262444642e-05, -2.5786679073994624e-05], [-2.592235262444642e-05, 9.867201473136579e-05, -2.5681168724372422e-05], [-2.5786679073994624e-05, -2.5681168724372422e-05, 9.9083546767601e-05]]} - #*EXTRAS*# Step: 9 Bead: 56 -{"friction": [[9.87720702939819e-05, -2.6293519980471082e-05, -2.618202650387136e-05], [-2.6293519980471082e-05, 9.881965818752925e-05, -2.6074310648085636e-05], [-2.618202650387136e-05, -2.6074310648085636e-05, 9.918760036530422e-05]]} - #*EXTRAS*# Step: 10 Bead: 56 -{"friction": [[9.888602724874971e-05, -2.6525384068906894e-05, -2.642883206452779e-05], [-2.6525384068906894e-05, 9.891523897219836e-05, -2.6320573430616378e-05], [-2.642883206452779e-05, -2.6320573430616378e-05, 9.925479292249318e-05]]} - #*EXTRAS*# Step: 11 Bead: 56 -{"friction": [[9.896057272749836e-05, -2.6674937759617008e-05, -2.6587889100994513e-05], [-2.6674937759617008e-05, 9.897815838595836e-05, -2.6479655343789376e-05], [-2.6587889100994513e-05, -2.6479655343789376e-05, 9.929899957041641e-05]]} - #*EXTRAS*# Step: 12 Bead: 56 -{"friction": [[9.90084423196623e-05, -2.6770211420316332e-05, -2.6689144241545206e-05], [-2.6770211420316332e-05, 9.901873393352248e-05, -2.658108864512741e-05], [-2.6689144241545206e-05, -2.658108864512741e-05, 9.932750853576191e-05]]} - #*EXTRAS*# Step: 13 Bead: 56 -{"friction": [[9.90392602006085e-05, -2.6831262588544717e-05, -2.6753993844055985e-05], [-2.6831262588544717e-05, 9.904492902241295e-05, -2.664612119277719e-05], [-2.6753993844055985e-05, -2.664612119277719e-05, 9.934591690475344e-05]]} - #*EXTRAS*# Step: 14 Bead: 56 -{"friction": [[9.905901438514627e-05, -2.687028670419652e-05, -2.6795430566358988e-05], [-2.687028670419652e-05, 9.906175063967452e-05, -2.6687703619589283e-05], [-2.6795430566358988e-05, -2.6687703619589283e-05, 9.935774027581842e-05]]} - #*EXTRAS*# Step: 15 Bead: 56 -{"friction": [[9.907167628278578e-05, -2.6895257128670826e-05, -2.6821938132112364e-05], [-2.6895257128670826e-05, 9.90725455734403e-05, -2.6714316350255218e-05], [-2.6821938132112364e-05, -2.6714316350255218e-05, 9.93653287572673e-05]]} - #*EXTRAS*# Step: 16 Bead: 56 -{"friction": [[9.907978286939224e-05, -2.691122695772488e-05, -2.6838888245421934e-05], [-2.691122695772488e-05, 9.907946212699842e-05, -2.673133864661661e-05], [-2.6838888245421934e-05, -2.673133864661661e-05, 9.937019135667063e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_57 b/drivers/py/pes/friction/frictionH/060K/inst.raw_57 deleted file mode 100644 index 4d508a891..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_57 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 57 -{"friction": [[0.00010273307889993032, -3.387387660981356e-05, -3.383904253920663e-05], [-3.387387660981356e-05, 0.00010269165843199864, -3.406401214784578e-05], [-3.383904253920663e-05, -3.406401214784578e-05, 0.00010231189325852699]]} - #*EXTRAS*# Step: 1 Bead: 57 -{"friction": [[0.00010057715283536595, -2.9837698800403484e-05, -2.987096267704469e-05], [-2.9837698800403484e-05, 0.00010045166058892498, -2.985668537607142e-05], [-2.987096267704469e-05, -2.985668537607142e-05, 0.00010036859010096835]]} - #*EXTRAS*# Step: 2 Bead: 57 -{"friction": [[9.84469934341226e-05, -2.5602943619572132e-05, -2.5446511359930904e-05], [-2.5602943619572132e-05, 9.855067409837872e-05, -2.5344056217313763e-05], [-2.5446511359930904e-05, -2.5344056217313763e-05, 9.899757452818374e-05]]} - #*EXTRAS*# Step: 3 Bead: 57 -{"friction": [[9.719647288011471e-05, -2.093653628092836e-05, -2.0626090525615262e-05], [-2.093653628092836e-05, 9.754603179474513e-05, -2.0607785870569423e-05], [-2.0626090525615262e-05, -2.0607785870569423e-05, 9.81491085450342e-05]]} - #*EXTRAS*# Step: 4 Bead: 57 -{"friction": [[9.718356603935949e-05, -1.995664594534006e-05, -1.9669202298824862e-05], [-1.995664594534006e-05, 9.752818305548077e-05, -1.966290994207454e-05], [-1.9669202298824862e-05, -1.966290994207454e-05, 9.806640547093446e-05]]} - #*EXTRAS*# Step: 5 Bead: 57 -{"friction": [[9.740477582270654e-05, -2.2540160820586433e-05, -2.223611398202304e-05], [-2.2540160820586433e-05, 9.771540011534829e-05, -2.218990765202684e-05], [-2.223611398202304e-05, -2.218990765202684e-05, 9.835361127801993e-05]]} - #*EXTRAS*# Step: 6 Bead: 57 -{"friction": [[9.775409475685224e-05, -2.3842310227339477e-05, -2.358438885599657e-05], [-2.3842310227339477e-05, 9.799217557271071e-05, -2.351137862435719e-05], [-2.358438885599657e-05, -2.351137862435719e-05, 9.858655120530738e-05]]} - #*EXTRAS*# Step: 7 Bead: 57 -{"friction": [[9.811600216410788e-05, -2.483144567093975e-05, -2.462680067720907e-05], [-2.483144567093975e-05, 9.828169134819201e-05, -2.453520823860693e-05], [-2.462680067720907e-05, -2.453520823860693e-05, 9.880410660468447e-05]]} - #*EXTRAS*# Step: 8 Bead: 57 -{"friction": [[9.834875329666405e-05, -2.5382883432002616e-05, -2.521233230578152e-05], [-2.5382883432002616e-05, 9.847036138100085e-05, -2.5112521858724128e-05], [-2.521233230578152e-05, -2.5112521858724128e-05, 9.894031817530737e-05]]} - #*EXTRAS*# Step: 9 Bead: 57 -{"friction": [[9.851306405341418e-05, -2.574756285756342e-05, -2.560050360722155e-05], [-2.574756285756342e-05, 9.860493116648378e-05, -2.5496543224931544e-05], [-2.560050360722155e-05, -2.5496543224931544e-05, 9.903608394059837e-05]]} - #*EXTRAS*# Step: 10 Bead: 57 -{"friction": [[9.86192026335455e-05, -2.59749649119851e-05, -2.5842724316680504e-05], [-2.59749649119851e-05, 9.869252142140992e-05, -2.5736808556720074e-05], [-2.5842724316680504e-05, -2.5736808556720074e-05, 9.909802809928472e-05]]} - #*EXTRAS*# Step: 11 Bead: 57 -{"friction": [[9.868902983892818e-05, -2.6121665400185526e-05, -2.5998995060479605e-05], [-2.6121665400185526e-05, 9.875044681332458e-05, -2.5892106801708074e-05], [-2.5998995060479605e-05, -2.5892106801708074e-05, 9.913887734078048e-05]]} - #*EXTRAS*# Step: 12 Bead: 57 -{"friction": [[9.873400127404555e-05, -2.6215064649492156e-05, -2.6098475977837022e-05], [-2.6215064649492156e-05, 9.878788428260245e-05, -2.5991094832723575e-05], [-2.6098475977837022e-05, -2.5991094832723575e-05, 9.91652418789754e-05]]} - #*EXTRAS*# Step: 13 Bead: 57 -{"friction": [[9.876301580509413e-05, -2.627490836435924e-05, -2.6162207547267327e-05], [-2.627490836435924e-05, 9.8812094010301e-05, -2.60545644059837e-05], [-2.6162207547267327e-05, -2.60545644059837e-05, 9.918227892455216e-05]]} - #*EXTRAS*# Step: 14 Bead: 57 -{"friction": [[9.878163715401484e-05, -2.6313152756798784e-05, -2.6202931825496593e-05], [-2.6313152756798784e-05, 9.88276551502925e-05, -2.60951438325028e-05], [-2.6202931825496593e-05, -2.60951438325028e-05, 9.919322548500318e-05]]} - #*EXTRAS*# Step: 15 Bead: 57 -{"friction": [[9.879358307869977e-05, -2.6337622362568198e-05, -2.6228985889703894e-05], [-2.6337622362568198e-05, 9.883764766401769e-05, -2.6121114605317304e-05], [-2.6228985889703894e-05, -2.6121114605317304e-05, 9.92002532239501e-05]]} - #*EXTRAS*# Step: 16 Bead: 57 -{"friction": [[9.880123523234854e-05, -2.635327070261222e-05, -2.6245646504778955e-05], [-2.635327070261222e-05, 9.884405256686616e-05, -2.6137725835217763e-05], [-2.6245646504778955e-05, -2.6137725835217763e-05, 9.920475721263539e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_58 b/drivers/py/pes/friction/frictionH/060K/inst.raw_58 deleted file mode 100644 index 45e85d06f..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_58 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 58 -{"friction": [[0.00010261428366339391, -3.367703313457375e-05, -3.3647121432587244e-05], [-3.367703313457375e-05, 0.00010256698019056102, -3.3864653594504656e-05], [-3.3647121432587244e-05, -3.3864653594504656e-05, 0.00010219119996151315]]} - #*EXTRAS*# Step: 1 Bead: 58 -{"friction": [[0.00010046984925679088, -2.9623477882043044e-05, -2.965505709417293e-05], [-2.9623477882043044e-05, 0.00010034617869781209, -2.9628674208501218e-05], [-2.965505709417293e-05, -2.9628674208501218e-05, 0.00010028804089026298]]} - #*EXTRAS*# Step: 2 Bead: 58 -{"friction": [[9.833927812561367e-05, -2.536130971066541e-05, -2.5189386539940574e-05], [-2.536130971066541e-05, 9.846263748100797e-05, -2.50898568718136e-05], [-2.5189386539940574e-05, -2.50898568718136e-05, 9.893479301334817e-05]]} - #*EXTRAS*# Step: 3 Bead: 58 -{"friction": [[9.718354023267677e-05, -2.0602896865951697e-05, -2.0298403929499415e-05], [-2.0602896865951697e-05, 9.753359435908528e-05, -2.0284598088998606e-05], [-2.0298403929499415e-05, -2.0284598088998606e-05, 9.811750319503003e-05]]} - #*EXTRAS*# Step: 4 Bead: 58 -{"friction": [[9.719922753395536e-05, -1.9541231139559056e-05, -1.926792514905672e-05], [-1.9541231139559056e-05, 9.753634014543658e-05, -1.926568947530301e-05], [-1.926792514905672e-05, -1.926568947530301e-05, 9.804043811660889e-05]]} - #*EXTRAS*# Step: 5 Bead: 58 -{"friction": [[9.732572311801129e-05, -2.211911844276661e-05, -2.1807561018920152e-05], [-2.211911844276661e-05, 9.765248517509604e-05, -2.1769569750227396e-05], [-2.1807561018920152e-05, -2.1769569750227396e-05, 9.829125156219944e-05]]} - #*EXTRAS*# Step: 6 Bead: 58 -{"friction": [[9.761780824629172e-05, -2.3398356336237852e-05, -2.3121163598890848e-05], [-2.3398356336237852e-05, 9.788407213280974e-05, -2.3057296080704394e-05], [-2.3121163598890848e-05, -2.3057296080704394e-05, 9.850028964880448e-05]]} - #*EXTRAS*# Step: 7 Bead: 58 -{"friction": [[9.793990035782005e-05, -2.4376066663578447e-05, -2.414535923761304e-05], [-2.4376066663578447e-05, 9.814029474527465e-05, -2.406187078957339e-05], [-2.414535923761304e-05, -2.406187078957339e-05, 9.869962576669298e-05]]} - #*EXTRAS*# Step: 8 Bead: 58 -{"friction": [[9.815129172013007e-05, -2.4918268108949004e-05, -2.4718833483943216e-05], [-2.4918268108949004e-05, 9.831016014092594e-05, -2.4625816148137668e-05], [-2.4718833483943216e-05, -2.4625816148137668e-05, 9.882485454836931e-05]]} - #*EXTRAS*# Step: 9 Bead: 58 -{"friction": [[9.830283003533844e-05, -2.52777025891553e-05, -2.510048646158218e-05], [-2.52777025891553e-05, 9.843296144374219e-05, -2.5002079093499052e-05], [-2.510048646158218e-05, -2.5002079093499052e-05, 9.89135302877234e-05]]} - #*EXTRAS*# Step: 10 Bead: 58 -{"friction": [[9.840135115152406e-05, -2.550149735789909e-05, -2.533853075320843e-05], [-2.550149735789909e-05, 9.85133081086695e-05, -2.5237243904949205e-05], [-2.533853075320843e-05, -2.5237243904949205e-05, 9.897097730320971e-05]]} - #*EXTRAS*# Step: 11 Bead: 58 -{"friction": [[9.846649996800344e-05, -2.5645905704020973e-05, -2.5492251678417157e-05], [-2.5645905704020973e-05, 9.856667204241357e-05, -2.5389329229511722e-05], [-2.5492251678417157e-05, -2.5389329229511722e-05, 9.900894202600237e-05]]} - #*EXTRAS*# Step: 12 Bead: 58 -{"friction": [[9.85085678396616e-05, -2.5737800262846334e-05, -2.5590106582853007e-05], [-2.5737800262846334e-05, 9.860123250271538e-05, -2.5486241648056924e-05], [-2.5590106582853007e-05, -2.5486241648056924e-05, 9.903346254219312e-05]]} - #*EXTRAS*# Step: 13 Bead: 58 -{"friction": [[9.853576088812997e-05, -2.5796676486847458e-05, -2.5652811856403554e-05], [-2.5796676486847458e-05, 9.862361642352616e-05, -2.5548385264148824e-05], [-2.5652811856403554e-05, -2.5548385264148824e-05, 9.904931928252995e-05]]} - #*EXTRAS*# Step: 14 Bead: 58 -{"friction": [[9.855323227405618e-05, -2.5834296448738123e-05, -2.569288168276351e-05], [-2.5834296448738123e-05, 9.86380163613488e-05, -2.5588113985872325e-05], [-2.569288168276351e-05, -2.5588113985872325e-05, 9.905951084516148e-05]]} - #*EXTRAS*# Step: 15 Bead: 58 -{"friction": [[9.856444884320471e-05, -2.5858365224805103e-05, -2.5718518912159505e-05], [-2.5858365224805103e-05, 9.864726872762261e-05, -2.5613540389031283e-05], [-2.5718518912159505e-05, -2.5613540389031283e-05, 9.906605557898674e-05]]} - #*EXTRAS*# Step: 16 Bead: 58 -{"friction": [[9.857163705017485e-05, -2.5873756329799365e-05, -2.5734913351675844e-05], [-2.5873756329799365e-05, 9.865320133027265e-05, -2.562980307922321e-05], [-2.5734913351675844e-05, -2.562980307922321e-05, 9.907025061433366e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_59 b/drivers/py/pes/friction/frictionH/060K/inst.raw_59 deleted file mode 100644 index 80e4b4bf1..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_59 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 59 -{"friction": [[0.00010251514085647045, -3.350986950112593e-05, -3.3484233397662335e-05], [-3.350986950112593e-05, 0.0001024627094050115, -3.369472217637789e-05], [-3.3484233397662335e-05, -3.369472217637789e-05, 0.00010209140079979171]]} - #*EXTRAS*# Step: 1 Bead: 59 -{"friction": [[0.00010037935865733542, -2.9443127531236544e-05, -2.9472607460003528e-05], [-2.9443127531236544e-05, 0.00010025804007922309, -2.9436518778351414e-05], [-2.9472607460003528e-05, -2.9436518778351414e-05, 0.00010022135715849928]]} - #*EXTRAS*# Step: 2 Bead: 59 -{"friction": [[9.825156322495388e-05, -2.5158344641308105e-05, -2.4973646352311754e-05], [-2.5158344641308105e-05, 9.839131353113851e-05, -2.4876931339995305e-05], [-2.4973646352311754e-05, -2.4876931339995305e-05, 9.888358954759786e-05]]} - #*EXTRAS*# Step: 3 Bead: 59 -{"friction": [[9.717968876776888e-05, -2.0323567344601568e-05, -2.002562150918368e-05], [-2.0323567344601568e-05, 9.752838005223056e-05, -2.0015250696461092e-05], [-2.002562150918368e-05, -2.0015250696461092e-05, 9.809379861566223e-05]]} - #*EXTRAS*# Step: 4 Bead: 59 -{"friction": [[9.722067865142672e-05, -1.9194728086477996e-05, -1.8934752509729627e-05], [-1.9194728086477996e-05, 9.754937046620953e-05, -1.8935471101597535e-05], [-1.8934752509729627e-05, -1.8935471101597535e-05, 9.802281954235908e-05]]} - #*EXTRAS*# Step: 5 Bead: 59 -{"friction": [[9.72727407106999e-05, -2.1765901177572855e-05, -2.1451177525339022e-05], [-2.1765901177572855e-05, 9.760988469766427e-05, -2.1419661850770163e-05], [-2.1451177525339022e-05, -2.1419661850770163e-05, 9.824374882612662e-05]]} - #*EXTRAS*# Step: 6 Bead: 59 -{"friction": [[9.751700884830694e-05, -2.30260081247189e-05, -2.2735368606543846e-05], [-2.30260081247189e-05, 9.780428588246839e-05, -2.2679240201096193e-05], [-2.2735368606543846e-05, -2.2679240201096193e-05, 9.843340721484104e-05]]} - #*EXTRAS*# Step: 7 Bead: 59 -{"friction": [[9.780468786863167e-05, -2.3994469695012272e-05, -2.3743888961589212e-05], [-2.3994469695012272e-05, 9.803241141047216e-05, -2.3667814288760632e-05], [-2.3743888961589212e-05, -2.3667814288760632e-05, 9.861774629299982e-05]]} - #*EXTRAS*# Step: 8 Bead: 59 -{"friction": [[9.799737324253508e-05, -2.4529162323707588e-05, -2.4306958950579498e-05], [-2.4529162323707588e-05, 9.81863236536516e-05, -2.4220639837419018e-05], [-2.4306958950579498e-05, -2.4220639837419018e-05, 9.873393391796848e-05]]} - #*EXTRAS*# Step: 9 Bead: 59 -{"friction": [[9.813746772487275e-05, -2.4884411793309146e-05, -2.468293727100296e-05], [-2.4884411793309146e-05, 9.829900245930342e-05, -2.459047037640573e-05], [-2.468293727100296e-05, -2.459047037640573e-05, 9.881673260395983e-05]]} - #*EXTRAS*# Step: 10 Bead: 59 -{"friction": [[9.822908807208024e-05, -2.5105328595214404e-05, -2.4917337901636612e-05], [-2.5105328595214404e-05, 9.837308901581875e-05, -2.4821406913389253e-05], [-2.4917337901636612e-05, -2.4821406913389253e-05, 9.887044756863591e-05]]} - #*EXTRAS*# Step: 11 Bead: 59 -{"friction": [[9.828995178564207e-05, -2.524791855936654e-05, -2.506882681132987e-05], [-2.524791855936654e-05, 9.842248927939609e-05, -2.4970832037013967e-05], [-2.506882681132987e-05, -2.4970832037013967e-05, 9.89060133091731e-05]]} - #*EXTRAS*# Step: 12 Bead: 59 -{"friction": [[9.832934383837228e-05, -2.5338620321198715e-05, -2.5165256843632497e-05], [-2.5338620321198715e-05, 9.84545434254939e-05, -2.506602642136082e-05], [-2.5165256843632497e-05, -2.506602642136082e-05, 9.892899918040389e-05]]} - #*EXTRAS*# Step: 13 Bead: 59 -{"friction": [[9.835485009581442e-05, -2.5396730906633058e-05, -2.522706172790782e-05], [-2.5396730906633058e-05, 9.847533335457675e-05, -2.512707300640674e-05], [-2.522706172790782e-05, -2.512707300640674e-05, 9.894387291848124e-05]]} - #*EXTRAS*# Step: 14 Bead: 59 -{"friction": [[9.837125345346259e-05, -2.5433856969923737e-05, -2.526655709503163e-05], [-2.5433856969923737e-05, 9.848871832089122e-05, -2.5166098026024688e-05], [-2.526655709503163e-05, -2.5166098026024688e-05, 9.89534354853721e-05]]} - #*EXTRAS*# Step: 15 Bead: 59 -{"friction": [[9.838179124347716e-05, -2.5457608886525703e-05, -2.5291828282217243e-05], [-2.5457608886525703e-05, 9.849732318786211e-05, -2.5191074203160543e-05], [-2.5291828282217243e-05, -2.5191074203160543e-05, 9.895957771496338e-05]]} - #*EXTRAS*# Step: 16 Bead: 59 -{"friction": [[9.838854712750694e-05, -2.547279669631829e-05, -2.530798892731227e-05], [-2.547279669631829e-05, 9.850284239821027e-05, -2.520704865548808e-05], [-2.530798892731227e-05, -2.520704865548808e-05, 9.896351525200723e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_60 b/drivers/py/pes/friction/frictionH/060K/inst.raw_60 deleted file mode 100644 index f7ff86fbf..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_60 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 60 -{"friction": [[0.00010243489413890537, -3.337266793205423e-05, -3.3350583183048474e-05], [-3.337266793205423e-05, 0.00010237819197671717, -3.355483283288116e-05], [-3.3350583183048474e-05, -3.355483283288116e-05, 0.00010201127331709875]]} - #*EXTRAS*# Step: 1 Bead: 60 -{"friction": [[0.00010030554386096575, -2.92963241292448e-05, -2.9323614712425175e-05], [-2.92963241292448e-05, 0.00010018671772734519, -2.9279986997115343e-05], [-2.9323614712425175e-05, -2.9279986997115343e-05, 0.000100167794024414]]} - #*EXTRAS*# Step: 2 Bead: 60 -{"friction": [[9.8182389441973e-05, -2.499373027515611e-05, -2.4798878087874322e-05], [-2.499373027515611e-05, 9.833528655743751e-05, -2.470465870608873e-05], [-2.4798878087874322e-05, -2.470465870608873e-05, 9.884310115457009e-05]]} - #*EXTRAS*# Step: 3 Bead: 60 -{"friction": [[9.7180908939243e-05, -2.0098659836044432e-05, -1.9806912509833764e-05], [-2.0098659836044432e-05, 9.752739895146938e-05, -1.9799098402679313e-05], [-1.9806912509833764e-05, -1.9799098402679313e-05, 9.807650775274657e-05]]} - #*EXTRAS*# Step: 4 Bead: 60 -{"friction": [[9.724291436829919e-05, -1.8917447617868385e-05, -1.866898504856869e-05], [-1.8917447617868385e-05, 9.75635553123535e-05, -1.8671800519933502e-05], [-1.866898504856869e-05, -1.8671800519933502e-05, 9.801134224729761e-05]]} - #*EXTRAS*# Step: 5 Bead: 60 -{"friction": [[9.723906648158019e-05, -2.1481719118558802e-05, -2.1166614804225257e-05], [-2.1481719118558802e-05, 9.7582366411545e-05, -2.1139962632404197e-05], [-2.1166614804225257e-05, -2.1139962632404197e-05, 9.820867972523337e-05]]} - #*EXTRAS*# Step: 6 Bead: 60 -{"friction": [[9.74451819842229e-05, -2.2726449748644298e-05, -2.2426964001285947e-05], [-2.2726449748644298e-05, 9.774742875711584e-05, -2.2376994505044336e-05], [-2.2426964001285947e-05, -2.2376994505044336e-05, 9.838321047901973e-05]]} - #*EXTRAS*# Step: 7 Bead: 60 -{"friction": [[9.770467661692687e-05, -2.3687650118301826e-05, -2.3422640001075604e-05], [-2.3687650118301826e-05, 9.795293378835016e-05, -2.335278847314381e-05], [-2.3422640001075604e-05, -2.335278847314381e-05, 9.855569566910974e-05]]} - #*EXTRAS*# Step: 8 Bead: 60 -{"friction": [[9.788191433043101e-05, -2.421642974038673e-05, -2.3977167117058714e-05], [-2.421642974038673e-05, 9.809396223106949e-05, -2.3896724869112565e-05], [-2.3977167117058714e-05, -2.3896724869112565e-05, 9.866473954955063e-05]]} - #*EXTRAS*# Step: 9 Bead: 60 -{"friction": [[9.801240338053946e-05, -2.4568433282431695e-05, -2.4348455659959415e-05], [-2.4568433282431695e-05, 9.819837923384216e-05, -2.4261426465855103e-05], [-2.4348455659959415e-05, -2.4261426465855103e-05, 9.874286827274087e-05]]} - #*EXTRAS*# Step: 10 Bead: 60 -{"friction": [[9.809819039411136e-05, -2.478711832135308e-05, -2.457984016929087e-05], [-2.478711832135308e-05, 9.826733988707809e-05, -2.4488991670490208e-05], [-2.457984016929087e-05, -2.4488991670490208e-05, 9.879361534773418e-05]]} - #*EXTRAS*# Step: 11 Bead: 60 -{"friction": [[9.815540521946722e-05, -2.4928304933050536e-05, -2.4729476985744752e-05], [-2.4928304933050536e-05, 9.831348164748491e-05, -2.4636297775665538e-05], [-2.4729476985744752e-05, -2.4636297775665538e-05, 9.882727000679762e-05]]} - #*EXTRAS*# Step: 12 Bead: 60 -{"friction": [[9.81925098947162e-05, -2.501808676709059e-05, -2.482472375447456e-05], [-2.501808676709059e-05, 9.834347177169294e-05, -2.4730123939354733e-05], [-2.482472375447456e-05, -2.4730123939354733e-05, 9.884903274866809e-05]]} - #*EXTRAS*# Step: 13 Bead: 60 -{"friction": [[9.821656971701218e-05, -2.5075607735100318e-05, -2.4885780295205246e-05], [-2.5075607735100318e-05, 9.83629469800449e-05, -2.4790297172275877e-05], [-2.4885780295205246e-05, -2.4790297172275877e-05, 9.886312257264868e-05]]} - #*EXTRAS*# Step: 14 Bead: 60 -{"friction": [[9.823205556020426e-05, -2.5112353621403843e-05, -2.4924798031565134e-05], [-2.5112353621403843e-05, 9.837549411179429e-05, -2.4828762049907244e-05], [-2.4924798031565134e-05, -2.4828762049907244e-05, 9.887218341119737e-05]]} - #*EXTRAS*# Step: 15 Bead: 60 -{"friction": [[9.824200947294337e-05, -2.5135861757294544e-05, -2.4949764781276185e-05], [-2.5135861757294544e-05, 9.838356415833861e-05, -2.4853379897647883e-05], [-2.4949764781276185e-05, -2.4853379897647883e-05, 9.887800451008932e-05]]} - #*EXTRAS*# Step: 16 Bead: 60 -{"friction": [[9.824839318294628e-05, -2.515089319378181e-05, -2.4965730947475086e-05], [-2.515089319378181e-05, 9.838874179355621e-05, -2.4869124960547818e-05], [-2.4965730947475086e-05, -2.4869124960547818e-05, 9.888173658419655e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_61 b/drivers/py/pes/friction/frictionH/060K/inst.raw_61 deleted file mode 100644 index 5e9c9aa13..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_61 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 61 -{"friction": [[0.00010237295826707656, -3.326562672264948e-05, -3.3246327268270765e-05], [-3.326562672264948e-05, 0.00010231289990664679, -3.3445442976744176e-05], [-3.3246327268270765e-05, -3.3445442976744176e-05, 0.0001019498435873969]]} - #*EXTRAS*# Step: 1 Bead: 61 -{"friction": [[0.0001002483250804849, -2.9182770965635303e-05, -2.9208061790821546e-05], [-2.9182770965635303e-05, 0.00010013179546908187, -2.915884176089963e-05], [-2.9208061790821546e-05, -2.915884176089963e-05, 0.00010012678129875834]]} - #*EXTRAS*# Step: 2 Bead: 61 -{"friction": [[9.813047548664374e-05, -2.4867211927167853e-05, -2.4664705023587918e-05], [-2.4867211927167853e-05, 9.829336160387571e-05, -2.45725203331877e-05], [-2.4664705023587918e-05, -2.45725203331877e-05, 9.881262177279298e-05]]} - #*EXTRAS*# Step: 3 Bead: 61 -{"friction": [[9.718427109561252e-05, -1.9928097196371617e-05, -1.9641553139821118e-05], [-1.9928097196371617e-05, 9.752846776829738e-05, -1.9635558226475252e-05], [-1.9641553139821118e-05, -1.9635558226475252e-05, 9.806445038796342e-05]]} - #*EXTRAS*# Step: 4 Bead: 61 -{"friction": [[9.726237259838942e-05, -1.870940538330825e-05, -1.847000303882603e-05], [-1.870940538330825e-05, 9.7576251869166e-05, -1.8474241856364478e-05], [-1.847000303882603e-05, -1.8474241856364478e-05, 9.800425251668492e-05]]} - #*EXTRAS*# Step: 5 Bead: 61 -{"friction": [[9.721898759670856e-05, -2.1267624347541838e-05, -2.0953536692540057e-05], [-2.1267624347541838e-05, 9.756559521814638e-05, -2.093031631413689e-05], [-2.0953536692540057e-05, -2.093031631413689e-05, 9.818409262140034e-05]]} - #*EXTRAS*# Step: 6 Bead: 61 -{"friction": [[9.739665128349606e-05, -2.2500749633865177e-05, -2.219583321778112e-05], [-2.2500749633865177e-05, 9.770895291997266e-05, -2.215041435568899e-05], [-2.219583321778112e-05, -2.215041435568899e-05, 9.834750767104676e-05]]} - #*EXTRAS*# Step: 7 Bead: 61 -{"friction": [[9.763469532250692e-05, -2.34565664201695e-05, -2.3181707735824556e-05], [-2.34565664201695e-05, 9.789744877579584e-05, -2.3116631077548038e-05], [-2.3181707735824556e-05, -2.3116631077548038e-05, 9.851119614864806e-05]]} - #*EXTRAS*# Step: 8 Bead: 61 -{"friction": [[9.780011539977943e-05, -2.398095306160085e-05, -2.3729706047420906e-05], [-2.398095306160085e-05, 9.802877228321592e-05, -2.365390154207851e-05], [-2.3729706047420906e-05, -2.365390154207851e-05, 9.861494155104444e-05]]} - #*EXTRAS*# Step: 9 Bead: 61 -{"friction": [[9.792317089661862e-05, -2.4330572893376855e-05, -2.409739380650449e-05], [-2.4330572893376855e-05, 9.812691664037869e-05, -2.401476428944014e-05], [-2.409739380650449e-05, -2.401476428944014e-05, 9.868959128600054e-05]]} - #*EXTRAS*# Step: 10 Bead: 61 -{"friction": [[9.800442280271126e-05, -2.454761930999833e-05, -2.4326459836574892e-05], [-2.454761930999833e-05, 9.819197710212993e-05, -2.4239806134395202e-05], [-2.4326459836574892e-05, -2.4239806134395202e-05, 9.873812618600461e-05]]} - #*EXTRAS*# Step: 11 Bead: 61 -{"friction": [[9.80587867600228e-05, -2.4687779425829518e-05, -2.4474670501189994e-05], [-2.4687779425829518e-05, 9.823563240247355e-05, -2.4385527347163866e-05], [-2.4474670501189994e-05, -2.4385527347163866e-05, 9.877035449281477e-05]]} - #*EXTRAS*# Step: 12 Bead: 61 -{"friction": [[9.809409984218466e-05, -2.477688874855366e-05, -2.4569005620520547e-05], [-2.477688874855366e-05, 9.826404566038217e-05, -2.4478330328987564e-05], [-2.4569005620520547e-05, -2.4478330328987564e-05, 9.879120402288565e-05]]} - #*EXTRAS*# Step: 13 Bead: 61 -{"friction": [[9.811702441204518e-05, -2.4833979187469834e-05, -2.462948525462925e-05], [-2.4833979187469834e-05, 9.828251535956562e-05, -2.453785062556591e-05], [-2.462948525462925e-05, -2.453785062556591e-05, 9.880470830772303e-05]]} - #*EXTRAS*# Step: 14 Bead: 61 -{"friction": [[9.813178928598965e-05, -2.4870447578644046e-05, -2.4668134682137145e-05], [-2.4870447578644046e-05, 9.829442134623774e-05, -2.4575896772734333e-05], [-2.4668134682137145e-05, -2.4575896772734333e-05, 9.881339431641726e-05]]} - #*EXTRAS*# Step: 15 Bead: 61 -{"friction": [[9.814128401020497e-05, -2.48937778478064e-05, -2.4692866624024347e-05], [-2.48937778478064e-05, 9.830208195249244e-05, -2.4600246780182208e-05], [-2.4692866624024347e-05, -2.4600246780182208e-05, 9.881897546848938e-05]]} - #*EXTRAS*# Step: 16 Bead: 61 -{"friction": [[9.814737487556166e-05, -2.4908695212416572e-05, -2.47086827742527e-05], [-2.4908695212416572e-05, 9.830699802495711e-05, -2.461582039012096e-05], [-2.47086827742527e-05, -2.461582039012096e-05, 9.882255400957526e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_62 b/drivers/py/pes/friction/frictionH/060K/inst.raw_62 deleted file mode 100644 index e0e5cc25b..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_62 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 62 -{"friction": [[0.00010232890466352831, -3.318888996525138e-05, -3.3171590289423344e-05], [-3.318888996525138e-05, 0.00010226643313891227, -3.33668903313071e-05], [-3.3171590289423344e-05, -3.33668903313071e-05, 0.00010190637620575303]]} - #*EXTRAS*# Step: 1 Bead: 62 -{"friction": [[0.00010020766388117925, -2.910222708904941e-05, -2.9125933233193048e-05], [-2.910222708904941e-05, 0.00010009296336100789, -2.9072879816209882e-05], [-2.9125933233193048e-05, -2.9072879816209882e-05, 0.00010009790297454793]]} - #*EXTRAS*# Step: 2 Bead: 62 -{"friction": [[9.80947837457584e-05, -2.4778600348563297e-05, -2.4570818373286747e-05], [-2.4778600348563297e-05, 9.826459638283224e-05, -2.448011406158536e-05], [-2.4570818373286747e-05, -2.448011406158536e-05, 9.879160722727227e-05]]} - #*EXTRAS*# Step: 3 Bead: 62 -{"friction": [[9.718772391202257e-05, -1.9811724841075762e-05, -1.952896214322264e-05], [-1.9811724841075762e-05, 9.753005858980748e-05, -1.952415079919637e-05], [-1.952896214322264e-05, -1.952415079919637e-05, 9.8056742244321e-05]]} - #*EXTRAS*# Step: 4 Bead: 62 -{"friction": [[9.727662818786011e-05, -1.8570481189546894e-05, -1.833730581359854e-05], [-1.8570481189546894e-05, 9.758566318478211e-05, -1.834242554119328e-05], [-1.833730581359854e-05, -1.834242554119328e-05, 9.800024243373918e-05]]} - #*EXTRAS*# Step: 5 Bead: 62 -{"friction": [[9.720801797885828e-05, -2.112446851566223e-05, -2.081166036072837e-05], [-2.112446851566223e-05, 9.755621496858423e-05, -2.079062243614572e-05], [-2.081166036072837e-05, -2.079062243614572e-05, 9.81685177842783e-05]]} - #*EXTRAS*# Step: 6 Bead: 62 -{"friction": [[9.736690767929569e-05, -2.2349774325247834e-05, -2.2041841350492772e-05], [-2.2349774325247834e-05, 9.768532040623553e-05, -2.199940646114245e-05], [-2.2041841350492772e-05, -2.199940646114245e-05, 9.832463646016201e-05]]} - #*EXTRAS*# Step: 7 Bead: 62 -{"friction": [[9.75905265976065e-05, -2.3302025519827016e-05, -2.3021104722003003e-05], [-2.3302025519827016e-05, 9.786246962441761e-05, -2.2959240737777208e-05], [-2.3021104722003003e-05, -2.2959240737777208e-05, 9.848250846652532e-05]]} - #*EXTRAS*# Step: 8 Bead: 62 -{"friction": [[9.774797512847753e-05, -2.3823498856457437e-05, -2.3564694811457992e-05], [-2.3823498856457437e-05, 9.798731306659037e-05, -2.3492066661894563e-05], [-2.3564694811457992e-05, -2.3492066661894563e-05, 9.85827523130476e-05]]} - #*EXTRAS*# Step: 9 Bead: 62 -{"friction": [[9.786597723002635e-05, -2.4171550645961008e-05, -2.3929943755029567e-05], [-2.4171550645961008e-05, 9.80812460237367e-05, -2.385037321143824e-05], [-2.3929943755029567e-05, -2.385037321143824e-05, 9.865509563096739e-05]]} - #*EXTRAS*# Step: 10 Bead: 62 -{"friction": [[9.794413727536207e-05, -2.4387519325032636e-05, -2.415743821706036e-05], [-2.4387519325032636e-05, 9.814368431488002e-05, -2.4073734764479703e-05], [-2.415743821706036e-05, -2.4073734764479703e-05, 9.870216346176393e-05]]} - #*EXTRAS*# Step: 11 Bead: 62 -{"friction": [[9.799655137183377e-05, -2.4527006128274284e-05, -2.430468105849995e-05], [-2.4527006128274284e-05, 9.818566465805331e-05, -2.4218401130951047e-05], [-2.430468105849995e-05, -2.4218401130951047e-05, 9.873344495240476e-05]]} - #*EXTRAS*# Step: 12 Bead: 62 -{"friction": [[9.803063716876702e-05, -2.4615674513122582e-05, -2.4398397275643036e-05], [-2.4615674513122582e-05, 9.821301486783601e-05, -2.4310523191521105e-05], [-2.4398397275643036e-05, -2.4310523191521105e-05, 9.875368814880108e-05]]} - #*EXTRAS*# Step: 13 Bead: 62 -{"friction": [[9.805278304377655e-05, -2.4672482913934752e-05, -2.4458485103095604e-05], [-2.4672482913934752e-05, 9.82308062080085e-05, -2.4369609042797243e-05], [-2.4458485103095604e-05, -2.4369609042797243e-05, 9.876680354253288e-05]]} - #*EXTRAS*# Step: 14 Bead: 62 -{"friction": [[9.806705302446392e-05, -2.4708769569168385e-05, -2.449688434883552e-05], [-2.4708769569168385e-05, 9.824227949104283e-05, -2.440737659831884e-05], [-2.449688434883552e-05, -2.440737659831884e-05, 9.877524057408884e-05]]} - #*EXTRAS*# Step: 15 Bead: 62 -{"friction": [[9.807623238122439e-05, -2.4731983384694714e-05, -2.4521456769266448e-05], [-2.4731983384694714e-05, 9.824966369148244e-05, -2.443154841724145e-05], [-2.4521456769266448e-05, -2.443154841724145e-05, 9.878066232652847e-05]]} - #*EXTRAS*# Step: 16 Bead: 62 -{"friction": [[9.80821220585243e-05, -2.4746826073737677e-05, -2.4537170995180064e-05], [-2.4746826073737677e-05, 9.825440315903343e-05, -2.444700796707389e-05], [-2.4537170995180064e-05, -2.444700796707389e-05, 9.878413886807257e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst.raw_63 b/drivers/py/pes/friction/frictionH/060K/inst.raw_63 deleted file mode 100644 index 4b5eb6449..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst.raw_63 +++ /dev/null @@ -1,34 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 63 -{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} - #*EXTRAS*# Step: 1 Bead: 63 -{"friction": [[0.00010018351870518526, -2.905446363591528e-05, -2.907716368803539e-05], [-2.905446363591528e-05, 0.00010006998277680341, -2.9021891158709383e-05], [-2.907716368803539e-05, -2.9021891158709383e-05, 0.00010008085846559029]]} - #*EXTRAS*# Step: 2 Bead: 63 -{"friction": [[9.807454252214828e-05, -2.4727717298074652e-05, -2.4516940596123586e-05], [-2.4727717298074652e-05, 9.824830408082602e-05, -2.44271056555307e-05], [-2.4516940596123586e-05, -2.44271056555307e-05, 9.877966453080054e-05]]} - #*EXTRAS*# Step: 3 Bead: 63 -{"friction": [[9.718995101344479e-05, -1.9749353309399745e-05, -1.9468690627591005e-05], [-1.9749353309399745e-05, 9.753119101376992e-05, -1.9464494746457783e-05], [-1.9468690627591005e-05, -1.9464494746457783e-05, 9.805278319385623e-05]]} - #*EXTRAS*# Step: 4 Bead: 63 -{"friction": [[9.728417694592658e-05, -1.850052555422473e-05, -1.8270534522998274e-05], [-1.850052555422473e-05, 9.75906758202262e-05, -1.8276077139052005e-05], [-1.8270534522998274e-05, -1.8276077139052005e-05, 9.799844237156387e-05]]} - #*EXTRAS*# Step: 5 Bead: 63 -{"friction": [[9.72032379249192e-05, -2.105277374985194e-05, -2.0740777801210474e-05], [-2.105277374985194e-05, 9.755204985851789e-05, -2.0720800011274557e-05], [-2.0740777801210474e-05, -2.0720800011274557e-05, 9.816097519124181e-05]]} - #*EXTRAS*# Step: 6 Bead: 63 -{"friction": [[9.735283198113455e-05, -2.227413073424113e-05, -2.1964876575809726e-05], [-2.227413073424113e-05, 9.767411603398189e-05, -2.1923915393552286e-05], [-2.1964876575809726e-05, -2.1923915393552286e-05, 9.831348089540015e-05]]} - #*EXTRAS*# Step: 7 Bead: 63 -{"friction": [[9.756920561901278e-05, -2.3224604970750704e-05, -2.2940811986814074e-05], [-2.3224604970750704e-05, 9.78455924485955e-05, -2.288055891288173e-05], [-2.2940811986814074e-05, -2.288055891288173e-05, 9.846845972521893e-05]]} - #*EXTRAS*# Step: 8 Bead: 63 -{"friction": [[9.772264383112357e-05, -2.374462536902469e-05, -2.348218170215389e-05], [-2.374462536902469e-05, 9.796719476811822e-05, -2.3411162188619685e-05], [-2.348218170215389e-05, -2.3411162188619685e-05, 9.856696251033694e-05]]} - #*EXTRAS*# Step: 9 Bead: 63 -{"friction": [[9.783809220176591e-05, -2.4091898866849364e-05, -2.3846200037384157e-05], [-2.4091898866849364e-05, 9.805901444636406e-05, -2.3768191412213577e-05], [-2.3846200037384157e-05, -2.3768191412213577e-05, 9.863815682857016e-05]]} - #*EXTRAS*# Step: 10 Bead: 63 -{"friction": [[9.791468731038645e-05, -2.430733267141808e-05, -2.4072901127049373e-05], [-2.430733267141808e-05, 9.812013592439068e-05, -2.399071330615677e-05], [-2.4072901127049373e-05, -2.399071330615677e-05, 9.86844936673206e-05]]} - #*EXTRAS*# Step: 11 Bead: 63 -{"friction": [[9.79661126948285e-05, -2.4446485854474863e-05, -2.4219655060252935e-05], [-2.4446485854474863e-05, 9.816127417500086e-05, -2.4134852709008207e-05], [-2.4219655060252935e-05, -2.4134852709008207e-05, 9.871530312614261e-05]]} - #*EXTRAS*# Step: 12 Bead: 63 -{"friction": [[9.799957563719973e-05, -2.4534935814705664e-05, -2.431305856288476e-05], [-2.4534935814705664e-05, 9.818808969936377e-05, -2.4226634625778833e-05], [-2.431305856288476e-05, -2.4226634625778833e-05, 9.873524399661502e-05]]} - #*EXTRAS*# Step: 13 Bead: 63 -{"friction": [[9.802132603040287e-05, -2.4591604576429815e-05, -2.4372948376028818e-05], [-2.4591604576429815e-05, 9.820553969992723e-05, -2.4285503479951573e-05], [-2.4372948376028818e-05, -2.4285503479951573e-05, 9.874816544921708e-05]]} - #*EXTRAS*# Step: 14 Bead: 63 -{"friction": [[9.80353445634791e-05, -2.462780126803823e-05, -2.441122117001879e-05], [-2.462780126803823e-05, 9.8216795207593e-05, -2.4323131890002328e-05], [-2.441122117001879e-05, -2.4323131890002328e-05, 9.87564783062955e-05]]} - #*EXTRAS*# Step: 15 Bead: 63 -{"friction": [[9.804436363951555e-05, -2.4650957446469668e-05, -2.4435712955289474e-05], [-2.4650957446469668e-05, 9.822404027333466e-05, -2.4347214714399244e-05], [-2.4435712955289474e-05, -2.4347214714399244e-05, 9.876182055492795e-05]]} - #*EXTRAS*# Step: 16 Bead: 63 -{"friction": [[9.80501510479367e-05, -2.4665763178915614e-05, -2.4451375658037263e-05], [-2.4665763178915614e-05, 9.822869083489756e-05, -2.4362617299172843e-05], [-2.4451375658037263e-05, -2.4362617299172843e-05, 9.876524622047617e-05]]} diff --git a/drivers/py/pes/friction/frictionH/060K/inst1D.dat b/drivers/py/pes/friction/frictionH/060K/inst1D.dat deleted file mode 100644 index c5b29658d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/inst1D.dat +++ /dev/null @@ -1,64 +0,0 @@ -1.8946271398760188 0.04188996657777692 -1.894899109419571 0.041900863526889834 -1.895446775546507 0.041923123290036494 -1.8962776582522902 0.04195770050408234 -1.8974032022448168 0.0420060855131063 -1.8988389743444964 0.04207037759868062 -1.9006049261077105 0.042153387961075615 -1.9027257208707462 0.04225877714797312 -1.90523112379517 0.04239123290766601 -1.9081564525570596 0.042556695720057956 -1.911543084944227 0.04276264043735885 -1.9154390176656064 0.043018423378940955 -1.9198994679528358 0.043335704593480864 -1.9249875058165546 0.04372895439217363 -1.9307746998326776 0.044216051019865206 -1.9373417527292698 0.04481897152736948 -1.944779094420871 0.04556456922968684 -1.953187389015454 0.04648541682458694 -1.9626778981716309 0.04762067205218661 -1.9733726254423485 0.04901688998007385 -1.985404144367682 0.05072865960581607 -1.9989149866301472 0.05281887968573434 -2.014056435407754 0.05535840789837423 -2.0309865334809216 0.058424719865035474 -2.0498670769172844 0.06209910701146486 -2.070859325905254 0.066461841209792 -2.094118129360892 0.07158467096788483 -2.1197841372029558 0.07752004091605551 -2.1479737758413475 0.08428662141762541 -2.178766705931564 0.09185113866674895 -2.212190608326317 0.10009593976347193 -2.2482067670047514 0.10877697963014449 -2.2867031902053014 0.11751915734160046 -2.3274929122114663 0.12581135530799012 -2.3703181182985524 0.13307220508135698 -2.4148594137053774 0.13895092600109205 -2.4607429171896102 0.1432150762092829 -2.507548727689012 0.1456581628459286 -2.554827002764131 0.14610963278888334 -2.6021216915269947 0.14458378473150957 -2.648991957297969 0.14143639238751873 -2.6950236423421674 0.13709530919860483 -2.73983806768427 0.1317981110496677 -2.7831028413206846 0.1255805307751963 -2.8245439522388858 0.11851733915702649 -2.8639534578924675 0.1108844393473955 -2.9011861646946615 0.10306701924110809 -2.936149039492901 0.09537350522366975 -2.968791143171844 0.08803268331193705 -2.999094611103431 0.08118650169152661 -3.0270670057098226 0.07490294300227612 -3.052735015597897 0.06921489462993596 -3.076139066907417 0.06412983710469453 -3.097328765727429 0.05963651004553192 -3.116359097484316 0.05571064347467451 -3.133287296790556 0.05231629164973843 -3.1481702244493515 0.049410067695638174 -3.161062173004411 0.04695241828952321 -3.1720131988989606 0.044908869850933196 -3.1810678866287674 0.04325007570479916 -3.1882644479839457 0.041951779568970234 -3.1936340784233743 0.04099473574992911 -3.1972005095141953 0.040364615621776574 -3.1989797112554377 0.040051921394414956 diff --git a/drivers/py/pes/friction/frictionH/060K/z_friction.dat b/drivers/py/pes/friction/frictionH/060K/z_friction.dat deleted file mode 100644 index 88b85ef6d..000000000 --- a/drivers/py/pes/friction/frictionH/060K/z_friction.dat +++ /dev/null @@ -1,1003 +0,0 @@ -#eta 1 -# bath_type Ohmic -# w_c 500 - # freq (cm^-1) Laplace transform -1 0.9915470158218098 -2 0.9848551497951816 -3 0.9788255643617454 -4 0.9732247078293326 -5 0.9679416696883935 -6 0.962911133018018 -7 0.9580899447435153 -8 0.9534474391977994 -9 0.9489606918318892 -10 0.9446119121776004 -11 0.9403868910489187 -12 0.9362740173481964 -13 0.9322636249598021 -14 0.928347541807527 -15 0.9245187684107862 -16 0.9207712425362906 -17 0.9170996629124359 -18 0.9134993545627568 -19 0.9099661641551429 -20 0.9064963774421086 -21 0.9030866532531712 -22 0.8997339700879358 -23 0.8964355824392188 -24 0.8931889847263488 -25 0.8899918812500051 -26 0.8868421609620551 -27 0.8837378761228457 -28 0.8806772241248969 -29 0.8776585319167312 -30 0.874680242577914 -31 0.8717409036863014 -32 0.8688391571880675 -33 0.8659737305354348 -34 0.8631434288998111 -35 0.8603471283020212 -36 0.857583769528487 -37 0.8548523527240882 -38 0.8521519325701771 -39 0.8494816139706848 -40 0.8468405481811211 -41 0.8442279293250585 -42 0.8416429912508109 -43 0.8390850046877706 -44 0.8365532746675381 -45 0.8340471381797273 -46 0.831565962036351 -47 0.8291091409221039 -48 0.8266760956107441 -49 0.824266271330268 -50 0.8218791362616757 -51 0.8195141801579645 -52 0.8171709130715548 -53 0.8148488641797111 -54 0.8125475806987108 -55 0.8102666268785352 -56 0.8080055830707606 -57 0.8057640448631033 -58 0.8035416222747761 -59 0.8013379390074006 -60 0.7991526317467734 -61 0.796985349511237 -62 0.7948357530428389 -63 0.7927035142377412 -64 0.7905883156132424 -65 0.7884898498073732 -66 0.7864078191101018 -67 0.7843419350226136 -68 0.7822919178430147 -69 0.7802574962764451 -70 0.7782384070678282 -71 0.7762343946556395 -72 0.7742452108452136 -73 0.7722706145002324 -74 0.770310371251143 -75 0.76836425321937 -76 0.7664320387562564 -77 0.7645135121957763 -78 0.7626084636201109 -79 0.7607166886372758 -80 0.7588379881700227 -81 0.7569721682553251 -82 0.7551190398537776 -83 0.7532784186683185 -84 0.7514501249717047 -85 0.7496339834422199 -86 0.7478298230071312 -87 0.7460374766934447 -88 0.744256781485537 -89 0.742487578189273 -90 0.740729711302249 -91 0.738983028889811 -92 0.7372473824665428 -93 0.7355226268829143 -94 0.7338086202168218 -95 0.7321052236697538 -96 0.7304123014673415 -97 0.7287297207640642 -98 0.7270573515518944 -99 0.7253950665726847 -100 0.7237427412341026 -101 0.7221002535289383 -102 0.7204674839576208 -103 0.7188443154537764 -104 0.7172306333126927 -105 0.7156263251225384 -106 0.7140312806982176 -107 0.712445392017719 -108 0.7108685531608633 -109 0.7093006602503189 -110 0.7077416113947941 -111 0.7061913066343006 -112 0.7046496478873963 -113 0.7031165389003207 -114 0.701591885197936 -115 0.7000755940363974 -116 0.6985675743574739 -117 0.6970677367444532 -118 0.6955759933795586 -119 0.694092258002813 -120 0.6926164458722978 -121 0.6911484737257331 -122 0.6896882597433415 -123 0.6882357235119293 -124 0.6867907859901439 -125 0.6853533694748546 -126 0.6839233975686164 -127 0.6825007951481693 -128 0.6810854883339358 -129 0.6796774044604751 -130 0.6782764720478581 -131 0.6768826207739282 -132 0.675495781447412 -133 0.6741158859818493 -134 0.6727428673703116 -135 0.6713766596608783 -136 0.6700171979328448 -137 0.6686644182736309 -138 0.6673182577563711 -139 0.665978654418155 -140 0.6646455472388978 -141 0.6633188761208197 -142 0.6619985818685072 -143 0.6606846061695424 -144 0.6593768915756765 -145 0.6580753814845278 -146 0.6567800201217898 -147 0.6554907525239279 -148 0.6542075245213498 -149 0.6529302827220361 -150 0.6516589744956094 -151 0.6503935479578326 -152 0.6491339519555221 -153 0.6478801360518566 -154 0.6466320505120773 -155 0.6453896462895573 -156 0.6441528750122365 -157 0.642921688969405 -158 0.6416960410988252 -159 0.640475884974183 -160 0.6392611747928573 -161 0.6380518653639957 -162 0.6368479120968908 -163 0.635649270989643 -164 0.6344558986181063 -165 0.6332677521251036 -166 0.6320847892099062 -167 0.6309069681179693 -168 0.6297342476309137 -169 0.6285665870567494 -170 0.6274039462203316 -171 0.626246285454043 -172 0.6250935655886968 -173 0.623945747944651 -174 0.6228027943231316 -175 0.6216646669977567 -176 0.6205313287062546 -177 0.6194027426423736 -178 0.6182788724479744 -179 0.6171596822053032 -180 0.6160451364294374 -181 0.6149352000609029 -182 0.6138298384584534 -183 0.6127290173920114 -184 0.6116327030357649 -185 0.610540861961415 -186 0.6094534611315701 -187 0.6083704678932862 -188 0.6072918499717428 -189 0.6062175754640584 -190 0.6051476128332351 -191 0.6040819309022343 -192 0.6030204988481755 -193 0.6019632861966588 -194 0.6009102628162061 -195 0.5998613989128165 -196 0.5988166650246367 -197 0.5977760320167395 -198 0.5967394710760106 -199 0.5957069537061387 -200 0.5946784517227086 -201 0.5936539372483923 -202 0.5926333827082372 -203 0.5916167608250495 -204 0.5906040446148677 -205 0.5895952073825281 -206 0.5885902227173152 -207 0.5875890644887002 -208 0.5865917068421604 -209 0.5855981241950815 -210 0.5846082912327386 -211 0.5836221829043546 -212 0.5826397744192342 -213 0.581661041242972 -214 0.5806859590937321 -215 0.5797145039385988 -216 0.5787466519899951 -217 0.5777823797021695 -218 0.5768216637677468 -219 0.5758644811143447 -220 0.5749108089012515 -221 0.5739606245161651 -222 0.5730139055719944 -223 0.5720706299037137 -224 0.5711307755652795 -225 0.5701943208266014 -226 0.5692612441705648 -227 0.5683315242901118 -228 0.5674051400853706 -229 0.5664820706608363 -230 0.565562295322604 -231 0.5646457935756481 -232 0.5637325451211503 -233 0.5628225298538745 -234 0.5619157278595864 -235 0.5610121194125203 -236 0.5601116849728858 -237 0.5592144051844212 -238 0.5583202608719857 -239 0.5574292330391953 -240 0.5565413028660963 -241 0.5556564517068797 -242 0.5547746610876346 -243 0.5538959127041372 -244 0.5530201884196781 -245 0.5521474702629271 -246 0.5512777404258298 -247 0.5504109812615423 -248 0.549547175282398 -249 0.548686305157909 -250 0.5478283537127981 -251 0.5469733039250656 -252 0.5461211389240842 -253 0.5452718419887275 -254 0.5444253965455269 -255 0.5435817861668577 -256 0.5427409945691563 -257 0.5419030056111626 -258 0.5410678032921926 -259 0.5402353717504378 -260 0.5394056952612899 -261 0.5385787582356935 -262 0.5377545452185236 -263 0.5369330408869883 -264 0.5361142300490556 -265 0.5352980976419066 -266 0.5344846287304097 -267 0.5336738085056196 -268 0.5328656222832998 -269 0.5320600555024659 -270 0.5312570937239519 -271 0.5304567226289982 -272 0.5296589280178607 -273 0.5288636958084402 -274 0.528071012034933 -275 0.527280862846501 -276 0.526493234505962 -277 0.5257081133884988 -278 0.5249254859803876 -279 0.5241453388777454 -280 0.5233676587852939 -281 0.5225924325151446 -282 0.5218196469855986 -283 0.5210492892199644 -284 0.5202813463453946 -285 0.5195158055917365 -286 0.5187526542904008 -287 0.5179918798732471 -288 0.5172334698714828 -289 0.5164774119145797 -290 0.5157236937292059 -291 0.5149723031381711 -292 0.5142232280593879 -293 0.5134764565048479 -294 0.5127319765796108 -295 0.5119897764808087 -296 0.5112498444966641 -297 0.5105121690055203 -298 0.5097767384748864 -299 0.5090435414604948 -300 0.5083125666053719 -301 0.507583802638921 -302 0.5068572383760178 -303 0.5061328627161186 -304 0.5054106646423798 -305 0.5046906332207897 -306 0.5039727575993115 -307 0.5032570270070392 -308 0.5025434307533622 -309 0.5018319582271428 -310 0.5011225988959046 -311 0.5004153423050312 -312 0.49971017807697427 -313 0.49900709591047493 -314 0.49830608557979217 -315 0.497607136933943 -316 0.4969102398959523 -317 0.4962153844621122 -318 0.4955225607012511 -319 0.4948317587540115 -320 0.4941429688321387 -321 0.4934561812177765 -322 0.49277138626277345 -323 0.4920885743879972 -324 0.4914077360826579 -325 0.49072886190364023 -326 0.4900519424748425 -327 0.48937696848652695 -328 0.4887039306946743 -329 0.4880328199203507 -330 0.48736362704907843 -331 0.48669634303021736 -332 0.4860309588763527 -333 0.48536746566269084 -334 0.48470585452646225 -335 0.4840461166663318 -336 0.48338824334181657 -337 0.4827322258727103 -338 0.48207805563851625 -339 0.4814257240778837 -340 0.4807752226880555 -341 0.4801265430243186 -342 0.4794796766994642 -343 0.4788346153832517 -344 0.478191350801881 -345 0.4775498747374702 -346 0.47691017902753985 -347 0.4762722555645029 -348 0.47563609629516157 -349 0.4750016932202088 -350 0.474369038393737 -351 0.4737381239227518 -352 0.4731089419666909 -353 0.4724814847369504 -354 0.4718557444964145 -355 0.471231713558992 -356 0.4706093842891585 -357 0.46998874910150146 -358 0.46936980046027404 -359 0.46875253087895113 -360 0.4681369329197923 -361 0.4675229991934086 -362 0.4669107223583348 -363 0.46630009512060633 -364 0.4656911102333418 -365 0.46508376049632844 -366 0.4644780387556143 -367 0.4638739379031033 -368 0.46327145087615657 -369 0.4626705706571957 -370 0.4620712902733141 -371 0.46147360279588856 -372 0.46087750134019834 -373 0.4602829790650468 -374 0.4596900291723878 -375 0.4590986449069562 -376 0.45850881955590195 -377 0.45792054644842906 -378 0.4573338189554377 -379 0.45674863048917047 -380 0.45616497450286275 -381 0.4555828444903966 -382 0.4550022339859583 -383 0.45442313656369987 -384 0.4538455458374046 -385 0.45326945546015474 -386 0.4526948591240039 -387 0.45212175055965415 -388 0.45155012353613266 -389 0.4509799718604769 -390 0.4504112893774181 -391 0.44984406996907317 -392 0.44927830755463477 -393 0.44871399609006835 -394 0.4481511295678115 -395 0.44758970201647463 -396 0.4470297075005478 -397 0.44647114012010813 -398 0.4459139940105313 -399 0.445358263342206 -400 0.4448039423202515 -401 0.4442510251842373 -402 0.4436995062079068 -403 0.4431493796989029 -404 0.44260063999849697 -405 0.4420532814813202 -406 0.4415072985550987 -407 0.44096268566038893 -408 0.4404194372703193 -409 0.4398775478903305 -410 0.4393370120579223 -411 0.4387978243423998 -412 0.43825997934462363 -413 0.4377234716967632 -414 0.43718829606205123 -415 0.43665444713454066 -416 0.4361219196388661 -417 0.4355907083300043 -418 0.4350608079930402 -419 0.43453221344293347 -420 0.4340049195242877 -421 0.43347892111112174 -422 0.43295421310664406 -423 0.43243079044302857 -424 0.43190864808119267 -425 0.43138778101057784 -426 0.43086818424893225 -427 0.43034985284209504 -428 0.4298327818637838 -429 0.42931696641538275 -430 0.4288024016257333 -431 0.4282890826509284 -432 0.4277770046741056 -433 0.4272661629052452 -434 0.4267565525809683 -435 0.426248168964338 -436 0.4257410073446616 -437 0.4252350630372958 -438 0.42473033138345195 -439 0.42422680775000515 -440 0.42372448752930386 -441 0.4232233661389823 -442 0.4227234390217727 -443 0.42222470164532216 -444 0.4217271495020085 -445 0.42123077810876014 -446 0.4207355830068754 -447 0.42024155976184563 -448 0.419748703963178 -449 0.4192570112242222 -450 0.4187664771819965 -451 0.41827709749701647 -452 0.4177888678531257 -453 0.41730178395732725 -454 0.4168158415396169 -455 0.4163310363528185 -456 0.4158473641724194 -457 0.41536482079640946 -458 0.4148834020451197 -459 0.41440310376106304 -460 0.41392392180877696 -461 0.4134458520746668 -462 0.41296889046685104 -463 0.4124930329150079 -464 0.4120182753702229 -465 0.41154461380483826 -466 0.41107204421230364 -467 0.4106005626070276 -468 0.41013016502423144 -469 0.4096608475198032 -470 0.4091926061701538 -471 0.4087254370720742 -472 0.40825933634259365 -473 0.40779430011883927 -474 0.407330324557897 -475 0.40686740583667413 -476 0.40640554015176156 -477 0.40594472371929935 -478 0.4054849527748419 -479 0.40502622357322515 -480 0.40456853238843427 -481 0.40411187551347244 -482 0.4036562492602327 -483 0.4032016499593676 -484 0.40274807396016254 -485 0.40229551763040994 -486 0.401843977356283 -487 0.4013934495422118 -488 0.40094393061076083 -489 0.40049541700250596 -490 0.4000479051759142 -491 0.39960139160722313 -492 0.3991558727903225 -493 0.39871134523663565 -494 0.39826780547500285 -495 0.3978252500515656 -496 0.3973836755296513 -497 0.3969430784896594 -498 0.39650345552894783 -499 0.39606480326172205 -500 0.39562711831892267 -501 0.3951903973481156 -502 0.39475463701338354 -503 0.3943198339952161 -504 0.39388598499040356 -505 0.39345308671192963 -506 0.39302113588886617 -507 0.3925901292662675 -508 0.39216006360506744 -509 0.39173093568197576 -510 0.39130274228937556 -511 0.39087548023522245 -512 0.3904491463429436 -513 0.3900237374513377 -514 0.38959925041447707 -515 0.389175682101608 -516 0.38875302939705453 -517 0.38833128920012144 -518 0.38791045842499833 -519 0.3874905340006655 -520 0.3870715128707984 -521 0.3866533919936748 -522 0.3862361683420825 -523 0.38581983890322674 -524 0.385404400678639 -525 0.38498985068408675 -526 0.3845761859494836 -527 0.38416340351880035 -528 0.38375150044997597 -529 0.38334047381483105 -530 0.3829303206989799 -531 0.3825210382017448 -532 0.38211262343607033 -533 0.38170507352843797 -534 0.38129838561878276 -535 0.3808925568604089 -536 0.38048758441990777 -537 0.38008346547707406 -538 0.3796801972248261 -539 0.37927777686912334 -540 0.3788762016288872 -541 0.37847546873592014 -542 0.3780755754348275 -543 0.37767651898293847 -544 0.3772782966502284 -545 0.3768809057192419 -546 0.3764843434850152 -547 0.37608860725500115 -548 0.37569369434899286 -549 0.3752996020990492 -550 0.3749063278494206 -551 0.37451386895647465 -552 0.37412222278862356 -553 0.373731386726251 -554 0.3733413581616405 -555 0.3729521344989033 -556 0.3725637131539079 -557 0.3721760915542089 -558 0.37178926713897814 -559 0.3714032373589341 -560 0.37101799967627386 -561 0.37063355156460415 -562 0.37024989050887425 -563 0.3698670140053074 -564 0.36948491956133556 -565 0.36910360469553166 -566 0.36872306693754475 -567 0.3683433038280338 -568 0.36796431291860365 -569 0.3675860917717399 -570 0.36720863796074577 -571 0.366831949069678 -572 0.36645602269328403 -573 0.3660808564369399 -574 0.36570644791658763 -575 0.36533279475867425 -576 0.36495989460009 -577 0.3645877450881084 -578 0.36421634388032514 -579 0.3638456886445993 -580 0.36347577705899325 -581 0.36310660681171375 -582 0.36273817560105387 -583 0.3623704811353349 -584 0.36200352113284795 -585 0.3616372933217977 -586 0.361271795440245 -587 0.3609070252360509 -588 0.36054298046682 -589 0.36017965889984516 -590 0.3598170583120531 -591 0.35945517648994796 -592 0.3590940112295585 -593 0.3587335603363829 -594 0.35837382162533604 -595 0.3580147929206956 -596 0.35765647205604956 -597 0.3572988568742431 -598 0.35694194522732786 -599 0.3565857349765085 -600 0.3562302239920924 -601 0.35587541015343827 -602 0.3555212913489055 -603 0.3551678654758042 -604 0.3548151304403445 -605 0.35446308415758787 -606 0.3541117245513971 -607 0.3537610495543878 -608 0.3534110571078797 -609 0.35306174516184863 -610 0.3527131116748783 -611 0.3523651546141128 -612 0.3520178719552097 -613 0.35167126168229296 -614 0.3513253217879061 -615 0.3509800502729663 -616 0.3506354451467184 -617 0.35029150442668927 -618 0.3499482261386421 -619 0.34960560831653265 -620 0.3492636490024624 -621 0.3489223462466368 -622 0.3485816981073192 -623 0.34824170265078774 -624 0.34790235795129204 -625 0.3475636620910101 -626 0.3472256131600049 -627 0.3468882092561822 -628 0.3465514484852485 -629 0.3462153289606681 -630 0.3458798488036226 -631 0.34554500614296846 -632 0.3452107991151962 -633 0.3448772258643897 -634 0.34454428454218505 -635 0.34421197330773123 -636 0.34388029032764894 -637 0.3435492337759909 -638 0.3432188018342032 -639 0.3428889926910855 -640 0.3425598045427515 -641 0.342231235592591 -642 0.34190328405123144 -643 0.3415759481364984 -644 0.3412492260733795 -645 0.3409231160939852 -646 0.3405976164375119 -647 0.3402727253502047 -648 0.33994844108532046 -649 0.3396247619030907 -650 0.3393016860706855 -651 0.33897921186217694 -652 0.33865733755850347 -653 0.33833606144743356 -654 0.3380153818235307 -655 0.3376952969881176 -656 0.33737580524924166 -657 0.3370569049216394 -658 0.33673859432670233 -659 0.3364208717924425 -660 0.3361037356534581 -661 0.33578718425089965 -662 0.33547121593243634 -663 0.3351558290522219 -664 0.33484102197086224 -665 0.33452679305538185 -666 0.3342131406791904 -667 0.3339000632220512 -668 0.33358755907004783 -669 0.3332756266155521 -670 0.3329642642571924 -671 0.33265347039982107 -672 0.33234324345448363 -673 0.3320335818383867 -674 0.3317244839748669 -675 0.3314159482933603 -676 0.3311079732293706 -677 0.3308005572244392 -678 0.33049369872611495 -679 0.33018739618792325 -680 0.32988164806933584 -681 0.32957645283574216 -682 0.329271808958418 -683 0.32896771491449733 -684 0.32866416918694225 -685 0.3283611702645137 -686 0.3280587166417438 -687 0.32775680681890496 -688 0.32745543930198334 -689 0.32715461260264894 -690 0.32685432523822827 -691 0.32655457573167584 -692 0.3262553626115465 -693 0.32595668441196735 -694 0.3256585396726107 -695 0.32536092693866625 -696 0.3250638447608144 -697 0.32476729169519847 -698 0.3244712663033984 -699 0.3241757671524041 -700 0.3238807928145882 -701 0.32358634186768065 -702 0.32329241289474187 -703 0.32299900448413643 -704 0.32270611522950815 -705 0.3224137437297533 -706 0.3221218885889956 -707 0.3218305484165607 -708 0.32153972182695095 -709 0.3212494074398199 -710 0.320959603879948 -711 0.32067030977721706 -712 0.32038152376658613 -713 0.3200932444880666 -714 0.3198054705866983 -715 0.31951820071252474 -716 0.3192314335205693 -717 0.3189451676708114 -718 0.3186594018281623 -719 0.31837413466244235 -720 0.3180893648483562 -721 0.3178050910654704 -722 0.3175213119981899 -723 0.31723802633573495 -724 0.316955232772118 -725 0.31667293000612123 -726 0.31639111674127374 -727 0.3161097916858287 -728 0.3158289535527413 -729 0.3155486010596463 -730 0.31526873292883634 -731 0.31498934788723887 -732 0.3147104446663956 -733 0.3144320220024395 -734 0.31415407863607436 -735 0.3138766133125523 -736 0.3135996247816527 -737 0.31332311179766137 -738 0.3130470731193488 -739 0.3127715075099498 -740 0.312496413737142 -741 0.3122217905730254 -742 0.31194763679410176 -743 0.3116739511812541 -744 0.3114007325197262 -745 0.3111279795991024 -746 0.3108556912132874 -747 0.310583866160486 -748 0.3103125032431839 -749 0.31004160126812674 -750 0.3097711590463018 -751 0.3095011753929171 -752 0.30923164912738277 -753 0.30896257907329133 -754 0.3086939640583986 -755 0.30842580291460436 -756 0.30815809447793374 -757 0.30789083758851776 -758 0.30762403109057496 -759 0.30735767383239243 -760 0.3070917646663073 -761 0.30682630244868847 -762 0.3065612860399177 -763 0.306296714304372 -764 0.3060325861104046 -765 0.305768900330328 -766 0.30550565584039485 -767 0.30524285152078096 -768 0.304980486255567 -769 0.30471855893272104 -770 0.30445706844408094 -771 0.30419601368533694 -772 0.30393539355601423 -773 0.30367520695945566 -774 0.30341545280280474 -775 0.30315612999698804 -776 0.3028972374566991 -777 0.30263877410038054 -778 0.30238073885020794 -779 0.30212313063207297 -780 0.30186594837556674 -781 0.3016091910139632 -782 0.30135285748420293 -783 0.30109694672687665 -784 0.30084145768620885 -785 0.30058638931004206 -786 0.3003317405498202 -787 0.30007751036057334 -788 0.29982369770090106 -789 0.2995703015329571 -790 0.2993173208224336 -791 0.29906475453854525 -792 0.2988126016540142 -793 0.29856086114505387 -794 0.29830953199135457 -795 0.29805861317606724 -796 0.29780810368578886 -797 0.2975580025105472 -798 0.2973083086437855 -799 0.297059021082348 -800 0.2968101388264648 -801 0.2965616608797368 -802 0.29631358624912163 -803 0.29606591394491844 -804 0.2958186429807536 -805 0.2955717723735663 -806 0.29532530114359384 -807 0.29507922831435773 -808 0.29483355291264907 -809 0.29458827396851467 -810 0.29434339051524283 -811 0.2940989015893491 -812 0.293854806230563 -813 0.2936111034818134 -814 0.2933677923892153 -815 0.2931248720020557 -816 0.2928823413727803 -817 0.2926401995569797 -818 0.292398445613376 -819 0.2921570786038094 -820 0.2919160975932247 -821 0.2916755016496583 -822 0.2914352898442247 -823 0.29119546125110335 -824 0.29095601494752615 -825 0.29071695001376363 -826 0.29047826553311235 -827 0.29023996059188234 -828 0.29000203427938387 -829 0.28976448568791496 -830 0.28952731391274866 -831 0.2892905180521204 -832 0.28905409720721553 -833 0.28881805048215686 -834 0.28858237698399214 -835 0.28834707582268215 -836 0.28811214611108754 -837 0.28787758696495763 -838 0.28764339750291784 -839 0.28740957684645724 -840 0.2871761241199174 -841 0.2869430384504794 -842 0.286710318968153 -843 0.28647796480576393 -844 0.2862459750989426 -845 0.2860143489861123 -846 0.2857830856084774 -847 0.2855521841100122 -848 0.2853216436374487 -849 0.2850914633402659 -850 0.28486164237067796 -851 0.28463217988362266 -852 0.2844030750367507 -853 0.2841743269904139 -854 0.28394593490765446 -855 0.2837178979541936 -856 0.28349021529842056 -857 0.28326288611138145 -858 0.2830359095667686 -859 0.2828092848409096 -860 0.28258301111275624 -861 0.2823570875638738 -862 0.28213151337843057 -863 0.28190628774318693 -864 0.28168140984748485 -865 0.28145687888323717 -866 0.2812326940449174 -867 0.28100885452954893 -868 0.28078535953669487 -869 0.28056220826844747 -870 0.2803393999294182 -871 0.2801169337267269 -872 0.27989480886999235 -873 0.27967302457132137 -874 0.27945158004529935 -875 0.2792304745089797 -876 0.27900970718187434 -877 0.2787892772859434 -878 0.27856918404558545 -879 0.27834942668762763 -880 0.27813000444131597 -881 0.2779109165383055 -882 0.27769216221265064 -883 0.2774737407007956 -884 0.27725565124156454 -885 0.2770378930761524 -886 0.27682046544811495 -887 0.27660336760335985 -888 0.2763865987901368 -889 0.2761701582590283 -890 0.27595404526294054 -891 0.27573825905709387 -892 0.2755227988990136 -893 0.2753076640485212 -894 0.2750928537677243 -895 0.2748783673210088 -896 0.2746642039750288 -897 0.27445036299869796 -898 0.27423684366318085 -899 0.2740236452418835 -900 0.27381076701044504 -901 0.27359820824672837 -902 0.27338596823081174 -903 0.2731740462449801 -904 0.2729624415737158 -905 0.27275115350369084 -906 0.2725401813237574 -907 0.2723295243249398 -908 0.27211918180042577 -909 0.2719091530455581 -910 0.271699437357826 -911 0.2714900340368568 -912 0.27128094238440764 -913 0.27107216170435705 -914 0.2708636913026968 -915 0.27065553048752344 -916 0.2704476785690303 -917 0.27024013485949927 -918 0.27003289867329255 -919 0.2698259693268448 -920 0.26961934613865485 -921 0.269413028429278 -922 0.2692070155213177 -923 0.26900130673941763 -924 0.26879590141025433 -925 0.2685907988625287 -926 0.26838599842695854 -927 0.2681814994362706 -928 0.2679773012251932 -929 0.2677734031304478 -930 0.267569804490742 -931 0.2673665046467618 -932 0.2671635029411637 -933 0.26696079871856737 -934 0.2667583913255481 -935 0.26655628011062926 -936 0.2663544644242748 -937 0.26615294361888214 -938 0.26595171704877413 -939 0.26575078407019265 -940 0.2655501440412903 -941 0.26534979632212374 -942 0.2651497402746465 -943 0.26494997526270114 -944 0.26475050065201294 -945 0.26455131581018193 -946 0.2643524201066763 -947 0.2641538129128253 -948 0.2639554936018118 -949 0.26375746154866575 -950 0.26355971613025697 -951 0.2633622567252881 -952 0.2631650827142882 -953 0.26296819347960493 -954 0.26277158840539866 -955 0.26257526687763516 -956 0.2623792282840789 -957 0.2621834720142861 -958 0.26198799745959866 -959 0.2617928040131365 -960 0.2615978910697918 -961 0.2614032580262219 -962 0.26120890428084254 -963 0.2610148292338218 -964 0.26082103228707326 -965 0.26062751284424945 -966 0.2604342703107354 -967 0.2602413040936423 -968 0.2600486136018011 -969 0.259856198245756 -970 0.25966405743775794 -971 0.25947219059175874 -972 0.2592805971234043 -973 0.25908927645002855 -974 0.2588982279906473 -975 0.2587074511659519 -976 0.25851694539830294 -977 0.2583267101117244 -978 0.2581367447318972 -979 0.2579470486861532 -980 0.25775762140346925 -981 0.25756846231446096 -982 0.25737957085137686 -983 0.2571909464480922 -984 0.2570025885401032 -985 0.2568144965645208 -986 0.2566266699600653 -987 0.25643910816705967 -988 0.2562518106274244 -989 0.25606477678467143 -990 0.25587800608389827 -991 0.2556914979717821 -992 0.25550525189657447 -993 0.255319267308095 -994 0.2551335436577262 -995 0.2549480803984073 -996 0.25476287698462907 -997 0.2545779328724277 -998 0.2543932475193798 -999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/080K/RESTART b/drivers/py/pes/friction/frictionH/080K/RESTART deleted file mode 100644 index 2dd6bdb46..000000000 --- a/drivers/py/pes/friction/frictionH/080K/RESTART +++ /dev/null @@ -1,612 +0,0 @@ - - - [ step, potential{electronvolt} ] - extras - extras - - 8 - 50 - - - - - - [ friction ] - - - - 2.53345216e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 1.87125253e-03, 1.94415705e-03, 2.11485323e-03, 2.43333383e-03, 2.96417915e-03, - 3.73894991e-03, 4.62473097e-03, 5.24531366e-03, 5.33474337e-03, 4.92758778e-03, - 4.24486200e-03, 3.47030406e-03, 2.81905209e-03, 2.35304891e-03, 2.06372948e-03, - 1.92715839e-03 ] - - - [ -1.85101715e-03, 1.78054446e-05, 1.72347097e-05, -1.99935349e-03, 1.87715891e-05, - 1.82552250e-05, -2.27916672e-03, 2.04242136e-05, 2.00299537e-05, -2.63635485e-03, - 2.21550416e-05, 2.19414412e-05, -2.93491219e-03, 2.29794467e-05, 2.29137533e-05, - -2.89739482e-03, 2.15580367e-05, 2.14545521e-05, -2.25370048e-03, 1.62445756e-05, - 1.61023873e-05, -1.05469771e-03, 6.43464786e-06, 6.41458842e-06, 4.02628281e-04, - -5.86683778e-06, -5.84993412e-06, 1.65907654e-03, -1.78251631e-05, -1.78386211e-05, - 2.43915345e-03, -2.74463257e-05, -2.74344677e-05, 2.72472822e-03, -3.40805857e-05, - -3.40689424e-05, 2.74382201e-03, -3.81045174e-05, -3.81325991e-05, 2.65724093e-03, - -4.03253940e-05, -4.03618379e-05, 2.55902302e-03, -4.14460535e-05, -4.14371939e-05, - 2.49940959e-03, -4.19041578e-05, -4.18476427e-05 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00 ] - - True - - [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, - 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, - 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, - 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, - 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, - 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, - 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, - 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, - 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, - 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, - 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, - 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, - 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, - 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, - 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, - 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, - 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, - 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, - 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, - 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, - 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, - 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, - 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, - 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, - 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, - 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, - 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, - 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, - 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, - 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, - 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, - 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, - 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, - 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, - 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, - 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, - 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, - 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, - 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, - 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, - 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, - 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, - 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, - 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, - 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, - 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, - 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, - 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, - 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, - 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, - 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, - 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, - 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, - 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, - 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, - 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, - 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, - 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, - 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, - 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, - 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, - 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, - 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, - 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, - 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, - 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, - 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, - 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, - 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, - 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, - 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, - 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, - 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, - 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, - 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, - 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, - 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, - 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, - 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, - 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, - 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, - 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, - 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, - 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, - 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, - 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, - 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, - 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, - 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, - 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, - 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, - 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, - 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, - 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, - 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, - 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, - 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, - 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, - 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, - 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, - 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, - 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, - 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, - 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, - 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, - 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, - 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, - 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, - 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, - 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, - 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, - 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, - 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, - 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, - 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, - 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, - 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, - 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, - 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, - 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, - 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, - 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, - 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, - 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, - 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, - 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, - 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, - 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, - 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, - 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, - 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, - 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, - 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, - 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, - 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, - 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, - 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, - 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, - 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, - 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, - 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, - 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, - 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, - 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, - 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, - 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, - 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, - 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, - 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, - 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, - 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, - 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, - 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, - 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, - 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, - 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, - 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, - 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, - 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, - 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, - 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, - 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, - 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, - 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, - 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, - 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, - 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, - 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, - 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, - 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, - 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, - 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, - 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, - 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, - 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, - 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, - 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, - 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, - 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, - 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, - 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, - 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, - 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, - 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, - 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, - 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, - 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, - 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, - 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, - 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, - 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, - 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, - 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, - 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, - 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, - 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, - 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, - 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, - 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, - 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, - 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, - 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, - 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, - 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, - 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, - 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, - 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, - 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, - 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, - 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, - 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, - 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, - 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, - 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, - 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, - 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, - 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, - 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, - 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, - 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, - 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, - 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, - 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, - 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, - 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, - 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, - 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, - 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, - 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, - 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, - 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, - 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, - 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, - 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, - 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, - 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, - 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, - 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, - 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, - 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, - 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, - 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, - 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, - 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, - 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, - 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, - 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, - 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, - 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, - 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, - 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, - 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, - 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, - 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, - 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, - 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, - 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, - 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, - 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, - 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, - 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, - 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, - 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, - 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, - 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, - 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, - 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, - 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, - 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, - 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, - 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, - 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, - 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, - 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, - 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, - 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, - 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, - 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, - 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, - 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, - 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, - 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, - 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, - 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, - 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, - 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, - 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, - 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, - 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, - 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, - 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, - 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, - 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, - 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, - 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, - 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, - 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, - 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, - 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, - 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, - 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, - 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, - 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, - 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, - 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, - 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, - 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, - 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, - 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, - 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, - 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, - 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, - 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, - 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, - 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, - 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, - 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, - 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, - 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, - 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, - 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, - 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, - 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, - 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, - 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, - 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, - 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, - 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, - 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, - 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, - 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, - 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, - 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, - 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, - 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, - 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, - 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, - 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, - 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, - 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, - 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, - 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, - 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, - 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, - 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, - 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, - 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, - 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, - 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, - 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, - 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, - 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, - 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, - 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, - 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, - 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, - 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, - 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, - 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, - 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, - 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, - 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, - 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, - 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, - 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, - 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, - 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, - 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, - 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, - 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, - 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, - 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, - 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, - 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, - 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, - 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, - 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, - 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, - 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, - 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, - 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, - 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, - 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, - 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, - 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, - 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, - 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, - 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, - 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, - 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, - 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, - 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, - 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, - 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, - 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, - 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, - 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, - 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, - 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, - 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] - - - [ 1.21172076e-02, 1.33987082e-04, 1.36080893e-04, 1.13463014e-02, 1.26926930e-04, - 1.29740772e-04, 9.68973888e-03, 1.13407995e-04, 1.17089937e-04, 6.90881613e-03, - 9.47721243e-05, 9.83732453e-05, 2.63412953e-03, 7.33099879e-05, 7.45531034e-05, - -3.21521752e-03, 5.08542413e-05, 4.83341232e-05, -7.97977335e-03, 2.22445852e-05, - 2.28629884e-05, -1.06083078e-02, 5.93668383e-06, 5.74605447e-06, -1.04273577e-02, - 3.93573554e-06, 3.61536359e-06, -8.38045235e-03, 1.40836676e-05, 1.40973166e-05, - -4.54031070e-03, 2.89910424e-05, 2.92975625e-05, -1.36089546e-03, 4.53413577e-05, - 4.48852482e-05, 7.57470041e-04, 5.88513284e-05, 5.81954661e-05, 2.15165782e-03, - 6.78512307e-05, 6.85411407e-05, 2.98889580e-03, 7.31959302e-05, 7.57688979e-05, - 3.36916454e-03, 7.60546386e-05, 7.95919396e-05, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, 4.23516474e-19, 5.51152161e-01, - 0.00000000e+00, 8.47032947e-19, 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, - 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] - - - [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] - - True - - - - - [ 1.98668503e+00, -3.23058601e-05, -3.12703295e-05, 1.99943789e+00, -3.40588143e-05, - -3.31219331e-05, 2.02627213e+00, -3.70573047e-05, -3.63419672e-05, 2.06970175e+00, - -4.01976861e-05, -3.98101337e-05, 2.13297153e+00, -4.16934710e-05, -4.15742783e-05, - 2.21892113e+00, -3.91144919e-05, -3.89267314e-05, 2.32767375e+00, -2.94738490e-05, - -2.92158654e-05, 2.45437017e+00, -1.16749027e-05, -1.16385073e-05, 2.58955300e+00, - 1.06446789e-05, 1.06140092e-05, 2.72160968e+00, 3.23416370e-05, 3.23660548e-05, - 2.84056578e+00, 4.97980914e-05, 4.97765764e-05, 2.94036115e+00, 6.18351666e-05, - 6.18140413e-05, 3.01899058e+00, 6.91361117e-05, 6.91870627e-05, 3.07660539e+00, - 7.31656280e-05, 7.32317512e-05, 3.11416743e+00, 7.51989314e-05, 7.51828567e-05, - 3.13265872e+00, 7.60301071e-05, 7.59275671e-05 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/frictionH/080K/clean.sh b/drivers/py/pes/friction/frictionH/080K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/frictionH/080K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/frictionH/080K/get1D.sh b/drivers/py/pes/friction/frictionH/080K/get1D.sh deleted file mode 100755 index 5cd175503..000000000 --- a/drivers/py/pes/friction/frictionH/080K/get1D.sh +++ /dev/null @@ -1,6 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 -xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/frictionH/080K/init.xyz b/drivers/py/pes/friction/frictionH/080K/init.xyz deleted file mode 100644 index 223399063..000000000 --- a/drivers/py/pes/friction/frictionH/080K/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/frictionH/080K/input.xml b/drivers/py/pes/friction/frictionH/080K/input.xml deleted file mode 100644 index fd619e24e..000000000 --- a/drivers/py/pes/friction/frictionH/080K/input.xml +++ /dev/null @@ -1,45 +0,0 @@ - - - [ step, potential{electronvolt}] - extras - extras - - 50 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - ['friction'] - - - - 80 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - - z_friction.dat - true - true - none - 0.1 - - - -
diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_00 b/drivers/py/pes/friction/frictionH/080K/inst.fric_00 deleted file mode 100644 index 637fd6134..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_00 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 - 0.00013194 -0.00003135 -0.00003130 - -0.00003135 0.00013218 -0.00003131 - -0.00003130 -0.00003131 0.00013173 - #*EXTRAS*# Step: 1 Bead: 0 - 0.00013433 -0.00002303 -0.00002278 - -0.00002303 0.00013453 -0.00002291 - -0.00002278 -0.00002291 0.00013451 - #*EXTRAS*# Step: 2 Bead: 0 - 0.00013622 -0.00001252 -0.00001199 - -0.00001252 0.00013629 -0.00001239 - -0.00001199 -0.00001239 0.00013683 - #*EXTRAS*# Step: 3 Bead: 0 - 0.00013549 -0.00001671 -0.00001624 - -0.00001671 0.00013561 -0.00001658 - -0.00001624 -0.00001658 0.00013595 - #*EXTRAS*# Step: 4 Bead: 0 - 0.00013579 -0.00001498 -0.00001447 - -0.00001498 0.00013588 -0.00001484 - -0.00001447 -0.00001484 0.00013631 - #*EXTRAS*# Step: 5 Bead: 0 - 0.00013578 -0.00001505 -0.00001454 - -0.00001505 0.00013587 -0.00001491 - -0.00001454 -0.00001491 0.00013630 - #*EXTRAS*# Step: 6 Bead: 0 - 0.00013580 -0.00001492 -0.00001441 - -0.00001492 0.00013589 -0.00001478 - -0.00001441 -0.00001478 0.00013632 - #*EXTRAS*# Step: 7 Bead: 0 - 0.00013580 -0.00001490 -0.00001440 - -0.00001490 0.00013590 -0.00001477 - -0.00001440 -0.00001477 0.00013633 - #*EXTRAS*# Step: 8 Bead: 0 - 0.00013580 -0.00001489 -0.00001438 - -0.00001489 0.00013590 -0.00001475 - -0.00001438 -0.00001475 0.00013633 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_01 b/drivers/py/pes/friction/frictionH/080K/inst.fric_01 deleted file mode 100644 index 097f5a008..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_01 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 - 0.00013155 -0.00003225 -0.00003218 - -0.00003225 0.00013179 -0.00003222 - -0.00003218 -0.00003222 0.00013130 - #*EXTRAS*# Step: 1 Bead: 1 - 0.00013405 -0.00002436 -0.00002416 - -0.00002436 0.00013426 -0.00002425 - -0.00002416 -0.00002425 0.00013416 - #*EXTRAS*# Step: 2 Bead: 1 - 0.00013592 -0.00001423 -0.00001372 - -0.00001423 0.00013600 -0.00001410 - -0.00001372 -0.00001410 0.00013647 - #*EXTRAS*# Step: 3 Bead: 1 - 0.00013525 -0.00001812 -0.00001769 - -0.00001812 0.00013538 -0.00001799 - -0.00001769 -0.00001799 0.00013565 - #*EXTRAS*# Step: 4 Bead: 1 - 0.00013555 -0.00001640 -0.00001592 - -0.00001640 0.00013566 -0.00001626 - -0.00001592 -0.00001626 0.00013602 - #*EXTRAS*# Step: 5 Bead: 1 - 0.00013554 -0.00001645 -0.00001598 - -0.00001645 0.00013565 -0.00001631 - -0.00001598 -0.00001631 0.00013600 - #*EXTRAS*# Step: 6 Bead: 1 - 0.00013556 -0.00001632 -0.00001584 - -0.00001632 0.00013567 -0.00001618 - -0.00001584 -0.00001618 0.00013603 - #*EXTRAS*# Step: 7 Bead: 1 - 0.00013556 -0.00001630 -0.00001582 - -0.00001630 0.00013567 -0.00001616 - -0.00001582 -0.00001616 0.00013603 - #*EXTRAS*# Step: 8 Bead: 1 - 0.00013556 -0.00001629 -0.00001580 - -0.00001629 0.00013567 -0.00001615 - -0.00001580 -0.00001615 0.00013604 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_02 b/drivers/py/pes/friction/frictionH/080K/inst.fric_02 deleted file mode 100644 index 04c999e47..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_02 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 - 0.00013052 -0.00003427 -0.00003412 - -0.00003427 0.00013073 -0.00003427 - -0.00003412 -0.00003427 0.00013021 - #*EXTRAS*# Step: 1 Bead: 2 - 0.00013334 -0.00002721 -0.00002711 - -0.00002721 0.00013358 -0.00002713 - -0.00002711 -0.00002713 0.00013331 - #*EXTRAS*# Step: 2 Bead: 2 - 0.00013531 -0.00001773 -0.00001729 - -0.00001773 0.00013544 -0.00001759 - -0.00001729 -0.00001759 0.00013573 - #*EXTRAS*# Step: 3 Bead: 2 - 0.00013474 -0.00002097 -0.00002063 - -0.00002097 0.00013491 -0.00002084 - -0.00002063 -0.00002084 0.00013501 - #*EXTRAS*# Step: 4 Bead: 2 - 0.00013504 -0.00001927 -0.00001887 - -0.00001927 0.00013519 -0.00001914 - -0.00001887 -0.00001914 0.00013539 - #*EXTRAS*# Step: 5 Bead: 2 - 0.00013504 -0.00001930 -0.00001891 - -0.00001930 0.00013519 -0.00001917 - -0.00001891 -0.00001917 0.00013539 - #*EXTRAS*# Step: 6 Bead: 2 - 0.00013506 -0.00001916 -0.00001876 - -0.00001916 0.00013521 -0.00001903 - -0.00001876 -0.00001903 0.00013542 - #*EXTRAS*# Step: 7 Bead: 2 - 0.00013507 -0.00001914 -0.00001874 - -0.00001914 0.00013521 -0.00001900 - -0.00001874 -0.00001900 0.00013542 - #*EXTRAS*# Step: 8 Bead: 2 - 0.00013507 -0.00001912 -0.00001872 - -0.00001912 0.00013522 -0.00001898 - -0.00001872 -0.00001898 0.00013543 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_03 b/drivers/py/pes/friction/frictionH/080K/inst.fric_03 deleted file mode 100644 index 0fb9794c2..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_03 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 - 0.00012868 -0.00003715 -0.00003680 - -0.00003715 0.00012883 -0.00003720 - -0.00003680 -0.00003720 0.00012833 - #*EXTRAS*# Step: 1 Bead: 3 - 0.00013192 -0.00003140 -0.00003135 - -0.00003140 0.00013216 -0.00003136 - -0.00003135 -0.00003136 0.00013170 - #*EXTRAS*# Step: 2 Bead: 3 - 0.00013434 -0.00002299 -0.00002274 - -0.00002299 0.00013454 -0.00002288 - -0.00002274 -0.00002288 0.00013452 - #*EXTRAS*# Step: 3 Bead: 3 - 0.00013385 -0.00002523 -0.00002507 - -0.00002523 0.00013407 -0.00002513 - -0.00002507 -0.00002513 0.00013391 - #*EXTRAS*# Step: 4 Bead: 3 - 0.00013421 -0.00002361 -0.00002338 - -0.00002361 0.00013441 -0.00002350 - -0.00002338 -0.00002350 0.00013436 - #*EXTRAS*# Step: 5 Bead: 3 - 0.00013421 -0.00002361 -0.00002338 - -0.00002361 0.00013441 -0.00002350 - -0.00002338 -0.00002350 0.00013436 - #*EXTRAS*# Step: 6 Bead: 3 - 0.00013424 -0.00002346 -0.00002322 - -0.00002346 0.00013444 -0.00002334 - -0.00002322 -0.00002334 0.00013440 - #*EXTRAS*# Step: 7 Bead: 3 - 0.00013425 -0.00002343 -0.00002319 - -0.00002343 0.00013445 -0.00002331 - -0.00002319 -0.00002331 0.00013440 - #*EXTRAS*# Step: 8 Bead: 3 - 0.00013425 -0.00002340 -0.00002316 - -0.00002340 0.00013446 -0.00002329 - -0.00002316 -0.00002329 0.00013441 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_04 b/drivers/py/pes/friction/frictionH/080K/inst.fric_04 deleted file mode 100644 index 0adcaaaa0..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_04 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 - 0.00012608 -0.00004029 -0.00003974 - -0.00004029 0.00012615 -0.00004038 - -0.00003974 -0.00004038 0.00012575 - #*EXTRAS*# Step: 1 Bead: 4 - 0.00012916 -0.00003646 -0.00003616 - -0.00003646 0.00012933 -0.00003650 - -0.00003616 -0.00003650 0.00012882 - #*EXTRAS*# Step: 2 Bead: 4 - 0.00013255 -0.00002975 -0.00002970 - -0.00002975 0.00013280 -0.00002969 - -0.00002970 -0.00002969 0.00013240 - #*EXTRAS*# Step: 3 Bead: 4 - 0.00013218 -0.00003075 -0.00003070 - -0.00003075 0.00013243 -0.00003070 - -0.00003070 -0.00003070 0.00013199 - #*EXTRAS*# Step: 4 Bead: 4 - 0.00013271 -0.00002928 -0.00002923 - -0.00002928 0.00013296 -0.00002922 - -0.00002923 -0.00002922 0.00013258 - #*EXTRAS*# Step: 5 Bead: 4 - 0.00013273 -0.00002923 -0.00002918 - -0.00002923 0.00013298 -0.00002917 - -0.00002918 -0.00002917 0.00013260 - #*EXTRAS*# Step: 6 Bead: 4 - 0.00013278 -0.00002907 -0.00002902 - -0.00002907 0.00013303 -0.00002901 - -0.00002902 -0.00002901 0.00013266 - #*EXTRAS*# Step: 7 Bead: 4 - 0.00013279 -0.00002903 -0.00002898 - -0.00002903 0.00013304 -0.00002897 - -0.00002898 -0.00002897 0.00013268 - #*EXTRAS*# Step: 8 Bead: 4 - 0.00013280 -0.00002901 -0.00002895 - -0.00002901 0.00013305 -0.00002894 - -0.00002895 -0.00002894 0.00013269 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_05 b/drivers/py/pes/friction/frictionH/080K/inst.fric_05 deleted file mode 100644 index 43b9cff95..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_05 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 - 0.00012329 -0.00004270 -0.00004239 - -0.00004270 0.00012336 -0.00004279 - -0.00004239 -0.00004279 0.00012310 - #*EXTRAS*# Step: 1 Bead: 5 - 0.00012524 -0.00004112 -0.00004057 - -0.00004112 0.00012530 -0.00004122 - -0.00004057 -0.00004122 0.00012494 - #*EXTRAS*# Step: 2 Bead: 5 - 0.00012869 -0.00003713 -0.00003678 - -0.00003713 0.00012884 -0.00003717 - -0.00003678 -0.00003717 0.00012834 - #*EXTRAS*# Step: 3 Bead: 5 - 0.00012881 -0.00003696 -0.00003663 - -0.00003696 0.00012896 -0.00003701 - -0.00003663 -0.00003701 0.00012846 - #*EXTRAS*# Step: 4 Bead: 5 - 0.00012960 -0.00003580 -0.00003555 - -0.00003580 0.00012978 -0.00003582 - -0.00003555 -0.00003582 0.00012926 - #*EXTRAS*# Step: 5 Bead: 5 - 0.00012966 -0.00003569 -0.00003545 - -0.00003569 0.00012985 -0.00003572 - -0.00003545 -0.00003572 0.00012933 - #*EXTRAS*# Step: 6 Bead: 5 - 0.00012976 -0.00003554 -0.00003531 - -0.00003554 0.00012995 -0.00003557 - -0.00003531 -0.00003557 0.00012943 - #*EXTRAS*# Step: 7 Bead: 5 - 0.00012979 -0.00003550 -0.00003527 - -0.00003550 0.00012997 -0.00003552 - -0.00003527 -0.00003552 0.00012946 - #*EXTRAS*# Step: 8 Bead: 5 - 0.00012980 -0.00003548 -0.00003525 - -0.00003548 0.00012999 -0.00003550 - -0.00003525 -0.00003550 0.00012947 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_06 b/drivers/py/pes/friction/frictionH/080K/inst.fric_06 deleted file mode 100644 index d3b2f7b0c..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_06 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 - 0.00012029 -0.00004409 -0.00004407 - -0.00004409 0.00012020 -0.00004396 - -0.00004407 -0.00004396 0.00012025 - #*EXTRAS*# Step: 1 Bead: 6 - 0.00012145 -0.00004366 -0.00004363 - -0.00004366 0.00012147 -0.00004365 - -0.00004363 -0.00004365 0.00012137 - #*EXTRAS*# Step: 2 Bead: 6 - 0.00012354 -0.00004252 -0.00004217 - -0.00004252 0.00012361 -0.00004262 - -0.00004217 -0.00004262 0.00012333 - #*EXTRAS*# Step: 3 Bead: 6 - 0.00012421 -0.00004202 -0.00004157 - -0.00004202 0.00012427 -0.00004213 - -0.00004157 -0.00004213 0.00012396 - #*EXTRAS*# Step: 4 Bead: 6 - 0.00012487 -0.00004147 -0.00004094 - -0.00004147 0.00012493 -0.00004157 - -0.00004094 -0.00004157 0.00012458 - #*EXTRAS*# Step: 5 Bead: 6 - 0.00012498 -0.00004137 -0.00004083 - -0.00004137 0.00012504 -0.00004147 - -0.00004083 -0.00004147 0.00012469 - #*EXTRAS*# Step: 6 Bead: 6 - 0.00012507 -0.00004128 -0.00004074 - -0.00004128 0.00012514 -0.00004138 - -0.00004074 -0.00004138 0.00012478 - #*EXTRAS*# Step: 7 Bead: 6 - 0.00012511 -0.00004125 -0.00004071 - -0.00004125 0.00012517 -0.00004135 - -0.00004071 -0.00004135 0.00012481 - #*EXTRAS*# Step: 8 Bead: 6 - 0.00012512 -0.00004123 -0.00004069 - -0.00004123 0.00012518 -0.00004133 - -0.00004069 -0.00004133 0.00012483 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_07 b/drivers/py/pes/friction/frictionH/080K/inst.fric_07 deleted file mode 100644 index 72dea0f1a..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_07 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 - 0.00011665 -0.00004461 -0.00004432 - -0.00004461 0.00011623 -0.00004421 - -0.00004432 -0.00004421 0.00011666 - #*EXTRAS*# Step: 1 Bead: 7 - 0.00011691 -0.00004462 -0.00004434 - -0.00004462 0.00011649 -0.00004422 - -0.00004434 -0.00004422 0.00011692 - #*EXTRAS*# Step: 2 Bead: 7 - 0.00011833 -0.00004455 -0.00004437 - -0.00004455 0.00011801 -0.00004422 - -0.00004437 -0.00004422 0.00011833 - #*EXTRAS*# Step: 3 Bead: 7 - 0.00011968 -0.00004427 -0.00004421 - -0.00004427 0.00011951 -0.00004407 - -0.00004421 -0.00004407 0.00011965 - #*EXTRAS*# Step: 4 Bead: 7 - 0.00012029 -0.00004409 -0.00004407 - -0.00004409 0.00012020 -0.00004396 - -0.00004407 -0.00004396 0.00012025 - #*EXTRAS*# Step: 5 Bead: 7 - 0.00012045 -0.00004404 -0.00004402 - -0.00004404 0.00012038 -0.00004393 - -0.00004402 -0.00004393 0.00012041 - #*EXTRAS*# Step: 6 Bead: 7 - 0.00012055 -0.00004400 -0.00004399 - -0.00004400 0.00012049 -0.00004390 - -0.00004399 -0.00004390 0.00012050 - #*EXTRAS*# Step: 7 Bead: 7 - 0.00012059 -0.00004399 -0.00004398 - -0.00004399 0.00012053 -0.00004389 - -0.00004398 -0.00004389 0.00012054 - #*EXTRAS*# Step: 8 Bead: 7 - 0.00012060 -0.00004398 -0.00004398 - -0.00004398 0.00012055 -0.00004389 - -0.00004398 -0.00004389 0.00012056 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_08 b/drivers/py/pes/friction/frictionH/080K/inst.fric_08 deleted file mode 100644 index 8911c1063..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_08 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 - 0.00011322 -0.00004352 -0.00004346 - -0.00004352 0.00011306 -0.00004343 - -0.00004346 -0.00004343 0.00011326 - #*EXTRAS*# Step: 1 Bead: 8 - 0.00011255 -0.00004316 -0.00004317 - -0.00004316 0.00011247 -0.00004314 - -0.00004317 -0.00004314 0.00011260 - #*EXTRAS*# Step: 2 Bead: 8 - 0.00011281 -0.00004330 -0.00004328 - -0.00004330 0.00011270 -0.00004326 - -0.00004328 -0.00004326 0.00011286 - #*EXTRAS*# Step: 3 Bead: 8 - 0.00011444 -0.00004407 -0.00004389 - -0.00004407 0.00011415 -0.00004384 - -0.00004389 -0.00004384 0.00011447 - #*EXTRAS*# Step: 4 Bead: 8 - 0.00011491 -0.00004424 -0.00004402 - -0.00004424 0.00011457 -0.00004395 - -0.00004402 -0.00004395 0.00011494 - #*EXTRAS*# Step: 5 Bead: 8 - 0.00011511 -0.00004430 -0.00004406 - -0.00004430 0.00011475 -0.00004399 - -0.00004406 -0.00004399 0.00011513 - #*EXTRAS*# Step: 6 Bead: 8 - 0.00011520 -0.00004433 -0.00004409 - -0.00004433 0.00011484 -0.00004401 - -0.00004409 -0.00004401 0.00011523 - #*EXTRAS*# Step: 7 Bead: 8 - 0.00011524 -0.00004434 -0.00004409 - -0.00004434 0.00011487 -0.00004402 - -0.00004409 -0.00004402 0.00011527 - #*EXTRAS*# Step: 8 Bead: 8 - 0.00011526 -0.00004434 -0.00004410 - -0.00004434 0.00011489 -0.00004403 - -0.00004410 -0.00004403 0.00011529 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_09 b/drivers/py/pes/friction/frictionH/080K/inst.fric_09 deleted file mode 100644 index a9a573430..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_09 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 - 0.00011023 -0.00004172 -0.00004180 - -0.00004172 0.00011025 -0.00004177 - -0.00004180 -0.00004177 0.00011031 - #*EXTRAS*# Step: 1 Bead: 9 - 0.00010885 -0.00004070 -0.00004074 - -0.00004070 0.00010887 -0.00004071 - -0.00004074 -0.00004071 0.00010891 - #*EXTRAS*# Step: 2 Bead: 9 - 0.00010821 -0.00004017 -0.00004019 - -0.00004017 0.00010821 -0.00004018 - -0.00004019 -0.00004018 0.00010824 - #*EXTRAS*# Step: 3 Bead: 9 - 0.00010994 -0.00004152 -0.00004159 - -0.00004152 0.00010996 -0.00004156 - -0.00004159 -0.00004156 0.00011002 - #*EXTRAS*# Step: 4 Bead: 9 - 0.00011023 -0.00004172 -0.00004180 - -0.00004172 0.00011026 -0.00004177 - -0.00004180 -0.00004177 0.00011031 - #*EXTRAS*# Step: 5 Bead: 9 - 0.00011043 -0.00004186 -0.00004194 - -0.00004186 0.00011046 -0.00004191 - -0.00004194 -0.00004191 0.00011051 - #*EXTRAS*# Step: 6 Bead: 9 - 0.00011051 -0.00004191 -0.00004199 - -0.00004191 0.00011053 -0.00004196 - -0.00004199 -0.00004196 0.00011059 - #*EXTRAS*# Step: 7 Bead: 9 - 0.00011054 -0.00004193 -0.00004201 - -0.00004193 0.00011057 -0.00004199 - -0.00004201 -0.00004199 0.00011062 - #*EXTRAS*# Step: 8 Bead: 9 - 0.00011056 -0.00004194 -0.00004202 - -0.00004194 0.00011058 -0.00004200 - -0.00004202 -0.00004200 0.00011064 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_10 b/drivers/py/pes/friction/frictionH/080K/inst.fric_10 deleted file mode 100644 index 2467ff17a..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_10 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 - 0.00010769 -0.00003973 -0.00003972 - -0.00003973 0.00010769 -0.00003973 - -0.00003972 -0.00003973 0.00010770 - #*EXTRAS*# Step: 1 Bead: 10 - 0.00010577 -0.00003785 -0.00003780 - -0.00003785 0.00010577 -0.00003793 - -0.00003780 -0.00003793 0.00010561 - #*EXTRAS*# Step: 2 Bead: 10 - 0.00010449 -0.00003638 -0.00003631 - -0.00003638 0.00010449 -0.00003652 - -0.00003631 -0.00003652 0.00010419 - #*EXTRAS*# Step: 3 Bead: 10 - 0.00010621 -0.00003832 -0.00003827 - -0.00003832 0.00010621 -0.00003837 - -0.00003827 -0.00003837 0.00010610 - #*EXTRAS*# Step: 4 Bead: 10 - 0.00010636 -0.00003846 -0.00003842 - -0.00003846 0.00010635 -0.00003851 - -0.00003842 -0.00003851 0.00010626 - #*EXTRAS*# Step: 5 Bead: 10 - 0.00010656 -0.00003867 -0.00003863 - -0.00003867 0.00010656 -0.00003870 - -0.00003863 -0.00003870 0.00010648 - #*EXTRAS*# Step: 6 Bead: 10 - 0.00010662 -0.00003873 -0.00003869 - -0.00003873 0.00010662 -0.00003876 - -0.00003869 -0.00003876 0.00010654 - #*EXTRAS*# Step: 7 Bead: 10 - 0.00010665 -0.00003876 -0.00003872 - -0.00003876 0.00010665 -0.00003879 - -0.00003872 -0.00003879 0.00010658 - #*EXTRAS*# Step: 8 Bead: 10 - 0.00010667 -0.00003877 -0.00003873 - -0.00003877 0.00010666 -0.00003880 - -0.00003873 -0.00003880 0.00010659 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_11 b/drivers/py/pes/friction/frictionH/080K/inst.fric_11 deleted file mode 100644 index dbe3db5f8..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_11 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 - 0.00010562 -0.00003769 -0.00003763 - -0.00003769 0.00010562 -0.00003777 - -0.00003763 -0.00003777 0.00010544 - #*EXTRAS*# Step: 1 Bead: 11 - 0.00010349 -0.00003504 -0.00003498 - -0.00003504 0.00010347 -0.00003522 - -0.00003498 -0.00003522 0.00010310 - #*EXTRAS*# Step: 2 Bead: 11 - 0.00010203 -0.00003265 -0.00003265 - -0.00003265 0.00010195 -0.00003282 - -0.00003265 -0.00003282 0.00010162 - #*EXTRAS*# Step: 3 Bead: 11 - 0.00010344 -0.00003496 -0.00003490 - -0.00003496 0.00010342 -0.00003515 - -0.00003490 -0.00003515 0.00010305 - #*EXTRAS*# Step: 4 Bead: 11 - 0.00010346 -0.00003499 -0.00003494 - -0.00003499 0.00010345 -0.00003518 - -0.00003494 -0.00003518 0.00010307 - #*EXTRAS*# Step: 5 Bead: 11 - 0.00010363 -0.00003524 -0.00003518 - -0.00003524 0.00010362 -0.00003542 - -0.00003518 -0.00003542 0.00010326 - #*EXTRAS*# Step: 6 Bead: 11 - 0.00010367 -0.00003529 -0.00003523 - -0.00003529 0.00010366 -0.00003548 - -0.00003523 -0.00003548 0.00010330 - #*EXTRAS*# Step: 7 Bead: 11 - 0.00010370 -0.00003533 -0.00003527 - -0.00003533 0.00010369 -0.00003551 - -0.00003527 -0.00003551 0.00010333 - #*EXTRAS*# Step: 8 Bead: 11 - 0.00010371 -0.00003534 -0.00003528 - -0.00003534 0.00010370 -0.00003552 - -0.00003528 -0.00003552 0.00010334 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_12 b/drivers/py/pes/friction/frictionH/080K/inst.fric_12 deleted file mode 100644 index 2f6598a56..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_12 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 - 0.00010410 -0.00003588 -0.00003581 - -0.00003588 0.00010410 -0.00003604 - -0.00003581 -0.00003604 0.00010377 - #*EXTRAS*# Step: 1 Bead: 12 - 0.00010201 -0.00003262 -0.00003262 - -0.00003262 0.00010193 -0.00003278 - -0.00003262 -0.00003278 0.00010160 - #*EXTRAS*# Step: 2 Bead: 12 - 0.00010043 -0.00002954 -0.00002957 - -0.00002954 0.00010030 -0.00002953 - -0.00002957 -0.00002953 0.00010026 - #*EXTRAS*# Step: 3 Bead: 12 - 0.00010169 -0.00003203 -0.00003204 - -0.00003203 0.00010159 -0.00003216 - -0.00003204 -0.00003216 0.00010130 - #*EXTRAS*# Step: 4 Bead: 12 - 0.00010164 -0.00003194 -0.00003195 - -0.00003194 0.00010154 -0.00003207 - -0.00003195 -0.00003207 0.00010126 - #*EXTRAS*# Step: 5 Bead: 12 - 0.00010178 -0.00003220 -0.00003221 - -0.00003220 0.00010169 -0.00003235 - -0.00003221 -0.00003235 0.00010139 - #*EXTRAS*# Step: 6 Bead: 12 - 0.00010181 -0.00003225 -0.00003225 - -0.00003225 0.00010172 -0.00003239 - -0.00003225 -0.00003239 0.00010141 - #*EXTRAS*# Step: 7 Bead: 12 - 0.00010183 -0.00003228 -0.00003229 - -0.00003228 0.00010174 -0.00003243 - -0.00003229 -0.00003243 0.00010143 - #*EXTRAS*# Step: 8 Bead: 12 - 0.00010183 -0.00003229 -0.00003230 - -0.00003229 0.00010174 -0.00003244 - -0.00003230 -0.00003244 0.00010143 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_13 b/drivers/py/pes/friction/frictionH/080K/inst.fric_13 deleted file mode 100644 index 5d0e45ed8..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_13 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 - 0.00010310 -0.00003446 -0.00003442 - -0.00003446 0.00010308 -0.00003466 - -0.00003442 -0.00003466 0.00010270 - #*EXTRAS*# Step: 1 Bead: 13 - 0.00010106 -0.00003079 -0.00003082 - -0.00003079 0.00010093 -0.00003087 - -0.00003082 -0.00003087 0.00010075 - #*EXTRAS*# Step: 2 Bead: 13 - 0.00009923 -0.00002720 -0.00002715 - -0.00002720 0.00009921 -0.00002704 - -0.00002715 -0.00002704 0.00009946 - #*EXTRAS*# Step: 3 Bead: 13 - 0.00010054 -0.00002977 -0.00002980 - -0.00002977 0.00010042 -0.00002978 - -0.00002980 -0.00002978 0.00010034 - #*EXTRAS*# Step: 4 Bead: 13 - 0.00010045 -0.00002958 -0.00002961 - -0.00002958 0.00010033 -0.00002958 - -0.00002961 -0.00002958 0.00010027 - #*EXTRAS*# Step: 5 Bead: 13 - 0.00010058 -0.00002985 -0.00002989 - -0.00002985 0.00010046 -0.00002987 - -0.00002989 -0.00002987 0.00010037 - #*EXTRAS*# Step: 6 Bead: 13 - 0.00010060 -0.00002989 -0.00002992 - -0.00002989 0.00010048 -0.00002991 - -0.00002992 -0.00002991 0.00010039 - #*EXTRAS*# Step: 7 Bead: 13 - 0.00010062 -0.00002992 -0.00002996 - -0.00002992 0.00010049 -0.00002995 - -0.00002996 -0.00002995 0.00010040 - #*EXTRAS*# Step: 8 Bead: 13 - 0.00010063 -0.00002993 -0.00002997 - -0.00002993 0.00010050 -0.00002996 - -0.00002997 -0.00002996 0.00010041 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_14 b/drivers/py/pes/friction/frictionH/080K/inst.fric_14 deleted file mode 100644 index e7c39bd7e..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_14 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 - 0.00010253 -0.00003354 -0.00003351 - -0.00003354 0.00010248 -0.00003373 - -0.00003351 -0.00003373 0.00010211 - #*EXTRAS*# Step: 1 Bead: 14 - 0.00010046 -0.00002960 -0.00002963 - -0.00002960 0.00010033 -0.00002960 - -0.00002963 -0.00002960 0.00010028 - #*EXTRAS*# Step: 2 Bead: 14 - 0.00009847 -0.00002565 -0.00002549 - -0.00002565 0.00009857 -0.00002539 - -0.00002549 -0.00002539 0.00009901 - #*EXTRAS*# Step: 3 Bead: 14 - 0.00009978 -0.00002826 -0.00002826 - -0.00002826 0.00009969 -0.00002818 - -0.00002826 -0.00002818 0.00009981 - #*EXTRAS*# Step: 4 Bead: 14 - 0.00009965 -0.00002801 -0.00002800 - -0.00002801 0.00009958 -0.00002791 - -0.00002800 -0.00002791 0.00009972 - #*EXTRAS*# Step: 5 Bead: 14 - 0.00009979 -0.00002829 -0.00002828 - -0.00002829 0.00009970 -0.00002820 - -0.00002828 -0.00002820 0.00009981 - #*EXTRAS*# Step: 6 Bead: 14 - 0.00009981 -0.00002831 -0.00002831 - -0.00002831 0.00009972 -0.00002823 - -0.00002831 -0.00002823 0.00009982 - #*EXTRAS*# Step: 7 Bead: 14 - 0.00009982 -0.00002835 -0.00002835 - -0.00002835 0.00009973 -0.00002827 - -0.00002835 -0.00002827 0.00009984 - #*EXTRAS*# Step: 8 Bead: 14 - 0.00009983 -0.00002836 -0.00002836 - -0.00002836 0.00009974 -0.00002828 - -0.00002836 -0.00002828 0.00009984 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.fric_15 b/drivers/py/pes/friction/frictionH/080K/inst.fric_15 deleted file mode 100644 index f9ea2019f..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.fric_15 +++ /dev/null @@ -1,36 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 - 0.00010230 -0.00003314 -0.00003313 - -0.00003314 0.00010224 -0.00003332 - -0.00003313 -0.00003332 0.00010188 - #*EXTRAS*# Step: 1 Bead: 15 - 0.00010018 -0.00002905 -0.00002907 - -0.00002905 0.00010007 -0.00002902 - -0.00002907 -0.00002902 0.00010008 - #*EXTRAS*# Step: 2 Bead: 15 - 0.00009813 -0.00002486 -0.00002466 - -0.00002486 0.00009829 -0.00002457 - -0.00002466 -0.00002457 0.00009881 - #*EXTRAS*# Step: 3 Bead: 15 - 0.00009939 -0.00002752 -0.00002748 - -0.00002752 0.00009935 -0.00002738 - -0.00002748 -0.00002738 0.00009956 - #*EXTRAS*# Step: 4 Bead: 15 - 0.00009925 -0.00002723 -0.00002718 - -0.00002723 0.00009922 -0.00002708 - -0.00002718 -0.00002708 0.00009947 - #*EXTRAS*# Step: 5 Bead: 15 - 0.00009939 -0.00002751 -0.00002747 - -0.00002751 0.00009934 -0.00002737 - -0.00002747 -0.00002737 0.00009956 - #*EXTRAS*# Step: 6 Bead: 15 - 0.00009940 -0.00002753 -0.00002750 - -0.00002753 0.00009936 -0.00002739 - -0.00002750 -0.00002739 0.00009956 - #*EXTRAS*# Step: 7 Bead: 15 - 0.00009942 -0.00002757 -0.00002753 - -0.00002757 0.00009937 -0.00002743 - -0.00002753 -0.00002743 0.00009958 - #*EXTRAS*# Step: 8 Bead: 15 - 0.00009942 -0.00002757 -0.00002754 - -0.00002757 0.00009937 -0.00002744 - -0.00002754 -0.00002744 0.00009958 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 deleted file mode 100644 index 702bbbd68..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -3.848816013467453844e-03 8.168849192070688130e-05 8.117592854329587677e-05 2.962103052563885321e-03 7.737806929705504978e-05 7.595675177554375636e-05 8.975563515802296478e-04 6.848565001727331637e-05 6.561133136189707432e-05 -2.279414089407330070e-03 5.449456957949019137e-05 5.142695233042486537e-05 -5.819192557942849849e-03 3.517614308405234093e-05 3.458346556665543576e-05 -8.619900403653483686e-03 1.512031549807616858e-05 1.737695997800449278e-05 -1.050642290345041308e-02 7.000723082972680365e-06 6.483629802385290260e-06 -1.077156939376164649e-02 2.403438865849462230e-06 2.367109196458023822e-06 -9.590799175848638281e-03 5.722235238920154082e-06 5.179207098056606810e-06 -7.529661465569640992e-03 1.250728202561327896e-05 1.262622107606156164e-05 -4.570709393129483017e-03 2.102853683006754019e-05 2.145574844841502055e-05 -2.199434432594933077e-03 2.989454560225144667e-05 2.996517364354508100e-05 -5.537097967210666098e-04 3.760926945321859982e-05 3.731691345500043485e-05 5.452320173647189159e-04 4.349293265564602813e-05 4.288886364187012985e-05 1.207055123009427361e-03 4.724537850899594851e-05 4.653315033514263973e-05 1.489936701812690943e-03 4.898796923558525440e-05 4.827437869671750428e-05 4.756585481032841307e-13 5.511521605213636210e-01 -5.676965204487502605e-10 4.896548224208646806e-13 5.511521605134122037e-01 -5.763532532219209933e-10 4.881943095111531276e-13 5.511521605264637635e-01 -5.636988022399026912e-10 4.162489825411322898e-13 5.511521606215992186e-01 -4.670684602112703929e-10 2.748815967240572581e-13 5.511521607900793374e-01 -2.970966278006180707e-10 1.322238212863753943e-13 5.511521609500706909e-01 -1.381621920360443077e-10 4.228008071949504894e-14 5.511521610459323428e-01 -4.335852348985841361e-11 -5.628166873325347571e-15 5.511521610947808236e-01 5.370058672060792098e-12 3.086039872903703092e-14 5.511521610561048723e-01 -3.328257264253010421e-11 1.218258078601125395e-13 5.511521609584872916e-01 -1.309164509509935022e-10 2.197823580693126418e-13 5.511521608518080706e-01 -2.372725164466611198e-10 2.345608691806549038e-13 5.511521608343793455e-01 -2.546135821108957362e-10 2.346714708399622283e-13 5.511521608327488719e-01 -2.563549098278644410e-10 2.332240545357269058e-13 5.511521608327861754e-01 -2.565116327920593380e-10 2.309275105286272925e-13 5.511521608336157341e-01 -2.558209768911843809e-10 2.277690898883131463e-13 5.511521608349958523e-01 -2.544938715600596783e-10 4.753823797942655208e-13 -5.676965204487502605e-10 5.511521605220229825e-01 4.899740903349011554e-13 -5.763532532219209933e-10 5.511521605126608048e-01 4.888643683112122866e-13 -5.636988022399026912e-10 5.511521605249173339e-01 4.156063245953167610e-13 -4.670684602112703929e-10 5.511521606230426196e-01 2.728483934342467479e-13 -2.970966278006180707e-10 5.511521607944908085e-01 1.311257108518350478e-13 -1.381621920360443077e-10 5.511521609523751808e-01 4.218373058284853604e-14 -4.335852348985841361e-11 5.511521610461301846e-01 -5.606326919321834710e-15 5.370058672060792098e-12 5.511521610947391903e-01 3.085806226771893369e-14 -3.328257264253010421e-11 5.511521610561098683e-01 1.218387915056642939e-13 -1.309164509509935022e-10 5.511521609584596471e-01 2.194961976319706031e-13 -2.372725164466611198e-10 5.511521608524263538e-01 2.341957540808614450e-13 -2.546135821108957362e-10 5.511521608351727108e-01 2.344098775140466797e-13 -2.563549098278644410e-10 5.511521608333207478e-01 2.331403207051633409e-13 -2.565116327920593380e-10 5.511521608329703614e-01 2.309697927147226834e-13 -2.558209768911843809e-10 5.511521608335221423e-01 2.278584650633292919e-13 -2.544938715600596783e-10 5.511521608347962342e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 deleted file mode 100644 index b9f66511c..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -1.022250950873395889e-02 8.168849171540636946e-05 8.117592833633839231e-05 9.314407321804780981e-03 7.737806913220926519e-05 7.595675160898745311e-05 7.278376835342327891e-03 6.848564994995253363e-05 6.561133129398484575e-05 3.839627858465096723e-03 5.449456966952433200e-05 5.142695242202354361e-05 -1.235483919753982938e-03 3.517614328163232363e-05 3.458346576414425739e-05 -6.460585866343576331e-03 1.512031563377981681e-05 1.737696011194258383e-05 -9.720477741770972707e-03 7.000723126361082503e-06 6.483629845682273826e-06 -1.089281043220580690e-02 2.403438865595860142e-06 2.367109196198344273e-06 -9.506461776959478430e-03 5.722235108785362929e-06 5.179206968071776910e-06 -6.572535358646245524e-03 1.250728341084602608e-05 1.262622246032084599e-05 -2.837894456659251739e-03 2.102853777149363580e-05 2.145574938850087286e-05 -2.484929710929685218e-04 2.989454631292735295e-05 2.996517435392006358e-05 1.515222886837315486e-03 3.760927004338793169e-05 3.731691404599285234e-05 2.675238157588899317e-03 4.349293317036180057e-05 4.288886415777347637e-05 3.345622494813633996e-03 4.724537896897752933e-05 4.653315079606289568e-05 3.633865862444505580e-03 4.898796965941733250e-05 4.827437912121075597e-05 2.703580413307583857e-13 5.511521603186859686e-01 -7.651463142724816371e-10 3.248090363729109867e-13 5.511521602630644612e-01 -8.227628429228076383e-10 4.208735329804183436e-13 5.511521601824186378e-01 -9.071396388601220390e-10 5.062831226641827345e-13 5.511521601654791880e-01 -9.255875701053610310e-10 4.724615823866634858e-13 5.511521603360959309e-01 -7.499046070455007176e-10 2.679274700679838702e-13 5.511521606950948726e-01 -3.900800269419927783e-10 8.566848284963499992e-14 5.511521609597531679e-01 -1.293526217250779925e-10 -5.881769073666515335e-15 5.511521611017147215e-01 1.229174133093861704e-11 -9.927439258136484675e-14 5.511521610166586482e-01 -7.262290928369203041e-11 1.507058555768717822e-12 5.511521602268968367e-01 -8.619433763561921486e-10 1.161208453036284952e-12 5.511521601655102742e-01 -9.225854992733558791e-10 9.452367766457263920e-13 5.511521602357430938e-01 -8.530451911171518194e-10 8.248408005983791478e-13 5.511521602871567449e-01 -8.027784534129508419e-10 7.479398267253954023e-13 5.511521603249700529e-01 -7.655473142625396778e-10 6.909090921392663053e-13 5.511521603580815665e-01 -7.323463412986064471e-10 6.516011675045972317e-13 5.511521603817637338e-01 -7.084411357047056412e-10 2.684248910602787833e-13 -7.651463142724816371e-10 5.511521603296661853e-01 3.234177870682267496e-13 -8.227628429228076383e-10 5.511521602701273670e-01 4.209521359718583480e-13 -9.071396388601220390e-10 5.511521601820796867e-01 5.072050015764997785e-13 -9.255875701053610310e-10 5.511521601621117705e-01 4.703372162888127459e-13 -7.499046070455007176e-10 5.511521603428551908e-01 2.650638020208627260e-13 -3.900800269419927783e-10 5.511521607034786108e-01 8.548071456600408005e-14 -1.293526217250779925e-10 5.511521609603208249e-01 -5.866006640857568178e-15 1.229174133093861704e-11 5.511521611016487743e-01 -9.912676757080312601e-14 -7.262290928369203041e-11 5.511521610168750307e-01 1.506098075541328232e-12 -8.619433763561921486e-10 5.511521602279958465e-01 1.159582051071548834e-12 -9.225854992733558791e-10 5.511521601680967608e-01 9.445707365418246590e-13 -8.530451911171518194e-10 5.511521602369456874e-01 8.254022949076064589e-13 -8.027784534129508419e-10 5.511521602860645075e-01 7.490436647789404468e-13 -7.655473142625396778e-10 5.511521603227121924e-01 6.918900465207069115e-13 -7.323463412986064471e-10 5.511521603560035620e-01 6.523517159948754699e-13 -7.084411357047056412e-10 5.511521603801327052e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 deleted file mode 100644 index 86a53757c..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.213474489650410125e-02 8.168849700374486216e-05 8.117593367649364444e-05 1.128424870710178010e-02 7.737807465904134963e-05 7.595675721331588293e-05 9.440621591194747406e-03 6.848565654012305447e-05 6.561133801227827492e-05 6.320083573381450603e-03 5.449457970774858502e-05 5.142696261665835280e-05 1.494213710163675574e-03 3.517617640907361805e-05 3.458349859360403659e-05 -4.628095741883485673e-03 1.511977055843484447e-05 1.737642638271837242e-05 -8.872511444336286107e-03 7.000722920284769805e-06 6.483629639143110138e-06 -1.090919162834840667e-02 2.403438871147049381e-06 2.367109201734640978e-06 -9.871846414026550984e-03 5.722235221697636454e-06 5.179207080818901880e-06 -7.093829044566472321e-03 1.250728214748009681e-05 1.262622119777729592e-05 -3.068959554078140150e-03 2.102853695074402942e-05 2.145574856892599954e-05 -2.219397023078864789e-04 2.989454576690063492e-05 2.996517380827204720e-05 1.697511820478513544e-03 3.760926967861484636e-05 3.731691368095627878e-05 2.951930272532381390e-03 4.349293293855055340e-05 4.288886392584222835e-05 3.667268201574347929e-03 4.724537883408970766e-05 4.653315066164967674e-05 3.976081782074991806e-03 4.898796958399663119e-05 4.827437904671262261e-05 5.558696534331097481e-12 5.511521583695530024e-01 -2.744057024231243171e-09 5.851641115052203308e-12 5.511521582455521928e-01 -2.880626678497070631e-09 7.011044048241369889e-12 5.511521578126543641e-01 -3.336447183175965589e-09 1.054450737744966950e-11 5.511521567015560397e-01 -4.453198177427882760e-09 3.359990287600885206e-11 5.511521516080973848e-01 -9.396597659134412891e-09 -5.448074175018051431e-10 5.511521088167019577e-01 -5.118431443330913843e-08 -1.204078300376211055e-13 5.511521608867114841e-01 -2.037629958781918905e-10 -3.305796914762238071e-16 5.511521611017179412e-01 1.229468806433471576e-11 1.363788106388006488e-14 5.511521610202351207e-01 -6.906580174727430600e-11 2.436926262134731966e-13 5.511521602376366902e-01 -8.512698745463684233e-10 3.404588471785187252e-13 5.511521601735831499e-01 -9.145919014279664702e-10 3.992100602842416411e-13 5.511521602342810411e-01 -8.544932818821358959e-10 4.600677186171777081e-13 5.511521602726872082e-01 -8.172308994084592148e-10 5.161285821640344071e-13 5.511521602961261257e-01 -7.947733155018685915e-10 5.560212674589925133e-13 5.511521603174508455e-01 -7.739499286793696513e-10 5.761804664852089093e-13 5.511521603335632902e-01 -7.580045307676715695e-10 5.608580146409156458e-12 -2.744057024231243171e-09 5.511521583205227781e-01 5.927746217711726468e-12 -2.880626678497070631e-09 5.511521581711048556e-01 7.139245559000621467e-12 -3.336447183175965589e-09 5.511521576917327581e-01 1.070183981228245095e-11 -4.453198177427882760e-09 5.511521565696427816e-01 3.329979699691218952e-11 -9.396597659134412891e-09 5.511521517767101752e-01 -5.334641604106086912e-10 -5.118431443330913843e-08 5.511521109707457899e-01 -1.210584493707743558e-13 -2.037629958781918905e-10 5.511521608845161291e-01 -3.297097853820426015e-16 1.229468806433471576e-11 5.511521611016514388e-01 1.362035700338916265e-14 -6.906580174727430600e-11 5.511521610204128674e-01 2.435545247122672577e-13 -8.512698745463684233e-10 5.511521602386033614e-01 3.400071777418803425e-13 -9.145919014279664702e-10 5.511521601760118738e-01 3.989227196953342904e-13 -8.544932818821358959e-10 5.511521602355113902e-01 4.603657240382528359e-13 -8.172308994084592148e-10 5.511521602716291657e-01 5.171124183277519517e-13 -7.947733155018685915e-10 5.511521602930991026e-01 5.574768273141885669e-13 -7.739499286793696513e-10 5.511521603134038605e-01 5.778535817977709306e-13 -7.580045307676715695e-10 5.511521603291678062e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 deleted file mode 100644 index a7c31b429..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ -1.148727464454150568e-02 8.168849550871075805e-05 8.117593217108051359e-05 1.069052542290745665e-02 7.737807295971834852e-05 7.595675549244376734e-05 8.978329026521949738e-03 6.848565384129504986e-05 6.561133526328859970e-05 6.105210616616484239e-03 5.449457362791876238e-05 5.142695644576762297e-05 1.694406448271799969e-03 3.517614903071349352e-05 3.458347145993574532e-05 -4.064637037711391586e-03 1.512033434225979787e-05 1.737697842824592576e-05 -8.418996877365858555e-03 7.000723080360539176e-06 6.483629800054897640e-06 -1.077154444001353871e-02 2.403438870605099490e-06 2.367109201194806552e-06 -1.023511732673308521e-02 5.722235199242722718e-06 5.179207058382723667e-06 -7.994935036065664233e-03 1.250728140544632609e-05 1.262622045576768089e-05 -4.087040763840558630e-03 2.102853758902800398e-05 2.145574917449845614e-05 -1.043952669360425712e-03 2.989560876566563834e-05 2.996622367393672032e-05 9.893587631268044476e-04 3.760916837160726374e-05 3.731681225179358895e-05 2.332544146037315250e-03 4.349292015974616477e-05 4.288885079716610359e-05 3.140028989046306663e-03 4.724537408046027177e-05 4.653314566207486660e-05 3.502635738655277171e-03 4.898796663002114059e-05 4.827437590318597134e-05 4.063662430881635696e-12 5.511521589380419250e-01 -2.172078095477291178e-09 4.152318115752613051e-12 5.511521586728382882e-01 -2.448105267342441530e-09 4.312216041533378824e-12 5.511521580340895676e-01 -3.110388660660705836e-09 4.464677551550094175e-12 5.511521567565818014e-01 -4.397017206738851148e-09 6.221542748716405658e-12 5.511521515864775678e-01 -9.418260295684605978e-09 1.897640745181470589e-11 5.511521087977395705e-01 -5.120304998926697556e-08 3.966793953922608162e-14 5.511521608824353491e-01 -2.079086051123496080e-10 -8.725296980836753789e-16 5.511521611015488542e-01 1.211695830240388816e-11 -8.817032641791125975e-15 5.511521610218647060e-01 -6.751828580050805921e-11 -4.983411439441867365e-13 5.511521603371335454e-01 -7.524289837664857125e-10 9.787428225621367145e-13 5.511521615240350114e-01 4.200722261448114165e-10 1.063397975062885625e-09 5.511522227849084965e-01 6.093361079365765211e-08 -1.008469398625218168e-10 5.511521729787619561e-01 1.190374001004779939e-08 -1.226267580713257810e-11 5.511521636559422177e-01 2.639790795855090065e-09 -4.197608167422198893e-12 5.511521621603934218e-01 1.134096174061590751e-09 -2.377795025657471446e-12 5.511521617394657957e-01 7.024909593661340369e-10 4.103167015826818304e-12 -2.172078095477291178e-09 5.511521588960132112e-01 4.206874102449894273e-12 -2.448105267342441530e-09 5.511521586089257463e-01 4.390255888497085413e-12 -3.110388660660705836e-09 5.511521579225111545e-01 4.530949081985711996e-12 -4.397017206738851148e-09 5.511521566270032313e-01 6.166128707973944523e-12 -9.418260295684605978e-09 5.511521517550046489e-01 1.858136714125196845e-11 -5.120304998926697556e-08 5.511521109522343753e-01 3.985333806332250267e-14 -2.079086051123496080e-10 5.511521608804971217e-01 -8.695442376942530056e-16 1.211695830240388816e-11 5.511521611014645883e-01 -8.815821102797558275e-15 -6.751828580050805921e-11 5.511521610218824696e-01 -4.984550901597501560e-13 -7.524289837664857125e-10 5.511521603367925959e-01 9.455796352675250402e-13 4.200722261448114165e-10 5.511521614950728454e-01 1.050264587391547796e-09 6.093361079365765211e-08 5.511522212703875434e-01 -1.009687969688070562e-10 1.190374001004779939e-08 5.511521730075137349e-01 -1.261156370593685958e-11 2.639790795855090065e-09 5.511521638040741689e-01 -4.442097981735285692e-12 1.134096174061590751e-09 5.511521622888533312e-01 -2.565673069591487310e-12 7.024909593661340369e-10 5.511521618463761651e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 deleted file mode 100644 index 19baee6ec..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ -1.194609519088017310e-02 8.168866876252675558e-05 8.117610847307584160e-05 1.116848124441446877e-02 7.737838301283975011e-05 7.595707360947497901e-05 9.495229746956303229e-03 6.848727722154936961e-05 6.561301824779411449e-05 6.690657496589770201e-03 5.422663114131081658e-05 5.114983527271563897e-05 2.354532922473803833e-03 3.517585203656454731e-05 3.458317441170667277e-05 -3.508678470960618044e-03 1.512011131095072591e-05 1.737676009667945287e-05 -8.150396893536930934e-03 7.000722515964341281e-06 6.483629231955818983e-06 -1.067836609500128452e-02 2.403438873721513274e-06 2.367109204286613182e-06 -1.033584371098340664e-02 5.722235192068733973e-06 5.179207051211823203e-06 -8.183758531896713484e-03 1.250728184889370181e-05 1.262622089931744426e-05 -4.276490789822882423e-03 2.102853657718814078e-05 2.145574819694395232e-05 -1.149239313849215530e-03 2.989452918275996136e-05 2.996515742430733275e-05 9.352184531151144700e-04 3.760926346121555672e-05 3.731690745631323114e-05 2.309581701104157156e-03 4.349293059126632796e-05 4.288886152552526330e-05 3.135005222865847475e-03 4.724537730818806954e-05 4.653314907783503399e-05 3.505364494002718035e-03 4.898796834715435112e-05 4.827437775594430166e-05 1.773174784314222454e-10 5.511521451855092568e-01 -1.618056100807836841e-08 3.142054395203040535e-10 5.511521378909758351e-01 -2.379740009192075632e-08 1.627692470357670862e-09 5.511520918193216767e-01 -7.180922139511712548e-08 -2.679380219303927123e-07 5.511500296497280349e-01 -2.204454410957910228e-06 -2.907726062005159603e-10 5.511521334395411698e-01 -2.765962685182482183e-08 -2.040549016203031689e-10 5.511521067403231111e-01 -5.320245317180295586e-08 -5.247282585024413128e-13 5.511521607364220365e-01 -3.553196966544836533e-10 2.243884244282036897e-15 5.511521610931457982e-01 3.719149447666536059e-12 -1.599102107170741120e-14 5.511521610233308666e-01 -6.604229666964056829e-11 -5.489376856941828928e-14 5.511521603373742417e-01 -7.521776573702375300e-10 -3.309704053645203043e-14 5.511521615243316630e-01 4.203554526608867761e-10 -1.618493061332452149e-11 5.511522227864783519e-01 6.093516134113727624e-08 -5.757331572204494416e-12 5.511521729819934823e-01 1.190695432439285548e-08 -1.831155641509630742e-12 5.511521636587757289e-01 2.642632480471970944e-09 -9.698803700001246776e-13 5.511521621613556521e-01 1.135068931958450479e-09 -6.606618134995239459e-13 5.511521617388250860e-01 7.018408290427240437e-10 1.804051623412379161e-10 -1.618056100807836841e-08 5.511521446268166091e-01 3.223239053202732732e-10 -2.379740009192075632e-08 5.511521366767052621e-01 1.687374761402610505e-09 -7.180922139511712548e-08 5.511520866464232338e-01 -2.771166421029032047e-07 -2.204454410957910228e-06 5.511498811171823276e-01 -2.908821003637339904e-10 -2.765962685182482183e-08 5.511521334187166055e-01 -1.997501993308963627e-10 -5.320245317180295586e-08 5.511521090092086350e-01 -5.282457408661083667e-13 -3.553196966544836533e-10 5.511521607316748339e-01 2.222262348238359919e-15 3.719149447666536059e-12 5.511521610930720794e-01 -1.598672114610569521e-14 -6.604229666964056829e-11 5.511521610233682811e-01 -5.490532709959895736e-14 -7.521776573702375300e-10 5.511521603370549416e-01 -3.197486765801182999e-14 4.203554526608867761e-10 5.511521614953432957e-01 -1.598504199455734085e-11 6.093516134113727624e-08 5.511522212719190961e-01 -5.764277328406737922e-12 1.190695432439285548e-08 5.511521730107108441e-01 -1.883204547021388141e-12 2.642632480471970944e-09 5.511521638069240003e-01 -1.026337815243301887e-12 1.135068931958450479e-09 5.511521622898367667e-01 -7.129147404835939678e-13 7.018408290427240437e-10 5.511521618457164706e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 deleted file mode 100644 index 37bc291fa..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ -1.196183917173967819e-02 8.168850961281770562e-05 8.117594655196902920e-05 1.118984777531227374e-02 7.737809163103933469e-05 7.595677469883255250e-05 9.529360275040041697e-03 6.848570028469011875e-05 6.561138348959391381e-05 6.738434369764941499e-03 5.449558214546306654e-05 5.142799959903568668e-05 2.443959019660742974e-03 3.517615040909386777e-05 3.458347289658708710e-05 -3.397842537391878269e-03 1.512032423335174485e-05 1.737696852731456654e-05 -8.078209948545826344e-03 7.000723089538597710e-06 6.483629809372825031e-06 -1.064136406300011765e-02 2.403438870984566015e-06 2.367109201576260216e-06 -1.037801800467184031e-02 5.722235214373190093e-06 5.179207073509804603e-06 -8.285907016976842149e-03 1.250728186130603622e-05 1.262622091173203855e-05 -4.420146180520683268e-03 2.102853675958730423e-05 2.145574837320423094e-05 -1.263483854937507214e-03 2.989459471148623251e-05 2.996522214375597798e-05 8.388988987292986949e-04 3.760928659939345383e-05 3.731693062200491323e-05 2.225628301235645697e-03 4.349293865206814376e-05 4.288886981181363968e-05 3.060211249714175300e-03 4.724538244508970900e-05 4.653315449754097101e-05 3.437943879029638737e-03 4.898797262214283607e-05 4.827438233027248868e-05 1.816776937504030192e-11 5.511521451803104155e-01 -1.618578732525582605e-08 2.282363911015333401e-11 5.511521378856951703e-01 -2.380272332478414526e-08 5.075561110514579111e-11 5.511520918138224090e-01 -7.181479250297925298e-08 1.012982221858732238e-09 5.511500297723587183e-01 -2.204329205748493972e-06 7.599923122978640365e-12 5.511521334379325676e-01 -2.766123307817034152e-08 8.867499397919887931e-12 5.511521067396160101e-01 -5.320317192774800879e-08 4.884599759849672394e-14 5.511521607360732045e-01 -3.556622403884388879e-10 -4.930629623813490367e-16 5.511521610929706050e-01 3.541892266442918413e-12 6.313435279810250904e-15 5.511521610234257906e-01 -6.594569598088282138e-11 -4.248143339068855715e-14 5.511521603374575085e-01 -7.520961724628136594e-10 1.493021231631938468e-13 5.511521615286397724e-01 4.246457657886060592e-10 4.934379565795613953e-11 5.511522228051066730e-01 6.095359260555205305e-08 1.738084632276309895e-11 5.511521730331154778e-01 1.195785400956425934e-08 6.229646173031579167e-12 5.511521637676544128e-01 2.753035016648047418e-09 4.167021271254762545e-12 5.511521623490096555e-01 1.328698790435420181e-09 3.614326672908227553e-12 5.511521619850342502e-01 9.577816990819015875e-10 1.848405552448303609e-11 -1.618578732525582605e-08 5.511521446215627007e-01 2.341326289792069372e-11 -2.380272332478414526e-08 5.511521366713391101e-01 5.261656120689161690e-11 -7.181479250297925298e-08 5.511520866407794150e-01 1.047684217142814380e-09 -2.204329205748493972e-06 5.511498812449926454e-01 7.602780050954048299e-12 -2.766123307817034152e-08 5.511521334171127773e-01 8.680435783202303266e-12 -5.320317192774800879e-08 5.511521090084779972e-01 4.917126526988335079e-14 -3.556622403884388879e-10 5.511521607313384363e-01 -4.880906581602812015e-16 3.541892266442918413e-12 5.511521610928926673e-01 6.311260387834471753e-15 -6.594569598088282138e-11 5.511521610234666468e-01 -4.249073360458570311e-14 -7.520961724628136594e-10 5.511521603371346556e-01 1.442854094908636081e-13 4.246457657886060592e-10 5.511521614996158780e-01 4.873440664979866414e-11 6.095359260555205305e-08 5.511522212901553974e-01 1.740141435448434962e-11 1.195785400956425934e-08 5.511521730613891945e-01 6.403083831626514001e-12 2.753035016648047418e-09 5.511521639188716737e-01 4.393368119440338579e-12 1.328698790435420181e-09 5.511521624896327243e-01 3.861413447033865401e-12 9.577816990819015875e-10 5.511521621117736469e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 deleted file mode 100644 index e01b13275..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ -1.200016753583814898e-02 8.168847279019404717e-05 8.117590908806338068e-05 1.123199108145899947e-02 7.737803675327323922e-05 7.595671840282052455e-05 9.579599301549840060e-03 6.848554189056633328e-05 6.561121928719634453e-05 6.801936875236425616e-03 5.449134255689154808e-05 5.142361477326099731e-05 2.526880692213784134e-03 3.517610803590462084e-05 3.458343050704775970e-05 -3.313770477595053519e-03 1.512026624252606510e-05 1.737691176000734876e-05 -8.032227676602419347e-03 7.000722853805530394e-06 6.483629572072869582e-06 -1.062068470943312685e-02 2.403438872305497803e-06 2.367109202882778891e-06 -1.039706173624113140e-02 5.722235199179500179e-06 5.179207058321046963e-06 -8.325938225652021116e-03 1.250728181472054888e-05 1.262622086513309186e-05 -4.470717683830401946e-03 2.102853666422046779e-05 2.145574828104688703e-05 -1.298606139429777078e-03 2.989455168866636772e-05 2.996517965227207475e-05 8.131127725153922082e-04 3.760926958601434498e-05 3.731691358849250885e-05 2.205805383523282495e-03 4.349293220956482718e-05 4.288886318995238401e-05 3.044098646491445303e-03 4.724537803668690090e-05 4.653314984968488283e-05 3.424167966510261677e-03 4.898796877332344056e-05 4.827437821832526255e-05 -1.865485428976108960e-11 5.511521451678402794e-01 -1.619866573040677813e-08 -3.205412698789609181e-11 5.511521378670778404e-01 -2.382219168971532569e-08 -1.076385126794936371e-10 5.511520917863800273e-01 -7.184371600355541428e-08 -3.226606349662299339e-09 5.511500297449033470e-01 -2.204357918932243236e-06 -3.477326612394739076e-11 5.511521334056278532e-01 -2.769387456071488596e-08 -4.912332628139585333e-11 5.511521067215676695e-01 -5.322063517401172563e-08 -1.868870698858813461e-13 5.511521607329519234e-01 -3.588013163230157884e-10 8.278686476077146447e-16 5.511521610926268799e-01 3.200175487202451685e-12 -8.880254848944250688e-15 5.511521610235123880e-01 -6.585916281980453983e-11 -8.906692155818844546e-14 5.511521603375976186e-01 -7.519557285902273555e-10 5.393528719424191941e-14 5.511521615288347276e-01 4.248427705969897798e-10 6.320975793420797653e-12 5.511522228052051497e-01 6.095369026097176907e-08 3.674672118000830782e-13 5.511521730331221391e-01 1.195786062797528356e-08 -2.128571419352805749e-13 5.511521637676861651e-01 2.753064948178598263e-09 -2.413815360231809021e-13 5.511521623491559829e-01 1.328838145877133473e-09 -2.344927208183605756e-13 5.511521619852632892e-01 9.580013067615405916e-10 -1.897985012491591699e-11 -1.619866573040677813e-08 5.511521446082626730e-01 -3.288274913596305452e-11 -2.382219168971532569e-08 5.511521366509807285e-01 -1.115858363666935595e-10 -7.184371600355541428e-08 5.511520866102949112e-01 -3.337141557544958380e-09 -2.204357918932243236e-06 5.511498812149641102e-01 -3.478675927620656034e-11 -2.769387456071488596e-08 5.511521333841309378e-01 -4.808687143385368070e-11 -5.322063517401172563e-08 5.511521089915808469e-01 -1.881286901702747537e-13 -3.588013163230157884e-10 5.511521607281815172e-01 8.184281006649142078e-16 3.200175487202451685e-12 5.511521610925529391e-01 -8.877497172870469302e-15 -6.585916281980453983e-11 5.511521610235531332e-01 -8.908967954847416453e-14 -7.519557285902273555e-10 5.511521603372754319e-01 5.212806515489982089e-14 4.248427705969897798e-10 5.511521614998149410e-01 6.242922746089320882e-12 6.095369026097176907e-08 5.511522212902522089e-01 3.679019474853450807e-13 1.195786062797528356e-08 5.511521730613957448e-01 -2.187774209710848842e-13 2.753064948178598263e-09 5.511521639188998734e-01 -2.544879663431090900e-13 1.328838145877133473e-09 5.511521624897653959e-01 -2.505337758143741582e-13 9.580013067615405916e-10 5.511521621119841452e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 b/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 deleted file mode 100644 index db9fd84ec..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ -1.200930518458296140e-02 8.168850031394288443e-05 8.117593709132900771e-05 1.124254127796948249e-02 7.737807725997106157e-05 7.595675995664787951e-05 9.593217322184778226e-03 6.848565593918205883e-05 6.561133751819932182e-05 6.820735304878434643e-03 5.449430020211852517e-05 5.142667373979726788e-05 2.553562004725284072e-03 3.517613663847057458e-05 3.458345912070116465e-05 -3.284428553004262001e-03 1.512030422896776519e-05 1.737694894496922857e-05 -8.014908915282050947e-03 7.000723004646764462e-06 6.483629723908972646e-06 -1.061226483013992875e-02 2.403438871505481537e-06 2.367109202090435050e-06 -1.040508087313818733e-02 5.722235208759063342e-06 5.179207067897670921e-06 -8.344010006203475896e-03 1.250728185353025852e-05 1.262622090395466843e-05 -4.495663575051244906e-03 2.102853670162307782e-05 2.145574831718771613e-05 -1.317498643081258230e-03 2.989456954589724591e-05 2.996519728895552956e-05 7.979217700936241161e-04 3.760927615231312600e-05 3.731692016254095016e-05 2.193052376306329002e-03 4.349293443633833452e-05 4.288886547868126924e-05 3.032955635145838640e-03 4.724537939415126696e-05 4.653315128086622137e-05 3.414265251563279851e-03 4.898796986952100226e-05 4.827437938939939838e-05 8.868894552845111131e-12 5.511521451671540506e-01 -1.619934702417882326e-08 8.452570836201241094e-12 5.511521378667435522e-01 -2.382251756863293668e-08 6.410103052634350595e-12 5.511520917863580449e-01 -7.184373339040264921e-08 -2.689611226845306107e-10 5.511500297444990037e-01 -2.204358363155267775e-06 -6.170700171204049640e-12 5.511521334052973398e-01 -2.769421217854284012e-08 -1.113688458214228647e-11 5.511521067212266090e-01 -5.322095687669273544e-08 -3.604583575689914593e-14 5.511521607329087358e-01 -3.588453129606688890e-10 2.785217201028614703e-17 5.511521610926266579e-01 3.200025338994255916e-12 6.993079200069004598e-16 5.511521610235126101e-01 -6.585893720151299056e-11 -5.025721226145817982e-14 5.511521603376180467e-01 -7.519355432267673345e-10 9.133789741915530852e-14 5.511521615291128384e-01 4.251209887183846514e-10 2.417820667132331498e-11 5.511522228059394513e-01 6.095441713036122434e-08 6.933765992555206428e-12 5.511521730344033365e-01 1.195913495163170699e-08 2.013916367350442402e-12 5.511521637694063447e-01 2.754813899036565292e-09 1.116082833163727225e-12 5.511521623511356216e-01 1.330898915900606179e-09 8.617048437084673168e-13 5.511521619872800093e-01 9.601251100754930572e-10 9.023415498917623428e-12 -1.619934702417882326e-08 5.511521446075863251e-01 8.671078221543159340e-12 -2.382251756863293668e-08 5.511521366506630937e-01 6.645166614426772349e-12 -7.184373339040264921e-08 5.511520866102811445e-01 -2.781750212733276203e-10 -2.204358363155267775e-06 5.511498812144769444e-01 -6.173105867896660987e-12 -2.769421217854284012e-08 5.511521333837861025e-01 -1.090190955330275254e-11 -5.322095687669273544e-08 5.511521089912774229e-01 -3.629258713028714108e-14 -3.588453129606688890e-10 5.511521607281366641e-01 2.608436313747171848e-17 3.200025338994255916e-12 5.511521610925528281e-01 6.991263867155419665e-16 -6.585893720151299056e-11 5.511521610235533553e-01 -5.026810376442409349e-14 -7.519355432267673345e-10 5.511521603372954159e-01 8.826889339957348759e-14 4.251209887183846514e-10 5.511521615000932739e-01 2.387960620084051051e-11 6.095441713036122434e-08 5.511522212909717444e-01 6.941950387633462989e-12 1.195913495163170699e-08 5.511521730626632865e-01 2.069951467511333706e-12 2.754813899036565292e-09 5.511521639206780065e-01 1.176693371779026789e-12 1.330898915900606179e-09 5.511521624919105689e-01 9.205403591267005536e-13 9.601251100754930572e-10 5.511521621142206895e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener deleted file mode 100644 index 085f61416..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.06537776555844366 -1 0.06842840551476514 -2 0.07563770918924644 -3 0.08790095468383863 -4 0.10538783775378793 -5 0.12528362884254654 -6 0.14068829284912457 -7 0.1461764612687949 -8 0.14016344893874955 -9 0.12712439965785238 -10 0.10983889792154287 -11 0.09258127399307692 -12 0.0785531932506661 -13 0.06852373141042968 -14 0.06231255846883983 -15 0.05955519530225097 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz deleted file mode 100644 index da9ba5065..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.06576135339134 -4.036977577669698e-05 -4.03463370142543e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.0799379986567645 -3.9872849638913154e-05 -3.989885072496056e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.111762005589272 -3.881648447878733e-05 -3.8869764093055744e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.162745192727229 -3.6688731640361026e-05 -3.663208693183834e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.233971607719767 -3.260399530531656e-05 -3.236283492760897e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.3247011922205028 -2.550397741657568e-05 -2.5292168501822956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.431298374974536 -1.5291976853077628e-05 -1.5257128673206789e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.547155042590501 -3.3712361796752077e-06 -3.3581738254979327e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.663764407093567 8.698200609595615e-06 8.697542060115588e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7730715160409685 1.9368513676873852e-05 1.9370564946948017e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8690765826574727 2.795830574700837e-05 2.7921903538529764e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9486107853901364 3.436355184889286e-05 3.431006188664314e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0107836513609896 3.888125633027276e-05 3.883791455518526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0558864229391904 4.191617690764468e-05 4.190113445407812e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.0846425024467283 4.380763178863292e-05 4.381565284163732e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.09771729893857 4.4749415184144526e-05 4.476697456611449e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener deleted file mode 100644 index e3890bfac..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.048010793705999144 -1 0.05006230761537636 -2 0.055167515402352374 -3 0.06530035693631965 -4 0.08283835118220956 -5 0.10794612286167661 -6 0.13311540055758112 -7 0.14578290160402213 -8 0.14080551258723087 -9 0.12402205532312414 -10 0.10070845223403804 -11 0.07872570175415318 -12 0.061990000932250065 -13 0.05071974760920981 -14 0.04395987380765516 -15 0.04082131565137507 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz deleted file mode 100644 index 418f6c213..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9657613533913398 -5.8202069490434e-05 -5.771866984911536e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9808403042617393 -5.954580709354527e-05 -5.926234119974396e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.01295774550751 -6.175921295031682e-05 -6.177219820570546e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.065394422534147 -6.326764817066309e-05 -6.335080194055869e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.1420089836739553 -6.154561995206643e-05 -6.122952499016171e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.244690369108785 -5.2998130516496316e-05 -5.245657964740542e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3706039960943808 -3.5390012816408726e-05 -3.531199956865308e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5118110993782414 -1.1823584811031625e-05 -1.1795690495273182e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6564888880281594 1.3673936162686538e-05 1.3659927640233507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7928306798508027 3.664353990332544e-05 3.6632284516012933e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.9120333154196882 5.4992400435010195e-05 5.491720488447381e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 3.010016890698354 6.837861109276882e-05 6.831349223243517e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.086161101335155 7.758941766024247e-05 7.760506372253507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.141416678427201 8.367831999734887e-05 8.376357674166844e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1771747403887316 8.744139486333775e-05 8.754036352842724e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1946133120708797 8.930080161392669e-05 8.938865662257378e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener deleted file mode 100644 index 4a34dd317..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.053551887997109415 -1 0.055821523787737866 -2 0.06104397476068316 -3 0.070540369673141 -4 0.08586896151139578 -5 0.10731810114616054 -6 0.13012540827844282 -7 0.14435658014354713 -8 0.1440744580029646 -9 0.1317573290770667 -10 0.11270517536494683 -11 0.09214406697587658 -12 0.07521632481201693 -13 0.06317455833056673 -14 0.0557056992021589 -15 0.0521766654434155 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz deleted file mode 100644 index 03279a1fe..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.003410922436927 -2.019089826258433e-05 -1.912678519726927e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.0166975261971185 -2.3257199650390734e-05 -2.2247937752807154e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0445755874166265 -2.865878295841778e-05 -2.7840079323915293e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.089474518135972 -3.481137112022684e-05 -3.437133012466438e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.1544582649569106 -3.92844857593742e-05 -3.917576381189261e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.2420446957327496 -3.892039048008819e-05 -3.867303719014884e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3517982652580818 -2.9870679789311668e-05 -2.9689240918028162e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.47823469448337 -1.2294756793963556e-05 -1.2226080548025182e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6114737533745647 9.220341758268867e-06 9.23047117336199e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7401495529015643 2.9081816922087504e-05 2.911729255699749e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.854896883175759 4.431245358068483e-05 4.434217346078701e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9505556492764846 5.44273456611705e-05 5.449515852337697e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0256642421278923 6.054520758177529e-05 6.0580983641131965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0805986298376604 6.404198772553064e-05 6.386715555669364e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.116383287627362 6.583509310841344e-05 6.541672177816995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.13399370443819 6.655043744003064e-05 6.599499369725066e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener deleted file mode 100644 index 7f8a756ae..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.05104097515712119 -1 0.05306951644368564 -2 0.05782256256069674 -3 0.06669383309098245 -4 0.08146358784021217 -5 0.10291615059174383 -6 0.1270534587852278 -7 0.14334274627411497 -8 0.14474698761547658 -9 0.13287887029520795 -10 0.11361730053412121 -11 0.09233877126651915 -12 0.0747290768002318 -13 0.0622286250911736 -14 0.05450969761310025 -15 0.05087332238233164 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz deleted file mode 100644 index 7a35e4969..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9874962540886816 -3.5103373834124876e-05 -3.4130810633550696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.000464822853745 -3.702801532724975e-05 -3.618747959311343e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.027758128739662 -4.029813818870549e-05 -3.972245038332976e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.071941220035372 -4.368456406598558e-05 -4.343080885451845e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.136316736944003 -4.524378713224654e-05 -4.514688481395709e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.2237441215902525 -4.229597210110211e-05 -4.2008081049005955e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.334205800733934 -3.157896506770632e-05 -3.134536665709115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.462511308082689 -1.2845770647930886e-05 -1.2805405688684325e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.598846134728532 1.0066091822875302e-05 1.0033635778585991e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7314158518194604 3.198392723105558e-05 3.200027067034645e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8502892735604335 4.961915023133467e-05 4.9586830797757707e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9496898227973714 6.198125461898199e-05 6.195698137054672e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0278455495047085 6.978524375308098e-05 6.983185251663175e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0850375702576183 7.43805508222998e-05 7.443572771261109e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1222951858572316 7.688811658934849e-05 7.68602037356926e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.14062975868737 7.798590311639581e-05 7.787451423465271e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener deleted file mode 100644 index dd1eaee39..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.05113388898041316 -1 0.05315468032355862 -2 0.05788076548489761 -3 0.06668110401421838 -4 0.08130346544361368 -5 0.10253287771705626 -6 0.12654370455256153 -7 0.1430434023270727 -8 0.14499112687101906 -9 0.13362758166350597 -10 0.11486952483536592 -11 0.0938044536225434 -12 0.07618623057397172 -13 0.06360637717503197 -14 0.05580505037353811 -15 0.05212372038791605 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz deleted file mode 100644 index f16f6084b..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9881132783422466 -3.1725043571321754e-05 -3.068960605493158e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.0009884491959355 -3.357488820436078e-05 -3.2640067991699516e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.028072074027783 -3.67438851685318e-05 -3.603485939119004e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0718819548958547 -4.008501825292844e-05 -3.970781531005999e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.1356516269476638 -4.175625012253249e-05 -4.164120141586025e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.222167547136141 -3.9262465503888336e-05 -3.9060106184827616e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3314256236731645 -2.952913967753447e-05 -2.9275917815924268e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.458422661518627 -1.1617933392790702e-05 -1.1578335993530693e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.593609264503044 1.0697913936911713e-05 1.0669681309218199e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.725388015454487 3.2199177642932124e-05 3.222497783467351e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8438783613390433 4.9365438526928155e-05 4.9344584955500745e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.943161541981536 6.111436483605497e-05 6.110073997710469e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0213293451304386 6.820465545899864e-05 6.825977668149615e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0785799900010846 7.21150551456202e-05 7.216378943398968e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.115894800919542 7.409113202235872e-05 7.403276965452013e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1342619266026532 7.489621250238764e-05 7.473929616956903e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener deleted file mode 100644 index dec5591c4..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.05096590857496589 -1 0.05296025606468151 -2 0.05762923639623487 -3 0.06633787559093109 -4 0.08084381285521451 -5 0.10198573435910428 -6 0.12607642557685142 -7 0.14284298456344546 -8 0.1451019566831399 -9 0.13390376560117467 -10 0.11523346685962982 -11 0.09413744671544252 -12 0.07644109075721481 -13 0.0637921276786535 -14 0.05594442270948384 -15 0.05224097116990205 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz deleted file mode 100644 index a031f6698..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9869959945567084 -3.235588538026311e-05 -3.132364631607926e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.999790845512831 -3.415415574828053e-05 -3.3223720876963385e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0267124595615718 -3.723042384440743e-05 -3.6526440921082085e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.070279855779636 -4.04579756379904e-05 -4.008344318313165e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.133739664963162 -4.201914098164972e-05 -4.1903714777187574e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.219920672446604 -3.9446296613399574e-05 -3.92468052376286e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3289082063854503 -2.9704154078014313e-05 -2.944778562151041e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.455791146619531 -1.179899379578984e-05 -1.1761552890889106e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5910695556756833 1.0577440101088408e-05 1.0547050970922665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7231219283228514 3.22638676155198e-05 3.2288301380567665e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.841995349169877 4.969153037373674e-05 4.966932784427873e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.941675559373527 6.171526181113743e-05 6.16952782165634e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0201917030369465 6.90337339336999e-05 6.908525087386455e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0777130519897202 7.310241862169309e-05 7.316497258225675e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1152100709250803 7.517576763333801e-05 7.515194634206205e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1336683060080013 7.603064627275364e-05 7.591857078036052e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener deleted file mode 100644 index fc62b4fc2..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.05094187433573566 -1 0.0529298251585715 -2 0.05758385082110203 -3 0.06626549962662247 -4 0.08073133514217475 -5 0.10183206447338992 -6 0.125926637864579 -7 0.14276948725526517 -8 0.14514562154489985 -9 0.13403132328658401 -10 0.11542990653474229 -11 0.09435240856147208 -12 0.07664205640103602 -13 0.0639729291756765 -14 0.056108504280995376 -15 0.052396357945602295 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz deleted file mode 100644 index 572ce1484..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9868354779851642 -3.226417335080169e-05 -3.122893380422429e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9996026733280081 -3.402884161097801e-05 -3.309268289001407e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.026466305571826 -3.704771897292677e-05 -3.633388887768044e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0699411574235818 -4.0211512564476274e-05 -3.9825976577662086e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.133271201686821 -4.172650366702104e-05 -4.160802874973194e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.219290387431041 -3.9153830337802e-05 -3.896381456926752e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.328107309129175 -2.94954841083799e-05 -2.923792925264978e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4548455605069495 -1.1677089312347159e-05 -1.1640350438179178e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.590036103347134 1.0647134901478912e-05 1.061668167018751e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.722067299043064 3.232624857430142e-05 3.235085243410479e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8409750998646413 4.975487454324541e-05 4.973333833060576e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9407156729184627 6.176493941056483e-05 6.174452089446403e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.019295028959897 6.904756658501146e-05 6.909898967341392e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.076870008735045 7.30683943438249e-05 7.313289186327829e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1144048866942033 7.509881444143623e-05 7.507863869028115e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.132882495933586 7.592909444034276e-05 7.582119205131972e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener deleted file mode 100644 index bbbcd3287..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.050919370072655595 -1 0.05290320294685336 -2 0.05754808218924119 -3 0.06621437972546856 -4 0.08065941548510698 -5 0.10174199948043824 -6 0.12584532755081587 -7 0.14273224115687608 -8 0.1451657473533179 -9 0.1340864802905247 -10 0.11550856746259959 -11 0.09443177425200715 -12 0.07671030737855557 -13 0.06402971605434313 -14 0.05615693406720792 -15 0.05244064585222887 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz deleted file mode 100644 index 6062a3587..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9866850273986039 -3.2305860104540206e-05 -3.12703294686253e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9994378884395796 -3.405881426510707e-05 -3.3121933062634965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0262721287516 -3.705730471897021e-05 -3.6341967160473165e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0697017458568143 -4.019768612195744e-05 -3.981013365295688e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.132971532488317 -4.169347101729316e-05 -4.157427830738678e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.2189211317131208 -3.9114491911721445e-05 -3.892673141640411e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3276737541836696 -2.9473849035048844e-05 -2.921586536761708e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.454370168604051 -1.16749027180496e-05 -1.1638507252232225e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.589552996042531 1.0644678897939056e-05 1.061400922297992e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.721609676386341 3.234163701300121e-05 3.2366054826199795e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8405657820583787 4.979809141462031e-05 4.97765764170584e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.940361149221517 6.183516655769054e-05 6.181404125495404e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0189905842206826 6.913611168713314e-05 6.918706267085788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0766053861354705 7.316562798941619e-05 7.323175115589965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.114167429500616 7.519893138440071e-05 7.518285667877604e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1326587164143738 7.603010705557766e-05 7.592756707577359e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 deleted file mode 100644 index 122ea3a03..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL.hess_7 +++ /dev/null @@ -1 +0,0 @@ -1.211720761571505843e-02 1.339870819610409710e-04 1.360808927209427536e-04 1.134630141982721774e-02 1.269269298678142284e-04 1.297407724649498218e-04 9.689738882759238794e-03 1.134079951150337848e-04 1.170899365757808411e-04 6.908816133368049159e-03 9.477212433123437447e-05 9.837324525751751643e-05 2.634129529348241266e-03 7.330998793279303982e-05 7.455310335816610400e-05 -3.215217516627745173e-03 5.085424134226921959e-05 4.833412323727535322e-05 -7.979773345621454100e-03 2.224458523295589978e-05 2.286298843202176352e-05 -1.060830783469399186e-02 5.936683831159546867e-06 5.746054465677738401e-06 -1.042735772591469982e-02 3.935735542469341629e-06 3.615363592539134991e-06 -8.380452352951643646e-03 1.408366762291792115e-05 1.409731663410453964e-05 -4.540310698796260966e-03 2.899104242590973030e-05 2.929756245350242070e-05 -1.360895464848485212e-03 4.534135768375485969e-05 4.488524817596351870e-05 7.574700407592376700e-04 5.885132838912696313e-05 5.819546608878853030e-05 2.151657818134531872e-03 6.785123070855844304e-05 6.854114065953120262e-05 2.988895800948385834e-03 7.319593016904220643e-05 7.576889790622987498e-05 3.369164542445018604e-03 7.605463863359418269e-05 7.959193960478886244e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 8.470329472543003391e-19 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener deleted file mode 100644 index bbbcd3287..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.050919370072655595 -1 0.05290320294685336 -2 0.05754808218924119 -3 0.06621437972546856 -4 0.08065941548510698 -5 0.10174199948043824 -6 0.12584532755081587 -7 0.14273224115687608 -8 0.1451657473533179 -9 0.1340864802905247 -10 0.11550856746259959 -11 0.09443177425200715 -12 0.07671030737855557 -13 0.06402971605434313 -14 0.05615693406720792 -15 0.05244064585222887 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz deleted file mode 100644 index 6062a3587..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9866850273986039 -3.2305860104540206e-05 -3.12703294686253e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9994378884395796 -3.405881426510707e-05 -3.3121933062634965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0262721287516 -3.705730471897021e-05 -3.6341967160473165e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0697017458568143 -4.019768612195744e-05 -3.981013365295688e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.132971532488317 -4.169347101729316e-05 -4.157427830738678e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.2189211317131208 -3.9114491911721445e-05 -3.892673141640411e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3276737541836696 -2.9473849035048844e-05 -2.921586536761708e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.454370168604051 -1.16749027180496e-05 -1.1638507252232225e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.589552996042531 1.0644678897939056e-05 1.061400922297992e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.721609676386341 3.234163701300121e-05 3.2366054826199795e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8405657820583787 4.979809141462031e-05 4.97765764170584e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.940361149221517 6.183516655769054e-05 6.181404125495404e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0189905842206826 6.913611168713314e-05 6.918706267085788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0766053861354705 7.316562798941619e-05 7.323175115589965e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.114167429500616 7.519893138440071e-05 7.518285667877604e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1326587164143738 7.603010705557766e-05 7.592756707577359e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz deleted file mode 100644 index 93fc95899..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_FINAL_forces_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0018510171490633024 1.7805444612468837e-05 1.723470966461007e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0019993534862349617 1.87715890863559e-05 1.8255224986929376e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0022791667179112743 2.042421358000848e-05 2.0029953738734423e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002636354850968157 2.215504157690982e-05 2.1941441196084636e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002934912185468499 2.2979446654498968e-05 2.2913753334847966e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002897394824317648 2.1558036747058737e-05 2.145455214429737e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002253700475321969 1.6244575591289603e-05 1.6102387335458818e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0010546977141204122 6.43464786356143e-06 6.414588423922328e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.000402628280509582 -5.866837778701736e-06 -5.8499341210681e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0016590765439645418 -1.7825163132884215e-05 -1.7838621063397695e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002439153445089345 -2.744632570129498e-05 -2.7434467663892897e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002724728219458331 -3.408058567959351e-05 -3.406894242333663e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027438220079638877 -3.810451736568086e-05 -3.813259911047038e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026572409261364713 -4.0325393983829086e-05 -4.036183790993452e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0025590230172260983 -4.14460535441252e-05 -4.143719393538129e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0024994095898694248 -4.19041578115393e-05 -4.1847642680072234e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz deleted file mode 100644 index 40df50387..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.002608941726057982 2.2249889162020644e-05 2.22369708374471e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0027028221704973707 2.197600724727929e-05 2.1990337802044984e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0028649977762466887 2.1393789306376403e-05 2.1423154480922444e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0029801311282103677 2.0221073731213658e-05 2.01898538776971e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002841619470618425 1.7969762472673544e-05 1.7836846409330875e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00227738121980783 1.4056572269520682e-05 1.3939833328416719e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0012958536758315143 8.428206089902662e-06 8.408999440256819e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -4.7295560127201694e-05 1.8580641059707294e-06 1.8508647612370095e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0011416766538413117 -4.794032063567673e-06 -4.793669102598571e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.002053451479545508 -1.0674998170098429e-05 -1.0676128732032786e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0025535693852966807 -1.5409280632861575e-05 -1.5389217476990163e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027346652423528113 -1.89395458642246e-05 -1.8910064755934075e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002749481416171601 -2.1429488452300353e-05 -2.140560053929543e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002697597106316366 -2.3102191487253547e-05 -2.309390080646225e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002638896950870834 -2.414467093251329e-05 -2.4149091753210876e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0026059177089612275 -2.466373688622762e-05 -2.467341477754776e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz deleted file mode 100644 index 5a4f5487d..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015866879082761635 3.2078196379527555e-05 3.1811769622544945e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001779782887207077 3.2818800263419405e-05 3.266256742345567e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0021458600645275923 3.403872368474696e-05 3.4045880536316696e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0026063375764652725 3.4870101016304144e-05 3.491593139628484e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002955235797480483 3.3921001442167684e-05 3.3746785020804436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0027942971250027476 2.9210034167864484e-05 2.8911557236025204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0018858317640575316 1.9505282044744876e-05 1.9462284874650753e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00043229039317776416 6.5165943204237665e-06 6.50122030801139e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0010725121557649269 -7.536419466663044e-06 -7.528698639239388e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0021833188483289675 -2.019616620768311e-05 -2.018996277664193e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0026754749113868633 -3.0309180343248975e-05 -3.0267736153066545e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002749922192120615 -3.7687019276070466e-05 -3.7651128875469896e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002635264876363245 -4.276357522110991e-05 -4.277219858215502e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002468779691415813 -4.611948690286834e-05 -4.616647634174752e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002329314917974392 -4.819351374759928e-05 -4.824806054124348e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00225380625806679 -4.9218329796530575e-05 -4.926675127440895e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz deleted file mode 100644 index 575b2dfd3..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0020435620619153948 1.1128257211759362e-05 1.0541768996167511e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002184410316908276 1.2818255848200258e-05 1.2261998972241888e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0024443566387581783 1.579535016172374e-05 1.5344119884275956e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002758528834162892 1.91863624233978e-05 1.8943832877725624e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002973839230012961 2.165172922356445e-05 2.1591806887252127e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002806542007049702 2.1451057323543524e-05 2.1314728023240884e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0020526859012169082 1.646328971908829e-05 1.6363289293074765e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0007985818262157207 6.7762817770614735e-06 6.738430715697031e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006281297085835031 -5.081811286052631e-06 -5.087394135071777e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0018096081293385185 -1.6028506245014523e-05 -1.6048058717861173e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00250012596324479 -2.4422904554167718e-05 -2.4439284730313353e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027367262130361023 -2.9997749183513347e-05 -3.0035124389068103e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027379602862758184 -3.336962200230117e-05 -3.338934005473086e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026483120375402065 -3.52968799353864e-05 -3.520052080770394e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002552255529894339 -3.628515384222327e-05 -3.6054567579421726e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0024948370194203618 -3.6679417416517135e-05 -3.637328339732037e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz deleted file mode 100644 index 3fe6a3522..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001860743459578863 1.934730035020667e-05 1.8811270040414197e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0020108720647718766 2.040807066846475e-05 1.9944807582122663e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00229336238461937 2.22104059505839e-05 2.1893114372538264e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0026514834070125223 2.4076841891215858e-05 2.3936984158028055e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0029430996918390208 2.4936211053806013e-05 2.488280313166621e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0028809270895277703 2.331151642889897e-05 2.315284465337788e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0022007967824139384 1.740481484203269e-05 1.7276066573195092e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0009679469788825094 7.079974253465762e-06 7.057727018944733e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0004988845411847778 -5.547948261901959e-06 -5.530060042951492e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0017397826838640555 -1.7628010613522073e-05 -1.763701833540687e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0024812942508029693 -2.7347701881419204e-05 -2.7329888955758077e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00273582188174067 -3.416110243028366e-05 -3.4147724176951895e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002735801497984479 -3.8462287906660425e-05 -3.848797642741715e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002637957110120812 -4.099500132872973e-05 -4.102541219106699e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002533690943366815 -4.237705162031239e-05 -4.2361667390697777e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002471592204966878 -4.298209903710934e-05 -4.29207068142153e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz deleted file mode 100644 index d9e57d969..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0018681150453619304 1.748532632498904e-05 1.6914642700157567e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002016720712402111 1.8504872192168113e-05 1.7989644011729812e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002296343852633139 2.0251471717456688e-05 1.9860690628006687e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002651087269884273 2.209294443740915e-05 2.1885048220277927e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0029415339123703196 2.3014047494022885e-05 2.295063815070994e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0028864588794659863 2.163959271216568e-05 2.1528061936148787e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002223456356661316 1.6275049148383574e-05 1.6135485372122032e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.001011607049582267 6.403249096829184e-06 6.3814249046535115e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00044475706208978763 -5.896178385477194e-06 -5.880617911710681e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0016904523210539292 -1.7746646343203208e-05 -1.7760866174637995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002453878054266583 -2.7207868127241882e-05 -2.7196374636283234e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027283193763479345 -3.3683314252997115e-05 -3.367580488254213e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002741895690669336 -3.7591143252584355e-05 -3.762152343348575e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002652871615288606 -3.9746368490589105e-05 -3.9773228498943095e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0025537564472888257 -4.083548753168231e-05 -4.0803320986521775e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002493914080168783 -4.1279209378101136e-05 -4.119272460215793e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz deleted file mode 100644 index c48c7693c..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0018547501734087837 1.7833016151292608e-05 1.726409536030679e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002003319620338011 1.8824136750848423e-05 1.831132556076905e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0022833875309751705 2.0519628560119106e-05 2.0131626850558315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0026402915904934522 2.2298500706180303e-05 2.2092076334286783e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0029368611373069365 2.3158940359155995e-05 2.3095322957120335e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0028940933998384353 2.1740911625448258e-05 2.163096152257339e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0022437925797000173 1.6371508713429806e-05 1.6230210684592526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0010396099567918956 6.503040929229874e-06 6.482405293580692e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00041839991947731955 -5.82977897050845e-06 -5.813029935743975e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0016716757321801937 -1.778230036139572e-05 -1.77957670838054e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002445554851394332 -2.738759435332406e-05 -2.737535738123163e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027264418255349555 -3.401449991940589e-05 -3.400348591807009e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002742849995383501 -3.8048091645628646e-05 -3.807648531853311e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026548010111791622 -4.0290556004207406e-05 -4.032503275475677e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0025558517623980492 -4.143328679266805e-05 -4.142015763650137e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002495954801956268 -4.190445500225114e-05 -4.184268435241351e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz deleted file mode 100644 index 092a62e8c..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0018528239628381662 1.7782468868057054e-05 1.7211894354715718e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002001206091686079 1.875506959325909e-05 1.823910369107713e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002281029499533148 2.0418930375360984e-05 2.002550137571532e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002637987812325792 2.2162662050584255e-05 2.1950173058273883e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002935677407018618 2.2997652670783e-05 2.2932354964084222e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0028961820290551495 2.157971820560689e-05 2.147499060413805e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002250225571629458 1.625649980871134e-05 1.611454789337662e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.001049652729339132 6.435853009733955e-06 6.415604299840281e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00040765505105648623 -5.868191410360371e-06 -5.85140704612196e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.001662894952375722 -1.7816681761639036e-05 -1.7830242232140806e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0024409936020780725 -2.742250662924118e-05 -2.7410636899103156e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027251953081305984 -3.404187983568803e-05 -3.403062612641284e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002743579091495408 -3.8055715541292614e-05 -3.808405748759552e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002656660603384589 -4.027180344993085e-05 -4.0307351397162486e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002558302829672356 -4.139087387464866e-05 -4.137975396579794e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002498645557316557 -4.1848484490355295e-05 -4.178901385545854e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz deleted file mode 100644 index 93fc95899..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0018510171490633024 1.7805444612468837e-05 1.723470966461007e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0019993534862349617 1.87715890863559e-05 1.8255224986929376e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0022791667179112743 2.042421358000848e-05 2.0029953738734423e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002636354850968157 2.215504157690982e-05 2.1941441196084636e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002934912185468499 2.2979446654498968e-05 2.2913753334847966e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002897394824317648 2.1558036747058737e-05 2.145455214429737e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002253700475321969 1.6244575591289603e-05 1.6102387335458818e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0010546977141204122 6.43464786356143e-06 6.414588423922328e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.000402628280509582 -5.866837778701736e-06 -5.8499341210681e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0016590765439645418 -1.7825163132884215e-05 -1.7838621063397695e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002439153445089345 -2.744632570129498e-05 -2.7434467663892897e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002724728219458331 -3.408058567959351e-05 -3.406894242333663e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027438220079638877 -3.810451736568086e-05 -3.813259911047038e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026572409261364713 -4.0325393983829086e-05 -4.036183790993452e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0025590230172260983 -4.14460535441252e-05 -4.143719393538129e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0024994095898694248 -4.19041578115393e-05 -4.1847642680072234e-05 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 b/drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 deleted file mode 100644 index aa2c39b08..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.instantonfric_FINAL.hess_7 +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_00 b/drivers/py/pes/friction/frictionH/080K/inst.raw_00 deleted file mode 100644 index 9c2e17fee..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_00 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 -{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} - #*EXTRAS*# Step: 1 Bead: 0 -{"friction": [[0.0001343325901679972, -2.3029816478463187e-05, -2.2775283311006272e-05], [-2.3029816478463187e-05, 0.00013452857993798977, -2.2912148578879323e-05], [-2.2775283311006272e-05, -2.2912148578879323e-05, 0.0001345066031031012]]} - #*EXTRAS*# Step: 2 Bead: 0 -{"friction": [[0.0001362189769165877, -1.2519544510922201e-05, -1.1991851051186898e-05], [-1.2519544510922201e-05, 0.00013628685189819752, -1.2386884344101075e-05], [-1.1991851051186898e-05, -1.2386884344101075e-05, 0.0001368253923285999]]} - #*EXTRAS*# Step: 3 Bead: 0 -{"friction": [[0.00013549040085582398, -1.6714181591711767e-05, -1.624245031402653e-05], [-1.6714181591711767e-05, 0.0001356057406669174, -1.6575056620968432e-05], [-1.624245031402653e-05, -1.6575056620968432e-05, 0.0001359479668833992]]} - #*EXTRAS*# Step: 4 Bead: 0 -{"friction": [[0.0001357891516320171, -1.4977046550053155e-05, -1.447084000436214e-05], [-1.4977046550053155e-05, 0.00013588358550651897, -1.4838606081290266e-05], [-1.447084000436214e-05, -1.4838606081290266e-05, 0.0001363129737319015]]} - #*EXTRAS*# Step: 5 Bead: 0 -{"friction": [[0.00013577736796275977, -1.5045370482195335e-05, -1.4540235805003285e-05], [-1.5045370482195335e-05, 0.00013587259507233013, -1.4906849639791598e-05], [-1.4540235805003285e-05, -1.4906849639791598e-05, 0.0001362987023273524]]} - #*EXTRAS*# Step: 6 Bead: 0 -{"friction": [[0.00013579871948064717, -1.49215941447545e-05, -1.4414535573054557e-05], [-1.49215941447545e-05, 0.000135892511502374, -1.4783222117114463e-05], [-1.4414535573054557e-05, -1.4783222117114463e-05, 0.00013632455330610078]]} - #*EXTRAS*# Step: 7 Bead: 0 -{"friction": [[0.00013580179219248217, -1.4903790311347482e-05, -1.4396461599257387e-05], [-1.4903790311347482e-05, 0.00013589537851007013, -1.4765440867407678e-05], [-1.4396461599257387e-05, -1.4765440867407678e-05, 0.00013632827051372336]]} - #*EXTRAS*# Step: 8 Bead: 0 -{"friction": [[0.00013580467341873405, -1.488709809791072e-05, -1.437951762333288e-05], [-1.488709809791072e-05, 0.00013589806704095714, -1.4748770096723624e-05], [-1.437951762333288e-05, -1.4748770096723624e-05, 0.00013633175537668956]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_01 b/drivers/py/pes/friction/frictionH/080K/inst.raw_01 deleted file mode 100644 index d124bb725..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_01 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 -{"friction": [[0.00013154835182754853, -3.2245612347009654e-05, -3.218171211344349e-05], [-3.2245612347009654e-05, 0.00013178701661774967, -3.222276035226155e-05], [-3.218171211344349e-05, -3.222276035226155e-05, 0.00013130290733224788]]} - #*EXTRAS*# Step: 1 Bead: 1 -{"friction": [[0.00013404800539914356, -2.436037887371007e-05, -2.415899864701066e-05], [-2.436037887371007e-05, 0.00013425935339702558, -2.4251978728149912e-05], [-2.415899864701066e-05, -2.4251978728149912e-05, 0.00013415696335680426]]} - #*EXTRAS*# Step: 2 Bead: 1 -{"friction": [[0.00013591755732220224, -1.4234991320132281e-05, -1.371873807356159e-05], [-1.4234991320132281e-05, 0.00013600355259382716, -1.4097704601413974e-05], [-1.371873807356159e-05, -1.4097704601413974e-05, 0.0001364677476022238]]} - #*EXTRAS*# Step: 3 Bead: 1 -{"friction": [[0.00013524657105314206, -1.812481719770889e-05, -1.7691148695722927e-05], [-1.812481719770889e-05, 0.00013537977721473854, -1.7987225520532583e-05], [-1.7691148695722927e-05, -1.7987225520532583e-05, 0.00013564601497308176]]} - #*EXTRAS*# Step: 4 Bead: 1 -{"friction": [[0.0001355450056975202, -1.6396530953391097e-05, -1.591741415317564e-05], [-1.6396530953391097e-05, 0.00013565641809378282, -1.625731938638031e-05], [-1.591741415317564e-05, -1.625731938638031e-05, 0.0001360151427437123]]} - #*EXTRAS*# Step: 5 Bead: 1 -{"friction": [[0.0001355352813789965, -1.6453118447610952e-05, -1.5975283472627247e-05], [-1.6453118447610952e-05, 0.0001356473903732143, -1.6313915356692954e-05], [-1.5975283472627247e-05, -1.6313915356692954e-05, 0.00013600319345187937]]} - #*EXTRAS*# Step: 6 Bead: 1 -{"friction": [[0.0001355575350584718, -1.6323612614509698e-05, -1.5842865982210645e-05], [-1.6323612614509698e-05, 0.00013566805183654317, -1.618439456637294e-05], [-1.5842865982210645e-05, -1.618439456637294e-05, 0.00013603052986069702]]} - #*EXTRAS*# Step: 7 Bead: 1 -{"friction": [[0.0001355610358521006, -1.6303237443329304e-05, -1.582203982961405e-05], [-1.6303237443329304e-05, 0.00013567130278302, -1.6164018478018974e-05], [-1.582203982961405e-05, -1.6164018478018974e-05, 0.00013603482729681386]]} - #*EXTRAS*# Step: 8 Bead: 1 -{"friction": [[0.0001355641025040489, -1.628538867452416e-05, -1.580379759533389e-05], [-1.628538867452416e-05, 0.00013567415071609625, -1.614616922652582e-05], [-1.580379759533389e-05, -1.614616922652582e-05, 0.00013603859113422458]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_02 b/drivers/py/pes/friction/frictionH/080K/inst.raw_02 deleted file mode 100644 index 44e482970..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_02 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 -{"friction": [[0.0001305169912654799, -3.426881693488592e-05, -3.4119381770048507e-05], [-3.426881693488592e-05, 0.0001307291042872236, -3.427459924542595e-05], [-3.4119381770048507e-05, -3.427459924542595e-05, 0.00013021252399325722]]} - #*EXTRAS*# Step: 1 Bead: 2 -{"friction": [[0.0001333421958542713, -2.721058277411568e-05, -2.7110687558216453e-05], [-2.721058277411568e-05, 0.00013357972977769557, -2.7127363461520503e-05], [-2.7110687558216453e-05, -2.7127363461520503e-05, 0.00013331183750996584]]} - #*EXTRAS*# Step: 2 Bead: 2 -{"friction": [[0.00013531490655029104, -1.7731381075050537e-05, -1.7286276380385558e-05], [-1.7731381075050537e-05, 0.00013544307036614567, -1.7593172998998247e-05], [-1.7286276380385558e-05, -1.7593172998998247e-05, 0.0001357309253988662]]} - #*EXTRAS*# Step: 3 Bead: 2 -{"friction": [[0.0001347357222289454, -2.0969690891298787e-05, -2.0633871563717828e-05], [-2.0969690891298787e-05, 0.00013490587286603701, -2.084090341880157e-05], [-2.0633871563717828e-05, -2.084090341880157e-05, 0.00013500801100379162]]} - #*EXTRAS*# Step: 4 Bead: 2 -{"friction": [[0.00013504485961717802, -1.9271988745538337e-05, -1.887488096892055e-05], [-1.9271988745538337e-05, 0.00013519293339583072, -1.913702867957289e-05], [-1.887488096892055e-05, -1.913702867957289e-05, 0.00013539448378420538]]} - #*EXTRAS*# Step: 5 Bead: 2 -{"friction": [[0.00013503912983159528, -1.9304193527458456e-05, -1.890817541314613e-05], [-1.9304193527458456e-05, 0.0001351876231709267, -1.9169325269716634e-05], [-1.890817541314613e-05, -1.9169325269716634e-05, 0.0001353873250454647]]} - #*EXTRAS*# Step: 6 Bead: 2 -{"friction": [[0.00013506393885172595, -1.9164581595844938e-05, -1.876386305372332e-05], [-1.9164581595844938e-05, 0.00013521061382802799, -1.902932241492807e-05], [-1.876386305372332e-05, -1.902932241492807e-05, 0.00013541831724196514]]} - #*EXTRAS*# Step: 7 Bead: 2 -{"friction": [[0.00013506842913240275, -1.9139265931955758e-05, -1.8737701640547414e-05], [-1.9139265931955758e-05, 0.000135214774536433, -1.9003937836132406e-05], [-1.8737701640547414e-05, -1.9003937836132406e-05, 0.00013542392548549084]]} - #*EXTRAS*# Step: 8 Bead: 2 -{"friction": [[0.0001350719710107683, -1.911928733224865e-05, -1.8717057035135313e-05], [-1.911928733224865e-05, 0.00013521805635962274, -1.8983905277351872e-05], [-1.8717057035135313e-05, -1.8983905277351872e-05, 0.00013542834893299835]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_03 b/drivers/py/pes/friction/frictionH/080K/inst.raw_03 deleted file mode 100644 index 59ea064da..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_03 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 -{"friction": [[0.0001286764741586319, -3.714973769009648e-05, -3.679697296268993e-05], [-3.714973769009648e-05, 0.0001288266109833087, -3.7198122442431674e-05], [-3.679697296268993e-05, -3.7198122442431674e-05, 0.00012832661431276367]]} - #*EXTRAS*# Step: 1 Bead: 3 -{"friction": [[0.00013191977533222, -3.13970076878384e-05, -3.1349103889760666e-05], [-3.13970076878384e-05, 0.00013216432768522565, -3.136275911216881e-05], [-3.1349103889760666e-05, -3.136275911216881e-05, 0.00013170498747656282]]} - #*EXTRAS*# Step: 2 Bead: 3 -{"friction": [[0.00013433977145286933, -2.29948709154431e-05, -2.2738932745629637e-05], [-2.29948709154431e-05, 0.00013453534014958122, -2.2876981505907903e-05], [-2.2738932745629637e-05, -2.2876981505907903e-05, 0.00013451548097735057]]} - #*EXTRAS*# Step: 3 Bead: 3 -{"friction": [[0.00013384743571721785, -2.523414830719826e-05, -2.5066497021623274e-05], [-2.523414830719826e-05, 0.00013406797008689572, -2.5132707681851815e-05], [-2.5066497021623274e-05, -2.5132707681851815e-05, 0.0001339134312752118]]} - #*EXTRAS*# Step: 4 Bead: 3 -{"friction": [[0.0001342103213001641, -2.3614516675869967e-05, -2.3383471561309267e-05], [-2.3614516675869967e-05, 0.00013441323289915791, -2.350072184567294e-05], [-2.3383471561309267e-05, -2.350072184567294e-05, 0.00013435584182325486]]} - #*EXTRAS*# Step: 5 Bead: 3 -{"friction": [[0.00013421150627610878, -2.360894385672489e-05, -2.3377675400495666e-05], [-2.360894385672489e-05, 0.0001344143530812138, -2.349511062997733e-05], [-2.3377675400495666e-05, -2.349511062997733e-05, 0.0001343572991992221]]} - #*EXTRAS*# Step: 6 Bead: 3 -{"friction": [[0.0001342434454434474, -2.3458042730717532e-05, -2.3220720987423197e-05], [-2.3458042730717532e-05, 0.0001344445287256725, -2.3343180621906002e-05], [-2.3220720987423197e-05, -2.3343180621906002e-05, 0.00013439660884210155]]} - #*EXTRAS*# Step: 7 Bead: 3 -{"friction": [[0.00013425017478119327, -2.342607843833155e-05, -2.318747327526734e-05], [-2.342607843833155e-05, 0.00013445088231866728, -2.331100107022074e-05], [-2.318747327526734e-05, -2.331100107022074e-05, 0.00013440489797196685]]} - #*EXTRAS*# Step: 8 Bead: 3 -{"friction": [[0.00013425492671827313, -2.340347107654896e-05, -2.3163957982854646e-05], [-2.340347107654896e-05, 0.0001344553680509689, -2.3288242028624953e-05], [-2.3163957982854646e-05, -2.3288242028624953e-05, 0.00013441075278418816]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_04 b/drivers/py/pes/friction/frictionH/080K/inst.raw_04 deleted file mode 100644 index fb9e7325f..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_04 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 -{"friction": [[0.000126076844382827, -4.029075427069417e-05, -3.973794837135237e-05], [-4.029075427069417e-05, 0.000126150633634249, -4.038143906978131e-05], [-3.973794837135237e-05, -4.038143906978131e-05, 0.00012574927445048358]]} - #*EXTRAS*# Step: 1 Bead: 4 -{"friction": [[0.00012916032508804648, -3.6458225563158106e-05, -3.615935859269742e-05], [-3.6458225563158106e-05, 0.00012932726140209104, -3.649636992782728e-05], [-3.615935859269742e-05, -3.649636992782728e-05, 0.00012881671220173058]]} - #*EXTRAS*# Step: 2 Bead: 4 -{"friction": [[0.0001325510175585019, -2.9749316428185093e-05, -2.9702321549309065e-05], [-2.9749316428185093e-05, 0.00013279895321071728, -2.9694247485264653e-05], [-2.9702321549309065e-05, -2.9694247485264653e-05, 0.00013240364099129632]]} - #*EXTRAS*# Step: 3 Bead: 4 -{"friction": [[0.0001321817719200597, -3.074742930420066e-05, -3.0704152949807736e-05], [-3.074742930420066e-05, 0.00013242882098973667, -3.070475462516475e-05], [-3.0704152949807736e-05, -3.070475462516475e-05, 0.00013199246526964938]]} - #*EXTRAS*# Step: 4 Bead: 4 -{"friction": [[0.0001327107674198355, -2.9283941788712823e-05, -2.923137267902519e-05], [-2.9283941788712823e-05, 0.00013295803618974233, -2.9223338001015876e-05], [-2.923137267902519e-05, -2.9223338001015876e-05, 0.0001325838937358768]]} - #*EXTRAS*# Step: 5 Bead: 4 -{"friction": [[0.0001327290806396648, -2.9229193714563068e-05, -2.9175826149668666e-05], [-2.9229193714563068e-05, 0.00013297622972392048, -2.9167949398532285e-05], [-2.9175826149668666e-05, -2.9167949398532285e-05, 0.00013260465334777457]]} - #*EXTRAS*# Step: 6 Bead: 4 -{"friction": [[0.0001327813236003448, -2.9071377621087906e-05, -2.9015549204634447e-05], [-2.9071377621087906e-05, 0.00013302808105940012, -2.900829961724895e-05], [-2.9015549204634447e-05, -2.900829961724895e-05, 0.00013266398603481637]]} - #*EXTRAS*# Step: 7 Bead: 4 -{"friction": [[0.0001327940340261804, -2.9032611588393457e-05, -2.897614324060199e-05], [-2.9032611588393457e-05, 0.00013304068485569975, -2.8969086055272503e-05], [-2.897614324060199e-05, -2.8969086055272503e-05, 0.0001326784463475374]]} - #*EXTRAS*# Step: 8 Bead: 4 -{"friction": [[0.00013280214627510851, -2.900779318337574e-05, -2.895090793637561e-05], [-2.900779318337574e-05, 0.00013304872670841133, -2.894398174060807e-05], [-2.895090793637561e-05, -2.894398174060807e-05, 0.0001326876805833189]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_05 b/drivers/py/pes/friction/frictionH/080K/inst.raw_05 deleted file mode 100644 index 56746df16..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_05 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 -{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} - #*EXTRAS*# Step: 1 Bead: 5 -{"friction": [[0.00012524174352568902, -4.112217748095818e-05, -4.057345154621127e-05], [-4.112217748095818e-05, 0.00012530328643784738, -4.122062361627243e-05], [-4.057345154621127e-05, -4.122062361627243e-05, 0.0001249413281591193]]} - #*EXTRAS*# Step: 2 Bead: 5 -{"friction": [[0.00012869361339990943, -3.712591209730373e-05, -3.6775021785806604e-05], [-3.712591209730373e-05, 0.0001288443427447816, -3.717394569400575e-05], [-3.6775021785806604e-05, -3.717394569400575e-05, 0.00012834391438783729]]} - #*EXTRAS*# Step: 3 Bead: 5 -{"friction": [[0.00012880940349611984, -3.696369827082483e-05, -3.662555173834946e-05], [-3.696369827082483e-05, 0.00012896414364333724, -3.70093371328214e-05], [-3.662555173834946e-05, -3.70093371328214e-05, 0.00012846090510532763]]} - #*EXTRAS*# Step: 4 Bead: 5 -{"friction": [[0.000129598168644794, -3.579587980885944e-05, -3.5546594890148564e-05], [-3.579587980885944e-05, 0.0001297802328293621, -3.5824175283994236e-05], [-3.5546594890148564e-05, -3.5824175283994236e-05, 0.0001292634388336609]]} - #*EXTRAS*# Step: 5 Bead: 5 -{"friction": [[0.0001296648498303819, -3.569165958659948e-05, -3.5449902784487e-05], [-3.569165958659948e-05, 0.00012984919207512823, -3.5718406362556186e-05], [-3.5449902784487e-05, -3.5718406362556186e-05, 0.00012933176199810443]]} - #*EXTRAS*# Step: 6 Bead: 5 -{"friction": [[0.00012975945919063456, -3.5542172287482884e-05, -3.5311059497915575e-05], [-3.5542172287482884e-05, 0.00012994701604101812, -3.5566699393191735e-05], [-3.5311059497915575e-05, -3.5566699393191735e-05, 0.00012942883887239875]]} - #*EXTRAS*# Step: 7 Bead: 5 -{"friction": [[0.00012978590640224725, -3.550003819371587e-05, -3.527189120738363e-05], [-3.550003819371587e-05, 0.00012997435777114185, -3.5523940106106974e-05], [-3.527189120738363e-05, -3.5523940106106974e-05, 0.0001294560052654466]]} - #*EXTRAS*# Step: 8 Bead: 5 -{"friction": [[0.0001298013813935833, -3.547531313262659e-05, -3.5248899288938976e-05], [-3.547531313262659e-05, 0.00012999035527845652, -3.549884827080739e-05], [-3.5248899288938976e-05, -3.549884827080739e-05, 0.00012947190710448135]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_06 b/drivers/py/pes/friction/frictionH/080K/inst.raw_06 deleted file mode 100644 index 68bfaeeae..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_06 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 -{"friction": [[0.00012028748904337296, -4.4090190695074945e-05, -4.407165498061319e-05], [-4.4090190695074945e-05, 0.00012019515217934021, -4.396133059277882e-05], [-4.407165498061319e-05, -4.396133059277882e-05, 0.00012024878352738596]]} - #*EXTRAS*# Step: 1 Bead: 6 -{"friction": [[0.00012145407206483506, -4.36594650306861e-05, -4.3632636413704307e-05], [-4.36594650306861e-05, 0.00012147494648405821, -4.36515025590799e-05], [-4.3632636413704307e-05, -4.36515025590799e-05, 0.00012137143681311038]]} - #*EXTRAS*# Step: 2 Bead: 6 -{"friction": [[0.0001235448745571419, -4.2524887299287357e-05, -4.2174609255368744e-05], [-4.2524887299287357e-05, 0.00012361235660101615, -4.26198549194068e-05], [-4.2174609255368744e-05, -4.26198549194068e-05, 0.00012333442605315625]]} - #*EXTRAS*# Step: 3 Bead: 6 -{"friction": [[0.00012421148542347664, -4.2024759833114514e-05, -4.1568199107195194e-05], [-4.2024759833114514e-05, 0.0001242735613923723, -4.21260067308781e-05], [-4.1568199107195194e-05, -4.21260067308781e-05, 0.00012396068828996064]]} - #*EXTRAS*# Step: 4 Bead: 6 -{"friction": [[0.0001248686064523669, -4.1465830720107914e-05, -4.0938297559525664e-05], [-4.1465830720107914e-05, 0.00012492829878418794, -4.156642492842184e-05], [-4.0938297559525664e-05, -4.156642492842184e-05, 0.0001245840371275614]]} - #*EXTRAS*# Step: 5 Bead: 6 -{"friction": [[0.00012497632652204392, -4.136846768549615e-05, -4.083334364254299e-05], [-4.136846768549615e-05, 0.00012503627748784233, -4.146854001333588e-05], [-4.083334364254299e-05, -4.146854001333588e-05, 0.00012468692478294943]]} - #*EXTRAS*# Step: 6 Bead: 6 -{"friction": [[0.00012507489479930057, -4.127805107825864e-05, -4.0737051840557874e-05], [-4.127805107825864e-05, 0.00012513528198639266, -4.137757347499097e-05], [-4.0737051840557874e-05, -4.137757347499097e-05, 0.00012478125670705895]]} - #*EXTRAS*# Step: 7 Bead: 6 -{"friction": [[0.0001251064567061992, -4.1248835732025334e-05, -4.070616621868756e-05], [-4.1248835732025334e-05, 0.00012516702329372418, -4.134816828432282e-05], [-4.070616621868756e-05, -4.134816828432282e-05, 0.00012481149913710996]]} - #*EXTRAS*# Step: 8 Bead: 6 -{"friction": [[0.0001251235824522183, -4.1232930136881925e-05, -4.0689395966985576e-05], [-4.1232930136881925e-05, 0.00012518425421827227, -4.133215694720476e-05], [-4.0689395966985576e-05, -4.133215694720476e-05, 0.00012482791632483918]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_07 b/drivers/py/pes/friction/frictionH/080K/inst.raw_07 deleted file mode 100644 index 481841bcb..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_07 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 -{"friction": [[0.00011665083949596382, -4.4607528816683966e-05, -4.431825914901668e-05], [-4.4607528816683966e-05, 0.0001162267076263409, -4.4207173972077276e-05], [-4.431825914901668e-05, -4.4207173972077276e-05, 0.00011666327977368902]]} - #*EXTRAS*# Step: 1 Bead: 7 -{"friction": [[0.00011690567754713395, -4.462486812304193e-05, -4.4341095634371984e-05], [-4.462486812304193e-05, 0.0001164850838147236, -4.422278371703446e-05], [-4.4341095634371984e-05, -4.422278371703446e-05, 0.00011691588812359782]]} - #*EXTRAS*# Step: 2 Bead: 7 -{"friction": [[0.00011832949096438044, -4.45529575046454e-05, -4.436843069541386e-05], [-4.45529575046454e-05, 0.00011800532179359694, -4.4217590435120216e-05], [-4.436843069541386e-05, -4.4217590435120216e-05, 0.00011832635331643656]]} - #*EXTRAS*# Step: 3 Bead: 7 -{"friction": [[0.0001196784855374387, -4.427195657573872e-05, -4.421352131142412e-05], [-4.427195657573872e-05, 0.0001195120146170067, -4.407322522886284e-05], [-4.421352131142412e-05, -4.407322522886284e-05, 0.0001196545377292183]]} - #*EXTRAS*# Step: 4 Bead: 7 -{"friction": [[0.0001202933229784124, -4.408830014675597e-05, -4.407004140621317e-05], [-4.408830014675597e-05, 0.00012020167125612617, -4.396010658379329e-05], [-4.407004140621317e-05, -4.396010658379329e-05, 0.00012025445391588654]]} - #*EXTRAS*# Step: 5 Bead: 7 -{"friction": [[0.00012045040626937716, -4.403636580288439e-05, -4.4024636311831246e-05], [-4.403636580288439e-05, 0.00012037691640357787, -4.392601393703019e-05], [-4.4024636311831246e-05, -4.392601393703019e-05, 0.00012040695455346231]]} - #*EXTRAS*# Step: 6 Bead: 7 -{"friction": [[0.00012055080215192555, -4.400214417375305e-05, -4.3993583037086455e-05], [-4.400214417375305e-05, 0.00012048859101988257, -4.390305739800719e-05], [-4.3993583037086455e-05, -4.390305739800719e-05, 0.0001205042327488948]]} - #*EXTRAS*# Step: 7 Bead: 7 -{"friction": [[0.00012058673645645107, -4.398970261248895e-05, -4.398207052982151e-05], [-4.398970261248895e-05, 0.00012052849124395085, -4.389461491524374e-05], [-4.398207052982151e-05, -4.389461491524374e-05, 0.0001205390136251474]]} - #*EXTRAS*# Step: 8 Bead: 7 -{"friction": [[0.00012060477353813617, -4.398341954849152e-05, -4.397621148730388e-05], [-4.398341954849152e-05, 0.00012054850395012206, -4.3890331880578624e-05], [-4.397621148730388e-05, -4.3890331880578624e-05, 0.00012055646410073887]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_08 b/drivers/py/pes/friction/frictionH/080K/inst.raw_08 deleted file mode 100644 index 9c5433d48..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_08 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 -{"friction": [[0.00011321589094004546, -4.351814646398022e-05, -4.345964836559014e-05], [-4.351814646398022e-05, 0.00011306154132995574, -4.343115956369095e-05], [-4.345964836559014e-05, -4.343115956369095e-05, 0.00011326318332248197]]} - #*EXTRAS*# Step: 1 Bead: 8 -{"friction": [[0.00011254918292050029, -4.316243939422925e-05, -4.316520295598142e-05], [-4.316243939422925e-05, 0.00011246549909959065, -4.3144161407362884e-05], [-4.316520295598142e-05, -4.3144161407362884e-05, 0.00011260444690783562]]} - #*EXTRAS*# Step: 2 Bead: 8 -{"friction": [[0.00011280634231605482, -4.330348128256488e-05, -4.328397752837003e-05], [-4.330348128256488e-05, 0.00011269673018217933, -4.326060576583219e-05], [-4.328397752837003e-05, -4.326060576583219e-05, 0.00011285847888635022]]} - #*EXTRAS*# Step: 3 Bead: 8 -{"friction": [[0.00011443782095465676, -4.406815682033918e-05, -4.388776453379777e-05], [-4.406815682033918e-05, 0.00011414545785474514, -4.383585835559629e-05], [-4.388776453379777e-05, -4.383585835559629e-05, 0.00011447159801876669]]} - #*EXTRAS*# Step: 4 Bead: 8 -{"friction": [[0.00011490889838863745, -4.423698197134576e-05, -4.4015578219284754e-05], [-4.423698197134576e-05, 0.0001145698671843195, -4.395225526526253e-05], [-4.4015578219284754e-05, -4.395225526526253e-05, 0.00011493781465384376]]} - #*EXTRAS*# Step: 5 Bead: 8 -{"friction": [[0.00011510610153504759, -4.4299595045300337e-05, -4.40631157529807e-05], [-4.4299595045300337e-05, 0.00011474973901092989, -4.399473815620762e-05], [-4.40631157529807e-05, -4.399473815620762e-05, 0.0001151330370449228]]} - #*EXTRAS*# Step: 6 Bead: 8 -{"friction": [[0.0001152021349035972, -4.4328292995944204e-05, -4.408500665338837e-05], [-4.4328292995944204e-05, 0.0001148378923560084, -4.401411830990458e-05], [-4.408500665338837e-05, -4.401411830990458e-05, 0.00011522811707731956]]} - #*EXTRAS*# Step: 7 Bead: 8 -{"friction": [[0.00011524128732347879, -4.433965049905932e-05, -4.409369625519902e-05], [-4.433965049905932e-05, 0.0001148739443500732, -4.4021775792487194e-05], [-4.409369625519902e-05, -4.4021775792487194e-05, 0.00011526688291454595]]} - #*EXTRAS*# Step: 8 Bead: 8 -{"friction": [[0.00011525960476942507, -4.434489548063291e-05, -4.409771502253044e-05], [-4.434489548063291e-05, 0.0001148908342153642, -4.4025310061854805e-05], [-4.409771502253044e-05, -4.4025310061854805e-05, 0.00011528501991106724]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_09 b/drivers/py/pes/friction/frictionH/080K/inst.raw_09 deleted file mode 100644 index c4fd5514c..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_09 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 -{"friction": [[0.00011023000206976872, -4.1719099977050135e-05, -4.179519325177442e-05], [-4.1719099977050135e-05, 0.00011025478793267088, -4.1768623177242506e-05], [-4.179519325177442e-05, -4.1768623177242506e-05, 0.00011030747133180427]]} - #*EXTRAS*# Step: 1 Bead: 9 -{"friction": [[0.0001088530991364734, -4.069880420453629e-05, -4.073760919444428e-05], [-4.069880420453629e-05, 0.00010886695037594943, -4.071412661461412e-05], [-4.073760919444428e-05, -4.071412661461412e-05, 0.00010891343847498907]]} - #*EXTRAS*# Step: 2 Bead: 9 -{"friction": [[0.00010820791967953468, -4.0171509275046815e-05, -4.018531301274981e-05], [-4.0171509275046815e-05, 0.00010821179247971602, -4.0175042536591634e-05], [-4.018531301274981e-05, -4.0175042536591634e-05, 0.000108244120728227]]} - #*EXTRAS*# Step: 3 Bead: 9 -{"friction": [[0.00010993960158630413, -4.1515138528648044e-05, -4.158657967591049e-05], [-4.1515138528648044e-05, 0.00010996477356742037, -4.1558847507488136e-05], [-4.158657967591049e-05, -4.1558847507488136e-05, 0.00011001651748715463]]} - #*EXTRAS*# Step: 4 Bead: 9 -{"friction": [[0.000110230941139765, -4.171975028584762e-05, -4.1795854912505604e-05], [-4.171975028584762e-05, 0.00011025572242726744, -4.1769289478255534e-05], [-4.1795854912505604e-05, -4.1769289478255534e-05, 0.00011030841010447916]]} - #*EXTRAS*# Step: 5 Bead: 9 -{"friction": [[0.00011043290881662265, -4.185825633626275e-05, -4.1936203434194356e-05], [-4.185825633626275e-05, 0.00011045615719484379, -4.191073238593357e-05], [-4.1936203434194356e-05, -4.191073238593357e-05, 0.0001105100309062005]]} - #*EXTRAS*# Step: 6 Bead: 9 -{"friction": [[0.00011050903392794061, -4.1909768612844365e-05, -4.198808757022613e-05], [-4.1909768612844365e-05, 0.00011053140652433243, -4.196306849984698e-05], [-4.198808757022613e-05, -4.196306849984698e-05, 0.00011058588768548832]]} - #*EXTRAS*# Step: 7 Bead: 9 -{"friction": [[0.00011054450019550659, -4.1933640026952586e-05, -4.201206919069996e-05], [-4.1933640026952586e-05, 0.00011056640605521217, -4.198726592806423e-05], [-4.201206919069996e-05, -4.198726592806423e-05, 0.00011062120500468696]]} - #*EXTRAS*# Step: 8 Bead: 9 -{"friction": [[0.00011055989721789381, -4.1943978192678186e-05, -4.202244251025011e-05], [-4.1943978192678186e-05, 0.00011058158859663468, -4.199773380156925e-05], [-4.202244251025011e-05, -4.199773380156925e-05, 0.0001106365327702565]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_10 b/drivers/py/pes/friction/frictionH/080K/inst.raw_10 deleted file mode 100644 index 4778a501f..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_10 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 -{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} - #*EXTRAS*# Step: 1 Bead: 10 -{"friction": [[0.0001057721423295425, -3.78545515320464e-05, -3.7796997696729915e-05], [-3.78545515320464e-05, 0.00010576991461882027, -3.79261815546144e-05], [-3.7796997696729915e-05, -3.79261815546144e-05, 0.00010560881423484789]]} - #*EXTRAS*# Step: 2 Bead: 10 -{"friction": [[0.00010449000500139373, -3.637523863065668e-05, -3.630630183780285e-05], [-3.637523863065668e-05, 0.00010448927880300736, -3.6519355057688e-05], [-3.630630183780285e-05, -3.6519355057688e-05, 0.00010419237666424612]]} - #*EXTRAS*# Step: 3 Bead: 10 -{"friction": [[0.00010621385722659852, -3.831740356874446e-05, -3.826857923142562e-05], [-3.831740356874446e-05, 0.00010621004126137114, -3.836621588831704e-05], [-3.826857923142562e-05, -3.836621588831704e-05, 0.00010609571529716862]]} - #*EXTRAS*# Step: 4 Bead: 10 -{"friction": [[0.00010635891569301347, -3.846486442209238e-05, -3.841936481057238e-05], [-3.846486442209238e-05, 0.00010635466720509825, -3.8506838671620094e-05], [-3.841936481057238e-05, -3.8506838671620094e-05, 0.00010625508805064093]]} - #*EXTRAS*# Step: 5 Bead: 10 -{"friction": [[0.00010656184168632478, -3.8667565200767354e-05, -3.8627075492118905e-05], [-3.8667565200767354e-05, 0.00010655712630285816, -3.870064797296415e-05], [-3.8627075492118905e-05, -3.870064797296415e-05, 0.00010647747652884425]]} - #*EXTRAS*# Step: 6 Bead: 10 -{"friction": [[0.00010662167027733569, -3.872654749032652e-05, -3.868761255457008e-05], [-3.872654749032652e-05, 0.00010661685513516313, -3.875717362387767e-05], [-3.868761255457008e-05, -3.875717362387767e-05, 0.00010654290390950731]]} - #*EXTRAS*# Step: 7 Bead: 10 -{"friction": [[0.0001066541268558249, -3.875839874917558e-05, -3.87203217864592e-05], [-3.875839874917558e-05, 0.00010664926578572724, -3.8787725586677235e-05], [-3.87203217864592e-05, -3.8787725586677235e-05, 0.0001065783693082501]]} - #*EXTRAS*# Step: 8 Bead: 10 -{"friction": [[0.00010666715605311408, -3.877115618343743e-05, -3.873342649438059e-05], [-3.877115618343743e-05, 0.00010666227823436151, -3.8799968190310435e-05], [-3.873342649438059e-05, -3.8799968190310435e-05, 0.00010659260057903704]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_11 b/drivers/py/pes/friction/frictionH/080K/inst.raw_11 deleted file mode 100644 index 7120da2f3..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_11 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 -{"friction": [[0.00010562036954718544, -3.769046910141249e-05, -3.763042875179934e-05], [-3.769046910141249e-05, 0.00010561870141779494, -3.7770470863789636e-05], [-3.763042875179934e-05, -3.7770470863789636e-05, 0.0001054411173289977]]} - #*EXTRAS*# Step: 1 Bead: 11 -{"friction": [[0.00010348761360071319, -3.503542064480136e-05, -3.497684435890506e-05], [-3.503542064480136e-05, 0.0001034740250603811, -3.522188858887473e-05], [-3.497684435890506e-05, -3.522188858887473e-05, 0.00010310216196176272]]} - #*EXTRAS*# Step: 2 Bead: 11 -{"friction": [[0.00010202927103065378, -3.265415452690861e-05, -3.2650615638337266e-05], [-3.265415452690861e-05, 0.00010195011871326056, -3.2816616869330545e-05], [-3.2650615638337266e-05, -3.2816616869330545e-05, 0.00010161603651286742]]} - #*EXTRAS*# Step: 3 Bead: 11 -{"friction": [[0.00010343713004017408, -3.49623672535585e-05, -3.490490753004566e-05], [-3.49623672535585e-05, 0.00010342226463747947, -3.515006529103178e-05], [-3.490490753004566e-05, -3.515006529103178e-05, 0.00010304821743298625]]} - #*EXTRAS*# Step: 4 Bead: 11 -{"friction": [[0.00010345956656237301, -3.499491078171204e-05, -3.4936946642200153e-05], [-3.499491078171204e-05, 0.00010344527831379907, -3.5182076953966355e-05], [-3.4936946642200153e-05, -3.5182076953966355e-05, 0.00010307217663010795]]} - #*EXTRAS*# Step: 5 Bead: 11 -{"friction": [[0.00010363068095214582, -3.523918246007258e-05, -3.517779206125835e-05], [-3.523918246007258e-05, 0.0001036203041081349, -3.542154689443435e-05], [-3.517779206125835e-05, -3.542154689443435e-05, 0.00010325568445369107]]} - #*EXTRAS*# Step: 6 Bead: 11 -{"friction": [[0.00010367010120253335, -3.5294507275976526e-05, -3.523242914364329e-05], [-3.5294507275976526e-05, 0.00010366051001621782, -3.547559251172429e-05], [-3.523242914364329e-05, -3.547559251172429e-05, 0.00010329814176424597]]} - #*EXTRAS*# Step: 7 Bead: 11 -{"friction": [[0.00010369565617608655, -3.533018948496009e-05, -3.526768510217769e-05], [-3.533018948496009e-05, 0.0001036865526496562, -3.551041350279949e-05], [-3.526768510217769e-05, -3.551041350279949e-05, 0.00010332569933593052]]} - #*EXTRAS*# Step: 8 Bead: 11 -{"friction": [[0.00010370511258939588, -3.5343357263702424e-05, -3.528069901176963e-05], [-3.5343357263702424e-05, 0.00010369618528505914, -3.5523256383589847e-05], [-3.528069901176963e-05, -3.5523256383589847e-05, 0.00010333590336834901]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_12 b/drivers/py/pes/friction/frictionH/080K/inst.raw_12 deleted file mode 100644 index 6a3348f9e..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_12 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 -{"friction": [[0.00010410059478635681, -3.587758594138993e-05, -3.5810247906280144e-05], [-3.587758594138993e-05, 0.00010409721165943899, -3.604130532787345e-05], [-3.5810247906280144e-05, -3.604130532787345e-05, 0.00010376542350754372]]} - #*EXTRAS*# Step: 1 Bead: 12 -{"friction": [[0.00010201247487144806, -3.262354319305223e-05, -3.262077151375494e-05], [-3.262354319305223e-05, 0.00010193238868493448, -3.278497164745526e-05], [-3.262077151375494e-05, -3.278497164745526e-05, 0.00010160004958930738]]} - #*EXTRAS*# Step: 2 Bead: 12 -{"friction": [[0.00010042570025337742, -2.9535442820139492e-05, -2.956607705434336e-05], [-2.9535442820139492e-05, 0.00010030308189167838, -2.953489779035083e-05], [-2.956607705434336e-05, -2.953489779035083e-05, 0.00010025536563768875]]} - #*EXTRAS*# Step: 3 Bead: 12 -{"friction": [[0.000101691014836043, -3.202579122971117e-05, -3.2037127193822185e-05], [-3.202579122971117e-05, 0.00010159367507116184, -3.2164204440557716e-05], [-3.2037127193822185e-05, -3.2164204440557716e-05, 0.00010130047289456198]]} - #*EXTRAS*# Step: 4 Bead: 12 -{"friction": [[0.00010164452370351483, -3.193760339307928e-05, -3.195083895108882e-05], [-3.193760339307928e-05, 0.0001015448470299712, -3.207219493936574e-05], [-3.195083895108882e-05, -3.207219493936574e-05, 0.00010125819670674425]]} - #*EXTRAS*# Step: 5 Bead: 12 -{"friction": [[0.00010178384513937206, -3.2200627649962355e-05, -3.220804123004875e-05], [-3.2200627649962355e-05, 0.00010169131928070299, -3.234630629993251e-05], [-3.220804123004875e-05, -3.234630629993251e-05, 0.00010138570003551383]]} - #*EXTRAS*# Step: 6 Bead: 12 -{"friction": [[0.00010180831046105114, -3.224641749606478e-05, -3.22527723417854e-05], [-3.224641749606478e-05, 0.00010171708155735564, -3.2393928587599995e-05], [-3.22527723417854e-05, -3.2393928587599995e-05, 0.00010140833900254269]]} - #*EXTRAS*# Step: 7 Bead: 12 -{"friction": [[0.00010182762546836929, -3.228248052859509e-05, -3.228799305560916e-05], [-3.228248052859509e-05, 0.0001017374277213326, -3.243141374556784e-05], [-3.228799305560916e-05, -3.243141374556784e-05, 0.00010142626367664276]]} - #*EXTRAS*# Step: 8 Bead: 12 -{"friction": [[0.00010183418991213734, -3.229471926624222e-05, -3.2299944288260775e-05], [-3.229471926624222e-05, 0.00010174434398874803, -3.244413085578851e-05], [-3.2299944288260775e-05, -3.244413085578851e-05, 0.00010143236589790384]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_13 b/drivers/py/pes/friction/frictionH/080K/inst.raw_13 deleted file mode 100644 index 1de8884d0..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_13 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 -{"friction": [[0.00010310461147450481, -3.446489117457354e-05, -3.44165270104119e-05], [-3.446489117457354e-05, 0.00010307920642357731, -3.4657347226921115e-05], [-3.44165270104119e-05, -3.4657347226921115e-05, 0.00010269639584043074]]} - #*EXTRAS*# Step: 1 Bead: 13 -{"friction": [[0.00010105610748830827, -3.079237532374079e-05, -3.082369145202307e-05], [-3.079237532374079e-05, 0.00010093383027621988, -3.086900404080006e-05], [-3.082369145202307e-05, -3.086900404080006e-05, 0.00010074802376076155]]} - #*EXTRAS*# Step: 2 Bead: 13 -{"friction": [[9.922798230259201e-05, -2.720111575444535e-05, -2.7146143543515786e-05], [-2.720111575444535e-05, 9.920665371975914e-05, -2.704059602174001e-05], [-2.7146143543515786e-05, -2.704059602174001e-05, 9.945970885460705e-05]]} - #*EXTRAS*# Step: 3 Bead: 13 -{"friction": [[0.00010054212097041622, -2.976773135891528e-05, -2.980053894288423e-05], [-2.976773135891528e-05, 0.0001004171108862999, -2.978224314231892e-05], [-2.980053894288423e-05, -2.978224314231892e-05, 0.00010034211556951886]]} - #*EXTRAS*# Step: 4 Bead: 13 -{"friction": [[0.00010044925646621702, -2.9582405397081683e-05, -2.9613562444920224e-05], [-2.9582405397081683e-05, 0.00010032605431458083, -2.958492824937375e-05], [-2.9613562444920224e-05, -2.958492824937375e-05, 0.00010027276628737106]]} - #*EXTRAS*# Step: 5 Bead: 13 -{"friction": [[0.00010058425768568506, -2.985189137298372e-05, -2.9885236909808787e-05], [-2.985189137298372e-05, 0.00010045868071659685, -2.9871782038939736e-05], [-2.9885236909808787e-05, -2.9871782038939736e-05, 0.00010037398048117427]]} - #*EXTRAS*# Step: 6 Bead: 13 -{"friction": [[0.00010060233839611672, -2.988801195002687e-05, -2.9921548912667568e-05], [-2.988801195002687e-05, 0.00010047656549181346, -2.9910197969582903e-05], [-2.9921548912667568e-05, -2.9910197969582903e-05, 0.00010038773022463971]]} - #*EXTRAS*# Step: 7 Bead: 13 -{"friction": [[0.00010061991249763063, -2.992312334073741e-05, -2.9956823981258088e-05], [-2.992312334073741e-05, 0.00010049397601341848, -2.9947532788298766e-05], [-2.9956823981258088e-05, -2.9947532788298766e-05, 0.00010040113891931563]]} - #*EXTRAS*# Step: 8 Bead: 13 -{"friction": [[0.00010062542722465122, -2.993414165546153e-05, -2.996788914158192e-05], [-2.993414165546153e-05, 0.00010049944482865864, -2.995924723261611e-05], [-2.996788914158192e-05, -2.995924723261611e-05, 0.00010040535554239079]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_14 b/drivers/py/pes/friction/frictionH/080K/inst.raw_14 deleted file mode 100644 index c5c4e74f8..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_14 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 -{"friction": [[0.0001025334360101724, -3.35409127376559e-05, -3.351447758652769e-05], [-3.35409127376559e-05, 0.00010248196407672836, -3.372632209749448e-05], [-3.351447758652769e-05, -3.372632209749448e-05, 0.00010210975134216749]]} - #*EXTRAS*# Step: 1 Bead: 14 -{"friction": [[0.00010045753428263073, -2.9598913664620585e-05, -2.9630244306177948e-05], [-2.9598913664620585e-05, 0.00010033413916083015, -2.9602512159249237e-05], [-2.9630244306177948e-05, -2.9602512159249237e-05, 0.00010027889924373719]]} - #*EXTRAS*# Step: 2 Bead: 14 -{"friction": [[9.846641718517142e-05, -2.5645723860343796e-05, -2.549205806325441e-05], [-2.5645723860343796e-05, 9.856660411301771e-05, -2.5389137557014936e-05], [-2.549205806325441e-05, -2.5389137557014936e-05, 9.900889378179689e-05]]} - #*EXTRAS*# Step: 3 Bead: 14 -{"friction": [[9.977974733760773e-05, -2.8264965534873702e-05, -2.826341144315718e-05], [-2.8264965534873702e-05, 9.969465488029932e-05, -2.8178048740786784e-05], [-2.826341144315718e-05, -2.8178048740786784e-05, 9.980683477679885e-05]]} - #*EXTRAS*# Step: 4 Bead: 14 -{"friction": [[9.965002135450125e-05, -2.8014937904855224e-05, -2.800267432049681e-05], [-2.8014937904855224e-05, 9.957760768039353e-05, -2.791057338107884e-05], [-2.800267432049681e-05, -2.791057338107884e-05, 9.972283055715417e-05]]} - #*EXTRAS*# Step: 5 Bead: 14 -{"friction": [[9.979042505329167e-05, -2.8285599580978485e-05, -2.828486814641975e-05], [-2.8285599580978485e-05, 9.970436104539265e-05, -2.8200121046125185e-05], [-2.828486814641975e-05, -2.8200121046125185e-05, 9.981382786283588e-05]]} - #*EXTRAS*# Step: 6 Bead: 14 -{"friction": [[9.980538000673983e-05, -2.8314517219414108e-05, -2.8314922260621385e-05], [-2.8314517219414108e-05, 9.971797441681535e-05, -2.8231053498155316e-05], [-2.8314922260621385e-05, -2.8231053498155316e-05, 9.982364340630994e-05]]} - #*EXTRAS*# Step: 7 Bead: 14 -{"friction": [[9.982294649514996e-05, -2.834851338211944e-05, -2.8350229639486725e-05], [-2.834851338211944e-05, 9.973399390365758e-05, -2.8267416891423644e-05], [-2.8350229639486725e-05, -2.8267416891423644e-05, 9.983520505494521e-05]]} - #*EXTRAS*# Step: 8 Bead: 14 -{"friction": [[9.982812292399858e-05, -2.83585374899337e-05, -2.836063519030475e-05], [-2.83585374899337e-05, 9.973872047265023e-05, -2.8278138675487352e-05], [-2.836063519030475e-05, -2.8278138675487352e-05, 9.98386186881815e-05]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst.raw_15 b/drivers/py/pes/friction/frictionH/080K/inst.raw_15 deleted file mode 100644 index c7e88a8da..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst.raw_15 +++ /dev/null @@ -1,18 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 -{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} - #*EXTRAS*# Step: 1 Bead: 15 -{"friction": [[0.00010018186664153547, -2.905119740158293e-05, -2.907382683122514e-05], [-2.905119740158293e-05, 0.00010006841254719833, -2.9018404051194462e-05], [-2.907382683122514e-05, -2.9018404051194462e-05, 0.0001000796950585405]]} - #*EXTRAS*# Step: 2 Bead: 15 -{"friction": [[9.812930691293408e-05, -2.486433241599585e-05, -2.4661652939648045e-05], [-2.486433241599585e-05, 9.829241905848725e-05, -2.456951566119453e-05], [-2.4661652939648045e-05, -2.456951566119453e-05, 9.881193456873603e-05]]} - #*EXTRAS*# Step: 3 Bead: 15 -{"friction": [[9.939177943105922e-05, -2.7518132635428465e-05, -2.7481021140446154e-05], [-2.7518132635428465e-05, 9.93489880132999e-05, -2.7379261898305943e-05], [-2.7481021140446154e-05, -2.7379261898305943e-05, 9.956021835651802e-05]]} - #*EXTRAS*# Step: 4 Bead: 15 -{"friction": [[9.924531406422703e-05, -2.723479875154812e-05, -2.7181785583972395e-05], [-2.723479875154812e-05, 9.922162436164377e-05, -2.707655874342292e-05], [-2.7181785583972395e-05, -2.707655874342292e-05, 9.94702608589478e-05]]} - #*EXTRAS*# Step: 5 Bead: 15 -{"friction": [[9.938585266052157e-05, -2.750670403379218e-05, -2.7468972728109366e-05], [-2.750670403379218e-05, 9.934380367568316e-05, -2.73670462020629e-05], [-2.7468972728109366e-05, -2.73670462020629e-05, 9.955654925448419e-05]]} - #*EXTRAS*# Step: 6 Bead: 15 -{"friction": [[9.939896994049158e-05, -2.753199493294469e-05, -2.7495632619649693e-05], [-2.753199493294469e-05, 9.935528135180367e-05, -2.7394079461541272e-05], [-2.7495632619649693e-05, -2.7394079461541272e-05, 9.956467326920548e-05]]} - #*EXTRAS*# Step: 7 Bead: 15 -{"friction": [[9.94163355937843e-05, -2.7565459999022713e-05, -2.7530894310112865e-05], [-2.7565459999022713e-05, 9.937049649995253e-05, -2.74298530901322e-05], [-2.7530894310112865e-05, -2.74298530901322e-05, 9.957544807321247e-05]]} - #*EXTRAS*# Step: 8 Bead: 15 -{"friction": [[9.942128111579153e-05, -2.757498715948014e-05, -2.754092981262477e-05], [-2.757498715948014e-05, 9.937483381181673e-05, -2.7440038086575633e-05], [-2.754092981262477e-05, -2.7440038086575633e-05, 9.957852074394017e-05]]} diff --git a/drivers/py/pes/friction/frictionH/080K/inst1D.dat b/drivers/py/pes/friction/frictionH/080K/inst1D.dat deleted file mode 100644 index bed37db94..000000000 --- a/drivers/py/pes/friction/frictionH/080K/inst1D.dat +++ /dev/null @@ -1,16 +0,0 @@ -1.9866850273986039 0.050919370072655595 -1.9994378884395796 0.05290320294685336 -2.0262721287516 0.05754808218924119 -2.0697017458568143 0.06621437972546856 -2.132971532488317 0.08065941548510698 -2.2189211317131208 0.10174199948043824 -2.3276737541836696 0.12584532755081587 -2.454370168604051 0.14273224115687608 -2.589552996042531 0.1451657473533179 -2.721609676386341 0.1340864802905247 -2.8405657820583787 0.11550856746259959 -2.940361149221517 0.09443177425200715 -3.0189905842206826 0.07671030737855557 -3.0766053861354705 0.06402971605434313 -3.114167429500616 0.05615693406720792 -3.1326587164143738 0.05244064585222887 diff --git a/drivers/py/pes/friction/frictionH/080K/z_friction.dat b/drivers/py/pes/friction/frictionH/080K/z_friction.dat deleted file mode 100644 index 88b85ef6d..000000000 --- a/drivers/py/pes/friction/frictionH/080K/z_friction.dat +++ /dev/null @@ -1,1003 +0,0 @@ -#eta 1 -# bath_type Ohmic -# w_c 500 - # freq (cm^-1) Laplace transform -1 0.9915470158218098 -2 0.9848551497951816 -3 0.9788255643617454 -4 0.9732247078293326 -5 0.9679416696883935 -6 0.962911133018018 -7 0.9580899447435153 -8 0.9534474391977994 -9 0.9489606918318892 -10 0.9446119121776004 -11 0.9403868910489187 -12 0.9362740173481964 -13 0.9322636249598021 -14 0.928347541807527 -15 0.9245187684107862 -16 0.9207712425362906 -17 0.9170996629124359 -18 0.9134993545627568 -19 0.9099661641551429 -20 0.9064963774421086 -21 0.9030866532531712 -22 0.8997339700879358 -23 0.8964355824392188 -24 0.8931889847263488 -25 0.8899918812500051 -26 0.8868421609620551 -27 0.8837378761228457 -28 0.8806772241248969 -29 0.8776585319167312 -30 0.874680242577914 -31 0.8717409036863014 -32 0.8688391571880675 -33 0.8659737305354348 -34 0.8631434288998111 -35 0.8603471283020212 -36 0.857583769528487 -37 0.8548523527240882 -38 0.8521519325701771 -39 0.8494816139706848 -40 0.8468405481811211 -41 0.8442279293250585 -42 0.8416429912508109 -43 0.8390850046877706 -44 0.8365532746675381 -45 0.8340471381797273 -46 0.831565962036351 -47 0.8291091409221039 -48 0.8266760956107441 -49 0.824266271330268 -50 0.8218791362616757 -51 0.8195141801579645 -52 0.8171709130715548 -53 0.8148488641797111 -54 0.8125475806987108 -55 0.8102666268785352 -56 0.8080055830707606 -57 0.8057640448631033 -58 0.8035416222747761 -59 0.8013379390074006 -60 0.7991526317467734 -61 0.796985349511237 -62 0.7948357530428389 -63 0.7927035142377412 -64 0.7905883156132424 -65 0.7884898498073732 -66 0.7864078191101018 -67 0.7843419350226136 -68 0.7822919178430147 -69 0.7802574962764451 -70 0.7782384070678282 -71 0.7762343946556395 -72 0.7742452108452136 -73 0.7722706145002324 -74 0.770310371251143 -75 0.76836425321937 -76 0.7664320387562564 -77 0.7645135121957763 -78 0.7626084636201109 -79 0.7607166886372758 -80 0.7588379881700227 -81 0.7569721682553251 -82 0.7551190398537776 -83 0.7532784186683185 -84 0.7514501249717047 -85 0.7496339834422199 -86 0.7478298230071312 -87 0.7460374766934447 -88 0.744256781485537 -89 0.742487578189273 -90 0.740729711302249 -91 0.738983028889811 -92 0.7372473824665428 -93 0.7355226268829143 -94 0.7338086202168218 -95 0.7321052236697538 -96 0.7304123014673415 -97 0.7287297207640642 -98 0.7270573515518944 -99 0.7253950665726847 -100 0.7237427412341026 -101 0.7221002535289383 -102 0.7204674839576208 -103 0.7188443154537764 -104 0.7172306333126927 -105 0.7156263251225384 -106 0.7140312806982176 -107 0.712445392017719 -108 0.7108685531608633 -109 0.7093006602503189 -110 0.7077416113947941 -111 0.7061913066343006 -112 0.7046496478873963 -113 0.7031165389003207 -114 0.701591885197936 -115 0.7000755940363974 -116 0.6985675743574739 -117 0.6970677367444532 -118 0.6955759933795586 -119 0.694092258002813 -120 0.6926164458722978 -121 0.6911484737257331 -122 0.6896882597433415 -123 0.6882357235119293 -124 0.6867907859901439 -125 0.6853533694748546 -126 0.6839233975686164 -127 0.6825007951481693 -128 0.6810854883339358 -129 0.6796774044604751 -130 0.6782764720478581 -131 0.6768826207739282 -132 0.675495781447412 -133 0.6741158859818493 -134 0.6727428673703116 -135 0.6713766596608783 -136 0.6700171979328448 -137 0.6686644182736309 -138 0.6673182577563711 -139 0.665978654418155 -140 0.6646455472388978 -141 0.6633188761208197 -142 0.6619985818685072 -143 0.6606846061695424 -144 0.6593768915756765 -145 0.6580753814845278 -146 0.6567800201217898 -147 0.6554907525239279 -148 0.6542075245213498 -149 0.6529302827220361 -150 0.6516589744956094 -151 0.6503935479578326 -152 0.6491339519555221 -153 0.6478801360518566 -154 0.6466320505120773 -155 0.6453896462895573 -156 0.6441528750122365 -157 0.642921688969405 -158 0.6416960410988252 -159 0.640475884974183 -160 0.6392611747928573 -161 0.6380518653639957 -162 0.6368479120968908 -163 0.635649270989643 -164 0.6344558986181063 -165 0.6332677521251036 -166 0.6320847892099062 -167 0.6309069681179693 -168 0.6297342476309137 -169 0.6285665870567494 -170 0.6274039462203316 -171 0.626246285454043 -172 0.6250935655886968 -173 0.623945747944651 -174 0.6228027943231316 -175 0.6216646669977567 -176 0.6205313287062546 -177 0.6194027426423736 -178 0.6182788724479744 -179 0.6171596822053032 -180 0.6160451364294374 -181 0.6149352000609029 -182 0.6138298384584534 -183 0.6127290173920114 -184 0.6116327030357649 -185 0.610540861961415 -186 0.6094534611315701 -187 0.6083704678932862 -188 0.6072918499717428 -189 0.6062175754640584 -190 0.6051476128332351 -191 0.6040819309022343 -192 0.6030204988481755 -193 0.6019632861966588 -194 0.6009102628162061 -195 0.5998613989128165 -196 0.5988166650246367 -197 0.5977760320167395 -198 0.5967394710760106 -199 0.5957069537061387 -200 0.5946784517227086 -201 0.5936539372483923 -202 0.5926333827082372 -203 0.5916167608250495 -204 0.5906040446148677 -205 0.5895952073825281 -206 0.5885902227173152 -207 0.5875890644887002 -208 0.5865917068421604 -209 0.5855981241950815 -210 0.5846082912327386 -211 0.5836221829043546 -212 0.5826397744192342 -213 0.581661041242972 -214 0.5806859590937321 -215 0.5797145039385988 -216 0.5787466519899951 -217 0.5777823797021695 -218 0.5768216637677468 -219 0.5758644811143447 -220 0.5749108089012515 -221 0.5739606245161651 -222 0.5730139055719944 -223 0.5720706299037137 -224 0.5711307755652795 -225 0.5701943208266014 -226 0.5692612441705648 -227 0.5683315242901118 -228 0.5674051400853706 -229 0.5664820706608363 -230 0.565562295322604 -231 0.5646457935756481 -232 0.5637325451211503 -233 0.5628225298538745 -234 0.5619157278595864 -235 0.5610121194125203 -236 0.5601116849728858 -237 0.5592144051844212 -238 0.5583202608719857 -239 0.5574292330391953 -240 0.5565413028660963 -241 0.5556564517068797 -242 0.5547746610876346 -243 0.5538959127041372 -244 0.5530201884196781 -245 0.5521474702629271 -246 0.5512777404258298 -247 0.5504109812615423 -248 0.549547175282398 -249 0.548686305157909 -250 0.5478283537127981 -251 0.5469733039250656 -252 0.5461211389240842 -253 0.5452718419887275 -254 0.5444253965455269 -255 0.5435817861668577 -256 0.5427409945691563 -257 0.5419030056111626 -258 0.5410678032921926 -259 0.5402353717504378 -260 0.5394056952612899 -261 0.5385787582356935 -262 0.5377545452185236 -263 0.5369330408869883 -264 0.5361142300490556 -265 0.5352980976419066 -266 0.5344846287304097 -267 0.5336738085056196 -268 0.5328656222832998 -269 0.5320600555024659 -270 0.5312570937239519 -271 0.5304567226289982 -272 0.5296589280178607 -273 0.5288636958084402 -274 0.528071012034933 -275 0.527280862846501 -276 0.526493234505962 -277 0.5257081133884988 -278 0.5249254859803876 -279 0.5241453388777454 -280 0.5233676587852939 -281 0.5225924325151446 -282 0.5218196469855986 -283 0.5210492892199644 -284 0.5202813463453946 -285 0.5195158055917365 -286 0.5187526542904008 -287 0.5179918798732471 -288 0.5172334698714828 -289 0.5164774119145797 -290 0.5157236937292059 -291 0.5149723031381711 -292 0.5142232280593879 -293 0.5134764565048479 -294 0.5127319765796108 -295 0.5119897764808087 -296 0.5112498444966641 -297 0.5105121690055203 -298 0.5097767384748864 -299 0.5090435414604948 -300 0.5083125666053719 -301 0.507583802638921 -302 0.5068572383760178 -303 0.5061328627161186 -304 0.5054106646423798 -305 0.5046906332207897 -306 0.5039727575993115 -307 0.5032570270070392 -308 0.5025434307533622 -309 0.5018319582271428 -310 0.5011225988959046 -311 0.5004153423050312 -312 0.49971017807697427 -313 0.49900709591047493 -314 0.49830608557979217 -315 0.497607136933943 -316 0.4969102398959523 -317 0.4962153844621122 -318 0.4955225607012511 -319 0.4948317587540115 -320 0.4941429688321387 -321 0.4934561812177765 -322 0.49277138626277345 -323 0.4920885743879972 -324 0.4914077360826579 -325 0.49072886190364023 -326 0.4900519424748425 -327 0.48937696848652695 -328 0.4887039306946743 -329 0.4880328199203507 -330 0.48736362704907843 -331 0.48669634303021736 -332 0.4860309588763527 -333 0.48536746566269084 -334 0.48470585452646225 -335 0.4840461166663318 -336 0.48338824334181657 -337 0.4827322258727103 -338 0.48207805563851625 -339 0.4814257240778837 -340 0.4807752226880555 -341 0.4801265430243186 -342 0.4794796766994642 -343 0.4788346153832517 -344 0.478191350801881 -345 0.4775498747374702 -346 0.47691017902753985 -347 0.4762722555645029 -348 0.47563609629516157 -349 0.4750016932202088 -350 0.474369038393737 -351 0.4737381239227518 -352 0.4731089419666909 -353 0.4724814847369504 -354 0.4718557444964145 -355 0.471231713558992 -356 0.4706093842891585 -357 0.46998874910150146 -358 0.46936980046027404 -359 0.46875253087895113 -360 0.4681369329197923 -361 0.4675229991934086 -362 0.4669107223583348 -363 0.46630009512060633 -364 0.4656911102333418 -365 0.46508376049632844 -366 0.4644780387556143 -367 0.4638739379031033 -368 0.46327145087615657 -369 0.4626705706571957 -370 0.4620712902733141 -371 0.46147360279588856 -372 0.46087750134019834 -373 0.4602829790650468 -374 0.4596900291723878 -375 0.4590986449069562 -376 0.45850881955590195 -377 0.45792054644842906 -378 0.4573338189554377 -379 0.45674863048917047 -380 0.45616497450286275 -381 0.4555828444903966 -382 0.4550022339859583 -383 0.45442313656369987 -384 0.4538455458374046 -385 0.45326945546015474 -386 0.4526948591240039 -387 0.45212175055965415 -388 0.45155012353613266 -389 0.4509799718604769 -390 0.4504112893774181 -391 0.44984406996907317 -392 0.44927830755463477 -393 0.44871399609006835 -394 0.4481511295678115 -395 0.44758970201647463 -396 0.4470297075005478 -397 0.44647114012010813 -398 0.4459139940105313 -399 0.445358263342206 -400 0.4448039423202515 -401 0.4442510251842373 -402 0.4436995062079068 -403 0.4431493796989029 -404 0.44260063999849697 -405 0.4420532814813202 -406 0.4415072985550987 -407 0.44096268566038893 -408 0.4404194372703193 -409 0.4398775478903305 -410 0.4393370120579223 -411 0.4387978243423998 -412 0.43825997934462363 -413 0.4377234716967632 -414 0.43718829606205123 -415 0.43665444713454066 -416 0.4361219196388661 -417 0.4355907083300043 -418 0.4350608079930402 -419 0.43453221344293347 -420 0.4340049195242877 -421 0.43347892111112174 -422 0.43295421310664406 -423 0.43243079044302857 -424 0.43190864808119267 -425 0.43138778101057784 -426 0.43086818424893225 -427 0.43034985284209504 -428 0.4298327818637838 -429 0.42931696641538275 -430 0.4288024016257333 -431 0.4282890826509284 -432 0.4277770046741056 -433 0.4272661629052452 -434 0.4267565525809683 -435 0.426248168964338 -436 0.4257410073446616 -437 0.4252350630372958 -438 0.42473033138345195 -439 0.42422680775000515 -440 0.42372448752930386 -441 0.4232233661389823 -442 0.4227234390217727 -443 0.42222470164532216 -444 0.4217271495020085 -445 0.42123077810876014 -446 0.4207355830068754 -447 0.42024155976184563 -448 0.419748703963178 -449 0.4192570112242222 -450 0.4187664771819965 -451 0.41827709749701647 -452 0.4177888678531257 -453 0.41730178395732725 -454 0.4168158415396169 -455 0.4163310363528185 -456 0.4158473641724194 -457 0.41536482079640946 -458 0.4148834020451197 -459 0.41440310376106304 -460 0.41392392180877696 -461 0.4134458520746668 -462 0.41296889046685104 -463 0.4124930329150079 -464 0.4120182753702229 -465 0.41154461380483826 -466 0.41107204421230364 -467 0.4106005626070276 -468 0.41013016502423144 -469 0.4096608475198032 -470 0.4091926061701538 -471 0.4087254370720742 -472 0.40825933634259365 -473 0.40779430011883927 -474 0.407330324557897 -475 0.40686740583667413 -476 0.40640554015176156 -477 0.40594472371929935 -478 0.4054849527748419 -479 0.40502622357322515 -480 0.40456853238843427 -481 0.40411187551347244 -482 0.4036562492602327 -483 0.4032016499593676 -484 0.40274807396016254 -485 0.40229551763040994 -486 0.401843977356283 -487 0.4013934495422118 -488 0.40094393061076083 -489 0.40049541700250596 -490 0.4000479051759142 -491 0.39960139160722313 -492 0.3991558727903225 -493 0.39871134523663565 -494 0.39826780547500285 -495 0.3978252500515656 -496 0.3973836755296513 -497 0.3969430784896594 -498 0.39650345552894783 -499 0.39606480326172205 -500 0.39562711831892267 -501 0.3951903973481156 -502 0.39475463701338354 -503 0.3943198339952161 -504 0.39388598499040356 -505 0.39345308671192963 -506 0.39302113588886617 -507 0.3925901292662675 -508 0.39216006360506744 -509 0.39173093568197576 -510 0.39130274228937556 -511 0.39087548023522245 -512 0.3904491463429436 -513 0.3900237374513377 -514 0.38959925041447707 -515 0.389175682101608 -516 0.38875302939705453 -517 0.38833128920012144 -518 0.38791045842499833 -519 0.3874905340006655 -520 0.3870715128707984 -521 0.3866533919936748 -522 0.3862361683420825 -523 0.38581983890322674 -524 0.385404400678639 -525 0.38498985068408675 -526 0.3845761859494836 -527 0.38416340351880035 -528 0.38375150044997597 -529 0.38334047381483105 -530 0.3829303206989799 -531 0.3825210382017448 -532 0.38211262343607033 -533 0.38170507352843797 -534 0.38129838561878276 -535 0.3808925568604089 -536 0.38048758441990777 -537 0.38008346547707406 -538 0.3796801972248261 -539 0.37927777686912334 -540 0.3788762016288872 -541 0.37847546873592014 -542 0.3780755754348275 -543 0.37767651898293847 -544 0.3772782966502284 -545 0.3768809057192419 -546 0.3764843434850152 -547 0.37608860725500115 -548 0.37569369434899286 -549 0.3752996020990492 -550 0.3749063278494206 -551 0.37451386895647465 -552 0.37412222278862356 -553 0.373731386726251 -554 0.3733413581616405 -555 0.3729521344989033 -556 0.3725637131539079 -557 0.3721760915542089 -558 0.37178926713897814 -559 0.3714032373589341 -560 0.37101799967627386 -561 0.37063355156460415 -562 0.37024989050887425 -563 0.3698670140053074 -564 0.36948491956133556 -565 0.36910360469553166 -566 0.36872306693754475 -567 0.3683433038280338 -568 0.36796431291860365 -569 0.3675860917717399 -570 0.36720863796074577 -571 0.366831949069678 -572 0.36645602269328403 -573 0.3660808564369399 -574 0.36570644791658763 -575 0.36533279475867425 -576 0.36495989460009 -577 0.3645877450881084 -578 0.36421634388032514 -579 0.3638456886445993 -580 0.36347577705899325 -581 0.36310660681171375 -582 0.36273817560105387 -583 0.3623704811353349 -584 0.36200352113284795 -585 0.3616372933217977 -586 0.361271795440245 -587 0.3609070252360509 -588 0.36054298046682 -589 0.36017965889984516 -590 0.3598170583120531 -591 0.35945517648994796 -592 0.3590940112295585 -593 0.3587335603363829 -594 0.35837382162533604 -595 0.3580147929206956 -596 0.35765647205604956 -597 0.3572988568742431 -598 0.35694194522732786 -599 0.3565857349765085 -600 0.3562302239920924 -601 0.35587541015343827 -602 0.3555212913489055 -603 0.3551678654758042 -604 0.3548151304403445 -605 0.35446308415758787 -606 0.3541117245513971 -607 0.3537610495543878 -608 0.3534110571078797 -609 0.35306174516184863 -610 0.3527131116748783 -611 0.3523651546141128 -612 0.3520178719552097 -613 0.35167126168229296 -614 0.3513253217879061 -615 0.3509800502729663 -616 0.3506354451467184 -617 0.35029150442668927 -618 0.3499482261386421 -619 0.34960560831653265 -620 0.3492636490024624 -621 0.3489223462466368 -622 0.3485816981073192 -623 0.34824170265078774 -624 0.34790235795129204 -625 0.3475636620910101 -626 0.3472256131600049 -627 0.3468882092561822 -628 0.3465514484852485 -629 0.3462153289606681 -630 0.3458798488036226 -631 0.34554500614296846 -632 0.3452107991151962 -633 0.3448772258643897 -634 0.34454428454218505 -635 0.34421197330773123 -636 0.34388029032764894 -637 0.3435492337759909 -638 0.3432188018342032 -639 0.3428889926910855 -640 0.3425598045427515 -641 0.342231235592591 -642 0.34190328405123144 -643 0.3415759481364984 -644 0.3412492260733795 -645 0.3409231160939852 -646 0.3405976164375119 -647 0.3402727253502047 -648 0.33994844108532046 -649 0.3396247619030907 -650 0.3393016860706855 -651 0.33897921186217694 -652 0.33865733755850347 -653 0.33833606144743356 -654 0.3380153818235307 -655 0.3376952969881176 -656 0.33737580524924166 -657 0.3370569049216394 -658 0.33673859432670233 -659 0.3364208717924425 -660 0.3361037356534581 -661 0.33578718425089965 -662 0.33547121593243634 -663 0.3351558290522219 -664 0.33484102197086224 -665 0.33452679305538185 -666 0.3342131406791904 -667 0.3339000632220512 -668 0.33358755907004783 -669 0.3332756266155521 -670 0.3329642642571924 -671 0.33265347039982107 -672 0.33234324345448363 -673 0.3320335818383867 -674 0.3317244839748669 -675 0.3314159482933603 -676 0.3311079732293706 -677 0.3308005572244392 -678 0.33049369872611495 -679 0.33018739618792325 -680 0.32988164806933584 -681 0.32957645283574216 -682 0.329271808958418 -683 0.32896771491449733 -684 0.32866416918694225 -685 0.3283611702645137 -686 0.3280587166417438 -687 0.32775680681890496 -688 0.32745543930198334 -689 0.32715461260264894 -690 0.32685432523822827 -691 0.32655457573167584 -692 0.3262553626115465 -693 0.32595668441196735 -694 0.3256585396726107 -695 0.32536092693866625 -696 0.3250638447608144 -697 0.32476729169519847 -698 0.3244712663033984 -699 0.3241757671524041 -700 0.3238807928145882 -701 0.32358634186768065 -702 0.32329241289474187 -703 0.32299900448413643 -704 0.32270611522950815 -705 0.3224137437297533 -706 0.3221218885889956 -707 0.3218305484165607 -708 0.32153972182695095 -709 0.3212494074398199 -710 0.320959603879948 -711 0.32067030977721706 -712 0.32038152376658613 -713 0.3200932444880666 -714 0.3198054705866983 -715 0.31951820071252474 -716 0.3192314335205693 -717 0.3189451676708114 -718 0.3186594018281623 -719 0.31837413466244235 -720 0.3180893648483562 -721 0.3178050910654704 -722 0.3175213119981899 -723 0.31723802633573495 -724 0.316955232772118 -725 0.31667293000612123 -726 0.31639111674127374 -727 0.3161097916858287 -728 0.3158289535527413 -729 0.3155486010596463 -730 0.31526873292883634 -731 0.31498934788723887 -732 0.3147104446663956 -733 0.3144320220024395 -734 0.31415407863607436 -735 0.3138766133125523 -736 0.3135996247816527 -737 0.31332311179766137 -738 0.3130470731193488 -739 0.3127715075099498 -740 0.312496413737142 -741 0.3122217905730254 -742 0.31194763679410176 -743 0.3116739511812541 -744 0.3114007325197262 -745 0.3111279795991024 -746 0.3108556912132874 -747 0.310583866160486 -748 0.3103125032431839 -749 0.31004160126812674 -750 0.3097711590463018 -751 0.3095011753929171 -752 0.30923164912738277 -753 0.30896257907329133 -754 0.3086939640583986 -755 0.30842580291460436 -756 0.30815809447793374 -757 0.30789083758851776 -758 0.30762403109057496 -759 0.30735767383239243 -760 0.3070917646663073 -761 0.30682630244868847 -762 0.3065612860399177 -763 0.306296714304372 -764 0.3060325861104046 -765 0.305768900330328 -766 0.30550565584039485 -767 0.30524285152078096 -768 0.304980486255567 -769 0.30471855893272104 -770 0.30445706844408094 -771 0.30419601368533694 -772 0.30393539355601423 -773 0.30367520695945566 -774 0.30341545280280474 -775 0.30315612999698804 -776 0.3028972374566991 -777 0.30263877410038054 -778 0.30238073885020794 -779 0.30212313063207297 -780 0.30186594837556674 -781 0.3016091910139632 -782 0.30135285748420293 -783 0.30109694672687665 -784 0.30084145768620885 -785 0.30058638931004206 -786 0.3003317405498202 -787 0.30007751036057334 -788 0.29982369770090106 -789 0.2995703015329571 -790 0.2993173208224336 -791 0.29906475453854525 -792 0.2988126016540142 -793 0.29856086114505387 -794 0.29830953199135457 -795 0.29805861317606724 -796 0.29780810368578886 -797 0.2975580025105472 -798 0.2973083086437855 -799 0.297059021082348 -800 0.2968101388264648 -801 0.2965616608797368 -802 0.29631358624912163 -803 0.29606591394491844 -804 0.2958186429807536 -805 0.2955717723735663 -806 0.29532530114359384 -807 0.29507922831435773 -808 0.29483355291264907 -809 0.29458827396851467 -810 0.29434339051524283 -811 0.2940989015893491 -812 0.293854806230563 -813 0.2936111034818134 -814 0.2933677923892153 -815 0.2931248720020557 -816 0.2928823413727803 -817 0.2926401995569797 -818 0.292398445613376 -819 0.2921570786038094 -820 0.2919160975932247 -821 0.2916755016496583 -822 0.2914352898442247 -823 0.29119546125110335 -824 0.29095601494752615 -825 0.29071695001376363 -826 0.29047826553311235 -827 0.29023996059188234 -828 0.29000203427938387 -829 0.28976448568791496 -830 0.28952731391274866 -831 0.2892905180521204 -832 0.28905409720721553 -833 0.28881805048215686 -834 0.28858237698399214 -835 0.28834707582268215 -836 0.28811214611108754 -837 0.28787758696495763 -838 0.28764339750291784 -839 0.28740957684645724 -840 0.2871761241199174 -841 0.2869430384504794 -842 0.286710318968153 -843 0.28647796480576393 -844 0.2862459750989426 -845 0.2860143489861123 -846 0.2857830856084774 -847 0.2855521841100122 -848 0.2853216436374487 -849 0.2850914633402659 -850 0.28486164237067796 -851 0.28463217988362266 -852 0.2844030750367507 -853 0.2841743269904139 -854 0.28394593490765446 -855 0.2837178979541936 -856 0.28349021529842056 -857 0.28326288611138145 -858 0.2830359095667686 -859 0.2828092848409096 -860 0.28258301111275624 -861 0.2823570875638738 -862 0.28213151337843057 -863 0.28190628774318693 -864 0.28168140984748485 -865 0.28145687888323717 -866 0.2812326940449174 -867 0.28100885452954893 -868 0.28078535953669487 -869 0.28056220826844747 -870 0.2803393999294182 -871 0.2801169337267269 -872 0.27989480886999235 -873 0.27967302457132137 -874 0.27945158004529935 -875 0.2792304745089797 -876 0.27900970718187434 -877 0.2787892772859434 -878 0.27856918404558545 -879 0.27834942668762763 -880 0.27813000444131597 -881 0.2779109165383055 -882 0.27769216221265064 -883 0.2774737407007956 -884 0.27725565124156454 -885 0.2770378930761524 -886 0.27682046544811495 -887 0.27660336760335985 -888 0.2763865987901368 -889 0.2761701582590283 -890 0.27595404526294054 -891 0.27573825905709387 -892 0.2755227988990136 -893 0.2753076640485212 -894 0.2750928537677243 -895 0.2748783673210088 -896 0.2746642039750288 -897 0.27445036299869796 -898 0.27423684366318085 -899 0.2740236452418835 -900 0.27381076701044504 -901 0.27359820824672837 -902 0.27338596823081174 -903 0.2731740462449801 -904 0.2729624415737158 -905 0.27275115350369084 -906 0.2725401813237574 -907 0.2723295243249398 -908 0.27211918180042577 -909 0.2719091530455581 -910 0.271699437357826 -911 0.2714900340368568 -912 0.27128094238440764 -913 0.27107216170435705 -914 0.2708636913026968 -915 0.27065553048752344 -916 0.2704476785690303 -917 0.27024013485949927 -918 0.27003289867329255 -919 0.2698259693268448 -920 0.26961934613865485 -921 0.269413028429278 -922 0.2692070155213177 -923 0.26900130673941763 -924 0.26879590141025433 -925 0.2685907988625287 -926 0.26838599842695854 -927 0.2681814994362706 -928 0.2679773012251932 -929 0.2677734031304478 -930 0.267569804490742 -931 0.2673665046467618 -932 0.2671635029411637 -933 0.26696079871856737 -934 0.2667583913255481 -935 0.26655628011062926 -936 0.2663544644242748 -937 0.26615294361888214 -938 0.26595171704877413 -939 0.26575078407019265 -940 0.2655501440412903 -941 0.26534979632212374 -942 0.2651497402746465 -943 0.26494997526270114 -944 0.26475050065201294 -945 0.26455131581018193 -946 0.2643524201066763 -947 0.2641538129128253 -948 0.2639554936018118 -949 0.26375746154866575 -950 0.26355971613025697 -951 0.2633622567252881 -952 0.2631650827142882 -953 0.26296819347960493 -954 0.26277158840539866 -955 0.26257526687763516 -956 0.2623792282840789 -957 0.2621834720142861 -958 0.26198799745959866 -959 0.2617928040131365 -960 0.2615978910697918 -961 0.2614032580262219 -962 0.26120890428084254 -963 0.2610148292338218 -964 0.26082103228707326 -965 0.26062751284424945 -966 0.2604342703107354 -967 0.2602413040936423 -968 0.2600486136018011 -969 0.259856198245756 -970 0.25966405743775794 -971 0.25947219059175874 -972 0.2592805971234043 -973 0.25908927645002855 -974 0.2588982279906473 -975 0.2587074511659519 -976 0.25851694539830294 -977 0.2583267101117244 -978 0.2581367447318972 -979 0.2579470486861532 -980 0.25775762140346925 -981 0.25756846231446096 -982 0.25737957085137686 -983 0.2571909464480922 -984 0.2570025885401032 -985 0.2568144965645208 -986 0.2566266699600653 -987 0.25643910816705967 -988 0.2562518106274244 -989 0.25606477678467143 -990 0.25587800608389827 -991 0.2556914979717821 -992 0.25550525189657447 -993 0.255319267308095 -994 0.2551335436577262 -995 0.2549480803984073 -996 0.25476287698462907 -997 0.2545779328724277 -998 0.2543932475193798 -999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/100K/MEP.dat b/drivers/py/pes/friction/frictionH/100K/MEP.dat deleted file mode 100644 index e69de29bb..000000000 diff --git a/drivers/py/pes/friction/frictionH/100K/RESTART b/drivers/py/pes/friction/frictionH/100K/RESTART deleted file mode 100644 index 6f10c4583..000000000 --- a/drivers/py/pes/friction/frictionH/100K/RESTART +++ /dev/null @@ -1,612 +0,0 @@ - - - [ step, potential{electronvolt} ] - extras - extras - - 3 - 10 - - - - - - [ friction ] - - - - 3.16681520e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 3.09906606e-03, 3.22851909e-03, 3.49093586e-03, 3.88176275e-03, 4.36485396e-03, - 4.84679796e-03, 5.20913573e-03, 5.36951613e-03, 5.28551898e-03, 5.02084485e-03, - 4.65677172e-03, 4.23706344e-03, 3.83387796e-03, 3.50704134e-03, 3.28336292e-03, - 3.17092824e-03 ] - - - [ -2.96578142e-03, 3.12662139e-05, 3.12469565e-05, -2.98003823e-03, 3.11527793e-05, - 3.11240805e-05, -2.96409761e-03, 3.06339897e-05, 3.05569437e-05, -2.83746289e-03, - 2.91424634e-05, 2.89705536e-05, -2.51569483e-03, 2.59096758e-05, 2.56787589e-05, - -1.95742103e-03, 2.02680240e-05, 2.01244996e-05, -1.17861731e-03, 1.23180576e-05, - 1.22859988e-05, -2.49818691e-04, 2.88384895e-06, 2.87013899e-06, 6.70554207e-04, - -7.01954459e-06, -7.00842701e-06, 1.46822483e-03, -1.61622127e-05, -1.61730639e-05, - 2.07187846e-03, -2.38199354e-05, -2.38278020e-05, 2.44409999e-03, -2.97107394e-05, - -2.96955834e-05, 2.63506268e-03, -3.38928394e-05, -3.38669583e-05, 2.71852512e-03, - -3.66320899e-05, -3.66104886e-05, 2.74739598e-03, -3.82428483e-05, -3.82323615e-05, - 2.75418921e-03, -3.89794884e-05, -3.89773293e-05 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00 ] - - True - - [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, - 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, - 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, - 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, - 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, - 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, - 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, - 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, - 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, - 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, - 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, - 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, - 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, - 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, - 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, - 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, - 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, - 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, - 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, - 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, - 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, - 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, - 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, - 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, - 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, - 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, - 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, - 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, - 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, - 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, - 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, - 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, - 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, - 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, - 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, - 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, - 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, - 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, - 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, - 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, - 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, - 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, - 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, - 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, - 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, - 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, - 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, - 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, - 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, - 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, - 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, - 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, - 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, - 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, - 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, - 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, - 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, - 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, - 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, - 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, - 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, - 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, - 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, - 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, - 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, - 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, - 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, - 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, - 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, - 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, - 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, - 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, - 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, - 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, - 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, - 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, - 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, - 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, - 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, - 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, - 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, - 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, - 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, - 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, - 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, - 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, - 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, - 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, - 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, - 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, - 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, - 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, - 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, - 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, - 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, - 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, - 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, - 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, - 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, - 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, - 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, - 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, - 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, - 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, - 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, - 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, - 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, - 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, - 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, - 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, - 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, - 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, - 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, - 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, - 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, - 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, - 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, - 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, - 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, - 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, - 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, - 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, - 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, - 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, - 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, - 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, - 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, - 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, - 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, - 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, - 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, - 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, - 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, - 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, - 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, - 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, - 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, - 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, - 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, - 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, - 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, - 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, - 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, - 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, - 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, - 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, - 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, - 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, - 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, - 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, - 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, - 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, - 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, - 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, - 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, - 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, - 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, - 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, - 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, - 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, - 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, - 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, - 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, - 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, - 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, - 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, - 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, - 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, - 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, - 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, - 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, - 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, - 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, - 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, - 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, - 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, - 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, - 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, - 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, - 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, - 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, - 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, - 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, - 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, - 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, - 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, - 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, - 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, - 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, - 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, - 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, - 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, - 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, - 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, - 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, - 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, - 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, - 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, - 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, - 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, - 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, - 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, - 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, - 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, - 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, - 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, - 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, - 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, - 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, - 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, - 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, - 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, - 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, - 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, - 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, - 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, - 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, - 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, - 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, - 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, - 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, - 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, - 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, - 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, - 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, - 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, - 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, - 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, - 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, - 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, - 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, - 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, - 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, - 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, - 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, - 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, - 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, - 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, - 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, - 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, - 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, - 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, - 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, - 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, - 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, - 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, - 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, - 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, - 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, - 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, - 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, - 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, - 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, - 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, - 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, - 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, - 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, - 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, - 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, - 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, - 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, - 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, - 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, - 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, - 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, - 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, - 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, - 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, - 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, - 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, - 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, - 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, - 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, - 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, - 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, - 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, - 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, - 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, - 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, - 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, - 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, - 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, - 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, - 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, - 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, - 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, - 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, - 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, - 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, - 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, - 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, - 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, - 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, - 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, - 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, - 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, - 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, - 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, - 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, - 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, - 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, - 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, - 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, - 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, - 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, - 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, - 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, - 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, - 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, - 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, - 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, - 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, - 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, - 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, - 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, - 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, - 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, - 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, - 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, - 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, - 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, - 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, - 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, - 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, - 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, - 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, - 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, - 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, - 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, - 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, - 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, - 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, - 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, - 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, - 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, - 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, - 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, - 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, - 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, - 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, - 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, - 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, - 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, - 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, - 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, - 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, - 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, - 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, - 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, - 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, - 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, - 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, - 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, - 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, - 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, - 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, - 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, - 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, - 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, - 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, - 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, - 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, - 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, - 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, - 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, - 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, - 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, - 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, - 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, - 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, - 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, - 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, - 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, - 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, - 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, - 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, - 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, - 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, - 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, - 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, - 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, - 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, - 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, - 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, - 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, - 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, - 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, - 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, - 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, - 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, - 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, - 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, - 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, - 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, - 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, - 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, - 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, - 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, - 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, - 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] - - - [ 1.61128639e-03, 8.96103006e-05, 9.01702301e-05, 5.85637218e-04, 8.47072851e-05, - 8.41412320e-05, -1.44975075e-03, 7.54113422e-05, 7.27918282e-05, -4.09220496e-03, - 6.09609317e-05, 5.75683579e-05, -6.77517000e-03, 4.10634180e-05, 3.97375753e-05, - -8.87065059e-03, 1.87784050e-05, 2.10953763e-05, -1.04382044e-02, 8.16568351e-06, - 8.23902319e-06, -1.09127694e-02, 2.94847080e-06, 2.74567171e-06, -1.01314463e-02, - 4.97950336e-06, 4.43841410e-06, -8.86576512e-03, 1.21417728e-05, 1.18230825e-05, - -6.85083993e-03, 2.09453089e-05, 2.15233821e-05, -4.50208424e-03, 3.07544518e-05, - 3.10764066e-05, -2.71915988e-03, 3.97339843e-05, 3.96487514e-05, -1.48803720e-03, - 4.68628240e-05, 4.64157767e-05, -7.20754239e-04, 5.16924370e-05, 5.09769344e-05, - -3.50367397e-04, 5.40648783e-05, 5.32552981e-05, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, - 3.38813179e-18, 5.51152161e-01, 0.00000000e+00, 3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 5.08219768e-18, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.11758237e-19, 5.51152161e-01, - 0.00000000e+00, 4.23516474e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, - 1.69406589e-18, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -3.38813179e-18, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] - - - [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] - - True - - - - - [ 2.14815131e+00, -5.67288239e-05, -5.66938837e-05, 2.16254780e+00, -5.65230103e-05, - -5.64709397e-05, 2.19147692e+00, -5.55817284e-05, -5.54419375e-05, 2.23497203e+00, - -5.28755314e-05, -5.25636215e-05, 2.29252992e+00, -4.70100230e-05, -4.65910518e-05, - 2.36265144e+00, -3.67739174e-05, -3.65135093e-05, 2.44260635e+00, -2.23496495e-05, - -2.22914825e-05, 2.52850445e+00, -5.23240069e-06, -5.20752561e-06, 2.61565911e+00, - 1.27361282e-05, 1.27159567e-05, 2.69941684e+00, 2.93244114e-05, 2.93440996e-05, - 2.77575774e+00, 4.32184377e-05, 4.32327109e-05, 2.84166905e+00, 5.39066006e-05, - 5.38791018e-05, 2.89533936e+00, 6.14945233e-05, 6.14475651e-05, 2.93588948e+00, - 6.64645673e-05, 6.64253742e-05, 2.96297908e+00, 6.93870968e-05, 6.93680697e-05, - 2.97652439e+00, 7.07236426e-05, 7.07197251e-05 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/frictionH/100K/clean.sh b/drivers/py/pes/friction/frictionH/100K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/frictionH/100K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/frictionH/100K/get1D.sh b/drivers/py/pes/friction/frictionH/100K/get1D.sh deleted file mode 100755 index 152292560..000000000 --- a/drivers/py/pes/friction/frictionH/100K/get1D.sh +++ /dev/null @@ -1,5 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 diff --git a/drivers/py/pes/friction/frictionH/100K/init.xyz b/drivers/py/pes/friction/frictionH/100K/init.xyz deleted file mode 100644 index 223399063..000000000 --- a/drivers/py/pes/friction/frictionH/100K/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/frictionH/100K/input.xml b/drivers/py/pes/friction/frictionH/100K/input.xml deleted file mode 100644 index c9b86e609..000000000 --- a/drivers/py/pes/friction/frictionH/100K/input.xml +++ /dev/null @@ -1,45 +0,0 @@ - - - [ step, potential{electronvolt}] - extras - extras - - 10 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - ['friction'] - - - - 100 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - - z_friction.dat - true - true - none - 0.1 - - - -
diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_00 b/drivers/py/pes/friction/frictionH/100K/inst.fric_00 deleted file mode 100644 index 74a7c6344..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_00 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 - 0.00013194 -0.00003135 -0.00003130 - -0.00003135 0.00013218 -0.00003131 - -0.00003130 -0.00003131 0.00013173 - #*EXTRAS*# Step: 1 Bead: 0 - 0.00013241 -0.00003014 -0.00003010 - -0.00003014 0.00013266 -0.00003009 - -0.00003010 -0.00003009 0.00013225 - #*EXTRAS*# Step: 2 Bead: 0 - 0.00013237 -0.00003024 -0.00003020 - -0.00003024 0.00013262 -0.00003019 - -0.00003020 -0.00003019 0.00013220 - #*EXTRAS*# Step: 3 Bead: 0 - 0.00013237 -0.00003025 -0.00003020 - -0.00003025 0.00013262 -0.00003020 - -0.00003020 -0.00003020 0.00013220 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_01 b/drivers/py/pes/friction/frictionH/100K/inst.fric_01 deleted file mode 100644 index aaf40a293..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_01 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 - 0.00013155 -0.00003225 -0.00003218 - -0.00003225 0.00013179 -0.00003222 - -0.00003218 -0.00003222 0.00013130 - #*EXTRAS*# Step: 1 Bead: 1 - 0.00013197 -0.00003128 -0.00003124 - -0.00003128 0.00013221 -0.00003125 - -0.00003124 -0.00003125 0.00013176 - #*EXTRAS*# Step: 2 Bead: 1 - 0.00013193 -0.00003138 -0.00003133 - -0.00003138 0.00013217 -0.00003135 - -0.00003133 -0.00003135 0.00013171 - #*EXTRAS*# Step: 3 Bead: 1 - 0.00013193 -0.00003138 -0.00003133 - -0.00003138 0.00013217 -0.00003135 - -0.00003133 -0.00003135 0.00013171 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_02 b/drivers/py/pes/friction/frictionH/100K/inst.fric_02 deleted file mode 100644 index 3150a6731..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_02 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 - 0.00013052 -0.00003427 -0.00003412 - -0.00003427 0.00013073 -0.00003427 - -0.00003412 -0.00003427 0.00013021 - #*EXTRAS*# Step: 1 Bead: 2 - 0.00013095 -0.00003347 -0.00003336 - -0.00003347 0.00013117 -0.00003347 - -0.00003336 -0.00003347 0.00013066 - #*EXTRAS*# Step: 2 Bead: 2 - 0.00013090 -0.00003356 -0.00003344 - -0.00003356 0.00013113 -0.00003355 - -0.00003344 -0.00003355 0.00013062 - #*EXTRAS*# Step: 3 Bead: 2 - 0.00013090 -0.00003356 -0.00003345 - -0.00003356 0.00013113 -0.00003355 - -0.00003345 -0.00003355 0.00013062 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_03 b/drivers/py/pes/friction/frictionH/100K/inst.fric_03 deleted file mode 100644 index db082403f..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_03 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 - 0.00012868 -0.00003715 -0.00003680 - -0.00003715 0.00012883 -0.00003720 - -0.00003680 -0.00003720 0.00012833 - #*EXTRAS*# Step: 1 Bead: 3 - 0.00012916 -0.00003645 -0.00003616 - -0.00003645 0.00012933 -0.00003649 - -0.00003616 -0.00003649 0.00012882 - #*EXTRAS*# Step: 2 Bead: 3 - 0.00012912 -0.00003652 -0.00003622 - -0.00003652 0.00012928 -0.00003656 - -0.00003622 -0.00003656 0.00012877 - #*EXTRAS*# Step: 3 Bead: 3 - 0.00012912 -0.00003652 -0.00003622 - -0.00003652 0.00012928 -0.00003656 - -0.00003622 -0.00003656 0.00012877 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_04 b/drivers/py/pes/friction/frictionH/100K/inst.fric_04 deleted file mode 100644 index 2a203a96c..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_04 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 - 0.00012608 -0.00004029 -0.00003974 - -0.00004029 0.00012615 -0.00004038 - -0.00003974 -0.00004038 0.00012575 - #*EXTRAS*# Step: 1 Bead: 4 - 0.00012663 -0.00003970 -0.00003917 - -0.00003970 0.00012671 -0.00003978 - -0.00003917 -0.00003978 0.00012629 - #*EXTRAS*# Step: 2 Bead: 4 - 0.00012659 -0.00003974 -0.00003921 - -0.00003974 0.00012668 -0.00003982 - -0.00003921 -0.00003982 0.00012625 - #*EXTRAS*# Step: 3 Bead: 4 - 0.00012659 -0.00003974 -0.00003921 - -0.00003974 0.00012667 -0.00003983 - -0.00003921 -0.00003983 0.00012625 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_05 b/drivers/py/pes/friction/frictionH/100K/inst.fric_05 deleted file mode 100644 index 6e08ea1b4..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_05 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 - 0.00012329 -0.00004270 -0.00004239 - -0.00004270 0.00012336 -0.00004279 - -0.00004239 -0.00004279 0.00012310 - #*EXTRAS*# Step: 1 Bead: 5 - 0.00012385 -0.00004231 -0.00004190 - -0.00004231 0.00012391 -0.00004241 - -0.00004190 -0.00004241 0.00012362 - #*EXTRAS*# Step: 2 Bead: 5 - 0.00012383 -0.00004232 -0.00004192 - -0.00004232 0.00012389 -0.00004242 - -0.00004192 -0.00004242 0.00012360 - #*EXTRAS*# Step: 3 Bead: 5 - 0.00012382 -0.00004232 -0.00004193 - -0.00004232 0.00012389 -0.00004242 - -0.00004193 -0.00004242 0.00012360 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_06 b/drivers/py/pes/friction/frictionH/100K/inst.fric_06 deleted file mode 100644 index 9ba1a5b72..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_06 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 - 0.00012029 -0.00004409 -0.00004407 - -0.00004409 0.00012020 -0.00004396 - -0.00004407 -0.00004396 0.00012025 - #*EXTRAS*# Step: 1 Bead: 6 - 0.00012106 -0.00004382 -0.00004381 - -0.00004382 0.00012105 -0.00004377 - -0.00004381 -0.00004377 0.00012099 - #*EXTRAS*# Step: 2 Bead: 6 - 0.00012105 -0.00004382 -0.00004381 - -0.00004382 0.00012104 -0.00004378 - -0.00004381 -0.00004378 0.00012098 - #*EXTRAS*# Step: 3 Bead: 6 - 0.00012104 -0.00004382 -0.00004382 - -0.00004382 0.00012103 -0.00004378 - -0.00004382 -0.00004378 0.00012098 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_07 b/drivers/py/pes/friction/frictionH/100K/inst.fric_07 deleted file mode 100644 index 09535a10a..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_07 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 - 0.00011665 -0.00004461 -0.00004432 - -0.00004461 0.00011623 -0.00004421 - -0.00004432 -0.00004421 0.00011666 - #*EXTRAS*# Step: 1 Bead: 7 - 0.00011766 -0.00004462 -0.00004438 - -0.00004462 0.00011727 -0.00004424 - -0.00004438 -0.00004424 0.00011766 - #*EXTRAS*# Step: 2 Bead: 7 - 0.00011766 -0.00004462 -0.00004438 - -0.00004462 0.00011727 -0.00004424 - -0.00004438 -0.00004424 0.00011766 - #*EXTRAS*# Step: 3 Bead: 7 - 0.00011765 -0.00004462 -0.00004438 - -0.00004462 0.00011727 -0.00004424 - -0.00004438 -0.00004424 0.00011766 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_08 b/drivers/py/pes/friction/frictionH/100K/inst.fric_08 deleted file mode 100644 index 4b6a5d702..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_08 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 - 0.00011322 -0.00004352 -0.00004346 - -0.00004352 0.00011306 -0.00004343 - -0.00004346 -0.00004343 0.00011326 - #*EXTRAS*# Step: 1 Bead: 8 - 0.00011427 -0.00004400 -0.00004384 - -0.00004400 0.00011400 -0.00004379 - -0.00004384 -0.00004379 0.00011431 - #*EXTRAS*# Step: 2 Bead: 8 - 0.00011429 -0.00004401 -0.00004384 - -0.00004401 0.00011401 -0.00004379 - -0.00004384 -0.00004379 0.00011432 - #*EXTRAS*# Step: 3 Bead: 8 - 0.00011428 -0.00004401 -0.00004384 - -0.00004401 0.00011401 -0.00004379 - -0.00004384 -0.00004379 0.00011432 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_09 b/drivers/py/pes/friction/frictionH/100K/inst.fric_09 deleted file mode 100644 index 3b4210e02..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_09 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 - 0.00011023 -0.00004172 -0.00004180 - -0.00004172 0.00011025 -0.00004177 - -0.00004180 -0.00004177 0.00011031 - #*EXTRAS*# Step: 1 Bead: 9 - 0.00011129 -0.00004242 -0.00004249 - -0.00004242 0.00011129 -0.00004247 - -0.00004249 -0.00004247 0.00011136 - #*EXTRAS*# Step: 2 Bead: 9 - 0.00011132 -0.00004243 -0.00004250 - -0.00004243 0.00011132 -0.00004248 - -0.00004250 -0.00004248 0.00011139 - #*EXTRAS*# Step: 3 Bead: 9 - 0.00011131 -0.00004243 -0.00004250 - -0.00004243 0.00011131 -0.00004248 - -0.00004250 -0.00004248 0.00011138 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_10 b/drivers/py/pes/friction/frictionH/100K/inst.fric_10 deleted file mode 100644 index b78c614e0..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_10 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 - 0.00010769 -0.00003973 -0.00003972 - -0.00003973 0.00010769 -0.00003973 - -0.00003972 -0.00003973 0.00010770 - #*EXTRAS*# Step: 1 Bead: 10 - 0.00010874 -0.00004061 -0.00004064 - -0.00004061 0.00010875 -0.00004062 - -0.00004064 -0.00004062 0.00010879 - #*EXTRAS*# Step: 2 Bead: 10 - 0.00010877 -0.00004063 -0.00004067 - -0.00004063 0.00010878 -0.00004064 - -0.00004067 -0.00004064 0.00010883 - #*EXTRAS*# Step: 3 Bead: 10 - 0.00010877 -0.00004063 -0.00004066 - -0.00004063 0.00010878 -0.00004064 - -0.00004066 -0.00004064 0.00010882 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_11 b/drivers/py/pes/friction/frictionH/100K/inst.fric_11 deleted file mode 100644 index 2efffe772..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_11 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 - 0.00010562 -0.00003769 -0.00003763 - -0.00003769 0.00010562 -0.00003777 - -0.00003763 -0.00003777 0.00010544 - #*EXTRAS*# Step: 1 Bead: 11 - 0.00010660 -0.00003870 -0.00003866 - -0.00003870 0.00010659 -0.00003874 - -0.00003866 -0.00003874 0.00010652 - #*EXTRAS*# Step: 2 Bead: 11 - 0.00010663 -0.00003874 -0.00003870 - -0.00003874 0.00010663 -0.00003877 - -0.00003870 -0.00003877 0.00010656 - #*EXTRAS*# Step: 3 Bead: 11 - 0.00010663 -0.00003874 -0.00003870 - -0.00003874 0.00010663 -0.00003877 - -0.00003870 -0.00003877 0.00010655 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_12 b/drivers/py/pes/friction/frictionH/100K/inst.fric_12 deleted file mode 100644 index e7b234434..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_12 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 - 0.00010410 -0.00003588 -0.00003581 - -0.00003588 0.00010410 -0.00003604 - -0.00003581 -0.00003604 0.00010377 - #*EXTRAS*# Step: 1 Bead: 12 - 0.00010494 -0.00003692 -0.00003686 - -0.00003692 0.00010494 -0.00003704 - -0.00003686 -0.00003704 0.00010469 - #*EXTRAS*# Step: 2 Bead: 12 - 0.00010498 -0.00003697 -0.00003690 - -0.00003697 0.00010498 -0.00003708 - -0.00003690 -0.00003708 0.00010473 - #*EXTRAS*# Step: 3 Bead: 12 - 0.00010498 -0.00003696 -0.00003690 - -0.00003696 0.00010498 -0.00003708 - -0.00003690 -0.00003708 0.00010473 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_13 b/drivers/py/pes/friction/frictionH/100K/inst.fric_13 deleted file mode 100644 index 269e0690c..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_13 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 - 0.00010310 -0.00003446 -0.00003442 - -0.00003446 0.00010308 -0.00003466 - -0.00003442 -0.00003466 0.00010270 - #*EXTRAS*# Step: 1 Bead: 13 - 0.00010379 -0.00003547 -0.00003540 - -0.00003547 0.00010379 -0.00003564 - -0.00003540 -0.00003564 0.00010343 - #*EXTRAS*# Step: 2 Bead: 13 - 0.00010383 -0.00003551 -0.00003545 - -0.00003551 0.00010382 -0.00003569 - -0.00003545 -0.00003569 0.00010347 - #*EXTRAS*# Step: 3 Bead: 13 - 0.00010383 -0.00003551 -0.00003544 - -0.00003551 0.00010382 -0.00003568 - -0.00003544 -0.00003568 0.00010347 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_14 b/drivers/py/pes/friction/frictionH/100K/inst.fric_14 deleted file mode 100644 index 1e6a6d78b..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_14 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 - 0.00010253 -0.00003354 -0.00003351 - -0.00003354 0.00010248 -0.00003373 - -0.00003351 -0.00003373 0.00010211 - #*EXTRAS*# Step: 1 Bead: 14 - 0.00010309 -0.00003445 -0.00003440 - -0.00003445 0.00010307 -0.00003464 - -0.00003440 -0.00003464 0.00010268 - #*EXTRAS*# Step: 2 Bead: 14 - 0.00010312 -0.00003449 -0.00003445 - -0.00003449 0.00010310 -0.00003469 - -0.00003445 -0.00003469 0.00010272 - #*EXTRAS*# Step: 3 Bead: 14 - 0.00010312 -0.00003449 -0.00003444 - -0.00003449 0.00010310 -0.00003468 - -0.00003444 -0.00003468 0.00010271 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.fric_15 b/drivers/py/pes/friction/frictionH/100K/inst.fric_15 deleted file mode 100644 index 9347f9578..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.fric_15 +++ /dev/null @@ -1,16 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 - 0.00010230 -0.00003314 -0.00003313 - -0.00003314 0.00010224 -0.00003332 - -0.00003313 -0.00003332 0.00010188 - #*EXTRAS*# Step: 1 Bead: 15 - 0.00010276 -0.00003392 -0.00003389 - -0.00003392 0.00010272 -0.00003412 - -0.00003389 -0.00003412 0.00010234 - #*EXTRAS*# Step: 2 Bead: 15 - 0.00010279 -0.00003397 -0.00003394 - -0.00003397 0.00010276 -0.00003416 - -0.00003394 -0.00003416 0.00010237 - #*EXTRAS*# Step: 3 Bead: 15 - 0.00010279 -0.00003397 -0.00003393 - -0.00003397 0.00010275 -0.00003416 - -0.00003393 -0.00003416 0.00010237 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 deleted file mode 100644 index a6a052bfa..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -1.050517860129783747e-03 9.137377647459879134e-05 9.080076934705130103e-05 1.178129399549104179e-04 8.656782020056923263e-05 8.497857656328429692e-05 -1.839923589039999972e-03 7.664696890966431740e-05 7.343154878584933279e-05 -4.423996751035020117e-03 6.102020189716153450e-05 5.758595437316045443e-05 -7.047071182251181398e-03 3.940891176778663671e-05 3.874481561485502610e-05 -9.078818164525201406e-03 1.692601931631166281e-05 1.946060847677243339e-05 -1.058199854381223701e-02 7.800639930314340822e-06 7.217351389507211251e-06 -1.083667114478526969e-02 2.593238188225781334e-06 2.552002872206671510e-06 -9.921540925601133459e-03 6.259508353564666123e-06 5.659563371109159885e-06 -8.479624240518145173e-03 1.386635571090646034e-05 1.399879054847931025e-05 -6.229567820365948874e-03 2.345006844083807730e-05 2.392746986455571035e-05 -3.893302608673681730e-03 3.344568950727864077e-05 3.352476241467512746e-05 -2.191828138098487772e-03 4.216422701134765885e-05 4.183657985971831031e-05 -1.038762715447995918e-03 4.882823999975094241e-05 4.815070241842687467e-05 -3.353516870363075736e-04 5.308790475332863455e-05 5.228864694523198940e-05 -1.773106875336378455e-05 5.507021293517846142e-05 5.426922874764085643e-05 3.878564293902863461e-11 5.511521556556987500e-01 -5.431729595932984637e-09 5.546704409993564131e-11 5.511521547152667955e-01 -6.368490155958578424e-09 5.835394086916648821e-11 5.511521550791331769e-01 -5.993312153256271465e-09 4.064924801164622677e-11 5.511521567029800117e-01 -4.358216563799630414e-09 1.599955001862748218e-11 5.511521588887506873e-01 -2.180299948695036550e-09 3.687192521261455043e-12 5.511521602952530463e-01 -7.887951571223996942e-10 3.190542404788802543e-13 5.511521609502595398e-01 -1.387516896008230498e-10 -3.113685996160978671e-15 5.511521610953061812e-01 5.885055055099548622e-12 1.984859460352787048e-14 5.511521611151838362e-01 2.578351401817867988e-11 4.702753944874935729e-13 5.511521613557449628e-01 2.666397360173306995e-10 2.393661953991340362e-12 5.511521620116702769e-01 9.223853510470508265e-10 4.587836567963637808e-12 5.511521624595412394e-01 1.369203256571597783e-09 7.067273421773703991e-12 5.511521628127235006e-01 1.721902298582995282e-09 1.010535776248566286e-11 5.511521631424967094e-01 2.051920644821578343e-09 1.436326966518886797e-11 5.511521635340919101e-01 2.444138555299355913e-09 2.035507864618434081e-11 5.511521639819079166e-01 2.892442619407331377e-09 3.877164154775360834e-11 -5.431729595932984637e-09 5.511521556596211679e-01 5.541802710219232855e-11 -6.368490155958578424e-09 5.511521547265276766e-01 5.818942496015227270e-11 -5.993312153256271465e-09 5.511521551129745511e-01 4.038797799560765619e-11 -4.358216563799630414e-09 5.511521567591854964e-01 1.585167523763928647e-11 -2.180299948695036550e-09 5.511521589292412981e-01 3.662390690904984888e-12 -7.887951571223996942e-10 5.511521603059005292e-01 3.181857067751855997e-13 -1.387516896008230498e-10 5.511521609510159347e-01 -3.097207287799526332e-15 5.885055055099548622e-12 5.511521610952438976e-01 1.984061053531491511e-14 2.578351401817867988e-11 5.511521611151630751e-01 4.707781743740401551e-13 2.666397360173306995e-10 5.511521613563146182e-01 2.393934359094164782e-12 9.223853510470508265e-10 5.511521620118802200e-01 4.584661932497964804e-12 1.369203256571597783e-09 5.511521624576457556e-01 7.061403876044906421e-12 1.721902298582995282e-09 5.511521628098621228e-01 1.009951972210817901e-11 2.051920644821578343e-09 5.511521631401251620e-01 1.435995957830825988e-11 2.444138555299355913e-09 5.511521635329652558e-01 2.035454836594628425e-11 2.892442619407331377e-09 5.511521639817571483e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 deleted file mode 100644 index 00a2f50d1..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -1.547049005068653824e-03 9.137371869098474320e-05 9.080071160986283058e-05 5.234389164450525345e-04 8.656774464689491314e-05 8.497850107882375006e-05 -1.511610417664242204e-03 7.664689661880846655e-05 7.343147668609034901e-05 -4.151875635085658725e-03 6.102015657549366134e-05 5.758590933842922053e-05 -6.824704535833937998e-03 3.940889689596180253e-05 3.874480087994355398e-05 -8.899779785322367923e-03 1.692601853917599972e-05 1.946060771880295072e-05 -1.045003894060336606e-02 7.800653391470694229e-06 7.217364788324546908e-06 -1.089439484638547208e-02 -1.021424290081238819e-05 -1.016375295004150610e-05 -1.010995660169375192e-02 6.259539924342483732e-06 5.659594618558983883e-06 -8.831010053073339375e-03 1.386636484358593459e-05 1.399879962938895070e-05 -6.802865082104048340e-03 2.345007354320162646e-05 2.392747499577482938e-05 -4.447323738845432306e-03 3.344569019976786537e-05 3.352476312077794690e-05 -2.664370271146937041e-03 4.216422376575357131e-05 4.183657661963358256e-05 -1.435560871580145951e-03 4.882823258936063430e-05 4.815069501232059493e-05 -6.709264511840144860e-04 5.308789210481572123e-05 5.228863429953312282e-05 -3.018892205201477788e-04 5.507019350437198317e-05 5.426920931733990100e-05 -1.899797110752491445e-11 5.511521545857042126e-01 -6.492557399128173309e-09 -2.008663022283076502e-11 5.511521539176257312e-01 -7.164554419274858609e-09 -1.393691497990999496e-11 5.511521546935270743e-01 -6.383621401557910681e-09 -4.672419860233382060e-12 5.511521566315045195e-01 -4.433283872031866492e-09 1.127725184388341346e-12 5.511521588729922927e-01 -2.194810161549793273e-09 2.910056859636346388e-12 5.511521599863095089e-01 -1.100915062180056710e-09 1.378021059394880733e-11 5.511521591926804575e-01 -1.888009422939506122e-09 -1.280748109215185544e-05 5.511616021473888516e-01 9.373442552017758995e-06 3.159062641182510646e-11 5.511521647317467743e-01 3.605075527036901181e-09 9.602954868184017190e-12 5.511521631983460345e-01 2.097690815967441940e-09 7.496025504844782051e-12 5.511521634464904285e-01 2.366250588646460493e-09 5.280325789939219483e-12 5.511521632670358661e-01 2.181939016785759146e-09 3.821679334311839881e-12 5.511521631991660453e-01 2.109573494894366702e-09 2.694967457533918124e-12 5.511521632912748103e-01 2.200617933298613764e-09 1.714756754187457254e-12 5.511521635742250291e-01 2.484110766697943730e-09 9.242721704923633655e-13 5.511521639891461266e-01 2.899666373774540462e-09 -1.896554692666287935e-11 -6.492557399128173309e-09 5.511521546078815836e-01 -2.006643344406034815e-11 -7.164554419274858609e-09 5.511521539320370922e-01 -1.391033402970311800e-11 -6.383621401557910681e-09 5.511521547179047964e-01 -4.646753240684107385e-12 -4.433283872031866492e-09 5.511521566803458949e-01 1.116763764728796893e-12 -2.194810161549793273e-09 5.511521589158804302e-01 2.904421207701438581e-12 -1.100915062180056710e-09 5.511521599905715441e-01 1.371700304278314234e-11 -1.888009422939506122e-09 5.511521592100401268e-01 -1.271575582534538322e-05 9.373442552017758995e-06 5.511614674007467851e-01 3.126729043492881165e-11 3.605075527036901181e-09 5.511521646575683331e-01 9.551687814119367623e-12 2.097690815967441940e-09 5.511521631758881101e-01 7.525153477189238591e-12 2.366250588646460493e-09 5.511521634648476331e-01 5.290764750036390172e-12 2.181939016785759146e-09 5.511521632756566369e-01 3.821319148818858819e-12 2.109573494894366702e-09 5.511521631987659209e-01 2.693413445270125018e-12 2.200617933298613764e-09 5.511521632887417255e-01 1.714260711190161131e-12 2.484110766697943730e-09 5.511521635727771873e-01 9.242474072422969921e-13 2.899666373774540462e-09 5.511521639889664925e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 deleted file mode 100644 index f340d3406..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.504880127178795596e-03 9.137416157409622105e-05 9.080115634843696423e-05 4.810600177144456926e-04 8.656783736698244814e-05 8.497859353809481084e-05 -1.549569322990012763e-03 7.664685544291771234e-05 7.343143513033669205e-05 -4.180263121993529028e-03 6.102012117303012818e-05 5.758587404095699328e-05 -6.841759056459575938e-03 3.940888291383285098e-05 3.874478703187218272e-05 -8.907886529546129445e-03 1.692601221105240398e-05 1.946060140314252322e-05 -1.045298517733375329e-02 7.800637204616011670e-06 7.217348675717499570e-06 -1.090810133748788477e-02 2.593923888822581751e-06 2.552683661425936504e-06 -1.011160454568261167e-02 6.259505570746042522e-06 5.659560616555116020e-06 -8.837031777241995123e-03 1.386635187035533797e-05 1.399878672540840682e-05 -6.817189420895747483e-03 2.345005984786747343e-05 2.392746124733194095e-05 -4.465634650934999055e-03 3.344567645512027407e-05 3.352474934910418378e-05 -2.682616101407273718e-03 4.216420882818310364e-05 4.183656168482858260e-05 -1.453158177267646492e-03 4.882821544821529930e-05 4.815067788550444854e-05 -6.879176932980816169e-04 5.308787176017931139e-05 5.228861397049401155e-05 -3.186410377093020310e-04 5.507016958296459351e-05 5.426918540974884521e-05 4.238851403649504143e-10 5.511521716004851301e-01 1.055802006292393764e-08 7.263345731094296724e-11 5.511521635089769999e-01 2.411579117044852458e-09 -5.511280573956027312e-11 5.511521582315089818e-01 -2.876355490938555675e-09 -4.007488339049367056e-11 5.511521575660071059e-01 -3.511819269740003725e-09 -1.285440376486393354e-11 5.511521590452613806e-01 -2.024501481999041767e-09 -3.418066736406546727e-12 5.511521600065242277e-01 -1.080661201556777941e-09 -2.406644088104912849e-12 5.511521591938925990e-01 -1.886796025306010208e-09 6.856974831145022653e-10 5.511616012172290135e-01 9.372512204770956957e-06 -2.762970029401101594e-12 5.511521647319608253e-01 3.605288950698538458e-09 -3.370275728720705661e-12 5.511521632021948447e-01 2.101521274652597781e-09 -6.199308647203065054e-12 5.511521634705879302e-01 2.390393670275831714e-09 -8.464321798869456809e-12 5.511521633320169977e-01 2.246972928805925670e-09 -1.111589113116243584e-11 5.511521633133432685e-01 2.223479932791307490e-09 -1.444617787612688549e-11 5.511521634560607730e-01 2.364573152707615681e-09 -1.862987965486285384e-11 5.511521637794406514e-01 2.687866566928897554e-09 -2.299713522175376640e-11 5.511521642173146107e-01 3.126007943062966230e-09 4.257730272032909475e-10 1.055802006292393764e-08 5.511521716943308391e-01 7.239283762272789054e-11 2.411579117044852458e-09 5.511521634929770208e-01 -5.546608768224437133e-11 -2.876355490938555675e-09 5.511521581947212978e-01 -3.994422546731439709e-11 -3.511819269740003725e-09 5.511521575889544167e-01 -1.273130760800347450e-11 -2.024501481999041767e-09 5.511521590842509699e-01 -3.411239219614883232e-12 -1.080661201556777941e-09 5.511521600108646446e-01 -2.395604004366810750e-12 -1.886796025306010208e-09 5.511521592112548218e-01 6.807861220593759092e-10 9.372512204770956957e-06 5.511614664702625399e-01 -2.734713432814151614e-12 3.605288950698538458e-09 5.511521646577811628e-01 -3.352292729859714780e-12 2.101521274652597781e-09 5.511521631797002829e-01 -6.223289409589567332e-12 2.390393670275831714e-09 5.511521634890363952e-01 -8.480909012933123051e-12 2.246972928805925670e-09 5.511521633407433507e-01 -1.111348584778844879e-11 2.223479932791307490e-09 5.511521633124022435e-01 -1.443340270446139239e-11 2.364573152707615681e-09 5.511521634518704582e-01 -1.861477839774182587e-11 2.687866566928897554e-09 5.511521637750835811e-01 -2.298334364987898664e-11 3.126007943062966230e-09 5.511521642134957766e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener deleted file mode 100644 index 938fa6134..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.08401548407667692 -1 0.08754521678856948 -2 0.09470243661361648 -3 0.10537225682720777 -4 0.1185798979659253 -5 0.1317789623338205 -6 0.1417109668300342 -7 0.1461109436421305 -8 0.1438103938424093 -9 0.13656002811924284 -10 0.1265854826602397 -11 0.11509595940389292 -12 0.1040808765227056 -13 0.09516630384107448 -14 0.08907266597203442 -15 0.0860117519104789 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz deleted file mode 100644 index 0996dff6a..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.146859278870165 -5.449829941095884e-05 -5.4478625218686e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1612971314069163 -5.446285174334084e-05 -5.441472189867923e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.1903005179820383 -5.4043839955618416e-05 -5.389147513190431e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.2339066720680725 -5.211221350891898e-05 -5.1777265362761315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.291623338866595 -4.7065760539437984e-05 -4.6630758365943643e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.361961026553299 -3.749023624795268e-05 -3.723806101933786e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.442192509627326 -2.353491062911471e-05 -2.3470849671114148e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.528420283284796 -6.657887038781299e-06 -6.622758944598768e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.615920230803764 1.1194041937275928e-05 1.1189539146511076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7000073768459254 2.7722486330324536e-05 2.7752118580099324e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7766202660352324 4.163782020597758e-05 4.164255869950001e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.8427079146927157 5.243925876247678e-05 5.240297371747839e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.8964780415567897 6.0247298557699757e-05 6.0197261682826016e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.9370766621284594 6.551663498040769e-05 6.547878488392058e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.964185114883056 6.874877652775765e-05 6.873293303065284e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.977734879913919 7.031145716070451e-05 7.030962544190375e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener deleted file mode 100644 index 60c934b53..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.0843255133367963 -1 0.08784695646818827 -2 0.09498561716298513 -3 0.10561815627972837 -4 0.11876220966359217 -5 0.13187767823589117 -6 0.14174105051536662 -7 0.14611096877995308 -8 0.14383135833979266 -9 0.1366328848797003 -10 0.12672863574611695 -11 0.11530963583959201 -12 0.10433880599460289 -13 0.09544487775657724 -14 0.08935791114416519 -15 0.08629819900209464 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz deleted file mode 100644 index 0224c3c50..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.148133397641608 -5.6368817387021064e-05 -5.6333119372623966e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1625253624323557 -5.6185428690941034e-05 -5.613389377798902e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.1914462608314498 -5.528578740524542e-05 -5.514856639305492e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.2349304568519095 -5.2637078253721405e-05 -5.23284958154783e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.292476040325305 -4.683882154297555e-05 -4.6421798679784094e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.3625855268875413 -3.666988901860317e-05 -3.6409279339036924e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4425304901279286 -2.2301406193119662e-05 -2.2243185290963054e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.528422374249604 -5.229420370114218e-06 -5.204522741712072e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6155755462322707 1.2704219275441677e-05 1.2684153189650736e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.699336099904963 2.925968573649099e-05 2.9279682346767077e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7756827079288064 4.312105337360357e-05 4.313514219806029e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.841600109751384 5.377668675700697e-05 5.374908241960164e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.8952755148976133 6.133475936142847e-05 6.128817999069391e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.9358293111973652 6.628040058734201e-05 6.624213561593327e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.9629211858445386 6.91858274747947e-05 6.916823171139528e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.9764675121102053 7.051364415499827e-05 7.051140746154286e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener deleted file mode 100644 index b920c5bf6..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.08432987489204383 -1 0.0878524706854077 -2 0.09499319420842016 -3 0.10562813455736628 -4 0.11877371459529028 -5 0.13188807751455592 -6 0.14174778956629122 -7 0.1461119622637928 -8 0.14382628338760886 -9 0.13662413424783038 -10 0.12671720061007438 -11 0.1152963578742579 -12 0.10432512307868111 -13 0.09543144662083826 -14 0.08934484742343426 -15 0.0862853441449061 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz deleted file mode 100644 index abaf7a4b9..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.1481513105503063 -5.6728823888303693e-05 -5.669388366511533e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1625477986976436 -5.6523010310080725e-05 -5.647093972619754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.191476918067772 -5.558172842824559e-05 -5.5441937521734e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.234972025953747 -5.287553137511578e-05 -5.256362153179287e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.2925299213224477 -4.7010023031763155e-05 -4.659105181171756e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.362651437553636 -3.6773917361895325e-05 -3.651350928961778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4426063516256007 -2.2349649542041483e-05 -2.229148249397201e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.528504449913656 -5.2324006940668625e-06 -5.2075256118839885e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.615659112134053 1.2736128217445895e-05 1.2715956697533609e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6994168427892715 2.9324411359713385e-05 2.9344099598348424e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7757577354079017 4.321843774305908e-05 4.3232710888588496e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.841669045376808 5.3906600632539787e-05 5.387910180261609e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.8953393601572226 6.149452327187083e-05 6.144756513831276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.935889475107298 6.64645673476594e-05 6.64253742280368e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.962979080068986 6.938709677345481e-05 6.93680696838832e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.976524391003271 7.072364257571076e-05 7.07197250689878e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 deleted file mode 100644 index 1cd016dfe..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.611286394922204282e-03 8.961030064316105972e-05 9.017023014854777443e-05 5.856372175742745323e-04 8.470728513569665704e-05 8.414123196024390645e-05 -1.449750754399124417e-03 7.541134224952320995e-05 7.279182823453407168e-05 -4.092204957287064182e-03 6.096093172076889595e-05 5.756835785661582907e-05 -6.775169995944501505e-03 4.106341803733507760e-05 3.973757527314467498e-05 -8.870650586407785934e-03 1.877840498689645112e-05 2.109537634456014397e-05 -1.043820444269192606e-02 8.165683506793692430e-06 8.239023186875773044e-06 -1.091276940996600310e-02 2.948470800730174351e-06 2.745671705410905833e-06 -1.013144625619836342e-02 4.979503363004260527e-06 4.438414103693054803e-06 -8.865765120917839387e-03 1.214177282481926725e-05 1.182308253333018487e-05 -6.850839932681651590e-03 2.094530887679483839e-05 2.152338214046350961e-05 -4.502084240976802695e-03 3.075445180364604709e-05 3.107640664454439767e-05 -2.719159883747502768e-03 3.973398434496290131e-05 3.964875140589896579e-05 -1.488037204041506995e-03 4.686282404387732341e-05 4.641577665866609926e-05 -7.207542386444745069e-04 5.169243702285745631e-05 5.097693437666156826e-05 -3.503673974517441253e-04 5.406487834837693084e-05 5.325529805098400344e-05 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 5.082197683525802034e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893900247e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.117582368135750848e-19 5.511521610893899137e-01 0.000000000000000000e+00 4.235164736271501695e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 1.694065894508600678e-18 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.388131789017201356e-18 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener deleted file mode 100644 index b920c5bf6..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.08432987489204383 -1 0.0878524706854077 -2 0.09499319420842016 -3 0.10562813455736628 -4 0.11877371459529028 -5 0.13188807751455592 -6 0.14174778956629122 -7 0.1461119622637928 -8 0.14382628338760886 -9 0.13662413424783038 -10 0.12671720061007438 -11 0.1152963578742579 -12 0.10432512307868111 -13 0.09543144662083826 -14 0.08934484742343426 -15 0.0862853441449061 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz deleted file mode 100644 index abaf7a4b9..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.1481513105503063 -5.6728823888303693e-05 -5.669388366511533e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1625477986976436 -5.6523010310080725e-05 -5.647093972619754e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.191476918067772 -5.558172842824559e-05 -5.5441937521734e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.234972025953747 -5.287553137511578e-05 -5.256362153179287e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.2925299213224477 -4.7010023031763155e-05 -4.659105181171756e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.362651437553636 -3.6773917361895325e-05 -3.651350928961778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4426063516256007 -2.2349649542041483e-05 -2.229148249397201e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.528504449913656 -5.2324006940668625e-06 -5.2075256118839885e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.615659112134053 1.2736128217445895e-05 1.2715956697533609e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6994168427892715 2.9324411359713385e-05 2.9344099598348424e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7757577354079017 4.321843774305908e-05 4.3232710888588496e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.841669045376808 5.3906600632539787e-05 5.387910180261609e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.8953393601572226 6.149452327187083e-05 6.144756513831276e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.935889475107298 6.64645673476594e-05 6.64253742280368e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.962979080068986 6.938709677345481e-05 6.93680696838832e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.976524391003271 7.072364257571076e-05 7.07197250689878e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz deleted file mode 100644 index df3cd38c8..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_FINAL_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.002965781422542287 3.126621388209799e-05 3.124695650257878e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002980038231166456 3.1152779283678856e-05 3.1124080468842454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002964097613290698 3.0633989740311134e-05 3.0556943680086626e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002837462892814288 2.91424633861449e-05 2.8970553601932426e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0025156948253141557 2.5909675786818254e-05 2.567875889345587e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0019574210269958075 2.0268024025731247e-05 2.0124499553930356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.001178617306289033 1.2318057644686657e-05 1.2285998750438975e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00024981869133459684 2.883848950220575e-06 2.870138994918208e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006705542066480325 -7.019544590956866e-06 -7.00842701416475e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0014682248333194579 -1.616221269358029e-05 -1.6173063908852032e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002071878461740548 -2.3819935360994266e-05 -2.382780203599835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002444099987435397 -2.9710739435606978e-05 -2.96955833960671e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0026350626818643402 -3.3892839396453387e-05 -3.3866958319662135e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002718525123006677 -3.663208992953378e-05 -3.661048855695395e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027473959786251194 -3.8242848338408254e-05 -3.8232361516871624e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0027541892093779375 -3.897948844571658e-05 -3.897732930342013e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz deleted file mode 100644 index fc6ca5306..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0029637837465429457 3.0036855496046588e-05 3.002601202245773e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0029793848871368313 3.0017318437433344e-05 2.999079156953521e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002965877267357862 2.9786379185108204e-05 2.9702402983244174e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0028418873815580933 2.872175909459239e-05 2.8537151699984712e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0025218828978923157 2.5940395634626974e-05 2.570064324662699e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.001963566040956436 2.0662824727810906e-05 2.0523837805586632e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0011829421770344526 1.2971316854282227e-05 1.2936009518838759e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00025073678981234583 3.669508829713351e-06 3.650147904689699e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006731939856464283 -6.169620405054888e-06 -6.167138682193907e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0014734394037977704 -1.527930825172944e-05 -1.5295640130230752e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0020777451416223525 -2.294877458957601e-05 -2.2951386220521206e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0024487190118945156 -2.89020107928648e-05 -2.8882012211898714e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002638095490720559 -3.32054287998739e-05 -3.3177850868153086e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00272022843538358 -3.610963495675642e-05 -3.6088773794280107e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027482042226856396 -3.789103675552515e-05 -3.788230457785662e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002754553735061706 -3.875231156346635e-05 -3.87513020076908e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz deleted file mode 100644 index ce0dea908..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0029657545314150744 3.1067795520909834e-05 3.1048120483128274e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0029800274958416808 3.096672044474596e-05 3.0938316866100904e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002964145163029242 3.0470881205929584e-05 3.0395251548513925e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0028376366906880733 2.901103943296988e-05 2.884096355525796e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0025160634794188647 2.5815317716291247e-05 2.558547466401959e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.001958008155519629 2.0210688579511225e-05 2.0067052991417474e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.001179410286124635 1.2291468218670207e-05 1.2259379642626017e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0002507139810108103 2.8822063382333284e-06 2.868483956533485e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006697092216754329 -7.001957908613163e-06 -6.990898442064881e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0014675113076843098 -1.612653902646341e-05 -1.6137560201431533e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002071366989822023 -2.3766261755312533e-05 -2.3774026841359067e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002443792154821744 -2.9639137122351565e-05 -2.962392293213518e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0026348914229473593 -3.380478517194899e-05 -3.3779112851106453e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0027184377131445796 -3.653058602158401e-05 -3.650949619989807e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027473561732979917 -3.8131918329490784e-05 -3.812222038646718e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0027541711082983028 -3.8863747362315525e-05 -3.886251460388388e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz deleted file mode 100644 index df3cd38c8..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.002965781422542287 3.126621388209799e-05 3.124695650257878e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002980038231166456 3.1152779283678856e-05 3.1124080468842454e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002964097613290698 3.0633989740311134e-05 3.0556943680086626e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002837462892814288 2.91424633861449e-05 2.8970553601932426e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0025156948253141557 2.5909675786818254e-05 2.567875889345587e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0019574210269958075 2.0268024025731247e-05 2.0124499553930356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.001178617306289033 1.2318057644686657e-05 1.2285998750438975e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00024981869133459684 2.883848950220575e-06 2.870138994918208e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006705542066480325 -7.019544590956866e-06 -7.00842701416475e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0014682248333194579 -1.616221269358029e-05 -1.6173063908852032e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002071878461740548 -2.3819935360994266e-05 -2.382780203599835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002444099987435397 -2.9710739435606978e-05 -2.96955833960671e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0026350626818643402 -3.3892839396453387e-05 -3.3866958319662135e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002718525123006677 -3.663208992953378e-05 -3.661048855695395e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027473959786251194 -3.8242848338408254e-05 -3.8232361516871624e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0027541892093779375 -3.897948844571658e-05 -3.897732930342013e-05 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 b/drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 deleted file mode 100644 index aa2c39b08..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.instantonfric_FINAL.hess_2 +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_00 b/drivers/py/pes/friction/frictionH/100K/inst.raw_00 deleted file mode 100644 index 921f2f18b..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_00 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 -{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} - #*EXTRAS*# Step: 1 Bead: 0 -{"friction": [[0.00013241049292501075, -3.014138508434695e-05, -3.009727779414303e-05], [-3.014138508434695e-05, 0.00013265847632881606, -3.009110158821114e-05], [-3.009727779414303e-05, -3.009110158821114e-05, 0.00013224628677061011]]} - #*EXTRAS*# Step: 2 Bead: 0 -{"friction": [[0.0001323728844522918, -3.0243698063094377e-05, -3.020005181941969e-05], [-3.0243698063094377e-05, 0.0001326207984892998, -3.0194681323071223e-05], [-3.020005181941969e-05, -3.0194681323071223e-05, 0.00013220435948451466]]} - #*EXTRAS*# Step: 3 Bead: 0 -{"friction": [[0.0001323723536194066, -3.024513447791457e-05, -3.0201493813233374e-05], [-3.024513447791457e-05, 0.00013262026643441214, -3.0196135574590085e-05], [-3.0201493813233374e-05, -3.0196135574590085e-05, 0.0001322037682428345]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_01 b/drivers/py/pes/friction/frictionH/100K/inst.raw_01 deleted file mode 100644 index 73a37c494..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_01 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 -{"friction": [[0.00013154835182754853, -3.2245612347009654e-05, -3.218171211344349e-05], [-3.2245612347009654e-05, 0.00013178701661774967, -3.222276035226155e-05], [-3.218171211344349e-05, -3.222276035226155e-05, 0.00013130290733224788]]} - #*EXTRAS*# Step: 1 Bead: 1 -{"friction": [[0.00013196653667926246, -3.128434745737252e-05, -3.1237689188435446e-05], [-3.128434745737252e-05, 0.00013221164032712512, -3.1248618231329475e-05], [-3.1237689188435446e-05, -3.1248618231329475e-05, 0.00013175605235207647]]} - #*EXTRAS*# Step: 2 Bead: 1 -{"friction": [[0.00013192690141785403, -3.137992775646232e-05, -3.1332225269561344e-05], [-3.137992775646232e-05, 0.00013217154065750227, -3.134545419891963e-05], [-3.1332225269561344e-05, -3.134545419891963e-05, 0.00013171276271381206]]} - #*EXTRAS*# Step: 3 Bead: 1 -{"friction": [[0.00013192617456524053, -3.138167134170412e-05, -3.133394850999344e-05], [-3.138167134170412e-05, 0.00013217080498963396, -3.134722074290985e-05], [-3.133394850999344e-05, -3.134722074290985e-05, 0.00013171196953902834]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_02 b/drivers/py/pes/friction/frictionH/100K/inst.raw_02 deleted file mode 100644 index 08ff2a346..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_02 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 -{"friction": [[0.0001305169912654799, -3.426881693488592e-05, -3.4119381770048507e-05], [-3.426881693488592e-05, 0.0001307291042872236, -3.427459924542595e-05], [-3.4119381770048507e-05, -3.427459924542595e-05, 0.00013021252399325722]]} - #*EXTRAS*# Step: 1 Bead: 2 -{"friction": [[0.00013094800444368891, -3.347208021256161e-05, -3.3363682543472525e-05], [-3.347208021256161e-05, 0.0001311725627001041, -3.3466375413923914e-05], [-3.3363682543472525e-05, -3.3466375413923914e-05, 0.00013066432379213962]]} - #*EXTRAS*# Step: 2 Bead: 2 -{"friction": [[0.00013090444819934417, -3.355541023963473e-05, -3.344313737024578e-05], [-3.355541023963473e-05, 0.00013112782007524884, -3.355089551199853e-05], [-3.344313737024578e-05, -3.355089551199853e-05, 0.00013061844076678366]]} - #*EXTRAS*# Step: 3 Bead: 2 -{"friction": [[0.00013090327966982303, -3.355763652894214e-05, -3.344525873597896e-05], [-3.355763652894214e-05, 0.0001311266194699744, -3.355315363498642e-05], [-3.344525873597896e-05, -3.355315363498642e-05, 0.00013061721055669854]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_03 b/drivers/py/pes/friction/frictionH/100K/inst.raw_03 deleted file mode 100644 index ffadda0b9..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_03 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 -{"friction": [[0.0001286764741586319, -3.714973769009648e-05, -3.679697296268993e-05], [-3.714973769009648e-05, 0.0001288266109833087, -3.7198122442431674e-05], [-3.679697296268993e-05, -3.7198122442431674e-05, 0.00012832661431276367]]} - #*EXTRAS*# Step: 1 Bead: 3 -{"friction": [[0.00012916313081760334, -3.6454096780161434e-05, -3.6155546656339866e-05], [-3.6454096780161434e-05, 0.0001293301646357157, -3.649217979347395e-05], [-3.6155546656339866e-05, -3.649217979347395e-05, 0.00012881956476362225]]} - #*EXTRAS*# Step: 2 Bead: 3 -{"friction": [[0.00012911886117451568, -3.651907593755638e-05, -3.621553020732557e-05], [-3.651907593755638e-05, 0.00012928435621188122, -3.65581243279753e-05], [-3.621553020732557e-05, -3.65581243279753e-05, 0.0001287745708447942]]} - #*EXTRAS*# Step: 3 Bead: 3 -{"friction": [[0.0001291170621567432, -3.6521709076363386e-05, -3.621796051228171e-05], [-3.6521709076363386e-05, 0.0001292824946485849, -3.656079657817937e-05], [-3.621796051228171e-05, -3.656079657817937e-05, 0.0001287727430540458]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_04 b/drivers/py/pes/friction/frictionH/100K/inst.raw_04 deleted file mode 100644 index e5997d434..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_04 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 -{"friction": [[0.000126076844382827, -4.029075427069417e-05, -3.973794837135237e-05], [-4.029075427069417e-05, 0.000126150633634249, -4.038143906978131e-05], [-3.973794837135237e-05, -4.038143906978131e-05, 0.00012574927445048358]]} - #*EXTRAS*# Step: 1 Bead: 4 -{"friction": [[0.00012662713675010322, -3.969736472933639e-05, -3.91661900500724e-05], [-3.969736472933639e-05, 0.00012671347809779037, -3.978112464531575e-05], [-3.91661900500724e-05, -3.978112464531575e-05, 0.0001262872538841391]]} - #*EXTRAS*# Step: 2 Bead: 4 -{"friction": [[0.00012659017450728093, -3.973835386854741e-05, -3.920524497404498e-05], [-3.973835386854741e-05, 0.00012667558551988773, -3.982261818977218e-05], [-3.920524497404498e-05, -3.982261818977218e-05, 0.00012625098816427898]]} - #*EXTRAS*# Step: 3 Bead: 4 -{"friction": [[0.00012658784052356454, -3.974093662473778e-05, -3.920770773140275e-05], [-3.974093662473778e-05, 0.00012667319317443055, -3.9825232615144797e-05], [-3.920770773140275e-05, -3.9825232615144797e-05, 0.00012624869878371224]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_05 b/drivers/py/pes/friction/frictionH/100K/inst.raw_05 deleted file mode 100644 index 23c986860..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_05 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 -{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} - #*EXTRAS*# Step: 1 Bead: 5 -{"friction": [[0.00012384764487746069, -4.230644904853384e-05, -4.190463885290095e-05], [-4.230644904853384e-05, 0.00012391271374757542, -4.240537211215134e-05], [-4.190463885290095e-05, -4.240537211215134e-05, 0.00012361827576529272]]} - #*EXTRAS*# Step: 2 Bead: 5 -{"friction": [[0.0001238255850732477, -4.232285939039786e-05, -4.192464654714575e-05], [-4.232285939039786e-05, 0.00012389084208806034, -4.2421561486696214e-05], [-4.192464654714575e-05, -4.2421561486696214e-05, 0.00012359756533038296]]} - #*EXTRAS*# Step: 3 Bead: 5 -{"friction": [[0.0001238232586613388, -4.232458550391126e-05, -4.192675365724461e-05], [-4.232458550391126e-05, 0.00012388853547303105, -4.242326371568662e-05], [-4.192675365724461e-05, -4.242326371568662e-05, 0.00012359538151910022]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_06 b/drivers/py/pes/friction/frictionH/100K/inst.raw_06 deleted file mode 100644 index c8643b67b..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_06 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 -{"friction": [[0.00012028748904337296, -4.4090190695074945e-05, -4.407165498061319e-05], [-4.4090190695074945e-05, 0.00012019515217934021, -4.396133059277882e-05], [-4.407165498061319e-05, -4.396133059277882e-05, 0.00012024878352738596]]} - #*EXTRAS*# Step: 1 Bead: 6 -{"friction": [[0.00012105973524236423, -4.381667770746481e-05, -4.380956687073731e-05], [-4.381667770746481e-05, 0.00012104923789500364, -4.377185326774247e-05], [-4.380956687073731e-05, -4.377185326774247e-05, 0.00012099478770101877]]} - #*EXTRAS*# Step: 2 Bead: 6 -{"friction": [[0.00012104730372598911, -4.3821441567513924e-05, -4.38146297635182e-05], [-4.3821441567513924e-05, 0.0001210356774853799, -4.3775368252327964e-05], [-4.38146297635182e-05, -4.3775368252327964e-05, 0.00012098286165606746]]} - #*EXTRAS*# Step: 3 Bead: 6 -{"friction": [[0.00012104451178443285, -4.3822509881205753e-05, -4.381576266322912e-05], [-4.3822509881205753e-05, 0.00012103263092868946, -4.37761554370922e-05], [-4.381576266322912e-05, -4.37761554370922e-05, 0.00012098018281360565]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_07 b/drivers/py/pes/friction/frictionH/100K/inst.raw_07 deleted file mode 100644 index be9fb0835..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_07 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 -{"friction": [[0.00011665083949596382, -4.4607528816683966e-05, -4.431825914901668e-05], [-4.4607528816683966e-05, 0.0001162267076263409, -4.4207173972077276e-05], [-4.431825914901668e-05, -4.4207173972077276e-05, 0.00011666327977368902]]} - #*EXTRAS*# Step: 1 Bead: 7 -{"friction": [[0.00011765715504790232, -4.46199139017368e-05, -4.437744402313602e-05], [-4.46199139017368e-05, 0.00011727374701921973, -4.4239063405498226e-05], [-4.437744402313602e-05, -4.4239063405498226e-05, 0.00011766079945326452]]} - #*EXTRAS*# Step: 2 Bead: 7 -{"friction": [[0.00011765707061276232, -4.4619918819381765e-05, -4.43774426152651e-05], [-4.4619918819381765e-05, 0.00011727365647092287, -4.4239063996128744e-05], [-4.43774426152651e-05, -4.4239063996128744e-05, 0.0001176607157907547]]} - #*EXTRAS*# Step: 3 Bead: 7 -{"friction": [[0.0001176537563883208, -4.4620111117280195e-05, -4.4377386865271886e-05], [-4.4620111117280195e-05, 0.0001172701025942119, -4.423908675760213e-05], [-4.4377386865271886e-05, -4.423908675760213e-05, 0.00011765743188217148]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_08 b/drivers/py/pes/friction/frictionH/100K/inst.raw_08 deleted file mode 100644 index 75fa5f024..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_08 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 -{"friction": [[0.00011321589094004546, -4.351814646398022e-05, -4.345964836559014e-05], [-4.351814646398022e-05, 0.00011306154132995574, -4.343115956369095e-05], [-4.345964836559014e-05, -4.343115956369095e-05, 0.00011326318332248197]]} - #*EXTRAS*# Step: 1 Bead: 8 -{"friction": [[0.00011427340352367481, -4.400314389839773e-05, -4.383835702708663e-05], [-4.400314389839773e-05, 0.00011399870247804618, -4.3790177173609096e-05], [-4.383835702708663e-05, -4.3790177173609096e-05, 0.00011430892127181576]]} - #*EXTRAS*# Step: 2 Bead: 8 -{"friction": [[0.00011428612220636616, -4.400828110279431e-05, -4.3842268479836776e-05], [-4.400828110279431e-05, 0.0001140100348907737, -4.379380571514355e-05], [-4.3842268479836776e-05, -4.379380571514355e-05, 0.0001143215044690975]]} - #*EXTRAS*# Step: 3 Bead: 8 -{"friction": [[0.00011428303825712806, -4.40070371113712e-05, -4.3841321435874e-05], [-4.40070371113712e-05, 0.00011400728678894107, -4.37929273542915e-05], [-4.3841321435874e-05, -4.37929273542915e-05, 0.00011431845335864552]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_09 b/drivers/py/pes/friction/frictionH/100K/inst.raw_09 deleted file mode 100644 index df76fe251..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_09 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 -{"friction": [[0.00011023000206976872, -4.1719099977050135e-05, -4.179519325177442e-05], [-4.1719099977050135e-05, 0.00011025478793267088, -4.1768623177242506e-05], [-4.179519325177442e-05, -4.1768623177242506e-05, 0.00011030747133180427]]} - #*EXTRAS*# Step: 1 Bead: 9 -{"friction": [[0.00011129227295643751, -4.2418718901641605e-05, -4.2489083831242044e-05], [-4.2418718901641605e-05, 0.00011129448241102563, -4.2468759923897396e-05], [-4.2489083831242044e-05, -4.2468759923897396e-05, 0.0001113630036578243]]} - #*EXTRAS*# Step: 2 Bead: 9 -{"friction": [[0.00011131521570227761, -4.243307134533579e-05, -4.250284642606272e-05], [-4.243307134533579e-05, 0.00011131649148380761, -4.248263452041488e-05], [-4.250284642606272e-05, -4.248263452041488e-05, 0.00011138569718004684]]} - #*EXTRAS*# Step: 3 Bead: 9 -{"friction": [[0.00011131245546942118, -4.2431346219940264e-05, -4.250119342716394e-05], [-4.2431346219940264e-05, 0.00011131384471044707, -4.2480968194840246e-05], [-4.250119342716394e-05, -4.2480968194840246e-05, 0.00011138296708126943]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_10 b/drivers/py/pes/friction/frictionH/100K/inst.raw_10 deleted file mode 100644 index ab62c70af..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_10 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 -{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} - #*EXTRAS*# Step: 1 Bead: 10 -{"friction": [[0.00010873690700669689, -4.0606269396953805e-05, -4.0640685927403815e-05], [-4.0606269396953805e-05, 0.0001087489278758463, -4.0618852558316136e-05], [-4.0640685927403815e-05, -4.0618852558316136e-05, 0.0001087937999443303]]} - #*EXTRAS*# Step: 2 Bead: 10 -{"friction": [[0.00010876758944238498, -4.0630806696776885e-05, -4.066639091255203e-05], [-4.0630806696776885e-05, 0.00010878009654283601, -4.0644093725262454e-05], [-4.066639091255203e-05, -4.0644093725262454e-05, 0.00010882542862972189]]} - #*EXTRAS*# Step: 3 Bead: 10 -{"friction": [[0.00010876513371408232, -4.0628845507335164e-05, -4.066433648239336e-05], [-4.0628845507335164e-05, 0.00010877760195671858, -4.0642075657745885e-05], [-4.066433648239336e-05, -4.0642075657745885e-05, 0.00010882289813159212]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_11 b/drivers/py/pes/friction/frictionH/100K/inst.raw_11 deleted file mode 100644 index ceb5e9092..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_11 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 -{"friction": [[0.00010562036954718544, -3.769046910141249e-05, -3.763042875179934e-05], [-3.769046910141249e-05, 0.00010561870141779494, -3.7770470863789636e-05], [-3.763042875179934e-05, -3.7770470863789636e-05, 0.0001054411173289977]]} - #*EXTRAS*# Step: 1 Bead: 11 -{"friction": [[0.00010659901857314309, -3.870425743209769e-05, -3.8664729746876114e-05], [-3.870425743209769e-05, 0.00010659423894840385, -3.8735804384514815e-05], [-3.8664729746876114e-05, -3.8735804384514815e-05, 0.00010651814035426669]]} - #*EXTRAS*# Step: 2 Bead: 11 -{"friction": [[0.00010663424047059139, -3.873889540262935e-05, -3.87002915473587e-05], [-3.873889540262935e-05, 0.00010662940683763141, -3.8769015499020965e-05], [-3.87002915473587e-05, -3.8769015499020965e-05, 0.00010655664181312053]]} - #*EXTRAS*# Step: 3 Bead: 11 -{"friction": [[0.0001066320477384514, -3.873674255270047e-05, -3.8698080834126625e-05], [-3.873674255270047e-05, 0.00010662721726753652, -3.8766950665293334e-05], [-3.8698080834126625e-05, -3.8766950665293334e-05, 0.00010655424560561226]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_12 b/drivers/py/pes/friction/frictionH/100K/inst.raw_12 deleted file mode 100644 index a21e2ed22..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_12 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 -{"friction": [[0.00010410059478635681, -3.587758594138993e-05, -3.5810247906280144e-05], [-3.587758594138993e-05, 0.00010409721165943899, -3.604130532787345e-05], [-3.5810247906280144e-05, -3.604130532787345e-05, 0.00010376542350754372]]} - #*EXTRAS*# Step: 1 Bead: 12 -{"friction": [[0.00010494306621244808, -3.6923583822871577e-05, -3.685601015820406e-05], [-3.6923583822871577e-05, 0.0001049430353597666, -3.7042386372285086e-05], [-3.685601015820406e-05, -3.7042386372285086e-05, 0.00010469209498702028]]} - #*EXTRAS*# Step: 2 Bead: 12 -{"friction": [[0.00010497866576286726, -3.696539758299062e-05, -3.689806398806715e-05], [-3.696539758299062e-05, 0.0001049786102977853, -3.708215379115218e-05], [-3.689806398806715e-05, -3.708215379115218e-05, 0.00010473144025740636]]} - #*EXTRAS*# Step: 3 Bead: 12 -{"friction": [[0.00010497677371856505, -3.696317971352253e-05, -3.689583289655348e-05], [-3.696317971352253e-05, 0.00010497671979745289, -3.7080044785837816e-05], [-3.689583289655348e-05, -3.7080044785837816e-05, 0.00010472934894678369]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_13 b/drivers/py/pes/friction/frictionH/100K/inst.raw_13 deleted file mode 100644 index 158e834fa..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_13 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 -{"friction": [[0.00010310461147450481, -3.446489117457354e-05, -3.44165270104119e-05], [-3.446489117457354e-05, 0.00010307920642357731, -3.4657347226921115e-05], [-3.44165270104119e-05, -3.4657347226921115e-05, 0.00010269639584043074]]} - #*EXTRAS*# Step: 1 Bead: 13 -{"friction": [[0.00010379317762040019, -3.546506429569328e-05, -3.54010714373525e-05], [-3.546506429569328e-05, 0.00010378578521589729, -3.564178326908264e-05], [-3.54010714373525e-05, -3.564178326908264e-05, 0.00010343109470027845]]} - #*EXTRAS*# Step: 2 Bead: 13 -{"friction": [[0.00010382683546350151, -3.551114865072701e-05, -3.544669172365276e-05], [-3.551114865072701e-05, 0.00010381998079165979, -3.568658180368192e-05], [-3.544669172365276e-05, -3.568658180368192e-05, 0.00010346755110348192]]} - #*EXTRAS*# Step: 3 Bead: 13 -{"friction": [[0.00010382520936415705, -3.550892758432382e-05, -3.544449250292804e-05], [-3.550892758432382e-05, 0.0001038183293145309, -3.5684423716109555e-05], [-3.544449250292804e-05, -3.5684423716109555e-05, 0.0001034657888826882]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_14 b/drivers/py/pes/friction/frictionH/100K/inst.raw_14 deleted file mode 100644 index 812633348..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_14 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 -{"friction": [[0.0001025334360101724, -3.35409127376559e-05, -3.351447758652769e-05], [-3.35409127376559e-05, 0.00010248196407672836, -3.372632209749448e-05], [-3.351447758652769e-05, -3.372632209749448e-05, 0.00010210975134216749]]} - #*EXTRAS*# Step: 1 Bead: 14 -{"friction": [[0.00010309218543363696, -3.4445728979633114e-05, -3.439776387630997e-05], [-3.4445728979633114e-05, 0.00010306631247558792, -3.463824075438718e-05], [-3.439776387630997e-05, -3.463824075438718e-05, 0.00010268337884146531]]} - #*EXTRAS*# Step: 2 Bead: 14 -{"friction": [[0.00010312352386576237, -3.449397587494829e-05, -3.4445012177632566e-05], [-3.449397587494829e-05, 0.00010309882109006887, -3.468632973255586e-05], [-3.4445012177632566e-05, -3.468632973255586e-05, 0.00010271622696250368]]} - #*EXTRAS*# Step: 3 Bead: 14 -{"friction": [[0.00010312208559256927, -3.449176740016379e-05, -3.444284896247926e-05], [-3.449176740016379e-05, 0.00010309732983078113, -3.468412976566287e-05], [-3.444284896247926e-05, -3.468412976566287e-05, 0.00010271471800731003]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst.raw_15 b/drivers/py/pes/friction/frictionH/100K/inst.raw_15 deleted file mode 100644 index 200491929..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst.raw_15 +++ /dev/null @@ -1,8 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 -{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} - #*EXTRAS*# Step: 1 Bead: 15 -{"friction": [[0.00010276392794825833, -3.392437257841892e-05, -3.388830127282243e-05], [-3.392437257841892e-05, 0.00010272398228244049, -3.411501912503905e-05], [-3.388830127282243e-05, -3.411501912503905e-05, 0.00010234342483199773]]} - #*EXTRAS*# Step: 2 Bead: 15 -{"friction": [[0.00010279406233929465, -3.397345062563802e-05, -3.393618848508074e-05], [-3.397345062563802e-05, 0.0001027555345506456, -3.4164540048979556e-05], [-3.393618848508074e-05, -3.4164540048979556e-05, 0.00010237429898943283]]} - #*EXTRAS*# Step: 3 Bead: 15 -{"friction": [[0.00010279270751910095, -3.397124938221481e-05, -3.3934040394869786e-05], [-3.397124938221481e-05, 0.00010275411647805539, -3.41623200863447e-05], [-3.3934040394869786e-05, -3.41623200863447e-05, 0.00010237290937688125]]} diff --git a/drivers/py/pes/friction/frictionH/100K/inst1D.dat b/drivers/py/pes/friction/frictionH/100K/inst1D.dat deleted file mode 100644 index 1d6c0d4cb..000000000 --- a/drivers/py/pes/friction/frictionH/100K/inst1D.dat +++ /dev/null @@ -1,16 +0,0 @@ -2.1481513105503063 0.08432987489204383 -2.1625477986976436 0.0878524706854077 -2.191476918067772 0.09499319420842016 -2.234972025953747 0.10562813455736628 -2.2925299213224477 0.11877371459529028 -2.362651437553636 0.13188807751455592 -2.4426063516256007 0.14174778956629122 -2.528504449913656 0.1461119622637928 -2.615659112134053 0.14382628338760886 -2.6994168427892715 0.13662413424783038 -2.7757577354079017 0.12671720061007438 -2.841669045376808 0.1152963578742579 -2.8953393601572226 0.10432512307868111 -2.935889475107298 0.09543144662083826 -2.962979080068986 0.08934484742343426 -2.976524391003271 0.0862853441449061 diff --git a/drivers/py/pes/friction/frictionH/100K/z_friction.dat b/drivers/py/pes/friction/frictionH/100K/z_friction.dat deleted file mode 100644 index 88b85ef6d..000000000 --- a/drivers/py/pes/friction/frictionH/100K/z_friction.dat +++ /dev/null @@ -1,1003 +0,0 @@ -#eta 1 -# bath_type Ohmic -# w_c 500 - # freq (cm^-1) Laplace transform -1 0.9915470158218098 -2 0.9848551497951816 -3 0.9788255643617454 -4 0.9732247078293326 -5 0.9679416696883935 -6 0.962911133018018 -7 0.9580899447435153 -8 0.9534474391977994 -9 0.9489606918318892 -10 0.9446119121776004 -11 0.9403868910489187 -12 0.9362740173481964 -13 0.9322636249598021 -14 0.928347541807527 -15 0.9245187684107862 -16 0.9207712425362906 -17 0.9170996629124359 -18 0.9134993545627568 -19 0.9099661641551429 -20 0.9064963774421086 -21 0.9030866532531712 -22 0.8997339700879358 -23 0.8964355824392188 -24 0.8931889847263488 -25 0.8899918812500051 -26 0.8868421609620551 -27 0.8837378761228457 -28 0.8806772241248969 -29 0.8776585319167312 -30 0.874680242577914 -31 0.8717409036863014 -32 0.8688391571880675 -33 0.8659737305354348 -34 0.8631434288998111 -35 0.8603471283020212 -36 0.857583769528487 -37 0.8548523527240882 -38 0.8521519325701771 -39 0.8494816139706848 -40 0.8468405481811211 -41 0.8442279293250585 -42 0.8416429912508109 -43 0.8390850046877706 -44 0.8365532746675381 -45 0.8340471381797273 -46 0.831565962036351 -47 0.8291091409221039 -48 0.8266760956107441 -49 0.824266271330268 -50 0.8218791362616757 -51 0.8195141801579645 -52 0.8171709130715548 -53 0.8148488641797111 -54 0.8125475806987108 -55 0.8102666268785352 -56 0.8080055830707606 -57 0.8057640448631033 -58 0.8035416222747761 -59 0.8013379390074006 -60 0.7991526317467734 -61 0.796985349511237 -62 0.7948357530428389 -63 0.7927035142377412 -64 0.7905883156132424 -65 0.7884898498073732 -66 0.7864078191101018 -67 0.7843419350226136 -68 0.7822919178430147 -69 0.7802574962764451 -70 0.7782384070678282 -71 0.7762343946556395 -72 0.7742452108452136 -73 0.7722706145002324 -74 0.770310371251143 -75 0.76836425321937 -76 0.7664320387562564 -77 0.7645135121957763 -78 0.7626084636201109 -79 0.7607166886372758 -80 0.7588379881700227 -81 0.7569721682553251 -82 0.7551190398537776 -83 0.7532784186683185 -84 0.7514501249717047 -85 0.7496339834422199 -86 0.7478298230071312 -87 0.7460374766934447 -88 0.744256781485537 -89 0.742487578189273 -90 0.740729711302249 -91 0.738983028889811 -92 0.7372473824665428 -93 0.7355226268829143 -94 0.7338086202168218 -95 0.7321052236697538 -96 0.7304123014673415 -97 0.7287297207640642 -98 0.7270573515518944 -99 0.7253950665726847 -100 0.7237427412341026 -101 0.7221002535289383 -102 0.7204674839576208 -103 0.7188443154537764 -104 0.7172306333126927 -105 0.7156263251225384 -106 0.7140312806982176 -107 0.712445392017719 -108 0.7108685531608633 -109 0.7093006602503189 -110 0.7077416113947941 -111 0.7061913066343006 -112 0.7046496478873963 -113 0.7031165389003207 -114 0.701591885197936 -115 0.7000755940363974 -116 0.6985675743574739 -117 0.6970677367444532 -118 0.6955759933795586 -119 0.694092258002813 -120 0.6926164458722978 -121 0.6911484737257331 -122 0.6896882597433415 -123 0.6882357235119293 -124 0.6867907859901439 -125 0.6853533694748546 -126 0.6839233975686164 -127 0.6825007951481693 -128 0.6810854883339358 -129 0.6796774044604751 -130 0.6782764720478581 -131 0.6768826207739282 -132 0.675495781447412 -133 0.6741158859818493 -134 0.6727428673703116 -135 0.6713766596608783 -136 0.6700171979328448 -137 0.6686644182736309 -138 0.6673182577563711 -139 0.665978654418155 -140 0.6646455472388978 -141 0.6633188761208197 -142 0.6619985818685072 -143 0.6606846061695424 -144 0.6593768915756765 -145 0.6580753814845278 -146 0.6567800201217898 -147 0.6554907525239279 -148 0.6542075245213498 -149 0.6529302827220361 -150 0.6516589744956094 -151 0.6503935479578326 -152 0.6491339519555221 -153 0.6478801360518566 -154 0.6466320505120773 -155 0.6453896462895573 -156 0.6441528750122365 -157 0.642921688969405 -158 0.6416960410988252 -159 0.640475884974183 -160 0.6392611747928573 -161 0.6380518653639957 -162 0.6368479120968908 -163 0.635649270989643 -164 0.6344558986181063 -165 0.6332677521251036 -166 0.6320847892099062 -167 0.6309069681179693 -168 0.6297342476309137 -169 0.6285665870567494 -170 0.6274039462203316 -171 0.626246285454043 -172 0.6250935655886968 -173 0.623945747944651 -174 0.6228027943231316 -175 0.6216646669977567 -176 0.6205313287062546 -177 0.6194027426423736 -178 0.6182788724479744 -179 0.6171596822053032 -180 0.6160451364294374 -181 0.6149352000609029 -182 0.6138298384584534 -183 0.6127290173920114 -184 0.6116327030357649 -185 0.610540861961415 -186 0.6094534611315701 -187 0.6083704678932862 -188 0.6072918499717428 -189 0.6062175754640584 -190 0.6051476128332351 -191 0.6040819309022343 -192 0.6030204988481755 -193 0.6019632861966588 -194 0.6009102628162061 -195 0.5998613989128165 -196 0.5988166650246367 -197 0.5977760320167395 -198 0.5967394710760106 -199 0.5957069537061387 -200 0.5946784517227086 -201 0.5936539372483923 -202 0.5926333827082372 -203 0.5916167608250495 -204 0.5906040446148677 -205 0.5895952073825281 -206 0.5885902227173152 -207 0.5875890644887002 -208 0.5865917068421604 -209 0.5855981241950815 -210 0.5846082912327386 -211 0.5836221829043546 -212 0.5826397744192342 -213 0.581661041242972 -214 0.5806859590937321 -215 0.5797145039385988 -216 0.5787466519899951 -217 0.5777823797021695 -218 0.5768216637677468 -219 0.5758644811143447 -220 0.5749108089012515 -221 0.5739606245161651 -222 0.5730139055719944 -223 0.5720706299037137 -224 0.5711307755652795 -225 0.5701943208266014 -226 0.5692612441705648 -227 0.5683315242901118 -228 0.5674051400853706 -229 0.5664820706608363 -230 0.565562295322604 -231 0.5646457935756481 -232 0.5637325451211503 -233 0.5628225298538745 -234 0.5619157278595864 -235 0.5610121194125203 -236 0.5601116849728858 -237 0.5592144051844212 -238 0.5583202608719857 -239 0.5574292330391953 -240 0.5565413028660963 -241 0.5556564517068797 -242 0.5547746610876346 -243 0.5538959127041372 -244 0.5530201884196781 -245 0.5521474702629271 -246 0.5512777404258298 -247 0.5504109812615423 -248 0.549547175282398 -249 0.548686305157909 -250 0.5478283537127981 -251 0.5469733039250656 -252 0.5461211389240842 -253 0.5452718419887275 -254 0.5444253965455269 -255 0.5435817861668577 -256 0.5427409945691563 -257 0.5419030056111626 -258 0.5410678032921926 -259 0.5402353717504378 -260 0.5394056952612899 -261 0.5385787582356935 -262 0.5377545452185236 -263 0.5369330408869883 -264 0.5361142300490556 -265 0.5352980976419066 -266 0.5344846287304097 -267 0.5336738085056196 -268 0.5328656222832998 -269 0.5320600555024659 -270 0.5312570937239519 -271 0.5304567226289982 -272 0.5296589280178607 -273 0.5288636958084402 -274 0.528071012034933 -275 0.527280862846501 -276 0.526493234505962 -277 0.5257081133884988 -278 0.5249254859803876 -279 0.5241453388777454 -280 0.5233676587852939 -281 0.5225924325151446 -282 0.5218196469855986 -283 0.5210492892199644 -284 0.5202813463453946 -285 0.5195158055917365 -286 0.5187526542904008 -287 0.5179918798732471 -288 0.5172334698714828 -289 0.5164774119145797 -290 0.5157236937292059 -291 0.5149723031381711 -292 0.5142232280593879 -293 0.5134764565048479 -294 0.5127319765796108 -295 0.5119897764808087 -296 0.5112498444966641 -297 0.5105121690055203 -298 0.5097767384748864 -299 0.5090435414604948 -300 0.5083125666053719 -301 0.507583802638921 -302 0.5068572383760178 -303 0.5061328627161186 -304 0.5054106646423798 -305 0.5046906332207897 -306 0.5039727575993115 -307 0.5032570270070392 -308 0.5025434307533622 -309 0.5018319582271428 -310 0.5011225988959046 -311 0.5004153423050312 -312 0.49971017807697427 -313 0.49900709591047493 -314 0.49830608557979217 -315 0.497607136933943 -316 0.4969102398959523 -317 0.4962153844621122 -318 0.4955225607012511 -319 0.4948317587540115 -320 0.4941429688321387 -321 0.4934561812177765 -322 0.49277138626277345 -323 0.4920885743879972 -324 0.4914077360826579 -325 0.49072886190364023 -326 0.4900519424748425 -327 0.48937696848652695 -328 0.4887039306946743 -329 0.4880328199203507 -330 0.48736362704907843 -331 0.48669634303021736 -332 0.4860309588763527 -333 0.48536746566269084 -334 0.48470585452646225 -335 0.4840461166663318 -336 0.48338824334181657 -337 0.4827322258727103 -338 0.48207805563851625 -339 0.4814257240778837 -340 0.4807752226880555 -341 0.4801265430243186 -342 0.4794796766994642 -343 0.4788346153832517 -344 0.478191350801881 -345 0.4775498747374702 -346 0.47691017902753985 -347 0.4762722555645029 -348 0.47563609629516157 -349 0.4750016932202088 -350 0.474369038393737 -351 0.4737381239227518 -352 0.4731089419666909 -353 0.4724814847369504 -354 0.4718557444964145 -355 0.471231713558992 -356 0.4706093842891585 -357 0.46998874910150146 -358 0.46936980046027404 -359 0.46875253087895113 -360 0.4681369329197923 -361 0.4675229991934086 -362 0.4669107223583348 -363 0.46630009512060633 -364 0.4656911102333418 -365 0.46508376049632844 -366 0.4644780387556143 -367 0.4638739379031033 -368 0.46327145087615657 -369 0.4626705706571957 -370 0.4620712902733141 -371 0.46147360279588856 -372 0.46087750134019834 -373 0.4602829790650468 -374 0.4596900291723878 -375 0.4590986449069562 -376 0.45850881955590195 -377 0.45792054644842906 -378 0.4573338189554377 -379 0.45674863048917047 -380 0.45616497450286275 -381 0.4555828444903966 -382 0.4550022339859583 -383 0.45442313656369987 -384 0.4538455458374046 -385 0.45326945546015474 -386 0.4526948591240039 -387 0.45212175055965415 -388 0.45155012353613266 -389 0.4509799718604769 -390 0.4504112893774181 -391 0.44984406996907317 -392 0.44927830755463477 -393 0.44871399609006835 -394 0.4481511295678115 -395 0.44758970201647463 -396 0.4470297075005478 -397 0.44647114012010813 -398 0.4459139940105313 -399 0.445358263342206 -400 0.4448039423202515 -401 0.4442510251842373 -402 0.4436995062079068 -403 0.4431493796989029 -404 0.44260063999849697 -405 0.4420532814813202 -406 0.4415072985550987 -407 0.44096268566038893 -408 0.4404194372703193 -409 0.4398775478903305 -410 0.4393370120579223 -411 0.4387978243423998 -412 0.43825997934462363 -413 0.4377234716967632 -414 0.43718829606205123 -415 0.43665444713454066 -416 0.4361219196388661 -417 0.4355907083300043 -418 0.4350608079930402 -419 0.43453221344293347 -420 0.4340049195242877 -421 0.43347892111112174 -422 0.43295421310664406 -423 0.43243079044302857 -424 0.43190864808119267 -425 0.43138778101057784 -426 0.43086818424893225 -427 0.43034985284209504 -428 0.4298327818637838 -429 0.42931696641538275 -430 0.4288024016257333 -431 0.4282890826509284 -432 0.4277770046741056 -433 0.4272661629052452 -434 0.4267565525809683 -435 0.426248168964338 -436 0.4257410073446616 -437 0.4252350630372958 -438 0.42473033138345195 -439 0.42422680775000515 -440 0.42372448752930386 -441 0.4232233661389823 -442 0.4227234390217727 -443 0.42222470164532216 -444 0.4217271495020085 -445 0.42123077810876014 -446 0.4207355830068754 -447 0.42024155976184563 -448 0.419748703963178 -449 0.4192570112242222 -450 0.4187664771819965 -451 0.41827709749701647 -452 0.4177888678531257 -453 0.41730178395732725 -454 0.4168158415396169 -455 0.4163310363528185 -456 0.4158473641724194 -457 0.41536482079640946 -458 0.4148834020451197 -459 0.41440310376106304 -460 0.41392392180877696 -461 0.4134458520746668 -462 0.41296889046685104 -463 0.4124930329150079 -464 0.4120182753702229 -465 0.41154461380483826 -466 0.41107204421230364 -467 0.4106005626070276 -468 0.41013016502423144 -469 0.4096608475198032 -470 0.4091926061701538 -471 0.4087254370720742 -472 0.40825933634259365 -473 0.40779430011883927 -474 0.407330324557897 -475 0.40686740583667413 -476 0.40640554015176156 -477 0.40594472371929935 -478 0.4054849527748419 -479 0.40502622357322515 -480 0.40456853238843427 -481 0.40411187551347244 -482 0.4036562492602327 -483 0.4032016499593676 -484 0.40274807396016254 -485 0.40229551763040994 -486 0.401843977356283 -487 0.4013934495422118 -488 0.40094393061076083 -489 0.40049541700250596 -490 0.4000479051759142 -491 0.39960139160722313 -492 0.3991558727903225 -493 0.39871134523663565 -494 0.39826780547500285 -495 0.3978252500515656 -496 0.3973836755296513 -497 0.3969430784896594 -498 0.39650345552894783 -499 0.39606480326172205 -500 0.39562711831892267 -501 0.3951903973481156 -502 0.39475463701338354 -503 0.3943198339952161 -504 0.39388598499040356 -505 0.39345308671192963 -506 0.39302113588886617 -507 0.3925901292662675 -508 0.39216006360506744 -509 0.39173093568197576 -510 0.39130274228937556 -511 0.39087548023522245 -512 0.3904491463429436 -513 0.3900237374513377 -514 0.38959925041447707 -515 0.389175682101608 -516 0.38875302939705453 -517 0.38833128920012144 -518 0.38791045842499833 -519 0.3874905340006655 -520 0.3870715128707984 -521 0.3866533919936748 -522 0.3862361683420825 -523 0.38581983890322674 -524 0.385404400678639 -525 0.38498985068408675 -526 0.3845761859494836 -527 0.38416340351880035 -528 0.38375150044997597 -529 0.38334047381483105 -530 0.3829303206989799 -531 0.3825210382017448 -532 0.38211262343607033 -533 0.38170507352843797 -534 0.38129838561878276 -535 0.3808925568604089 -536 0.38048758441990777 -537 0.38008346547707406 -538 0.3796801972248261 -539 0.37927777686912334 -540 0.3788762016288872 -541 0.37847546873592014 -542 0.3780755754348275 -543 0.37767651898293847 -544 0.3772782966502284 -545 0.3768809057192419 -546 0.3764843434850152 -547 0.37608860725500115 -548 0.37569369434899286 -549 0.3752996020990492 -550 0.3749063278494206 -551 0.37451386895647465 -552 0.37412222278862356 -553 0.373731386726251 -554 0.3733413581616405 -555 0.3729521344989033 -556 0.3725637131539079 -557 0.3721760915542089 -558 0.37178926713897814 -559 0.3714032373589341 -560 0.37101799967627386 -561 0.37063355156460415 -562 0.37024989050887425 -563 0.3698670140053074 -564 0.36948491956133556 -565 0.36910360469553166 -566 0.36872306693754475 -567 0.3683433038280338 -568 0.36796431291860365 -569 0.3675860917717399 -570 0.36720863796074577 -571 0.366831949069678 -572 0.36645602269328403 -573 0.3660808564369399 -574 0.36570644791658763 -575 0.36533279475867425 -576 0.36495989460009 -577 0.3645877450881084 -578 0.36421634388032514 -579 0.3638456886445993 -580 0.36347577705899325 -581 0.36310660681171375 -582 0.36273817560105387 -583 0.3623704811353349 -584 0.36200352113284795 -585 0.3616372933217977 -586 0.361271795440245 -587 0.3609070252360509 -588 0.36054298046682 -589 0.36017965889984516 -590 0.3598170583120531 -591 0.35945517648994796 -592 0.3590940112295585 -593 0.3587335603363829 -594 0.35837382162533604 -595 0.3580147929206956 -596 0.35765647205604956 -597 0.3572988568742431 -598 0.35694194522732786 -599 0.3565857349765085 -600 0.3562302239920924 -601 0.35587541015343827 -602 0.3555212913489055 -603 0.3551678654758042 -604 0.3548151304403445 -605 0.35446308415758787 -606 0.3541117245513971 -607 0.3537610495543878 -608 0.3534110571078797 -609 0.35306174516184863 -610 0.3527131116748783 -611 0.3523651546141128 -612 0.3520178719552097 -613 0.35167126168229296 -614 0.3513253217879061 -615 0.3509800502729663 -616 0.3506354451467184 -617 0.35029150442668927 -618 0.3499482261386421 -619 0.34960560831653265 -620 0.3492636490024624 -621 0.3489223462466368 -622 0.3485816981073192 -623 0.34824170265078774 -624 0.34790235795129204 -625 0.3475636620910101 -626 0.3472256131600049 -627 0.3468882092561822 -628 0.3465514484852485 -629 0.3462153289606681 -630 0.3458798488036226 -631 0.34554500614296846 -632 0.3452107991151962 -633 0.3448772258643897 -634 0.34454428454218505 -635 0.34421197330773123 -636 0.34388029032764894 -637 0.3435492337759909 -638 0.3432188018342032 -639 0.3428889926910855 -640 0.3425598045427515 -641 0.342231235592591 -642 0.34190328405123144 -643 0.3415759481364984 -644 0.3412492260733795 -645 0.3409231160939852 -646 0.3405976164375119 -647 0.3402727253502047 -648 0.33994844108532046 -649 0.3396247619030907 -650 0.3393016860706855 -651 0.33897921186217694 -652 0.33865733755850347 -653 0.33833606144743356 -654 0.3380153818235307 -655 0.3376952969881176 -656 0.33737580524924166 -657 0.3370569049216394 -658 0.33673859432670233 -659 0.3364208717924425 -660 0.3361037356534581 -661 0.33578718425089965 -662 0.33547121593243634 -663 0.3351558290522219 -664 0.33484102197086224 -665 0.33452679305538185 -666 0.3342131406791904 -667 0.3339000632220512 -668 0.33358755907004783 -669 0.3332756266155521 -670 0.3329642642571924 -671 0.33265347039982107 -672 0.33234324345448363 -673 0.3320335818383867 -674 0.3317244839748669 -675 0.3314159482933603 -676 0.3311079732293706 -677 0.3308005572244392 -678 0.33049369872611495 -679 0.33018739618792325 -680 0.32988164806933584 -681 0.32957645283574216 -682 0.329271808958418 -683 0.32896771491449733 -684 0.32866416918694225 -685 0.3283611702645137 -686 0.3280587166417438 -687 0.32775680681890496 -688 0.32745543930198334 -689 0.32715461260264894 -690 0.32685432523822827 -691 0.32655457573167584 -692 0.3262553626115465 -693 0.32595668441196735 -694 0.3256585396726107 -695 0.32536092693866625 -696 0.3250638447608144 -697 0.32476729169519847 -698 0.3244712663033984 -699 0.3241757671524041 -700 0.3238807928145882 -701 0.32358634186768065 -702 0.32329241289474187 -703 0.32299900448413643 -704 0.32270611522950815 -705 0.3224137437297533 -706 0.3221218885889956 -707 0.3218305484165607 -708 0.32153972182695095 -709 0.3212494074398199 -710 0.320959603879948 -711 0.32067030977721706 -712 0.32038152376658613 -713 0.3200932444880666 -714 0.3198054705866983 -715 0.31951820071252474 -716 0.3192314335205693 -717 0.3189451676708114 -718 0.3186594018281623 -719 0.31837413466244235 -720 0.3180893648483562 -721 0.3178050910654704 -722 0.3175213119981899 -723 0.31723802633573495 -724 0.316955232772118 -725 0.31667293000612123 -726 0.31639111674127374 -727 0.3161097916858287 -728 0.3158289535527413 -729 0.3155486010596463 -730 0.31526873292883634 -731 0.31498934788723887 -732 0.3147104446663956 -733 0.3144320220024395 -734 0.31415407863607436 -735 0.3138766133125523 -736 0.3135996247816527 -737 0.31332311179766137 -738 0.3130470731193488 -739 0.3127715075099498 -740 0.312496413737142 -741 0.3122217905730254 -742 0.31194763679410176 -743 0.3116739511812541 -744 0.3114007325197262 -745 0.3111279795991024 -746 0.3108556912132874 -747 0.310583866160486 -748 0.3103125032431839 -749 0.31004160126812674 -750 0.3097711590463018 -751 0.3095011753929171 -752 0.30923164912738277 -753 0.30896257907329133 -754 0.3086939640583986 -755 0.30842580291460436 -756 0.30815809447793374 -757 0.30789083758851776 -758 0.30762403109057496 -759 0.30735767383239243 -760 0.3070917646663073 -761 0.30682630244868847 -762 0.3065612860399177 -763 0.306296714304372 -764 0.3060325861104046 -765 0.305768900330328 -766 0.30550565584039485 -767 0.30524285152078096 -768 0.304980486255567 -769 0.30471855893272104 -770 0.30445706844408094 -771 0.30419601368533694 -772 0.30393539355601423 -773 0.30367520695945566 -774 0.30341545280280474 -775 0.30315612999698804 -776 0.3028972374566991 -777 0.30263877410038054 -778 0.30238073885020794 -779 0.30212313063207297 -780 0.30186594837556674 -781 0.3016091910139632 -782 0.30135285748420293 -783 0.30109694672687665 -784 0.30084145768620885 -785 0.30058638931004206 -786 0.3003317405498202 -787 0.30007751036057334 -788 0.29982369770090106 -789 0.2995703015329571 -790 0.2993173208224336 -791 0.29906475453854525 -792 0.2988126016540142 -793 0.29856086114505387 -794 0.29830953199135457 -795 0.29805861317606724 -796 0.29780810368578886 -797 0.2975580025105472 -798 0.2973083086437855 -799 0.297059021082348 -800 0.2968101388264648 -801 0.2965616608797368 -802 0.29631358624912163 -803 0.29606591394491844 -804 0.2958186429807536 -805 0.2955717723735663 -806 0.29532530114359384 -807 0.29507922831435773 -808 0.29483355291264907 -809 0.29458827396851467 -810 0.29434339051524283 -811 0.2940989015893491 -812 0.293854806230563 -813 0.2936111034818134 -814 0.2933677923892153 -815 0.2931248720020557 -816 0.2928823413727803 -817 0.2926401995569797 -818 0.292398445613376 -819 0.2921570786038094 -820 0.2919160975932247 -821 0.2916755016496583 -822 0.2914352898442247 -823 0.29119546125110335 -824 0.29095601494752615 -825 0.29071695001376363 -826 0.29047826553311235 -827 0.29023996059188234 -828 0.29000203427938387 -829 0.28976448568791496 -830 0.28952731391274866 -831 0.2892905180521204 -832 0.28905409720721553 -833 0.28881805048215686 -834 0.28858237698399214 -835 0.28834707582268215 -836 0.28811214611108754 -837 0.28787758696495763 -838 0.28764339750291784 -839 0.28740957684645724 -840 0.2871761241199174 -841 0.2869430384504794 -842 0.286710318968153 -843 0.28647796480576393 -844 0.2862459750989426 -845 0.2860143489861123 -846 0.2857830856084774 -847 0.2855521841100122 -848 0.2853216436374487 -849 0.2850914633402659 -850 0.28486164237067796 -851 0.28463217988362266 -852 0.2844030750367507 -853 0.2841743269904139 -854 0.28394593490765446 -855 0.2837178979541936 -856 0.28349021529842056 -857 0.28326288611138145 -858 0.2830359095667686 -859 0.2828092848409096 -860 0.28258301111275624 -861 0.2823570875638738 -862 0.28213151337843057 -863 0.28190628774318693 -864 0.28168140984748485 -865 0.28145687888323717 -866 0.2812326940449174 -867 0.28100885452954893 -868 0.28078535953669487 -869 0.28056220826844747 -870 0.2803393999294182 -871 0.2801169337267269 -872 0.27989480886999235 -873 0.27967302457132137 -874 0.27945158004529935 -875 0.2792304745089797 -876 0.27900970718187434 -877 0.2787892772859434 -878 0.27856918404558545 -879 0.27834942668762763 -880 0.27813000444131597 -881 0.2779109165383055 -882 0.27769216221265064 -883 0.2774737407007956 -884 0.27725565124156454 -885 0.2770378930761524 -886 0.27682046544811495 -887 0.27660336760335985 -888 0.2763865987901368 -889 0.2761701582590283 -890 0.27595404526294054 -891 0.27573825905709387 -892 0.2755227988990136 -893 0.2753076640485212 -894 0.2750928537677243 -895 0.2748783673210088 -896 0.2746642039750288 -897 0.27445036299869796 -898 0.27423684366318085 -899 0.2740236452418835 -900 0.27381076701044504 -901 0.27359820824672837 -902 0.27338596823081174 -903 0.2731740462449801 -904 0.2729624415737158 -905 0.27275115350369084 -906 0.2725401813237574 -907 0.2723295243249398 -908 0.27211918180042577 -909 0.2719091530455581 -910 0.271699437357826 -911 0.2714900340368568 -912 0.27128094238440764 -913 0.27107216170435705 -914 0.2708636913026968 -915 0.27065553048752344 -916 0.2704476785690303 -917 0.27024013485949927 -918 0.27003289867329255 -919 0.2698259693268448 -920 0.26961934613865485 -921 0.269413028429278 -922 0.2692070155213177 -923 0.26900130673941763 -924 0.26879590141025433 -925 0.2685907988625287 -926 0.26838599842695854 -927 0.2681814994362706 -928 0.2679773012251932 -929 0.2677734031304478 -930 0.267569804490742 -931 0.2673665046467618 -932 0.2671635029411637 -933 0.26696079871856737 -934 0.2667583913255481 -935 0.26655628011062926 -936 0.2663544644242748 -937 0.26615294361888214 -938 0.26595171704877413 -939 0.26575078407019265 -940 0.2655501440412903 -941 0.26534979632212374 -942 0.2651497402746465 -943 0.26494997526270114 -944 0.26475050065201294 -945 0.26455131581018193 -946 0.2643524201066763 -947 0.2641538129128253 -948 0.2639554936018118 -949 0.26375746154866575 -950 0.26355971613025697 -951 0.2633622567252881 -952 0.2631650827142882 -953 0.26296819347960493 -954 0.26277158840539866 -955 0.26257526687763516 -956 0.2623792282840789 -957 0.2621834720142861 -958 0.26198799745959866 -959 0.2617928040131365 -960 0.2615978910697918 -961 0.2614032580262219 -962 0.26120890428084254 -963 0.2610148292338218 -964 0.26082103228707326 -965 0.26062751284424945 -966 0.2604342703107354 -967 0.2602413040936423 -968 0.2600486136018011 -969 0.259856198245756 -970 0.25966405743775794 -971 0.25947219059175874 -972 0.2592805971234043 -973 0.25908927645002855 -974 0.2588982279906473 -975 0.2587074511659519 -976 0.25851694539830294 -977 0.2583267101117244 -978 0.2581367447318972 -979 0.2579470486861532 -980 0.25775762140346925 -981 0.25756846231446096 -982 0.25737957085137686 -983 0.2571909464480922 -984 0.2570025885401032 -985 0.2568144965645208 -986 0.2566266699600653 -987 0.25643910816705967 -988 0.2562518106274244 -989 0.25606477678467143 -990 0.25587800608389827 -991 0.2556914979717821 -992 0.25550525189657447 -993 0.255319267308095 -994 0.2551335436577262 -995 0.2549480803984073 -996 0.25476287698462907 -997 0.2545779328724277 -998 0.2543932475193798 -999 0.25420882038459613 diff --git a/drivers/py/pes/friction/frictionH/120K/RESTART b/drivers/py/pes/friction/frictionH/120K/RESTART deleted file mode 100644 index e67a530ad..000000000 --- a/drivers/py/pes/friction/frictionH/120K/RESTART +++ /dev/null @@ -1,612 +0,0 @@ - - - [ step, potential{electronvolt} ] - extras - extras - - 30 - 30 - - - - - - [ friction ] - - - - 3.80017824e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 5.37239687e-03, 5.37240995e-03, 5.37241752e-03, 5.37238587e-03, 5.37227257e-03, - 5.37203475e-03, 5.37163807e-03, 5.37106548e-03, 5.37032257e-03, 5.36943943e-03, - 5.36846890e-03, 5.36748153e-03, 5.36655763e-03, 5.36577781e-03, 5.36521322e-03, - 5.36491681e-03 ] - - - [ -1.19732308e-04, 1.40818188e-06, 1.39988637e-06, -1.15096254e-04, 1.35221829e-06, - 1.34385535e-06, -1.06007213e-04, 1.24267246e-06, 1.23445814e-06, -9.28237734e-05, - 1.08433099e-06, 1.07705256e-06, -7.60652415e-05, 8.84505191e-07, 8.79048461e-07, - -5.63901608e-05, 6.53102804e-07, 6.49508188e-07, -3.45689285e-05, 4.00697602e-07, - 3.98314933e-07, -1.14512248e-05, 1.34945413e-07, 1.34139829e-07, 1.20682495e-05, - -1.35502917e-07, -1.34660844e-07, 3.50849966e-05, -4.01960889e-07, -3.99517275e-07, - 5.67197001e-05, -6.55048051e-07, -6.51100717e-07, 7.61513206e-05, -8.85063207e-07, - -8.79659961e-07, 9.26471121e-05, -1.08247361e-06, -1.07575696e-06, 1.05588624e-04, - -1.23871356e-06, -1.23092323e-06, 1.14493026e-04, -1.34684715e-06, -1.33833155e-06, - 1.19029339e-04, -1.40210358e-06, -1.39323429e-06 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00 ] - - True - - [ 1.00000000e+00, 9.91547016e-01, 2.00000000e+00, 9.84855150e-01, 3.00000000e+00, - 9.78825564e-01, 4.00000000e+00, 9.73224708e-01, 5.00000000e+00, 9.67941670e-01, - 6.00000000e+00, 9.62911133e-01, 7.00000000e+00, 9.58089945e-01, 8.00000000e+00, - 9.53447439e-01, 9.00000000e+00, 9.48960692e-01, 1.00000000e+01, 9.44611912e-01, - 1.10000000e+01, 9.40386891e-01, 1.20000000e+01, 9.36274017e-01, 1.30000000e+01, - 9.32263625e-01, 1.40000000e+01, 9.28347542e-01, 1.50000000e+01, 9.24518768e-01, - 1.60000000e+01, 9.20771243e-01, 1.70000000e+01, 9.17099663e-01, 1.80000000e+01, - 9.13499355e-01, 1.90000000e+01, 9.09966164e-01, 2.00000000e+01, 9.06496377e-01, - 2.10000000e+01, 9.03086653e-01, 2.20000000e+01, 8.99733970e-01, 2.30000000e+01, - 8.96435582e-01, 2.40000000e+01, 8.93188985e-01, 2.50000000e+01, 8.89991881e-01, - 2.60000000e+01, 8.86842161e-01, 2.70000000e+01, 8.83737876e-01, 2.80000000e+01, - 8.80677224e-01, 2.90000000e+01, 8.77658532e-01, 3.00000000e+01, 8.74680243e-01, - 3.10000000e+01, 8.71740904e-01, 3.20000000e+01, 8.68839157e-01, 3.30000000e+01, - 8.65973731e-01, 3.40000000e+01, 8.63143429e-01, 3.50000000e+01, 8.60347128e-01, - 3.60000000e+01, 8.57583770e-01, 3.70000000e+01, 8.54852353e-01, 3.80000000e+01, - 8.52151933e-01, 3.90000000e+01, 8.49481614e-01, 4.00000000e+01, 8.46840548e-01, - 4.10000000e+01, 8.44227929e-01, 4.20000000e+01, 8.41642991e-01, 4.30000000e+01, - 8.39085005e-01, 4.40000000e+01, 8.36553275e-01, 4.50000000e+01, 8.34047138e-01, - 4.60000000e+01, 8.31565962e-01, 4.70000000e+01, 8.29109141e-01, 4.80000000e+01, - 8.26676096e-01, 4.90000000e+01, 8.24266271e-01, 5.00000000e+01, 8.21879136e-01, - 5.10000000e+01, 8.19514180e-01, 5.20000000e+01, 8.17170913e-01, 5.30000000e+01, - 8.14848864e-01, 5.40000000e+01, 8.12547581e-01, 5.50000000e+01, 8.10266627e-01, - 5.60000000e+01, 8.08005583e-01, 5.70000000e+01, 8.05764045e-01, 5.80000000e+01, - 8.03541622e-01, 5.90000000e+01, 8.01337939e-01, 6.00000000e+01, 7.99152632e-01, - 6.10000000e+01, 7.96985350e-01, 6.20000000e+01, 7.94835753e-01, 6.30000000e+01, - 7.92703514e-01, 6.40000000e+01, 7.90588316e-01, 6.50000000e+01, 7.88489850e-01, - 6.60000000e+01, 7.86407819e-01, 6.70000000e+01, 7.84341935e-01, 6.80000000e+01, - 7.82291918e-01, 6.90000000e+01, 7.80257496e-01, 7.00000000e+01, 7.78238407e-01, - 7.10000000e+01, 7.76234395e-01, 7.20000000e+01, 7.74245211e-01, 7.30000000e+01, - 7.72270615e-01, 7.40000000e+01, 7.70310371e-01, 7.50000000e+01, 7.68364253e-01, - 7.60000000e+01, 7.66432039e-01, 7.70000000e+01, 7.64513512e-01, 7.80000000e+01, - 7.62608464e-01, 7.90000000e+01, 7.60716689e-01, 8.00000000e+01, 7.58837988e-01, - 8.10000000e+01, 7.56972168e-01, 8.20000000e+01, 7.55119040e-01, 8.30000000e+01, - 7.53278419e-01, 8.40000000e+01, 7.51450125e-01, 8.50000000e+01, 7.49633983e-01, - 8.60000000e+01, 7.47829823e-01, 8.70000000e+01, 7.46037477e-01, 8.80000000e+01, - 7.44256781e-01, 8.90000000e+01, 7.42487578e-01, 9.00000000e+01, 7.40729711e-01, - 9.10000000e+01, 7.38983029e-01, 9.20000000e+01, 7.37247382e-01, 9.30000000e+01, - 7.35522627e-01, 9.40000000e+01, 7.33808620e-01, 9.50000000e+01, 7.32105224e-01, - 9.60000000e+01, 7.30412301e-01, 9.70000000e+01, 7.28729721e-01, 9.80000000e+01, - 7.27057352e-01, 9.90000000e+01, 7.25395067e-01, 1.00000000e+02, 7.23742741e-01, - 1.01000000e+02, 7.22100254e-01, 1.02000000e+02, 7.20467484e-01, 1.03000000e+02, - 7.18844315e-01, 1.04000000e+02, 7.17230633e-01, 1.05000000e+02, 7.15626325e-01, - 1.06000000e+02, 7.14031281e-01, 1.07000000e+02, 7.12445392e-01, 1.08000000e+02, - 7.10868553e-01, 1.09000000e+02, 7.09300660e-01, 1.10000000e+02, 7.07741611e-01, - 1.11000000e+02, 7.06191307e-01, 1.12000000e+02, 7.04649648e-01, 1.13000000e+02, - 7.03116539e-01, 1.14000000e+02, 7.01591885e-01, 1.15000000e+02, 7.00075594e-01, - 1.16000000e+02, 6.98567574e-01, 1.17000000e+02, 6.97067737e-01, 1.18000000e+02, - 6.95575993e-01, 1.19000000e+02, 6.94092258e-01, 1.20000000e+02, 6.92616446e-01, - 1.21000000e+02, 6.91148474e-01, 1.22000000e+02, 6.89688260e-01, 1.23000000e+02, - 6.88235724e-01, 1.24000000e+02, 6.86790786e-01, 1.25000000e+02, 6.85353369e-01, - 1.26000000e+02, 6.83923398e-01, 1.27000000e+02, 6.82500795e-01, 1.28000000e+02, - 6.81085488e-01, 1.29000000e+02, 6.79677404e-01, 1.30000000e+02, 6.78276472e-01, - 1.31000000e+02, 6.76882621e-01, 1.32000000e+02, 6.75495781e-01, 1.33000000e+02, - 6.74115886e-01, 1.34000000e+02, 6.72742867e-01, 1.35000000e+02, 6.71376660e-01, - 1.36000000e+02, 6.70017198e-01, 1.37000000e+02, 6.68664418e-01, 1.38000000e+02, - 6.67318258e-01, 1.39000000e+02, 6.65978654e-01, 1.40000000e+02, 6.64645547e-01, - 1.41000000e+02, 6.63318876e-01, 1.42000000e+02, 6.61998582e-01, 1.43000000e+02, - 6.60684606e-01, 1.44000000e+02, 6.59376892e-01, 1.45000000e+02, 6.58075381e-01, - 1.46000000e+02, 6.56780020e-01, 1.47000000e+02, 6.55490753e-01, 1.48000000e+02, - 6.54207525e-01, 1.49000000e+02, 6.52930283e-01, 1.50000000e+02, 6.51658974e-01, - 1.51000000e+02, 6.50393548e-01, 1.52000000e+02, 6.49133952e-01, 1.53000000e+02, - 6.47880136e-01, 1.54000000e+02, 6.46632051e-01, 1.55000000e+02, 6.45389646e-01, - 1.56000000e+02, 6.44152875e-01, 1.57000000e+02, 6.42921689e-01, 1.58000000e+02, - 6.41696041e-01, 1.59000000e+02, 6.40475885e-01, 1.60000000e+02, 6.39261175e-01, - 1.61000000e+02, 6.38051865e-01, 1.62000000e+02, 6.36847912e-01, 1.63000000e+02, - 6.35649271e-01, 1.64000000e+02, 6.34455899e-01, 1.65000000e+02, 6.33267752e-01, - 1.66000000e+02, 6.32084789e-01, 1.67000000e+02, 6.30906968e-01, 1.68000000e+02, - 6.29734248e-01, 1.69000000e+02, 6.28566587e-01, 1.70000000e+02, 6.27403946e-01, - 1.71000000e+02, 6.26246285e-01, 1.72000000e+02, 6.25093566e-01, 1.73000000e+02, - 6.23945748e-01, 1.74000000e+02, 6.22802794e-01, 1.75000000e+02, 6.21664667e-01, - 1.76000000e+02, 6.20531329e-01, 1.77000000e+02, 6.19402743e-01, 1.78000000e+02, - 6.18278872e-01, 1.79000000e+02, 6.17159682e-01, 1.80000000e+02, 6.16045136e-01, - 1.81000000e+02, 6.14935200e-01, 1.82000000e+02, 6.13829838e-01, 1.83000000e+02, - 6.12729017e-01, 1.84000000e+02, 6.11632703e-01, 1.85000000e+02, 6.10540862e-01, - 1.86000000e+02, 6.09453461e-01, 1.87000000e+02, 6.08370468e-01, 1.88000000e+02, - 6.07291850e-01, 1.89000000e+02, 6.06217575e-01, 1.90000000e+02, 6.05147613e-01, - 1.91000000e+02, 6.04081931e-01, 1.92000000e+02, 6.03020499e-01, 1.93000000e+02, - 6.01963286e-01, 1.94000000e+02, 6.00910263e-01, 1.95000000e+02, 5.99861399e-01, - 1.96000000e+02, 5.98816665e-01, 1.97000000e+02, 5.97776032e-01, 1.98000000e+02, - 5.96739471e-01, 1.99000000e+02, 5.95706954e-01, 2.00000000e+02, 5.94678452e-01, - 2.01000000e+02, 5.93653937e-01, 2.02000000e+02, 5.92633383e-01, 2.03000000e+02, - 5.91616761e-01, 2.04000000e+02, 5.90604045e-01, 2.05000000e+02, 5.89595207e-01, - 2.06000000e+02, 5.88590223e-01, 2.07000000e+02, 5.87589064e-01, 2.08000000e+02, - 5.86591707e-01, 2.09000000e+02, 5.85598124e-01, 2.10000000e+02, 5.84608291e-01, - 2.11000000e+02, 5.83622183e-01, 2.12000000e+02, 5.82639774e-01, 2.13000000e+02, - 5.81661041e-01, 2.14000000e+02, 5.80685959e-01, 2.15000000e+02, 5.79714504e-01, - 2.16000000e+02, 5.78746652e-01, 2.17000000e+02, 5.77782380e-01, 2.18000000e+02, - 5.76821664e-01, 2.19000000e+02, 5.75864481e-01, 2.20000000e+02, 5.74910809e-01, - 2.21000000e+02, 5.73960625e-01, 2.22000000e+02, 5.73013906e-01, 2.23000000e+02, - 5.72070630e-01, 2.24000000e+02, 5.71130776e-01, 2.25000000e+02, 5.70194321e-01, - 2.26000000e+02, 5.69261244e-01, 2.27000000e+02, 5.68331524e-01, 2.28000000e+02, - 5.67405140e-01, 2.29000000e+02, 5.66482071e-01, 2.30000000e+02, 5.65562295e-01, - 2.31000000e+02, 5.64645794e-01, 2.32000000e+02, 5.63732545e-01, 2.33000000e+02, - 5.62822530e-01, 2.34000000e+02, 5.61915728e-01, 2.35000000e+02, 5.61012119e-01, - 2.36000000e+02, 5.60111685e-01, 2.37000000e+02, 5.59214405e-01, 2.38000000e+02, - 5.58320261e-01, 2.39000000e+02, 5.57429233e-01, 2.40000000e+02, 5.56541303e-01, - 2.41000000e+02, 5.55656452e-01, 2.42000000e+02, 5.54774661e-01, 2.43000000e+02, - 5.53895913e-01, 2.44000000e+02, 5.53020188e-01, 2.45000000e+02, 5.52147470e-01, - 2.46000000e+02, 5.51277740e-01, 2.47000000e+02, 5.50410981e-01, 2.48000000e+02, - 5.49547175e-01, 2.49000000e+02, 5.48686305e-01, 2.50000000e+02, 5.47828354e-01, - 2.51000000e+02, 5.46973304e-01, 2.52000000e+02, 5.46121139e-01, 2.53000000e+02, - 5.45271842e-01, 2.54000000e+02, 5.44425397e-01, 2.55000000e+02, 5.43581786e-01, - 2.56000000e+02, 5.42740995e-01, 2.57000000e+02, 5.41903006e-01, 2.58000000e+02, - 5.41067803e-01, 2.59000000e+02, 5.40235372e-01, 2.60000000e+02, 5.39405695e-01, - 2.61000000e+02, 5.38578758e-01, 2.62000000e+02, 5.37754545e-01, 2.63000000e+02, - 5.36933041e-01, 2.64000000e+02, 5.36114230e-01, 2.65000000e+02, 5.35298098e-01, - 2.66000000e+02, 5.34484629e-01, 2.67000000e+02, 5.33673809e-01, 2.68000000e+02, - 5.32865622e-01, 2.69000000e+02, 5.32060056e-01, 2.70000000e+02, 5.31257094e-01, - 2.71000000e+02, 5.30456723e-01, 2.72000000e+02, 5.29658928e-01, 2.73000000e+02, - 5.28863696e-01, 2.74000000e+02, 5.28071012e-01, 2.75000000e+02, 5.27280863e-01, - 2.76000000e+02, 5.26493235e-01, 2.77000000e+02, 5.25708113e-01, 2.78000000e+02, - 5.24925486e-01, 2.79000000e+02, 5.24145339e-01, 2.80000000e+02, 5.23367659e-01, - 2.81000000e+02, 5.22592433e-01, 2.82000000e+02, 5.21819647e-01, 2.83000000e+02, - 5.21049289e-01, 2.84000000e+02, 5.20281346e-01, 2.85000000e+02, 5.19515806e-01, - 2.86000000e+02, 5.18752654e-01, 2.87000000e+02, 5.17991880e-01, 2.88000000e+02, - 5.17233470e-01, 2.89000000e+02, 5.16477412e-01, 2.90000000e+02, 5.15723694e-01, - 2.91000000e+02, 5.14972303e-01, 2.92000000e+02, 5.14223228e-01, 2.93000000e+02, - 5.13476457e-01, 2.94000000e+02, 5.12731977e-01, 2.95000000e+02, 5.11989776e-01, - 2.96000000e+02, 5.11249844e-01, 2.97000000e+02, 5.10512169e-01, 2.98000000e+02, - 5.09776738e-01, 2.99000000e+02, 5.09043541e-01, 3.00000000e+02, 5.08312567e-01, - 3.01000000e+02, 5.07583803e-01, 3.02000000e+02, 5.06857238e-01, 3.03000000e+02, - 5.06132863e-01, 3.04000000e+02, 5.05410665e-01, 3.05000000e+02, 5.04690633e-01, - 3.06000000e+02, 5.03972758e-01, 3.07000000e+02, 5.03257027e-01, 3.08000000e+02, - 5.02543431e-01, 3.09000000e+02, 5.01831958e-01, 3.10000000e+02, 5.01122599e-01, - 3.11000000e+02, 5.00415342e-01, 3.12000000e+02, 4.99710178e-01, 3.13000000e+02, - 4.99007096e-01, 3.14000000e+02, 4.98306086e-01, 3.15000000e+02, 4.97607137e-01, - 3.16000000e+02, 4.96910240e-01, 3.17000000e+02, 4.96215384e-01, 3.18000000e+02, - 4.95522561e-01, 3.19000000e+02, 4.94831759e-01, 3.20000000e+02, 4.94142969e-01, - 3.21000000e+02, 4.93456181e-01, 3.22000000e+02, 4.92771386e-01, 3.23000000e+02, - 4.92088574e-01, 3.24000000e+02, 4.91407736e-01, 3.25000000e+02, 4.90728862e-01, - 3.26000000e+02, 4.90051942e-01, 3.27000000e+02, 4.89376968e-01, 3.28000000e+02, - 4.88703931e-01, 3.29000000e+02, 4.88032820e-01, 3.30000000e+02, 4.87363627e-01, - 3.31000000e+02, 4.86696343e-01, 3.32000000e+02, 4.86030959e-01, 3.33000000e+02, - 4.85367466e-01, 3.34000000e+02, 4.84705855e-01, 3.35000000e+02, 4.84046117e-01, - 3.36000000e+02, 4.83388243e-01, 3.37000000e+02, 4.82732226e-01, 3.38000000e+02, - 4.82078056e-01, 3.39000000e+02, 4.81425724e-01, 3.40000000e+02, 4.80775223e-01, - 3.41000000e+02, 4.80126543e-01, 3.42000000e+02, 4.79479677e-01, 3.43000000e+02, - 4.78834615e-01, 3.44000000e+02, 4.78191351e-01, 3.45000000e+02, 4.77549875e-01, - 3.46000000e+02, 4.76910179e-01, 3.47000000e+02, 4.76272256e-01, 3.48000000e+02, - 4.75636096e-01, 3.49000000e+02, 4.75001693e-01, 3.50000000e+02, 4.74369038e-01, - 3.51000000e+02, 4.73738124e-01, 3.52000000e+02, 4.73108942e-01, 3.53000000e+02, - 4.72481485e-01, 3.54000000e+02, 4.71855744e-01, 3.55000000e+02, 4.71231714e-01, - 3.56000000e+02, 4.70609384e-01, 3.57000000e+02, 4.69988749e-01, 3.58000000e+02, - 4.69369800e-01, 3.59000000e+02, 4.68752531e-01, 3.60000000e+02, 4.68136933e-01, - 3.61000000e+02, 4.67522999e-01, 3.62000000e+02, 4.66910722e-01, 3.63000000e+02, - 4.66300095e-01, 3.64000000e+02, 4.65691110e-01, 3.65000000e+02, 4.65083760e-01, - 3.66000000e+02, 4.64478039e-01, 3.67000000e+02, 4.63873938e-01, 3.68000000e+02, - 4.63271451e-01, 3.69000000e+02, 4.62670571e-01, 3.70000000e+02, 4.62071290e-01, - 3.71000000e+02, 4.61473603e-01, 3.72000000e+02, 4.60877501e-01, 3.73000000e+02, - 4.60282979e-01, 3.74000000e+02, 4.59690029e-01, 3.75000000e+02, 4.59098645e-01, - 3.76000000e+02, 4.58508820e-01, 3.77000000e+02, 4.57920546e-01, 3.78000000e+02, - 4.57333819e-01, 3.79000000e+02, 4.56748630e-01, 3.80000000e+02, 4.56164975e-01, - 3.81000000e+02, 4.55582844e-01, 3.82000000e+02, 4.55002234e-01, 3.83000000e+02, - 4.54423137e-01, 3.84000000e+02, 4.53845546e-01, 3.85000000e+02, 4.53269455e-01, - 3.86000000e+02, 4.52694859e-01, 3.87000000e+02, 4.52121751e-01, 3.88000000e+02, - 4.51550124e-01, 3.89000000e+02, 4.50979972e-01, 3.90000000e+02, 4.50411289e-01, - 3.91000000e+02, 4.49844070e-01, 3.92000000e+02, 4.49278308e-01, 3.93000000e+02, - 4.48713996e-01, 3.94000000e+02, 4.48151130e-01, 3.95000000e+02, 4.47589702e-01, - 3.96000000e+02, 4.47029708e-01, 3.97000000e+02, 4.46471140e-01, 3.98000000e+02, - 4.45913994e-01, 3.99000000e+02, 4.45358263e-01, 4.00000000e+02, 4.44803942e-01, - 4.01000000e+02, 4.44251025e-01, 4.02000000e+02, 4.43699506e-01, 4.03000000e+02, - 4.43149380e-01, 4.04000000e+02, 4.42600640e-01, 4.05000000e+02, 4.42053281e-01, - 4.06000000e+02, 4.41507299e-01, 4.07000000e+02, 4.40962686e-01, 4.08000000e+02, - 4.40419437e-01, 4.09000000e+02, 4.39877548e-01, 4.10000000e+02, 4.39337012e-01, - 4.11000000e+02, 4.38797824e-01, 4.12000000e+02, 4.38259979e-01, 4.13000000e+02, - 4.37723472e-01, 4.14000000e+02, 4.37188296e-01, 4.15000000e+02, 4.36654447e-01, - 4.16000000e+02, 4.36121920e-01, 4.17000000e+02, 4.35590708e-01, 4.18000000e+02, - 4.35060808e-01, 4.19000000e+02, 4.34532213e-01, 4.20000000e+02, 4.34004920e-01, - 4.21000000e+02, 4.33478921e-01, 4.22000000e+02, 4.32954213e-01, 4.23000000e+02, - 4.32430790e-01, 4.24000000e+02, 4.31908648e-01, 4.25000000e+02, 4.31387781e-01, - 4.26000000e+02, 4.30868184e-01, 4.27000000e+02, 4.30349853e-01, 4.28000000e+02, - 4.29832782e-01, 4.29000000e+02, 4.29316966e-01, 4.30000000e+02, 4.28802402e-01, - 4.31000000e+02, 4.28289083e-01, 4.32000000e+02, 4.27777005e-01, 4.33000000e+02, - 4.27266163e-01, 4.34000000e+02, 4.26756553e-01, 4.35000000e+02, 4.26248169e-01, - 4.36000000e+02, 4.25741007e-01, 4.37000000e+02, 4.25235063e-01, 4.38000000e+02, - 4.24730331e-01, 4.39000000e+02, 4.24226808e-01, 4.40000000e+02, 4.23724488e-01, - 4.41000000e+02, 4.23223366e-01, 4.42000000e+02, 4.22723439e-01, 4.43000000e+02, - 4.22224702e-01, 4.44000000e+02, 4.21727150e-01, 4.45000000e+02, 4.21230778e-01, - 4.46000000e+02, 4.20735583e-01, 4.47000000e+02, 4.20241560e-01, 4.48000000e+02, - 4.19748704e-01, 4.49000000e+02, 4.19257011e-01, 4.50000000e+02, 4.18766477e-01, - 4.51000000e+02, 4.18277097e-01, 4.52000000e+02, 4.17788868e-01, 4.53000000e+02, - 4.17301784e-01, 4.54000000e+02, 4.16815842e-01, 4.55000000e+02, 4.16331036e-01, - 4.56000000e+02, 4.15847364e-01, 4.57000000e+02, 4.15364821e-01, 4.58000000e+02, - 4.14883402e-01, 4.59000000e+02, 4.14403104e-01, 4.60000000e+02, 4.13923922e-01, - 4.61000000e+02, 4.13445852e-01, 4.62000000e+02, 4.12968890e-01, 4.63000000e+02, - 4.12493033e-01, 4.64000000e+02, 4.12018275e-01, 4.65000000e+02, 4.11544614e-01, - 4.66000000e+02, 4.11072044e-01, 4.67000000e+02, 4.10600563e-01, 4.68000000e+02, - 4.10130165e-01, 4.69000000e+02, 4.09660848e-01, 4.70000000e+02, 4.09192606e-01, - 4.71000000e+02, 4.08725437e-01, 4.72000000e+02, 4.08259336e-01, 4.73000000e+02, - 4.07794300e-01, 4.74000000e+02, 4.07330325e-01, 4.75000000e+02, 4.06867406e-01, - 4.76000000e+02, 4.06405540e-01, 4.77000000e+02, 4.05944724e-01, 4.78000000e+02, - 4.05484953e-01, 4.79000000e+02, 4.05026224e-01, 4.80000000e+02, 4.04568532e-01, - 4.81000000e+02, 4.04111876e-01, 4.82000000e+02, 4.03656249e-01, 4.83000000e+02, - 4.03201650e-01, 4.84000000e+02, 4.02748074e-01, 4.85000000e+02, 4.02295518e-01, - 4.86000000e+02, 4.01843977e-01, 4.87000000e+02, 4.01393450e-01, 4.88000000e+02, - 4.00943931e-01, 4.89000000e+02, 4.00495417e-01, 4.90000000e+02, 4.00047905e-01, - 4.91000000e+02, 3.99601392e-01, 4.92000000e+02, 3.99155873e-01, 4.93000000e+02, - 3.98711345e-01, 4.94000000e+02, 3.98267805e-01, 4.95000000e+02, 3.97825250e-01, - 4.96000000e+02, 3.97383676e-01, 4.97000000e+02, 3.96943078e-01, 4.98000000e+02, - 3.96503456e-01, 4.99000000e+02, 3.96064803e-01, 5.00000000e+02, 3.95627118e-01, - 5.01000000e+02, 3.95190397e-01, 5.02000000e+02, 3.94754637e-01, 5.03000000e+02, - 3.94319834e-01, 5.04000000e+02, 3.93885985e-01, 5.05000000e+02, 3.93453087e-01, - 5.06000000e+02, 3.93021136e-01, 5.07000000e+02, 3.92590129e-01, 5.08000000e+02, - 3.92160064e-01, 5.09000000e+02, 3.91730936e-01, 5.10000000e+02, 3.91302742e-01, - 5.11000000e+02, 3.90875480e-01, 5.12000000e+02, 3.90449146e-01, 5.13000000e+02, - 3.90023737e-01, 5.14000000e+02, 3.89599250e-01, 5.15000000e+02, 3.89175682e-01, - 5.16000000e+02, 3.88753029e-01, 5.17000000e+02, 3.88331289e-01, 5.18000000e+02, - 3.87910458e-01, 5.19000000e+02, 3.87490534e-01, 5.20000000e+02, 3.87071513e-01, - 5.21000000e+02, 3.86653392e-01, 5.22000000e+02, 3.86236168e-01, 5.23000000e+02, - 3.85819839e-01, 5.24000000e+02, 3.85404401e-01, 5.25000000e+02, 3.84989851e-01, - 5.26000000e+02, 3.84576186e-01, 5.27000000e+02, 3.84163404e-01, 5.28000000e+02, - 3.83751500e-01, 5.29000000e+02, 3.83340474e-01, 5.30000000e+02, 3.82930321e-01, - 5.31000000e+02, 3.82521038e-01, 5.32000000e+02, 3.82112623e-01, 5.33000000e+02, - 3.81705074e-01, 5.34000000e+02, 3.81298386e-01, 5.35000000e+02, 3.80892557e-01, - 5.36000000e+02, 3.80487584e-01, 5.37000000e+02, 3.80083465e-01, 5.38000000e+02, - 3.79680197e-01, 5.39000000e+02, 3.79277777e-01, 5.40000000e+02, 3.78876202e-01, - 5.41000000e+02, 3.78475469e-01, 5.42000000e+02, 3.78075575e-01, 5.43000000e+02, - 3.77676519e-01, 5.44000000e+02, 3.77278297e-01, 5.45000000e+02, 3.76880906e-01, - 5.46000000e+02, 3.76484343e-01, 5.47000000e+02, 3.76088607e-01, 5.48000000e+02, - 3.75693694e-01, 5.49000000e+02, 3.75299602e-01, 5.50000000e+02, 3.74906328e-01, - 5.51000000e+02, 3.74513869e-01, 5.52000000e+02, 3.74122223e-01, 5.53000000e+02, - 3.73731387e-01, 5.54000000e+02, 3.73341358e-01, 5.55000000e+02, 3.72952134e-01, - 5.56000000e+02, 3.72563713e-01, 5.57000000e+02, 3.72176092e-01, 5.58000000e+02, - 3.71789267e-01, 5.59000000e+02, 3.71403237e-01, 5.60000000e+02, 3.71018000e-01, - 5.61000000e+02, 3.70633552e-01, 5.62000000e+02, 3.70249891e-01, 5.63000000e+02, - 3.69867014e-01, 5.64000000e+02, 3.69484920e-01, 5.65000000e+02, 3.69103605e-01, - 5.66000000e+02, 3.68723067e-01, 5.67000000e+02, 3.68343304e-01, 5.68000000e+02, - 3.67964313e-01, 5.69000000e+02, 3.67586092e-01, 5.70000000e+02, 3.67208638e-01, - 5.71000000e+02, 3.66831949e-01, 5.72000000e+02, 3.66456023e-01, 5.73000000e+02, - 3.66080856e-01, 5.74000000e+02, 3.65706448e-01, 5.75000000e+02, 3.65332795e-01, - 5.76000000e+02, 3.64959895e-01, 5.77000000e+02, 3.64587745e-01, 5.78000000e+02, - 3.64216344e-01, 5.79000000e+02, 3.63845689e-01, 5.80000000e+02, 3.63475777e-01, - 5.81000000e+02, 3.63106607e-01, 5.82000000e+02, 3.62738176e-01, 5.83000000e+02, - 3.62370481e-01, 5.84000000e+02, 3.62003521e-01, 5.85000000e+02, 3.61637293e-01, - 5.86000000e+02, 3.61271795e-01, 5.87000000e+02, 3.60907025e-01, 5.88000000e+02, - 3.60542980e-01, 5.89000000e+02, 3.60179659e-01, 5.90000000e+02, 3.59817058e-01, - 5.91000000e+02, 3.59455176e-01, 5.92000000e+02, 3.59094011e-01, 5.93000000e+02, - 3.58733560e-01, 5.94000000e+02, 3.58373822e-01, 5.95000000e+02, 3.58014793e-01, - 5.96000000e+02, 3.57656472e-01, 5.97000000e+02, 3.57298857e-01, 5.98000000e+02, - 3.56941945e-01, 5.99000000e+02, 3.56585735e-01, 6.00000000e+02, 3.56230224e-01, - 6.01000000e+02, 3.55875410e-01, 6.02000000e+02, 3.55521291e-01, 6.03000000e+02, - 3.55167865e-01, 6.04000000e+02, 3.54815130e-01, 6.05000000e+02, 3.54463084e-01, - 6.06000000e+02, 3.54111725e-01, 6.07000000e+02, 3.53761050e-01, 6.08000000e+02, - 3.53411057e-01, 6.09000000e+02, 3.53061745e-01, 6.10000000e+02, 3.52713112e-01, - 6.11000000e+02, 3.52365155e-01, 6.12000000e+02, 3.52017872e-01, 6.13000000e+02, - 3.51671262e-01, 6.14000000e+02, 3.51325322e-01, 6.15000000e+02, 3.50980050e-01, - 6.16000000e+02, 3.50635445e-01, 6.17000000e+02, 3.50291504e-01, 6.18000000e+02, - 3.49948226e-01, 6.19000000e+02, 3.49605608e-01, 6.20000000e+02, 3.49263649e-01, - 6.21000000e+02, 3.48922346e-01, 6.22000000e+02, 3.48581698e-01, 6.23000000e+02, - 3.48241703e-01, 6.24000000e+02, 3.47902358e-01, 6.25000000e+02, 3.47563662e-01, - 6.26000000e+02, 3.47225613e-01, 6.27000000e+02, 3.46888209e-01, 6.28000000e+02, - 3.46551448e-01, 6.29000000e+02, 3.46215329e-01, 6.30000000e+02, 3.45879849e-01, - 6.31000000e+02, 3.45545006e-01, 6.32000000e+02, 3.45210799e-01, 6.33000000e+02, - 3.44877226e-01, 6.34000000e+02, 3.44544285e-01, 6.35000000e+02, 3.44211973e-01, - 6.36000000e+02, 3.43880290e-01, 6.37000000e+02, 3.43549234e-01, 6.38000000e+02, - 3.43218802e-01, 6.39000000e+02, 3.42888993e-01, 6.40000000e+02, 3.42559805e-01, - 6.41000000e+02, 3.42231236e-01, 6.42000000e+02, 3.41903284e-01, 6.43000000e+02, - 3.41575948e-01, 6.44000000e+02, 3.41249226e-01, 6.45000000e+02, 3.40923116e-01, - 6.46000000e+02, 3.40597616e-01, 6.47000000e+02, 3.40272725e-01, 6.48000000e+02, - 3.39948441e-01, 6.49000000e+02, 3.39624762e-01, 6.50000000e+02, 3.39301686e-01, - 6.51000000e+02, 3.38979212e-01, 6.52000000e+02, 3.38657338e-01, 6.53000000e+02, - 3.38336061e-01, 6.54000000e+02, 3.38015382e-01, 6.55000000e+02, 3.37695297e-01, - 6.56000000e+02, 3.37375805e-01, 6.57000000e+02, 3.37056905e-01, 6.58000000e+02, - 3.36738594e-01, 6.59000000e+02, 3.36420872e-01, 6.60000000e+02, 3.36103736e-01, - 6.61000000e+02, 3.35787184e-01, 6.62000000e+02, 3.35471216e-01, 6.63000000e+02, - 3.35155829e-01, 6.64000000e+02, 3.34841022e-01, 6.65000000e+02, 3.34526793e-01, - 6.66000000e+02, 3.34213141e-01, 6.67000000e+02, 3.33900063e-01, 6.68000000e+02, - 3.33587559e-01, 6.69000000e+02, 3.33275627e-01, 6.70000000e+02, 3.32964264e-01, - 6.71000000e+02, 3.32653470e-01, 6.72000000e+02, 3.32343243e-01, 6.73000000e+02, - 3.32033582e-01, 6.74000000e+02, 3.31724484e-01, 6.75000000e+02, 3.31415948e-01, - 6.76000000e+02, 3.31107973e-01, 6.77000000e+02, 3.30800557e-01, 6.78000000e+02, - 3.30493699e-01, 6.79000000e+02, 3.30187396e-01, 6.80000000e+02, 3.29881648e-01, - 6.81000000e+02, 3.29576453e-01, 6.82000000e+02, 3.29271809e-01, 6.83000000e+02, - 3.28967715e-01, 6.84000000e+02, 3.28664169e-01, 6.85000000e+02, 3.28361170e-01, - 6.86000000e+02, 3.28058717e-01, 6.87000000e+02, 3.27756807e-01, 6.88000000e+02, - 3.27455439e-01, 6.89000000e+02, 3.27154613e-01, 6.90000000e+02, 3.26854325e-01, - 6.91000000e+02, 3.26554576e-01, 6.92000000e+02, 3.26255363e-01, 6.93000000e+02, - 3.25956684e-01, 6.94000000e+02, 3.25658540e-01, 6.95000000e+02, 3.25360927e-01, - 6.96000000e+02, 3.25063845e-01, 6.97000000e+02, 3.24767292e-01, 6.98000000e+02, - 3.24471266e-01, 6.99000000e+02, 3.24175767e-01, 7.00000000e+02, 3.23880793e-01, - 7.01000000e+02, 3.23586342e-01, 7.02000000e+02, 3.23292413e-01, 7.03000000e+02, - 3.22999004e-01, 7.04000000e+02, 3.22706115e-01, 7.05000000e+02, 3.22413744e-01, - 7.06000000e+02, 3.22121889e-01, 7.07000000e+02, 3.21830548e-01, 7.08000000e+02, - 3.21539722e-01, 7.09000000e+02, 3.21249407e-01, 7.10000000e+02, 3.20959604e-01, - 7.11000000e+02, 3.20670310e-01, 7.12000000e+02, 3.20381524e-01, 7.13000000e+02, - 3.20093244e-01, 7.14000000e+02, 3.19805471e-01, 7.15000000e+02, 3.19518201e-01, - 7.16000000e+02, 3.19231434e-01, 7.17000000e+02, 3.18945168e-01, 7.18000000e+02, - 3.18659402e-01, 7.19000000e+02, 3.18374135e-01, 7.20000000e+02, 3.18089365e-01, - 7.21000000e+02, 3.17805091e-01, 7.22000000e+02, 3.17521312e-01, 7.23000000e+02, - 3.17238026e-01, 7.24000000e+02, 3.16955233e-01, 7.25000000e+02, 3.16672930e-01, - 7.26000000e+02, 3.16391117e-01, 7.27000000e+02, 3.16109792e-01, 7.28000000e+02, - 3.15828954e-01, 7.29000000e+02, 3.15548601e-01, 7.30000000e+02, 3.15268733e-01, - 7.31000000e+02, 3.14989348e-01, 7.32000000e+02, 3.14710445e-01, 7.33000000e+02, - 3.14432022e-01, 7.34000000e+02, 3.14154079e-01, 7.35000000e+02, 3.13876613e-01, - 7.36000000e+02, 3.13599625e-01, 7.37000000e+02, 3.13323112e-01, 7.38000000e+02, - 3.13047073e-01, 7.39000000e+02, 3.12771508e-01, 7.40000000e+02, 3.12496414e-01, - 7.41000000e+02, 3.12221791e-01, 7.42000000e+02, 3.11947637e-01, 7.43000000e+02, - 3.11673951e-01, 7.44000000e+02, 3.11400733e-01, 7.45000000e+02, 3.11127980e-01, - 7.46000000e+02, 3.10855691e-01, 7.47000000e+02, 3.10583866e-01, 7.48000000e+02, - 3.10312503e-01, 7.49000000e+02, 3.10041601e-01, 7.50000000e+02, 3.09771159e-01, - 7.51000000e+02, 3.09501175e-01, 7.52000000e+02, 3.09231649e-01, 7.53000000e+02, - 3.08962579e-01, 7.54000000e+02, 3.08693964e-01, 7.55000000e+02, 3.08425803e-01, - 7.56000000e+02, 3.08158094e-01, 7.57000000e+02, 3.07890838e-01, 7.58000000e+02, - 3.07624031e-01, 7.59000000e+02, 3.07357674e-01, 7.60000000e+02, 3.07091765e-01, - 7.61000000e+02, 3.06826302e-01, 7.62000000e+02, 3.06561286e-01, 7.63000000e+02, - 3.06296714e-01, 7.64000000e+02, 3.06032586e-01, 7.65000000e+02, 3.05768900e-01, - 7.66000000e+02, 3.05505656e-01, 7.67000000e+02, 3.05242852e-01, 7.68000000e+02, - 3.04980486e-01, 7.69000000e+02, 3.04718559e-01, 7.70000000e+02, 3.04457068e-01, - 7.71000000e+02, 3.04196014e-01, 7.72000000e+02, 3.03935394e-01, 7.73000000e+02, - 3.03675207e-01, 7.74000000e+02, 3.03415453e-01, 7.75000000e+02, 3.03156130e-01, - 7.76000000e+02, 3.02897237e-01, 7.77000000e+02, 3.02638774e-01, 7.78000000e+02, - 3.02380739e-01, 7.79000000e+02, 3.02123131e-01, 7.80000000e+02, 3.01865948e-01, - 7.81000000e+02, 3.01609191e-01, 7.82000000e+02, 3.01352857e-01, 7.83000000e+02, - 3.01096947e-01, 7.84000000e+02, 3.00841458e-01, 7.85000000e+02, 3.00586389e-01, - 7.86000000e+02, 3.00331741e-01, 7.87000000e+02, 3.00077510e-01, 7.88000000e+02, - 2.99823698e-01, 7.89000000e+02, 2.99570302e-01, 7.90000000e+02, 2.99317321e-01, - 7.91000000e+02, 2.99064755e-01, 7.92000000e+02, 2.98812602e-01, 7.93000000e+02, - 2.98560861e-01, 7.94000000e+02, 2.98309532e-01, 7.95000000e+02, 2.98058613e-01, - 7.96000000e+02, 2.97808104e-01, 7.97000000e+02, 2.97558003e-01, 7.98000000e+02, - 2.97308309e-01, 7.99000000e+02, 2.97059021e-01, 8.00000000e+02, 2.96810139e-01, - 8.01000000e+02, 2.96561661e-01, 8.02000000e+02, 2.96313586e-01, 8.03000000e+02, - 2.96065914e-01, 8.04000000e+02, 2.95818643e-01, 8.05000000e+02, 2.95571772e-01, - 8.06000000e+02, 2.95325301e-01, 8.07000000e+02, 2.95079228e-01, 8.08000000e+02, - 2.94833553e-01, 8.09000000e+02, 2.94588274e-01, 8.10000000e+02, 2.94343391e-01, - 8.11000000e+02, 2.94098902e-01, 8.12000000e+02, 2.93854806e-01, 8.13000000e+02, - 2.93611103e-01, 8.14000000e+02, 2.93367792e-01, 8.15000000e+02, 2.93124872e-01, - 8.16000000e+02, 2.92882341e-01, 8.17000000e+02, 2.92640200e-01, 8.18000000e+02, - 2.92398446e-01, 8.19000000e+02, 2.92157079e-01, 8.20000000e+02, 2.91916098e-01, - 8.21000000e+02, 2.91675502e-01, 8.22000000e+02, 2.91435290e-01, 8.23000000e+02, - 2.91195461e-01, 8.24000000e+02, 2.90956015e-01, 8.25000000e+02, 2.90716950e-01, - 8.26000000e+02, 2.90478266e-01, 8.27000000e+02, 2.90239961e-01, 8.28000000e+02, - 2.90002034e-01, 8.29000000e+02, 2.89764486e-01, 8.30000000e+02, 2.89527314e-01, - 8.31000000e+02, 2.89290518e-01, 8.32000000e+02, 2.89054097e-01, 8.33000000e+02, - 2.88818050e-01, 8.34000000e+02, 2.88582377e-01, 8.35000000e+02, 2.88347076e-01, - 8.36000000e+02, 2.88112146e-01, 8.37000000e+02, 2.87877587e-01, 8.38000000e+02, - 2.87643398e-01, 8.39000000e+02, 2.87409577e-01, 8.40000000e+02, 2.87176124e-01, - 8.41000000e+02, 2.86943038e-01, 8.42000000e+02, 2.86710319e-01, 8.43000000e+02, - 2.86477965e-01, 8.44000000e+02, 2.86245975e-01, 8.45000000e+02, 2.86014349e-01, - 8.46000000e+02, 2.85783086e-01, 8.47000000e+02, 2.85552184e-01, 8.48000000e+02, - 2.85321644e-01, 8.49000000e+02, 2.85091463e-01, 8.50000000e+02, 2.84861642e-01, - 8.51000000e+02, 2.84632180e-01, 8.52000000e+02, 2.84403075e-01, 8.53000000e+02, - 2.84174327e-01, 8.54000000e+02, 2.83945935e-01, 8.55000000e+02, 2.83717898e-01, - 8.56000000e+02, 2.83490215e-01, 8.57000000e+02, 2.83262886e-01, 8.58000000e+02, - 2.83035910e-01, 8.59000000e+02, 2.82809285e-01, 8.60000000e+02, 2.82583011e-01, - 8.61000000e+02, 2.82357088e-01, 8.62000000e+02, 2.82131513e-01, 8.63000000e+02, - 2.81906288e-01, 8.64000000e+02, 2.81681410e-01, 8.65000000e+02, 2.81456879e-01, - 8.66000000e+02, 2.81232694e-01, 8.67000000e+02, 2.81008855e-01, 8.68000000e+02, - 2.80785360e-01, 8.69000000e+02, 2.80562208e-01, 8.70000000e+02, 2.80339400e-01, - 8.71000000e+02, 2.80116934e-01, 8.72000000e+02, 2.79894809e-01, 8.73000000e+02, - 2.79673025e-01, 8.74000000e+02, 2.79451580e-01, 8.75000000e+02, 2.79230475e-01, - 8.76000000e+02, 2.79009707e-01, 8.77000000e+02, 2.78789277e-01, 8.78000000e+02, - 2.78569184e-01, 8.79000000e+02, 2.78349427e-01, 8.80000000e+02, 2.78130004e-01, - 8.81000000e+02, 2.77910917e-01, 8.82000000e+02, 2.77692162e-01, 8.83000000e+02, - 2.77473741e-01, 8.84000000e+02, 2.77255651e-01, 8.85000000e+02, 2.77037893e-01, - 8.86000000e+02, 2.76820465e-01, 8.87000000e+02, 2.76603368e-01, 8.88000000e+02, - 2.76386599e-01, 8.89000000e+02, 2.76170158e-01, 8.90000000e+02, 2.75954045e-01, - 8.91000000e+02, 2.75738259e-01, 8.92000000e+02, 2.75522799e-01, 8.93000000e+02, - 2.75307664e-01, 8.94000000e+02, 2.75092854e-01, 8.95000000e+02, 2.74878367e-01, - 8.96000000e+02, 2.74664204e-01, 8.97000000e+02, 2.74450363e-01, 8.98000000e+02, - 2.74236844e-01, 8.99000000e+02, 2.74023645e-01, 9.00000000e+02, 2.73810767e-01, - 9.01000000e+02, 2.73598208e-01, 9.02000000e+02, 2.73385968e-01, 9.03000000e+02, - 2.73174046e-01, 9.04000000e+02, 2.72962442e-01, 9.05000000e+02, 2.72751154e-01, - 9.06000000e+02, 2.72540181e-01, 9.07000000e+02, 2.72329524e-01, 9.08000000e+02, - 2.72119182e-01, 9.09000000e+02, 2.71909153e-01, 9.10000000e+02, 2.71699437e-01, - 9.11000000e+02, 2.71490034e-01, 9.12000000e+02, 2.71280942e-01, 9.13000000e+02, - 2.71072162e-01, 9.14000000e+02, 2.70863691e-01, 9.15000000e+02, 2.70655530e-01, - 9.16000000e+02, 2.70447679e-01, 9.17000000e+02, 2.70240135e-01, 9.18000000e+02, - 2.70032899e-01, 9.19000000e+02, 2.69825969e-01, 9.20000000e+02, 2.69619346e-01, - 9.21000000e+02, 2.69413028e-01, 9.22000000e+02, 2.69207016e-01, 9.23000000e+02, - 2.69001307e-01, 9.24000000e+02, 2.68795901e-01, 9.25000000e+02, 2.68590799e-01, - 9.26000000e+02, 2.68385998e-01, 9.27000000e+02, 2.68181499e-01, 9.28000000e+02, - 2.67977301e-01, 9.29000000e+02, 2.67773403e-01, 9.30000000e+02, 2.67569804e-01, - 9.31000000e+02, 2.67366505e-01, 9.32000000e+02, 2.67163503e-01, 9.33000000e+02, - 2.66960799e-01, 9.34000000e+02, 2.66758391e-01, 9.35000000e+02, 2.66556280e-01, - 9.36000000e+02, 2.66354464e-01, 9.37000000e+02, 2.66152944e-01, 9.38000000e+02, - 2.65951717e-01, 9.39000000e+02, 2.65750784e-01, 9.40000000e+02, 2.65550144e-01, - 9.41000000e+02, 2.65349796e-01, 9.42000000e+02, 2.65149740e-01, 9.43000000e+02, - 2.64949975e-01, 9.44000000e+02, 2.64750501e-01, 9.45000000e+02, 2.64551316e-01, - 9.46000000e+02, 2.64352420e-01, 9.47000000e+02, 2.64153813e-01, 9.48000000e+02, - 2.63955494e-01, 9.49000000e+02, 2.63757462e-01, 9.50000000e+02, 2.63559716e-01, - 9.51000000e+02, 2.63362257e-01, 9.52000000e+02, 2.63165083e-01, 9.53000000e+02, - 2.62968193e-01, 9.54000000e+02, 2.62771588e-01, 9.55000000e+02, 2.62575267e-01, - 9.56000000e+02, 2.62379228e-01, 9.57000000e+02, 2.62183472e-01, 9.58000000e+02, - 2.61987997e-01, 9.59000000e+02, 2.61792804e-01, 9.60000000e+02, 2.61597891e-01, - 9.61000000e+02, 2.61403258e-01, 9.62000000e+02, 2.61208904e-01, 9.63000000e+02, - 2.61014829e-01, 9.64000000e+02, 2.60821032e-01, 9.65000000e+02, 2.60627513e-01, - 9.66000000e+02, 2.60434270e-01, 9.67000000e+02, 2.60241304e-01, 9.68000000e+02, - 2.60048614e-01, 9.69000000e+02, 2.59856198e-01, 9.70000000e+02, 2.59664057e-01, - 9.71000000e+02, 2.59472191e-01, 9.72000000e+02, 2.59280597e-01, 9.73000000e+02, - 2.59089276e-01, 9.74000000e+02, 2.58898228e-01, 9.75000000e+02, 2.58707451e-01, - 9.76000000e+02, 2.58516945e-01, 9.77000000e+02, 2.58326710e-01, 9.78000000e+02, - 2.58136745e-01, 9.79000000e+02, 2.57947049e-01, 9.80000000e+02, 2.57757621e-01, - 9.81000000e+02, 2.57568462e-01, 9.82000000e+02, 2.57379571e-01, 9.83000000e+02, - 2.57190946e-01, 9.84000000e+02, 2.57002589e-01, 9.85000000e+02, 2.56814497e-01, - 9.86000000e+02, 2.56626670e-01, 9.87000000e+02, 2.56439108e-01, 9.88000000e+02, - 2.56251811e-01, 9.89000000e+02, 2.56064777e-01, 9.90000000e+02, 2.55878006e-01, - 9.91000000e+02, 2.55691498e-01, 9.92000000e+02, 2.55505252e-01, 9.93000000e+02, - 2.55319267e-01, 9.94000000e+02, 2.55133544e-01, 9.95000000e+02, 2.54948080e-01, - 9.96000000e+02, 2.54762877e-01, 9.97000000e+02, 2.54577933e-01, 9.98000000e+02, - 2.54393248e-01, 9.99000000e+02, 2.54208820e-01 ] - - - [ -1.08428410e-02, 1.00796208e-07, 4.02972510e-08, -1.08401463e-02, 9.28468679e-08, - 3.59717644e-08, -1.08347470e-02, 7.81576417e-08, 2.81268864e-08, -1.08266407e-02, - 5.89885129e-08, 1.82493117e-08, -1.08158654e-02, 3.83468505e-08, 8.27356179e-09, - -1.08025451e-02, 1.95729598e-08, 2.76289399e-10, -1.07871701e-02, 5.91587407e-09, - -3.85006934e-09, -1.07705448e-02, -1.82444641e-10, -2.73787140e-09, -1.07532992e-02, - 2.38144468e-09, 4.20002544e-09, -1.07360964e-02, 1.33707478e-08, 1.66739763e-08, - -1.07196312e-02, 3.12744513e-08, 3.35377633e-08, -1.07045970e-02, 5.35531486e-08, - 5.29383504e-08, -1.06916508e-02, 7.70293007e-08, 7.25730606e-08, -1.06813757e-02, - 9.83584791e-08, 9.00149101e-08, -1.06742452e-02, 1.14511607e-07, 1.03057467e-07, - -1.06705935e-02, 1.23201936e-07, 1.10028708e-07, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, -1.05879118e-19, 5.51152161e-01, 0.00000000e+00, - -1.05879118e-19, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, -1.05879118e-19, 5.51152161e-01, 0.00000000e+00, 5.29395592e-20, - 5.51152161e-01, 0.00000000e+00, 5.29395592e-20, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 5.29395592e-20, 5.51152161e-01, 0.00000000e+00, - 5.29395592e-20, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.05879118e-19, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] - - - [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] - - True - - - - - [ 2.54046169e+00, -2.55497842e-06, -2.53992720e-06, 2.54088920e+00, -2.45343914e-06, - -2.43826559e-06, 2.54172768e+00, -2.25468129e-06, -2.23977738e-06, 2.54294465e+00, - -1.96738953e-06, -1.95418367e-06, 2.54449304e+00, -1.60482940e-06, -1.59492881e-06, - 2.54631299e+00, -1.18497731e-06, -1.17845531e-06, 2.54833424e+00, -7.27018109e-07, - -7.22695041e-07, 2.55047886e+00, -2.44842391e-07, -2.43380754e-07, 2.55266429e+00, - 2.45853915e-07, 2.44326075e-07, 2.55480653e+00, 7.29310194e-07, 7.24876546e-07, - 2.55682339e+00, 1.18850673e-06, 1.18134476e-06, 2.55863762e+00, 1.60584185e-06, - 1.59603831e-06, 2.56017981e+00, 1.96401954e-06, 1.95183297e-06, 2.56139106e+00, - 2.24749833e-06, 2.23336370e-06, 2.56222516e+00, 2.44369387e-06, 2.42824331e-06, - 2.56265031e+00, 2.54395008e-06, 2.52785780e-06 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/frictionH/120K/clean.sh b/drivers/py/pes/friction/frictionH/120K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/frictionH/120K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/frictionH/120K/get1D.sh b/drivers/py/pes/friction/frictionH/120K/get1D.sh deleted file mode 100755 index 152292560..000000000 --- a/drivers/py/pes/friction/frictionH/120K/get1D.sh +++ /dev/null @@ -1,5 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 diff --git a/drivers/py/pes/friction/frictionH/120K/init.xyz b/drivers/py/pes/friction/frictionH/120K/init.xyz deleted file mode 100644 index 223399063..000000000 --- a/drivers/py/pes/friction/frictionH/120K/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/frictionH/120K/input.xml b/drivers/py/pes/friction/frictionH/120K/input.xml deleted file mode 100644 index 2a0629d36..000000000 --- a/drivers/py/pes/friction/frictionH/120K/input.xml +++ /dev/null @@ -1,45 +0,0 @@ - - - [ step, potential{electronvolt}] - extras - extras - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - ['friction'] - - - - 120 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - - z_friction.dat - true - true - none - 0.1 - - - -
diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_00 b/drivers/py/pes/friction/frictionH/120K/inst.fric_00 deleted file mode 100644 index 683fa6135..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_00 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 - 0.00013194 -0.00003135 -0.00003130 - -0.00003135 0.00013218 -0.00003131 - -0.00003130 -0.00003131 0.00013173 - #*EXTRAS*# Step: 1 Bead: 0 - 0.00012916 -0.00003645 -0.00003615 - -0.00003645 0.00012933 -0.00003649 - -0.00003615 -0.00003649 0.00012882 - #*EXTRAS*# Step: 2 Bead: 0 - 0.00012595 -0.00004042 -0.00003987 - -0.00004042 0.00012602 -0.00004051 - -0.00003987 -0.00004051 0.00012563 - #*EXTRAS*# Step: 3 Bead: 0 - 0.00012376 -0.00004237 -0.00004198 - -0.00004237 0.00012383 -0.00004247 - -0.00004198 -0.00004247 0.00012354 - #*EXTRAS*# Step: 4 Bead: 0 - 0.00012251 -0.00004316 -0.00004300 - -0.00004316 0.00012257 -0.00004323 - -0.00004300 -0.00004323 0.00012236 - #*EXTRAS*# Step: 5 Bead: 0 - 0.00012165 -0.00004358 -0.00004353 - -0.00004358 0.00012168 -0.00004358 - -0.00004353 -0.00004358 0.00012156 - #*EXTRAS*# Step: 6 Bead: 0 - 0.00012100 -0.00004384 -0.00004383 - -0.00004384 0.00012098 -0.00004379 - -0.00004383 -0.00004379 0.00012093 - #*EXTRAS*# Step: 7 Bead: 0 - 0.00012048 -0.00004403 -0.00004402 - -0.00004403 0.00012040 -0.00004392 - -0.00004402 -0.00004392 0.00012043 - #*EXTRAS*# Step: 8 Bead: 0 - 0.00012005 -0.00004417 -0.00004413 - -0.00004417 0.00011993 -0.00004401 - -0.00004413 -0.00004401 0.00012001 - #*EXTRAS*# Step: 9 Bead: 0 - 0.00011969 -0.00004427 -0.00004421 - -0.00004427 0.00011952 -0.00004407 - -0.00004421 -0.00004407 0.00011966 - #*EXTRAS*# Step: 10 Bead: 0 - 0.00011938 -0.00004435 -0.00004426 - -0.00004435 0.00011918 -0.00004412 - -0.00004426 -0.00004412 0.00011937 - #*EXTRAS*# Step: 11 Bead: 0 - 0.00011912 -0.00004441 -0.00004430 - -0.00004441 0.00011889 -0.00004415 - -0.00004430 -0.00004415 0.00011911 - #*EXTRAS*# Step: 12 Bead: 0 - 0.00011889 -0.00004446 -0.00004433 - -0.00004446 0.00011863 -0.00004417 - -0.00004433 -0.00004417 0.00011888 - #*EXTRAS*# Step: 13 Bead: 0 - 0.00011869 -0.00004450 -0.00004435 - -0.00004450 0.00011841 -0.00004419 - -0.00004435 -0.00004419 0.00011869 - #*EXTRAS*# Step: 14 Bead: 0 - 0.00011851 -0.00004453 -0.00004436 - -0.00004453 0.00011821 -0.00004421 - -0.00004436 -0.00004421 0.00011851 - #*EXTRAS*# Step: 15 Bead: 0 - 0.00011836 -0.00004455 -0.00004437 - -0.00004455 0.00011803 -0.00004422 - -0.00004437 -0.00004422 0.00011835 - #*EXTRAS*# Step: 16 Bead: 0 - 0.00011821 -0.00004457 -0.00004437 - -0.00004457 0.00011788 -0.00004422 - -0.00004437 -0.00004422 0.00011821 - #*EXTRAS*# Step: 17 Bead: 0 - 0.00011809 -0.00004458 -0.00004438 - -0.00004458 0.00011774 -0.00004423 - -0.00004438 -0.00004423 0.00011808 - #*EXTRAS*# Step: 18 Bead: 0 - 0.00011797 -0.00004460 -0.00004438 - -0.00004460 0.00011761 -0.00004423 - -0.00004438 -0.00004423 0.00011797 - #*EXTRAS*# Step: 19 Bead: 0 - 0.00011786 -0.00004461 -0.00004438 - -0.00004461 0.00011750 -0.00004424 - -0.00004438 -0.00004424 0.00011787 - #*EXTRAS*# Step: 20 Bead: 0 - 0.00011777 -0.00004461 -0.00004438 - -0.00004461 0.00011739 -0.00004424 - -0.00004438 -0.00004424 0.00011777 - #*EXTRAS*# Step: 21 Bead: 0 - 0.00011768 -0.00004462 -0.00004438 - -0.00004462 0.00011730 -0.00004424 - -0.00004438 -0.00004424 0.00011769 - #*EXTRAS*# Step: 22 Bead: 0 - 0.00011760 -0.00004462 -0.00004438 - -0.00004462 0.00011722 -0.00004424 - -0.00004438 -0.00004424 0.00011761 - #*EXTRAS*# Step: 23 Bead: 0 - 0.00011753 -0.00004463 -0.00004437 - -0.00004463 0.00011714 -0.00004424 - -0.00004437 -0.00004424 0.00011754 - #*EXTRAS*# Step: 24 Bead: 0 - 0.00011747 -0.00004463 -0.00004437 - -0.00004463 0.00011707 -0.00004424 - -0.00004437 -0.00004424 0.00011747 - #*EXTRAS*# Step: 25 Bead: 0 - 0.00011741 -0.00004463 -0.00004437 - -0.00004463 0.00011701 -0.00004424 - -0.00004437 -0.00004424 0.00011741 - #*EXTRAS*# Step: 26 Bead: 0 - 0.00011735 -0.00004463 -0.00004437 - -0.00004463 0.00011695 -0.00004424 - -0.00004437 -0.00004424 0.00011736 - #*EXTRAS*# Step: 27 Bead: 0 - 0.00011730 -0.00004463 -0.00004437 - -0.00004463 0.00011689 -0.00004424 - -0.00004437 -0.00004424 0.00011731 - #*EXTRAS*# Step: 28 Bead: 0 - 0.00011725 -0.00004463 -0.00004436 - -0.00004463 0.00011685 -0.00004424 - -0.00004436 -0.00004424 0.00011726 - #*EXTRAS*# Step: 29 Bead: 0 - 0.00011721 -0.00004463 -0.00004436 - -0.00004463 0.00011680 -0.00004423 - -0.00004436 -0.00004423 0.00011722 - #*EXTRAS*# Step: 30 Bead: 0 - 0.00011717 -0.00004463 -0.00004436 - -0.00004463 0.00011676 -0.00004423 - -0.00004436 -0.00004423 0.00011718 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_01 b/drivers/py/pes/friction/frictionH/120K/inst.fric_01 deleted file mode 100644 index c201772ed..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_01 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 - 0.00013155 -0.00003225 -0.00003218 - -0.00003225 0.00013179 -0.00003222 - -0.00003218 -0.00003222 0.00013130 - #*EXTRAS*# Step: 1 Bead: 1 - 0.00012869 -0.00003713 -0.00003678 - -0.00003713 0.00012884 -0.00003718 - -0.00003678 -0.00003718 0.00012834 - #*EXTRAS*# Step: 2 Bead: 1 - 0.00012556 -0.00004082 -0.00004026 - -0.00004082 0.00012562 -0.00004091 - -0.00004026 -0.00004091 0.00012525 - #*EXTRAS*# Step: 3 Bead: 1 - 0.00012351 -0.00004255 -0.00004221 - -0.00004255 0.00012357 -0.00004265 - -0.00004221 -0.00004265 0.00012330 - #*EXTRAS*# Step: 4 Bead: 1 - 0.00012230 -0.00004327 -0.00004314 - -0.00004327 0.00012236 -0.00004332 - -0.00004314 -0.00004332 0.00012217 - #*EXTRAS*# Step: 5 Bead: 1 - 0.00012148 -0.00004365 -0.00004362 - -0.00004365 0.00012150 -0.00004364 - -0.00004362 -0.00004364 0.00012139 - #*EXTRAS*# Step: 6 Bead: 1 - 0.00012084 -0.00004390 -0.00004389 - -0.00004390 0.00012081 -0.00004383 - -0.00004389 -0.00004383 0.00012078 - #*EXTRAS*# Step: 7 Bead: 1 - 0.00012033 -0.00004408 -0.00004406 - -0.00004408 0.00012025 -0.00004395 - -0.00004406 -0.00004395 0.00012029 - #*EXTRAS*# Step: 8 Bead: 1 - 0.00011992 -0.00004420 -0.00004416 - -0.00004420 0.00011978 -0.00004403 - -0.00004416 -0.00004403 0.00011989 - #*EXTRAS*# Step: 9 Bead: 1 - 0.00011957 -0.00004430 -0.00004423 - -0.00004430 0.00011940 -0.00004409 - -0.00004423 -0.00004409 0.00011955 - #*EXTRAS*# Step: 10 Bead: 1 - 0.00011928 -0.00004437 -0.00004428 - -0.00004437 0.00011907 -0.00004413 - -0.00004428 -0.00004413 0.00011927 - #*EXTRAS*# Step: 11 Bead: 1 - 0.00011903 -0.00004443 -0.00004431 - -0.00004443 0.00011878 -0.00004416 - -0.00004431 -0.00004416 0.00011902 - #*EXTRAS*# Step: 12 Bead: 1 - 0.00011881 -0.00004447 -0.00004434 - -0.00004447 0.00011854 -0.00004418 - -0.00004434 -0.00004418 0.00011880 - #*EXTRAS*# Step: 13 Bead: 1 - 0.00011862 -0.00004451 -0.00004435 - -0.00004451 0.00011832 -0.00004420 - -0.00004435 -0.00004420 0.00011861 - #*EXTRAS*# Step: 14 Bead: 1 - 0.00011844 -0.00004454 -0.00004436 - -0.00004454 0.00011813 -0.00004421 - -0.00004436 -0.00004421 0.00011844 - #*EXTRAS*# Step: 15 Bead: 1 - 0.00011829 -0.00004456 -0.00004437 - -0.00004456 0.00011796 -0.00004422 - -0.00004437 -0.00004422 0.00011829 - #*EXTRAS*# Step: 16 Bead: 1 - 0.00011816 -0.00004458 -0.00004437 - -0.00004458 0.00011781 -0.00004423 - -0.00004437 -0.00004423 0.00011815 - #*EXTRAS*# Step: 17 Bead: 1 - 0.00011803 -0.00004459 -0.00004438 - -0.00004459 0.00011768 -0.00004423 - -0.00004438 -0.00004423 0.00011803 - #*EXTRAS*# Step: 18 Bead: 1 - 0.00011792 -0.00004460 -0.00004438 - -0.00004460 0.00011756 -0.00004423 - -0.00004438 -0.00004423 0.00011792 - #*EXTRAS*# Step: 19 Bead: 1 - 0.00011782 -0.00004461 -0.00004438 - -0.00004461 0.00011745 -0.00004424 - -0.00004438 -0.00004424 0.00011782 - #*EXTRAS*# Step: 20 Bead: 1 - 0.00011773 -0.00004462 -0.00004438 - -0.00004462 0.00011735 -0.00004424 - -0.00004438 -0.00004424 0.00011773 - #*EXTRAS*# Step: 21 Bead: 1 - 0.00011765 -0.00004462 -0.00004438 - -0.00004462 0.00011726 -0.00004424 - -0.00004438 -0.00004424 0.00011765 - #*EXTRAS*# Step: 22 Bead: 1 - 0.00011757 -0.00004462 -0.00004438 - -0.00004462 0.00011718 -0.00004424 - -0.00004438 -0.00004424 0.00011757 - #*EXTRAS*# Step: 23 Bead: 1 - 0.00011750 -0.00004463 -0.00004437 - -0.00004463 0.00011711 -0.00004424 - -0.00004437 -0.00004424 0.00011751 - #*EXTRAS*# Step: 24 Bead: 1 - 0.00011744 -0.00004463 -0.00004437 - -0.00004463 0.00011704 -0.00004424 - -0.00004437 -0.00004424 0.00011744 - #*EXTRAS*# Step: 25 Bead: 1 - 0.00011738 -0.00004463 -0.00004437 - -0.00004463 0.00011698 -0.00004424 - -0.00004437 -0.00004424 0.00011739 - #*EXTRAS*# Step: 26 Bead: 1 - 0.00011733 -0.00004463 -0.00004437 - -0.00004463 0.00011692 -0.00004424 - -0.00004437 -0.00004424 0.00011733 - #*EXTRAS*# Step: 27 Bead: 1 - 0.00011728 -0.00004463 -0.00004436 - -0.00004463 0.00011687 -0.00004424 - -0.00004436 -0.00004424 0.00011729 - #*EXTRAS*# Step: 28 Bead: 1 - 0.00011723 -0.00004463 -0.00004436 - -0.00004463 0.00011682 -0.00004424 - -0.00004436 -0.00004424 0.00011724 - #*EXTRAS*# Step: 29 Bead: 1 - 0.00011719 -0.00004463 -0.00004436 - -0.00004463 0.00011678 -0.00004423 - -0.00004436 -0.00004423 0.00011720 - #*EXTRAS*# Step: 30 Bead: 1 - 0.00011716 -0.00004463 -0.00004436 - -0.00004463 0.00011674 -0.00004423 - -0.00004436 -0.00004423 0.00011716 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_02 b/drivers/py/pes/friction/frictionH/120K/inst.fric_02 deleted file mode 100644 index 81e934e6a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_02 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 - 0.00013052 -0.00003427 -0.00003412 - -0.00003427 0.00013073 -0.00003427 - -0.00003412 -0.00003427 0.00013021 - #*EXTRAS*# Step: 1 Bead: 2 - 0.00012765 -0.00003850 -0.00003805 - -0.00003850 0.00012776 -0.00003857 - -0.00003805 -0.00003857 0.00012729 - #*EXTRAS*# Step: 2 Bead: 2 - 0.00012482 -0.00004151 -0.00004099 - -0.00004151 0.00012488 -0.00004161 - -0.00004099 -0.00004161 0.00012453 - #*EXTRAS*# Step: 3 Bead: 2 - 0.00012301 -0.00004288 -0.00004262 - -0.00004288 0.00012308 -0.00004296 - -0.00004262 -0.00004296 0.00012283 - #*EXTRAS*# Step: 4 Bead: 2 - 0.00012190 -0.00004346 -0.00004339 - -0.00004346 0.00012195 -0.00004349 - -0.00004339 -0.00004349 0.00012180 - #*EXTRAS*# Step: 5 Bead: 2 - 0.00012113 -0.00004379 -0.00004378 - -0.00004379 0.00012112 -0.00004375 - -0.00004378 -0.00004375 0.00012106 - #*EXTRAS*# Step: 6 Bead: 2 - 0.00012053 -0.00004401 -0.00004400 - -0.00004401 0.00012046 -0.00004391 - -0.00004400 -0.00004391 0.00012048 - #*EXTRAS*# Step: 7 Bead: 2 - 0.00012005 -0.00004416 -0.00004413 - -0.00004416 0.00011993 -0.00004401 - -0.00004413 -0.00004401 0.00012002 - #*EXTRAS*# Step: 8 Bead: 2 - 0.00011967 -0.00004427 -0.00004422 - -0.00004427 0.00011950 -0.00004407 - -0.00004422 -0.00004407 0.00011965 - #*EXTRAS*# Step: 9 Bead: 2 - 0.00011935 -0.00004436 -0.00004427 - -0.00004436 0.00011914 -0.00004412 - -0.00004427 -0.00004412 0.00011933 - #*EXTRAS*# Step: 10 Bead: 2 - 0.00011908 -0.00004442 -0.00004431 - -0.00004442 0.00011884 -0.00004415 - -0.00004431 -0.00004415 0.00011907 - #*EXTRAS*# Step: 11 Bead: 2 - 0.00011885 -0.00004447 -0.00004433 - -0.00004447 0.00011858 -0.00004418 - -0.00004433 -0.00004418 0.00011884 - #*EXTRAS*# Step: 12 Bead: 2 - 0.00011864 -0.00004450 -0.00004435 - -0.00004450 0.00011835 -0.00004420 - -0.00004435 -0.00004420 0.00011864 - #*EXTRAS*# Step: 13 Bead: 2 - 0.00011847 -0.00004453 -0.00004436 - -0.00004453 0.00011816 -0.00004421 - -0.00004436 -0.00004421 0.00011846 - #*EXTRAS*# Step: 14 Bead: 2 - 0.00011831 -0.00004456 -0.00004437 - -0.00004456 0.00011798 -0.00004422 - -0.00004437 -0.00004422 0.00011830 - #*EXTRAS*# Step: 15 Bead: 2 - 0.00011817 -0.00004457 -0.00004437 - -0.00004457 0.00011783 -0.00004423 - -0.00004437 -0.00004423 0.00011817 - #*EXTRAS*# Step: 16 Bead: 2 - 0.00011804 -0.00004459 -0.00004438 - -0.00004459 0.00011769 -0.00004423 - -0.00004438 -0.00004423 0.00011804 - #*EXTRAS*# Step: 17 Bead: 2 - 0.00011793 -0.00004460 -0.00004438 - -0.00004460 0.00011757 -0.00004423 - -0.00004438 -0.00004423 0.00011793 - #*EXTRAS*# Step: 18 Bead: 2 - 0.00011783 -0.00004461 -0.00004438 - -0.00004461 0.00011746 -0.00004424 - -0.00004438 -0.00004424 0.00011783 - #*EXTRAS*# Step: 19 Bead: 2 - 0.00011773 -0.00004462 -0.00004438 - -0.00004462 0.00011736 -0.00004424 - -0.00004438 -0.00004424 0.00011774 - #*EXTRAS*# Step: 20 Bead: 2 - 0.00011765 -0.00004462 -0.00004438 - -0.00004462 0.00011727 -0.00004424 - -0.00004438 -0.00004424 0.00011765 - #*EXTRAS*# Step: 21 Bead: 2 - 0.00011757 -0.00004462 -0.00004438 - -0.00004462 0.00011718 -0.00004424 - -0.00004438 -0.00004424 0.00011758 - #*EXTRAS*# Step: 22 Bead: 2 - 0.00011750 -0.00004463 -0.00004437 - -0.00004463 0.00011711 -0.00004424 - -0.00004437 -0.00004424 0.00011751 - #*EXTRAS*# Step: 23 Bead: 2 - 0.00011744 -0.00004463 -0.00004437 - -0.00004463 0.00011704 -0.00004424 - -0.00004437 -0.00004424 0.00011745 - #*EXTRAS*# Step: 24 Bead: 2 - 0.00011738 -0.00004463 -0.00004437 - -0.00004463 0.00011698 -0.00004424 - -0.00004437 -0.00004424 0.00011739 - #*EXTRAS*# Step: 25 Bead: 2 - 0.00011733 -0.00004463 -0.00004437 - -0.00004463 0.00011692 -0.00004424 - -0.00004437 -0.00004424 0.00011733 - #*EXTRAS*# Step: 26 Bead: 2 - 0.00011728 -0.00004463 -0.00004437 - -0.00004463 0.00011687 -0.00004424 - -0.00004437 -0.00004424 0.00011729 - #*EXTRAS*# Step: 27 Bead: 2 - 0.00011723 -0.00004463 -0.00004436 - -0.00004463 0.00011683 -0.00004424 - -0.00004436 -0.00004424 0.00011724 - #*EXTRAS*# Step: 28 Bead: 2 - 0.00011719 -0.00004463 -0.00004436 - -0.00004463 0.00011678 -0.00004423 - -0.00004436 -0.00004423 0.00011720 - #*EXTRAS*# Step: 29 Bead: 2 - 0.00011716 -0.00004463 -0.00004436 - -0.00004463 0.00011674 -0.00004423 - -0.00004436 -0.00004423 0.00011716 - #*EXTRAS*# Step: 30 Bead: 2 - 0.00011712 -0.00004463 -0.00004436 - -0.00004463 0.00011671 -0.00004423 - -0.00004436 -0.00004423 0.00011713 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_03 b/drivers/py/pes/friction/frictionH/120K/inst.fric_03 deleted file mode 100644 index fe0c320e9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_03 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 - 0.00012868 -0.00003715 -0.00003680 - -0.00003715 0.00012883 -0.00003720 - -0.00003680 -0.00003720 0.00012833 - #*EXTRAS*# Step: 1 Bead: 3 - 0.00012608 -0.00004029 -0.00003974 - -0.00004029 0.00012615 -0.00004038 - -0.00003974 -0.00004038 0.00012575 - #*EXTRAS*# Step: 2 Bead: 3 - 0.00012382 -0.00004233 -0.00004193 - -0.00004233 0.00012388 -0.00004243 - -0.00004193 -0.00004243 0.00012359 - #*EXTRAS*# Step: 3 Bead: 3 - 0.00012229 -0.00004328 -0.00004315 - -0.00004328 0.00012235 -0.00004333 - -0.00004315 -0.00004333 0.00012216 - #*EXTRAS*# Step: 4 Bead: 3 - 0.00012130 -0.00004372 -0.00004370 - -0.00004372 0.00012131 -0.00004370 - -0.00004370 -0.00004370 0.00012123 - #*EXTRAS*# Step: 5 Bead: 3 - 0.00012060 -0.00004399 -0.00004398 - -0.00004399 0.00012054 -0.00004389 - -0.00004398 -0.00004389 0.00012055 - #*EXTRAS*# Step: 6 Bead: 3 - 0.00012006 -0.00004416 -0.00004413 - -0.00004416 0.00011994 -0.00004401 - -0.00004413 -0.00004401 0.00012003 - #*EXTRAS*# Step: 7 Bead: 3 - 0.00011964 -0.00004428 -0.00004422 - -0.00004428 0.00011947 -0.00004408 - -0.00004422 -0.00004408 0.00011962 - #*EXTRAS*# Step: 8 Bead: 3 - 0.00011930 -0.00004437 -0.00004428 - -0.00004437 0.00011909 -0.00004413 - -0.00004428 -0.00004413 0.00011929 - #*EXTRAS*# Step: 9 Bead: 3 - 0.00011902 -0.00004443 -0.00004431 - -0.00004443 0.00011877 -0.00004416 - -0.00004431 -0.00004416 0.00011901 - #*EXTRAS*# Step: 10 Bead: 3 - 0.00011878 -0.00004448 -0.00004434 - -0.00004448 0.00011851 -0.00004418 - -0.00004434 -0.00004418 0.00011877 - #*EXTRAS*# Step: 11 Bead: 3 - 0.00011858 -0.00004451 -0.00004435 - -0.00004451 0.00011828 -0.00004420 - -0.00004435 -0.00004420 0.00011857 - #*EXTRAS*# Step: 12 Bead: 3 - 0.00011840 -0.00004454 -0.00004436 - -0.00004454 0.00011809 -0.00004421 - -0.00004436 -0.00004421 0.00011840 - #*EXTRAS*# Step: 13 Bead: 3 - 0.00011825 -0.00004456 -0.00004437 - -0.00004456 0.00011791 -0.00004422 - -0.00004437 -0.00004422 0.00011824 - #*EXTRAS*# Step: 14 Bead: 3 - 0.00011811 -0.00004458 -0.00004438 - -0.00004458 0.00011776 -0.00004423 - -0.00004438 -0.00004423 0.00011811 - #*EXTRAS*# Step: 15 Bead: 3 - 0.00011799 -0.00004459 -0.00004438 - -0.00004459 0.00011763 -0.00004423 - -0.00004438 -0.00004423 0.00011799 - #*EXTRAS*# Step: 16 Bead: 3 - 0.00011788 -0.00004460 -0.00004438 - -0.00004460 0.00011751 -0.00004424 - -0.00004438 -0.00004424 0.00011788 - #*EXTRAS*# Step: 17 Bead: 3 - 0.00011778 -0.00004461 -0.00004438 - -0.00004461 0.00011740 -0.00004424 - -0.00004438 -0.00004424 0.00011778 - #*EXTRAS*# Step: 18 Bead: 3 - 0.00011769 -0.00004462 -0.00004438 - -0.00004462 0.00011731 -0.00004424 - -0.00004438 -0.00004424 0.00011769 - #*EXTRAS*# Step: 19 Bead: 3 - 0.00011761 -0.00004462 -0.00004438 - -0.00004462 0.00011722 -0.00004424 - -0.00004438 -0.00004424 0.00011761 - #*EXTRAS*# Step: 20 Bead: 3 - 0.00011753 -0.00004463 -0.00004437 - -0.00004463 0.00011714 -0.00004424 - -0.00004437 -0.00004424 0.00011754 - #*EXTRAS*# Step: 21 Bead: 3 - 0.00011747 -0.00004463 -0.00004437 - -0.00004463 0.00011707 -0.00004424 - -0.00004437 -0.00004424 0.00011747 - #*EXTRAS*# Step: 22 Bead: 3 - 0.00011741 -0.00004463 -0.00004437 - -0.00004463 0.00011701 -0.00004424 - -0.00004437 -0.00004424 0.00011741 - #*EXTRAS*# Step: 23 Bead: 3 - 0.00011735 -0.00004463 -0.00004437 - -0.00004463 0.00011695 -0.00004424 - -0.00004437 -0.00004424 0.00011736 - #*EXTRAS*# Step: 24 Bead: 3 - 0.00011730 -0.00004463 -0.00004437 - -0.00004463 0.00011689 -0.00004424 - -0.00004437 -0.00004424 0.00011731 - #*EXTRAS*# Step: 25 Bead: 3 - 0.00011725 -0.00004463 -0.00004436 - -0.00004463 0.00011685 -0.00004424 - -0.00004436 -0.00004424 0.00011726 - #*EXTRAS*# Step: 26 Bead: 3 - 0.00011721 -0.00004463 -0.00004436 - -0.00004463 0.00011680 -0.00004423 - -0.00004436 -0.00004423 0.00011722 - #*EXTRAS*# Step: 27 Bead: 3 - 0.00011717 -0.00004463 -0.00004436 - -0.00004463 0.00011676 -0.00004423 - -0.00004436 -0.00004423 0.00011718 - #*EXTRAS*# Step: 28 Bead: 3 - 0.00011714 -0.00004463 -0.00004436 - -0.00004463 0.00011672 -0.00004423 - -0.00004436 -0.00004423 0.00011714 - #*EXTRAS*# Step: 29 Bead: 3 - 0.00011710 -0.00004463 -0.00004436 - -0.00004463 0.00011669 -0.00004423 - -0.00004436 -0.00004423 0.00011711 - #*EXTRAS*# Step: 30 Bead: 3 - 0.00011707 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011708 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_04 b/drivers/py/pes/friction/frictionH/120K/inst.fric_04 deleted file mode 100644 index 3d5dbd9ed..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_04 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 - 0.00012608 -0.00004029 -0.00003974 - -0.00004029 0.00012615 -0.00004038 - -0.00003974 -0.00004038 0.00012575 - #*EXTRAS*# Step: 1 Bead: 4 - 0.00012421 -0.00004202 -0.00004157 - -0.00004202 0.00012427 -0.00004213 - -0.00004157 -0.00004213 0.00012396 - #*EXTRAS*# Step: 2 Bead: 4 - 0.00012262 -0.00004310 -0.00004292 - -0.00004310 0.00012269 -0.00004317 - -0.00004292 -0.00004317 0.00012247 - #*EXTRAS*# Step: 3 Bead: 4 - 0.00012136 -0.00004370 -0.00004368 - -0.00004370 0.00012137 -0.00004368 - -0.00004368 -0.00004368 0.00012128 - #*EXTRAS*# Step: 4 Bead: 4 - 0.00012050 -0.00004402 -0.00004401 - -0.00004402 0.00012044 -0.00004391 - -0.00004401 -0.00004391 0.00012046 - #*EXTRAS*# Step: 5 Bead: 4 - 0.00011991 -0.00004421 -0.00004417 - -0.00004421 0.00011977 -0.00004403 - -0.00004417 -0.00004403 0.00011988 - #*EXTRAS*# Step: 6 Bead: 4 - 0.00011946 -0.00004433 -0.00004425 - -0.00004433 0.00011926 -0.00004411 - -0.00004425 -0.00004411 0.00011944 - #*EXTRAS*# Step: 7 Bead: 4 - 0.00011911 -0.00004441 -0.00004430 - -0.00004441 0.00011887 -0.00004415 - -0.00004430 -0.00004415 0.00011910 - #*EXTRAS*# Step: 8 Bead: 4 - 0.00011883 -0.00004447 -0.00004433 - -0.00004447 0.00011856 -0.00004418 - -0.00004433 -0.00004418 0.00011882 - #*EXTRAS*# Step: 9 Bead: 4 - 0.00011860 -0.00004451 -0.00004435 - -0.00004451 0.00011830 -0.00004420 - -0.00004435 -0.00004420 0.00011859 - #*EXTRAS*# Step: 10 Bead: 4 - 0.00011841 -0.00004454 -0.00004436 - -0.00004454 0.00011809 -0.00004421 - -0.00004436 -0.00004421 0.00011840 - #*EXTRAS*# Step: 11 Bead: 4 - 0.00011824 -0.00004457 -0.00004437 - -0.00004457 0.00011791 -0.00004422 - -0.00004437 -0.00004422 0.00011824 - #*EXTRAS*# Step: 12 Bead: 4 - 0.00011809 -0.00004458 -0.00004438 - -0.00004458 0.00011775 -0.00004423 - -0.00004438 -0.00004423 0.00011809 - #*EXTRAS*# Step: 13 Bead: 4 - 0.00011797 -0.00004460 -0.00004438 - -0.00004460 0.00011761 -0.00004423 - -0.00004438 -0.00004423 0.00011797 - #*EXTRAS*# Step: 14 Bead: 4 - 0.00011786 -0.00004461 -0.00004438 - -0.00004461 0.00011749 -0.00004424 - -0.00004438 -0.00004424 0.00011786 - #*EXTRAS*# Step: 15 Bead: 4 - 0.00011776 -0.00004461 -0.00004438 - -0.00004461 0.00011738 -0.00004424 - -0.00004438 -0.00004424 0.00011776 - #*EXTRAS*# Step: 16 Bead: 4 - 0.00011767 -0.00004462 -0.00004438 - -0.00004462 0.00011728 -0.00004424 - -0.00004438 -0.00004424 0.00011767 - #*EXTRAS*# Step: 17 Bead: 4 - 0.00011759 -0.00004462 -0.00004438 - -0.00004462 0.00011720 -0.00004424 - -0.00004438 -0.00004424 0.00011759 - #*EXTRAS*# Step: 18 Bead: 4 - 0.00011751 -0.00004463 -0.00004437 - -0.00004463 0.00011712 -0.00004424 - -0.00004437 -0.00004424 0.00011752 - #*EXTRAS*# Step: 19 Bead: 4 - 0.00011745 -0.00004463 -0.00004437 - -0.00004463 0.00011705 -0.00004424 - -0.00004437 -0.00004424 0.00011745 - #*EXTRAS*# Step: 20 Bead: 4 - 0.00011739 -0.00004463 -0.00004437 - -0.00004463 0.00011699 -0.00004424 - -0.00004437 -0.00004424 0.00011739 - #*EXTRAS*# Step: 21 Bead: 4 - 0.00011733 -0.00004463 -0.00004437 - -0.00004463 0.00011693 -0.00004424 - -0.00004437 -0.00004424 0.00011734 - #*EXTRAS*# Step: 22 Bead: 4 - 0.00011728 -0.00004463 -0.00004437 - -0.00004463 0.00011688 -0.00004424 - -0.00004437 -0.00004424 0.00011729 - #*EXTRAS*# Step: 23 Bead: 4 - 0.00011724 -0.00004463 -0.00004436 - -0.00004463 0.00011683 -0.00004424 - -0.00004436 -0.00004424 0.00011725 - #*EXTRAS*# Step: 24 Bead: 4 - 0.00011720 -0.00004463 -0.00004436 - -0.00004463 0.00011679 -0.00004423 - -0.00004436 -0.00004423 0.00011720 - #*EXTRAS*# Step: 25 Bead: 4 - 0.00011716 -0.00004463 -0.00004436 - -0.00004463 0.00011675 -0.00004423 - -0.00004436 -0.00004423 0.00011717 - #*EXTRAS*# Step: 26 Bead: 4 - 0.00011712 -0.00004463 -0.00004436 - -0.00004463 0.00011671 -0.00004423 - -0.00004436 -0.00004423 0.00011713 - #*EXTRAS*# Step: 27 Bead: 4 - 0.00011709 -0.00004463 -0.00004435 - -0.00004463 0.00011668 -0.00004423 - -0.00004435 -0.00004423 0.00011710 - #*EXTRAS*# Step: 28 Bead: 4 - 0.00011706 -0.00004463 -0.00004435 - -0.00004463 0.00011665 -0.00004423 - -0.00004435 -0.00004423 0.00011707 - #*EXTRAS*# Step: 29 Bead: 4 - 0.00011704 -0.00004463 -0.00004435 - -0.00004463 0.00011662 -0.00004423 - -0.00004435 -0.00004423 0.00011705 - #*EXTRAS*# Step: 30 Bead: 4 - 0.00011701 -0.00004463 -0.00004435 - -0.00004463 0.00011659 -0.00004423 - -0.00004435 -0.00004423 0.00011702 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_05 b/drivers/py/pes/friction/frictionH/120K/inst.fric_05 deleted file mode 100644 index 0c998d4f5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_05 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 - 0.00012329 -0.00004270 -0.00004239 - -0.00004270 0.00012336 -0.00004279 - -0.00004239 -0.00004279 0.00012310 - #*EXTRAS*# Step: 1 Bead: 5 - 0.00012223 -0.00004331 -0.00004319 - -0.00004331 0.00012229 -0.00004335 - -0.00004319 -0.00004335 0.00012211 - #*EXTRAS*# Step: 2 Bead: 5 - 0.00012120 -0.00004376 -0.00004375 - -0.00004376 0.00012121 -0.00004373 - -0.00004375 -0.00004373 0.00012113 - #*EXTRAS*# Step: 3 Bead: 5 - 0.00012018 -0.00004412 -0.00004410 - -0.00004412 0.00012008 -0.00004398 - -0.00004410 -0.00004398 0.00012014 - #*EXTRAS*# Step: 4 Bead: 5 - 0.00011952 -0.00004431 -0.00004424 - -0.00004431 0.00011933 -0.00004410 - -0.00004424 -0.00004410 0.00011950 - #*EXTRAS*# Step: 5 Bead: 5 - 0.00011907 -0.00004442 -0.00004431 - -0.00004442 0.00011883 -0.00004416 - -0.00004431 -0.00004416 0.00011906 - #*EXTRAS*# Step: 6 Bead: 5 - 0.00011873 -0.00004449 -0.00004434 - -0.00004449 0.00011845 -0.00004419 - -0.00004434 -0.00004419 0.00011873 - #*EXTRAS*# Step: 7 Bead: 5 - 0.00011848 -0.00004453 -0.00004436 - -0.00004453 0.00011817 -0.00004421 - -0.00004436 -0.00004421 0.00011847 - #*EXTRAS*# Step: 8 Bead: 5 - 0.00011827 -0.00004456 -0.00004437 - -0.00004456 0.00011794 -0.00004422 - -0.00004437 -0.00004422 0.00011827 - #*EXTRAS*# Step: 9 Bead: 5 - 0.00011810 -0.00004458 -0.00004438 - -0.00004458 0.00011776 -0.00004423 - -0.00004438 -0.00004423 0.00011810 - #*EXTRAS*# Step: 10 Bead: 5 - 0.00011796 -0.00004460 -0.00004438 - -0.00004460 0.00011760 -0.00004423 - -0.00004438 -0.00004423 0.00011796 - #*EXTRAS*# Step: 11 Bead: 5 - 0.00011784 -0.00004461 -0.00004438 - -0.00004461 0.00011747 -0.00004424 - -0.00004438 -0.00004424 0.00011784 - #*EXTRAS*# Step: 12 Bead: 5 - 0.00011773 -0.00004462 -0.00004438 - -0.00004462 0.00011736 -0.00004424 - -0.00004438 -0.00004424 0.00011774 - #*EXTRAS*# Step: 13 Bead: 5 - 0.00011764 -0.00004462 -0.00004438 - -0.00004462 0.00011726 -0.00004424 - -0.00004438 -0.00004424 0.00011765 - #*EXTRAS*# Step: 14 Bead: 5 - 0.00011756 -0.00004462 -0.00004438 - -0.00004462 0.00011717 -0.00004424 - -0.00004438 -0.00004424 0.00011756 - #*EXTRAS*# Step: 15 Bead: 5 - 0.00011749 -0.00004463 -0.00004437 - -0.00004463 0.00011709 -0.00004424 - -0.00004437 -0.00004424 0.00011749 - #*EXTRAS*# Step: 16 Bead: 5 - 0.00011742 -0.00004463 -0.00004437 - -0.00004463 0.00011702 -0.00004424 - -0.00004437 -0.00004424 0.00011743 - #*EXTRAS*# Step: 17 Bead: 5 - 0.00011736 -0.00004463 -0.00004437 - -0.00004463 0.00011696 -0.00004424 - -0.00004437 -0.00004424 0.00011737 - #*EXTRAS*# Step: 18 Bead: 5 - 0.00011731 -0.00004463 -0.00004437 - -0.00004463 0.00011690 -0.00004424 - -0.00004437 -0.00004424 0.00011732 - #*EXTRAS*# Step: 19 Bead: 5 - 0.00011726 -0.00004463 -0.00004436 - -0.00004463 0.00011685 -0.00004424 - -0.00004436 -0.00004424 0.00011727 - #*EXTRAS*# Step: 20 Bead: 5 - 0.00011722 -0.00004463 -0.00004436 - -0.00004463 0.00011681 -0.00004423 - -0.00004436 -0.00004423 0.00011722 - #*EXTRAS*# Step: 21 Bead: 5 - 0.00011718 -0.00004463 -0.00004436 - -0.00004463 0.00011676 -0.00004423 - -0.00004436 -0.00004423 0.00011718 - #*EXTRAS*# Step: 22 Bead: 5 - 0.00011714 -0.00004463 -0.00004436 - -0.00004463 0.00011673 -0.00004423 - -0.00004436 -0.00004423 0.00011715 - #*EXTRAS*# Step: 23 Bead: 5 - 0.00011711 -0.00004463 -0.00004436 - -0.00004463 0.00011669 -0.00004423 - -0.00004436 -0.00004423 0.00011711 - #*EXTRAS*# Step: 24 Bead: 5 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011708 - #*EXTRAS*# Step: 25 Bead: 5 - 0.00011705 -0.00004463 -0.00004435 - -0.00004463 0.00011663 -0.00004423 - -0.00004435 -0.00004423 0.00011706 - #*EXTRAS*# Step: 26 Bead: 5 - 0.00011702 -0.00004463 -0.00004435 - -0.00004463 0.00011660 -0.00004423 - -0.00004435 -0.00004423 0.00011703 - #*EXTRAS*# Step: 27 Bead: 5 - 0.00011700 -0.00004463 -0.00004435 - -0.00004463 0.00011658 -0.00004423 - -0.00004435 -0.00004423 0.00011701 - #*EXTRAS*# Step: 28 Bead: 5 - 0.00011698 -0.00004463 -0.00004435 - -0.00004463 0.00011656 -0.00004423 - -0.00004435 -0.00004423 0.00011699 - #*EXTRAS*# Step: 29 Bead: 5 - 0.00011696 -0.00004463 -0.00004435 - -0.00004463 0.00011654 -0.00004423 - -0.00004435 -0.00004423 0.00011697 - #*EXTRAS*# Step: 30 Bead: 5 - 0.00011694 -0.00004463 -0.00004434 - -0.00004463 0.00011652 -0.00004422 - -0.00004434 -0.00004422 0.00011695 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_06 b/drivers/py/pes/friction/frictionH/120K/inst.fric_06 deleted file mode 100644 index 54bf45aed..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_06 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 - 0.00012029 -0.00004409 -0.00004407 - -0.00004409 0.00012020 -0.00004396 - -0.00004407 -0.00004396 0.00012025 - #*EXTRAS*# Step: 1 Bead: 6 - 0.00011985 -0.00004422 -0.00004418 - -0.00004422 0.00011971 -0.00004404 - -0.00004418 -0.00004404 0.00011983 - #*EXTRAS*# Step: 2 Bead: 6 - 0.00011947 -0.00004433 -0.00004425 - -0.00004433 0.00011928 -0.00004410 - -0.00004425 -0.00004410 0.00011945 - #*EXTRAS*# Step: 3 Bead: 6 - 0.00011880 -0.00004448 -0.00004434 - -0.00004448 0.00011853 -0.00004418 - -0.00004434 -0.00004418 0.00011879 - #*EXTRAS*# Step: 4 Bead: 6 - 0.00011839 -0.00004454 -0.00004437 - -0.00004454 0.00011807 -0.00004421 - -0.00004437 -0.00004421 0.00011839 - #*EXTRAS*# Step: 5 Bead: 6 - 0.00011812 -0.00004458 -0.00004438 - -0.00004458 0.00011778 -0.00004423 - -0.00004438 -0.00004423 0.00011812 - #*EXTRAS*# Step: 6 Bead: 6 - 0.00011793 -0.00004460 -0.00004438 - -0.00004460 0.00011756 -0.00004423 - -0.00004438 -0.00004423 0.00011793 - #*EXTRAS*# Step: 7 Bead: 6 - 0.00011777 -0.00004461 -0.00004438 - -0.00004461 0.00011740 -0.00004424 - -0.00004438 -0.00004424 0.00011778 - #*EXTRAS*# Step: 8 Bead: 6 - 0.00011765 -0.00004462 -0.00004438 - -0.00004462 0.00011727 -0.00004424 - -0.00004438 -0.00004424 0.00011766 - #*EXTRAS*# Step: 9 Bead: 6 - 0.00011755 -0.00004463 -0.00004438 - -0.00004463 0.00011716 -0.00004424 - -0.00004438 -0.00004424 0.00011756 - #*EXTRAS*# Step: 10 Bead: 6 - 0.00011747 -0.00004463 -0.00004437 - -0.00004463 0.00011708 -0.00004424 - -0.00004437 -0.00004424 0.00011748 - #*EXTRAS*# Step: 11 Bead: 6 - 0.00011740 -0.00004463 -0.00004437 - -0.00004463 0.00011700 -0.00004424 - -0.00004437 -0.00004424 0.00011741 - #*EXTRAS*# Step: 12 Bead: 6 - 0.00011734 -0.00004463 -0.00004437 - -0.00004463 0.00011693 -0.00004424 - -0.00004437 -0.00004424 0.00011734 - #*EXTRAS*# Step: 13 Bead: 6 - 0.00011728 -0.00004463 -0.00004437 - -0.00004463 0.00011687 -0.00004424 - -0.00004437 -0.00004424 0.00011729 - #*EXTRAS*# Step: 14 Bead: 6 - 0.00011723 -0.00004463 -0.00004436 - -0.00004463 0.00011682 -0.00004424 - -0.00004436 -0.00004424 0.00011724 - #*EXTRAS*# Step: 15 Bead: 6 - 0.00011719 -0.00004463 -0.00004436 - -0.00004463 0.00011678 -0.00004423 - -0.00004436 -0.00004423 0.00011720 - #*EXTRAS*# Step: 16 Bead: 6 - 0.00011715 -0.00004463 -0.00004436 - -0.00004463 0.00011674 -0.00004423 - -0.00004436 -0.00004423 0.00011716 - #*EXTRAS*# Step: 17 Bead: 6 - 0.00011711 -0.00004463 -0.00004436 - -0.00004463 0.00011670 -0.00004423 - -0.00004436 -0.00004423 0.00011712 - #*EXTRAS*# Step: 18 Bead: 6 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011667 -0.00004423 - -0.00004435 -0.00004423 0.00011709 - #*EXTRAS*# Step: 19 Bead: 6 - 0.00011705 -0.00004463 -0.00004435 - -0.00004463 0.00011664 -0.00004423 - -0.00004435 -0.00004423 0.00011706 - #*EXTRAS*# Step: 20 Bead: 6 - 0.00011703 -0.00004463 -0.00004435 - -0.00004463 0.00011661 -0.00004423 - -0.00004435 -0.00004423 0.00011704 - #*EXTRAS*# Step: 21 Bead: 6 - 0.00011700 -0.00004463 -0.00004435 - -0.00004463 0.00011658 -0.00004423 - -0.00004435 -0.00004423 0.00011701 - #*EXTRAS*# Step: 22 Bead: 6 - 0.00011698 -0.00004463 -0.00004435 - -0.00004463 0.00011656 -0.00004423 - -0.00004435 -0.00004423 0.00011699 - #*EXTRAS*# Step: 23 Bead: 6 - 0.00011696 -0.00004463 -0.00004435 - -0.00004463 0.00011654 -0.00004423 - -0.00004435 -0.00004423 0.00011697 - #*EXTRAS*# Step: 24 Bead: 6 - 0.00011694 -0.00004463 -0.00004434 - -0.00004463 0.00011652 -0.00004422 - -0.00004434 -0.00004422 0.00011695 - #*EXTRAS*# Step: 25 Bead: 6 - 0.00011692 -0.00004463 -0.00004434 - -0.00004463 0.00011650 -0.00004422 - -0.00004434 -0.00004422 0.00011693 - #*EXTRAS*# Step: 26 Bead: 6 - 0.00011691 -0.00004463 -0.00004434 - -0.00004463 0.00011649 -0.00004422 - -0.00004434 -0.00004422 0.00011692 - #*EXTRAS*# Step: 27 Bead: 6 - 0.00011690 -0.00004462 -0.00004434 - -0.00004462 0.00011647 -0.00004422 - -0.00004434 -0.00004422 0.00011691 - #*EXTRAS*# Step: 28 Bead: 6 - 0.00011688 -0.00004462 -0.00004434 - -0.00004462 0.00011646 -0.00004422 - -0.00004434 -0.00004422 0.00011689 - #*EXTRAS*# Step: 29 Bead: 6 - 0.00011687 -0.00004462 -0.00004434 - -0.00004462 0.00011645 -0.00004422 - -0.00004434 -0.00004422 0.00011688 - #*EXTRAS*# Step: 30 Bead: 6 - 0.00011686 -0.00004462 -0.00004434 - -0.00004462 0.00011644 -0.00004422 - -0.00004434 -0.00004422 0.00011687 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_07 b/drivers/py/pes/friction/frictionH/120K/inst.fric_07 deleted file mode 100644 index c903d80c5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_07 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 - 0.00011665 -0.00004461 -0.00004432 - -0.00004461 0.00011623 -0.00004421 - -0.00004432 -0.00004421 0.00011666 - #*EXTRAS*# Step: 1 Bead: 7 - 0.00011708 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011709 - #*EXTRAS*# Step: 2 Bead: 7 - 0.00011753 -0.00004463 -0.00004437 - -0.00004463 0.00011714 -0.00004424 - -0.00004437 -0.00004424 0.00011754 - #*EXTRAS*# Step: 3 Bead: 7 - 0.00011731 -0.00004463 -0.00004437 - -0.00004463 0.00011691 -0.00004424 - -0.00004437 -0.00004424 0.00011732 - #*EXTRAS*# Step: 4 Bead: 7 - 0.00011719 -0.00004463 -0.00004436 - -0.00004463 0.00011678 -0.00004423 - -0.00004436 -0.00004423 0.00011720 - #*EXTRAS*# Step: 5 Bead: 7 - 0.00011713 -0.00004463 -0.00004436 - -0.00004463 0.00011671 -0.00004423 - -0.00004436 -0.00004423 0.00011713 - #*EXTRAS*# Step: 6 Bead: 7 - 0.00011707 -0.00004463 -0.00004435 - -0.00004463 0.00011666 -0.00004423 - -0.00004435 -0.00004423 0.00011708 - #*EXTRAS*# Step: 7 Bead: 7 - 0.00011704 -0.00004463 -0.00004435 - -0.00004463 0.00011662 -0.00004423 - -0.00004435 -0.00004423 0.00011705 - #*EXTRAS*# Step: 8 Bead: 7 - 0.00011700 -0.00004463 -0.00004435 - -0.00004463 0.00011659 -0.00004423 - -0.00004435 -0.00004423 0.00011701 - #*EXTRAS*# Step: 9 Bead: 7 - 0.00011698 -0.00004463 -0.00004435 - -0.00004463 0.00011656 -0.00004423 - -0.00004435 -0.00004423 0.00011699 - #*EXTRAS*# Step: 10 Bead: 7 - 0.00011696 -0.00004463 -0.00004434 - -0.00004463 0.00011654 -0.00004423 - -0.00004434 -0.00004423 0.00011697 - #*EXTRAS*# Step: 11 Bead: 7 - 0.00011694 -0.00004463 -0.00004434 - -0.00004463 0.00011652 -0.00004422 - -0.00004434 -0.00004422 0.00011695 - #*EXTRAS*# Step: 12 Bead: 7 - 0.00011692 -0.00004463 -0.00004434 - -0.00004463 0.00011650 -0.00004422 - -0.00004434 -0.00004422 0.00011693 - #*EXTRAS*# Step: 13 Bead: 7 - 0.00011690 -0.00004462 -0.00004434 - -0.00004462 0.00011648 -0.00004422 - -0.00004434 -0.00004422 0.00011691 - #*EXTRAS*# Step: 14 Bead: 7 - 0.00011689 -0.00004462 -0.00004434 - -0.00004462 0.00011647 -0.00004422 - -0.00004434 -0.00004422 0.00011690 - #*EXTRAS*# Step: 15 Bead: 7 - 0.00011688 -0.00004462 -0.00004434 - -0.00004462 0.00011645 -0.00004422 - -0.00004434 -0.00004422 0.00011689 - #*EXTRAS*# Step: 16 Bead: 7 - 0.00011686 -0.00004462 -0.00004434 - -0.00004462 0.00011644 -0.00004422 - -0.00004434 -0.00004422 0.00011687 - #*EXTRAS*# Step: 17 Bead: 7 - 0.00011685 -0.00004462 -0.00004434 - -0.00004462 0.00011643 -0.00004422 - -0.00004434 -0.00004422 0.00011686 - #*EXTRAS*# Step: 18 Bead: 7 - 0.00011684 -0.00004462 -0.00004434 - -0.00004462 0.00011642 -0.00004422 - -0.00004434 -0.00004422 0.00011685 - #*EXTRAS*# Step: 19 Bead: 7 - 0.00011684 -0.00004462 -0.00004434 - -0.00004462 0.00011641 -0.00004422 - -0.00004434 -0.00004422 0.00011685 - #*EXTRAS*# Step: 20 Bead: 7 - 0.00011683 -0.00004462 -0.00004433 - -0.00004462 0.00011640 -0.00004422 - -0.00004433 -0.00004422 0.00011684 - #*EXTRAS*# Step: 21 Bead: 7 - 0.00011682 -0.00004462 -0.00004433 - -0.00004462 0.00011640 -0.00004422 - -0.00004433 -0.00004422 0.00011683 - #*EXTRAS*# Step: 22 Bead: 7 - 0.00011681 -0.00004462 -0.00004433 - -0.00004462 0.00011639 -0.00004422 - -0.00004433 -0.00004422 0.00011682 - #*EXTRAS*# Step: 23 Bead: 7 - 0.00011681 -0.00004462 -0.00004433 - -0.00004462 0.00011638 -0.00004422 - -0.00004433 -0.00004422 0.00011682 - #*EXTRAS*# Step: 24 Bead: 7 - 0.00011680 -0.00004462 -0.00004433 - -0.00004462 0.00011638 -0.00004422 - -0.00004433 -0.00004422 0.00011681 - #*EXTRAS*# Step: 25 Bead: 7 - 0.00011680 -0.00004462 -0.00004433 - -0.00004462 0.00011637 -0.00004422 - -0.00004433 -0.00004422 0.00011681 - #*EXTRAS*# Step: 26 Bead: 7 - 0.00011679 -0.00004462 -0.00004433 - -0.00004462 0.00011637 -0.00004422 - -0.00004433 -0.00004422 0.00011680 - #*EXTRAS*# Step: 27 Bead: 7 - 0.00011679 -0.00004462 -0.00004433 - -0.00004462 0.00011636 -0.00004422 - -0.00004433 -0.00004422 0.00011680 - #*EXTRAS*# Step: 28 Bead: 7 - 0.00011678 -0.00004462 -0.00004433 - -0.00004462 0.00011636 -0.00004422 - -0.00004433 -0.00004422 0.00011679 - #*EXTRAS*# Step: 29 Bead: 7 - 0.00011678 -0.00004462 -0.00004433 - -0.00004462 0.00011635 -0.00004422 - -0.00004433 -0.00004422 0.00011679 - #*EXTRAS*# Step: 30 Bead: 7 - 0.00011677 -0.00004462 -0.00004433 - -0.00004462 0.00011635 -0.00004422 - -0.00004433 -0.00004422 0.00011679 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_08 b/drivers/py/pes/friction/frictionH/120K/inst.fric_08 deleted file mode 100644 index c5097d5ce..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_08 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 - 0.00011322 -0.00004352 -0.00004346 - -0.00004352 0.00011306 -0.00004343 - -0.00004346 -0.00004343 0.00011326 - #*EXTRAS*# Step: 1 Bead: 8 - 0.00011440 -0.00004405 -0.00004388 - -0.00004405 0.00011411 -0.00004383 - -0.00004388 -0.00004383 0.00011443 - #*EXTRAS*# Step: 2 Bead: 8 - 0.00011561 -0.00004444 -0.00004417 - -0.00004444 0.00011522 -0.00004409 - -0.00004417 -0.00004409 0.00011564 - #*EXTRAS*# Step: 3 Bead: 8 - 0.00011584 -0.00004449 -0.00004421 - -0.00004449 0.00011544 -0.00004412 - -0.00004421 -0.00004412 0.00011586 - #*EXTRAS*# Step: 4 Bead: 8 - 0.00011601 -0.00004452 -0.00004424 - -0.00004452 0.00011559 -0.00004414 - -0.00004424 -0.00004414 0.00011602 - #*EXTRAS*# Step: 5 Bead: 8 - 0.00011614 -0.00004454 -0.00004426 - -0.00004454 0.00011572 -0.00004416 - -0.00004426 -0.00004416 0.00011615 - #*EXTRAS*# Step: 6 Bead: 8 - 0.00011623 -0.00004456 -0.00004427 - -0.00004456 0.00011581 -0.00004417 - -0.00004427 -0.00004417 0.00011624 - #*EXTRAS*# Step: 7 Bead: 8 - 0.00011630 -0.00004457 -0.00004428 - -0.00004457 0.00011588 -0.00004418 - -0.00004428 -0.00004418 0.00011631 - #*EXTRAS*# Step: 8 Bead: 8 - 0.00011636 -0.00004458 -0.00004429 - -0.00004458 0.00011593 -0.00004418 - -0.00004429 -0.00004418 0.00011637 - #*EXTRAS*# Step: 9 Bead: 8 - 0.00011640 -0.00004458 -0.00004429 - -0.00004458 0.00011598 -0.00004419 - -0.00004429 -0.00004419 0.00011642 - #*EXTRAS*# Step: 10 Bead: 8 - 0.00011644 -0.00004459 -0.00004430 - -0.00004459 0.00011602 -0.00004419 - -0.00004430 -0.00004419 0.00011645 - #*EXTRAS*# Step: 11 Bead: 8 - 0.00011647 -0.00004459 -0.00004430 - -0.00004459 0.00011605 -0.00004419 - -0.00004430 -0.00004419 0.00011648 - #*EXTRAS*# Step: 12 Bead: 8 - 0.00011650 -0.00004459 -0.00004430 - -0.00004459 0.00011607 -0.00004420 - -0.00004430 -0.00004420 0.00011651 - #*EXTRAS*# Step: 13 Bead: 8 - 0.00011652 -0.00004459 -0.00004430 - -0.00004459 0.00011610 -0.00004420 - -0.00004430 -0.00004420 0.00011653 - #*EXTRAS*# Step: 14 Bead: 8 - 0.00011654 -0.00004460 -0.00004431 - -0.00004460 0.00011612 -0.00004420 - -0.00004431 -0.00004420 0.00011656 - #*EXTRAS*# Step: 15 Bead: 8 - 0.00011656 -0.00004460 -0.00004431 - -0.00004460 0.00011614 -0.00004420 - -0.00004431 -0.00004420 0.00011657 - #*EXTRAS*# Step: 16 Bead: 8 - 0.00011658 -0.00004460 -0.00004431 - -0.00004460 0.00011615 -0.00004420 - -0.00004431 -0.00004420 0.00011659 - #*EXTRAS*# Step: 17 Bead: 8 - 0.00011659 -0.00004460 -0.00004431 - -0.00004460 0.00011617 -0.00004420 - -0.00004431 -0.00004420 0.00011660 - #*EXTRAS*# Step: 18 Bead: 8 - 0.00011660 -0.00004460 -0.00004431 - -0.00004460 0.00011618 -0.00004420 - -0.00004431 -0.00004420 0.00011662 - #*EXTRAS*# Step: 19 Bead: 8 - 0.00011661 -0.00004460 -0.00004431 - -0.00004460 0.00011619 -0.00004420 - -0.00004431 -0.00004420 0.00011663 - #*EXTRAS*# Step: 20 Bead: 8 - 0.00011662 -0.00004461 -0.00004432 - -0.00004461 0.00011620 -0.00004421 - -0.00004432 -0.00004421 0.00011664 - #*EXTRAS*# Step: 21 Bead: 8 - 0.00011663 -0.00004461 -0.00004432 - -0.00004461 0.00011621 -0.00004421 - -0.00004432 -0.00004421 0.00011665 - #*EXTRAS*# Step: 22 Bead: 8 - 0.00011664 -0.00004461 -0.00004432 - -0.00004461 0.00011622 -0.00004421 - -0.00004432 -0.00004421 0.00011665 - #*EXTRAS*# Step: 23 Bead: 8 - 0.00011665 -0.00004461 -0.00004432 - -0.00004461 0.00011623 -0.00004421 - -0.00004432 -0.00004421 0.00011666 - #*EXTRAS*# Step: 24 Bead: 8 - 0.00011666 -0.00004461 -0.00004432 - -0.00004461 0.00011623 -0.00004421 - -0.00004432 -0.00004421 0.00011667 - #*EXTRAS*# Step: 25 Bead: 8 - 0.00011666 -0.00004461 -0.00004432 - -0.00004461 0.00011624 -0.00004421 - -0.00004432 -0.00004421 0.00011668 - #*EXTRAS*# Step: 26 Bead: 8 - 0.00011667 -0.00004461 -0.00004432 - -0.00004461 0.00011624 -0.00004421 - -0.00004432 -0.00004421 0.00011668 - #*EXTRAS*# Step: 27 Bead: 8 - 0.00011667 -0.00004461 -0.00004432 - -0.00004461 0.00011625 -0.00004421 - -0.00004432 -0.00004421 0.00011669 - #*EXTRAS*# Step: 28 Bead: 8 - 0.00011668 -0.00004461 -0.00004432 - -0.00004461 0.00011625 -0.00004421 - -0.00004432 -0.00004421 0.00011669 - #*EXTRAS*# Step: 29 Bead: 8 - 0.00011668 -0.00004461 -0.00004432 - -0.00004461 0.00011626 -0.00004421 - -0.00004432 -0.00004421 0.00011670 - #*EXTRAS*# Step: 30 Bead: 8 - 0.00011669 -0.00004461 -0.00004432 - -0.00004461 0.00011626 -0.00004421 - -0.00004432 -0.00004421 0.00011670 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_09 b/drivers/py/pes/friction/frictionH/120K/inst.fric_09 deleted file mode 100644 index 10f766150..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_09 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 - 0.00011023 -0.00004172 -0.00004180 - -0.00004172 0.00011025 -0.00004177 - -0.00004180 -0.00004177 0.00011031 - #*EXTRAS*# Step: 1 Bead: 9 - 0.00011201 -0.00004285 -0.00004289 - -0.00004285 0.00011197 -0.00004287 - -0.00004289 -0.00004287 0.00011207 - #*EXTRAS*# Step: 2 Bead: 9 - 0.00011383 -0.00004382 -0.00004369 - -0.00004382 0.00011361 -0.00004365 - -0.00004369 -0.00004365 0.00011387 - #*EXTRAS*# Step: 3 Bead: 9 - 0.00011446 -0.00004408 -0.00004390 - -0.00004408 0.00011417 -0.00004384 - -0.00004390 -0.00004384 0.00011450 - #*EXTRAS*# Step: 4 Bead: 9 - 0.00011489 -0.00004423 -0.00004401 - -0.00004423 0.00011455 -0.00004395 - -0.00004401 -0.00004395 0.00011491 - #*EXTRAS*# Step: 5 Bead: 9 - 0.00011520 -0.00004433 -0.00004408 - -0.00004433 0.00011483 -0.00004401 - -0.00004408 -0.00004401 0.00011522 - #*EXTRAS*# Step: 6 Bead: 9 - 0.00011542 -0.00004439 -0.00004413 - -0.00004439 0.00011504 -0.00004405 - -0.00004413 -0.00004405 0.00011544 - #*EXTRAS*# Step: 7 Bead: 9 - 0.00011559 -0.00004443 -0.00004417 - -0.00004443 0.00011520 -0.00004408 - -0.00004417 -0.00004408 0.00011562 - #*EXTRAS*# Step: 8 Bead: 9 - 0.00011573 -0.00004446 -0.00004419 - -0.00004446 0.00011533 -0.00004411 - -0.00004419 -0.00004411 0.00011575 - #*EXTRAS*# Step: 9 Bead: 9 - 0.00011585 -0.00004449 -0.00004421 - -0.00004449 0.00011544 -0.00004412 - -0.00004421 -0.00004412 0.00011587 - #*EXTRAS*# Step: 10 Bead: 9 - 0.00011594 -0.00004451 -0.00004423 - -0.00004451 0.00011553 -0.00004414 - -0.00004423 -0.00004414 0.00011596 - #*EXTRAS*# Step: 11 Bead: 9 - 0.00011602 -0.00004452 -0.00004424 - -0.00004452 0.00011561 -0.00004415 - -0.00004424 -0.00004415 0.00011604 - #*EXTRAS*# Step: 12 Bead: 9 - 0.00011609 -0.00004454 -0.00004425 - -0.00004454 0.00011568 -0.00004415 - -0.00004425 -0.00004415 0.00011611 - #*EXTRAS*# Step: 13 Bead: 9 - 0.00011615 -0.00004455 -0.00004426 - -0.00004455 0.00011573 -0.00004416 - -0.00004426 -0.00004416 0.00011617 - #*EXTRAS*# Step: 14 Bead: 9 - 0.00011621 -0.00004455 -0.00004427 - -0.00004455 0.00011579 -0.00004417 - -0.00004427 -0.00004417 0.00011622 - #*EXTRAS*# Step: 15 Bead: 9 - 0.00011625 -0.00004456 -0.00004427 - -0.00004456 0.00011583 -0.00004417 - -0.00004427 -0.00004417 0.00011627 - #*EXTRAS*# Step: 16 Bead: 9 - 0.00011630 -0.00004457 -0.00004428 - -0.00004457 0.00011587 -0.00004418 - -0.00004428 -0.00004418 0.00011631 - #*EXTRAS*# Step: 17 Bead: 9 - 0.00011633 -0.00004457 -0.00004428 - -0.00004457 0.00011591 -0.00004418 - -0.00004428 -0.00004418 0.00011635 - #*EXTRAS*# Step: 18 Bead: 9 - 0.00011637 -0.00004458 -0.00004429 - -0.00004458 0.00011595 -0.00004418 - -0.00004429 -0.00004418 0.00011638 - #*EXTRAS*# Step: 19 Bead: 9 - 0.00011640 -0.00004458 -0.00004429 - -0.00004458 0.00011598 -0.00004419 - -0.00004429 -0.00004419 0.00011641 - #*EXTRAS*# Step: 20 Bead: 9 - 0.00011643 -0.00004458 -0.00004429 - -0.00004458 0.00011600 -0.00004419 - -0.00004429 -0.00004419 0.00011644 - #*EXTRAS*# Step: 21 Bead: 9 - 0.00011645 -0.00004459 -0.00004430 - -0.00004459 0.00011603 -0.00004419 - -0.00004430 -0.00004419 0.00011647 - #*EXTRAS*# Step: 22 Bead: 9 - 0.00011648 -0.00004459 -0.00004430 - -0.00004459 0.00011605 -0.00004419 - -0.00004430 -0.00004419 0.00011649 - #*EXTRAS*# Step: 23 Bead: 9 - 0.00011650 -0.00004459 -0.00004430 - -0.00004459 0.00011607 -0.00004420 - -0.00004430 -0.00004420 0.00011651 - #*EXTRAS*# Step: 24 Bead: 9 - 0.00011652 -0.00004459 -0.00004430 - -0.00004459 0.00011609 -0.00004420 - -0.00004430 -0.00004420 0.00011653 - #*EXTRAS*# Step: 25 Bead: 9 - 0.00011653 -0.00004460 -0.00004431 - -0.00004460 0.00011611 -0.00004420 - -0.00004431 -0.00004420 0.00011655 - #*EXTRAS*# Step: 26 Bead: 9 - 0.00011655 -0.00004460 -0.00004431 - -0.00004460 0.00011613 -0.00004420 - -0.00004431 -0.00004420 0.00011656 - #*EXTRAS*# Step: 27 Bead: 9 - 0.00011657 -0.00004460 -0.00004431 - -0.00004460 0.00011614 -0.00004420 - -0.00004431 -0.00004420 0.00011658 - #*EXTRAS*# Step: 28 Bead: 9 - 0.00011658 -0.00004460 -0.00004431 - -0.00004460 0.00011615 -0.00004420 - -0.00004431 -0.00004420 0.00011659 - #*EXTRAS*# Step: 29 Bead: 9 - 0.00011659 -0.00004460 -0.00004431 - -0.00004460 0.00011617 -0.00004420 - -0.00004431 -0.00004420 0.00011660 - #*EXTRAS*# Step: 30 Bead: 9 - 0.00011660 -0.00004460 -0.00004431 - -0.00004460 0.00011618 -0.00004420 - -0.00004431 -0.00004420 0.00011662 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_10 b/drivers/py/pes/friction/frictionH/120K/inst.fric_10 deleted file mode 100644 index d4ce847fb..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_10 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 - 0.00010769 -0.00003973 -0.00003972 - -0.00003973 0.00010769 -0.00003973 - -0.00003972 -0.00003973 0.00010770 - #*EXTRAS*# Step: 1 Bead: 10 - 0.00010994 -0.00004152 -0.00004159 - -0.00004152 0.00010997 -0.00004156 - -0.00004159 -0.00004156 0.00011002 - #*EXTRAS*# Step: 2 Bead: 10 - 0.00011224 -0.00004299 -0.00004301 - -0.00004299 0.00011219 -0.00004300 - -0.00004301 -0.00004300 0.00011230 - #*EXTRAS*# Step: 3 Bead: 10 - 0.00011322 -0.00004352 -0.00004346 - -0.00004352 0.00011306 -0.00004343 - -0.00004346 -0.00004343 0.00011327 - #*EXTRAS*# Step: 4 Bead: 10 - 0.00011387 -0.00004383 -0.00004371 - -0.00004383 0.00011364 -0.00004367 - -0.00004371 -0.00004367 0.00011391 - #*EXTRAS*# Step: 5 Bead: 10 - 0.00011434 -0.00004403 -0.00004386 - -0.00004403 0.00011405 -0.00004381 - -0.00004386 -0.00004381 0.00011437 - #*EXTRAS*# Step: 6 Bead: 10 - 0.00011468 -0.00004416 -0.00004396 - -0.00004416 0.00011436 -0.00004390 - -0.00004396 -0.00004390 0.00011471 - #*EXTRAS*# Step: 7 Bead: 10 - 0.00011495 -0.00004425 -0.00004402 - -0.00004425 0.00011460 -0.00004396 - -0.00004402 -0.00004396 0.00011497 - #*EXTRAS*# Step: 8 Bead: 10 - 0.00011516 -0.00004432 -0.00004407 - -0.00004432 0.00011480 -0.00004401 - -0.00004407 -0.00004401 0.00011518 - #*EXTRAS*# Step: 9 Bead: 10 - 0.00011533 -0.00004437 -0.00004411 - -0.00004437 0.00011496 -0.00004404 - -0.00004411 -0.00004404 0.00011536 - #*EXTRAS*# Step: 10 Bead: 10 - 0.00011548 -0.00004440 -0.00004414 - -0.00004440 0.00011509 -0.00004407 - -0.00004414 -0.00004407 0.00011550 - #*EXTRAS*# Step: 11 Bead: 10 - 0.00011560 -0.00004444 -0.00004417 - -0.00004444 0.00011521 -0.00004409 - -0.00004417 -0.00004409 0.00011563 - #*EXTRAS*# Step: 12 Bead: 10 - 0.00011571 -0.00004446 -0.00004419 - -0.00004446 0.00011531 -0.00004410 - -0.00004419 -0.00004410 0.00011573 - #*EXTRAS*# Step: 13 Bead: 10 - 0.00011581 -0.00004448 -0.00004420 - -0.00004448 0.00011540 -0.00004412 - -0.00004420 -0.00004412 0.00011583 - #*EXTRAS*# Step: 14 Bead: 10 - 0.00011589 -0.00004450 -0.00004422 - -0.00004450 0.00011548 -0.00004413 - -0.00004422 -0.00004413 0.00011591 - #*EXTRAS*# Step: 15 Bead: 10 - 0.00011597 -0.00004451 -0.00004423 - -0.00004451 0.00011556 -0.00004414 - -0.00004423 -0.00004414 0.00011599 - #*EXTRAS*# Step: 16 Bead: 10 - 0.00011603 -0.00004453 -0.00004424 - -0.00004453 0.00011562 -0.00004415 - -0.00004424 -0.00004415 0.00011605 - #*EXTRAS*# Step: 17 Bead: 10 - 0.00011609 -0.00004454 -0.00004425 - -0.00004454 0.00011568 -0.00004415 - -0.00004425 -0.00004415 0.00011611 - #*EXTRAS*# Step: 18 Bead: 10 - 0.00011615 -0.00004454 -0.00004426 - -0.00004454 0.00011573 -0.00004416 - -0.00004426 -0.00004416 0.00011617 - #*EXTRAS*# Step: 19 Bead: 10 - 0.00011620 -0.00004455 -0.00004426 - -0.00004455 0.00011578 -0.00004417 - -0.00004426 -0.00004417 0.00011621 - #*EXTRAS*# Step: 20 Bead: 10 - 0.00011624 -0.00004456 -0.00004427 - -0.00004456 0.00011582 -0.00004417 - -0.00004427 -0.00004417 0.00011626 - #*EXTRAS*# Step: 21 Bead: 10 - 0.00011628 -0.00004457 -0.00004428 - -0.00004457 0.00011586 -0.00004418 - -0.00004428 -0.00004418 0.00011630 - #*EXTRAS*# Step: 22 Bead: 10 - 0.00011632 -0.00004457 -0.00004428 - -0.00004457 0.00011590 -0.00004418 - -0.00004428 -0.00004418 0.00011634 - #*EXTRAS*# Step: 23 Bead: 10 - 0.00011635 -0.00004457 -0.00004429 - -0.00004457 0.00011593 -0.00004418 - -0.00004429 -0.00004418 0.00011637 - #*EXTRAS*# Step: 24 Bead: 10 - 0.00011639 -0.00004458 -0.00004429 - -0.00004458 0.00011596 -0.00004419 - -0.00004429 -0.00004419 0.00011640 - #*EXTRAS*# Step: 25 Bead: 10 - 0.00011641 -0.00004458 -0.00004429 - -0.00004458 0.00011599 -0.00004419 - -0.00004429 -0.00004419 0.00011643 - #*EXTRAS*# Step: 26 Bead: 10 - 0.00011644 -0.00004459 -0.00004430 - -0.00004459 0.00011602 -0.00004419 - -0.00004430 -0.00004419 0.00011645 - #*EXTRAS*# Step: 27 Bead: 10 - 0.00011646 -0.00004459 -0.00004430 - -0.00004459 0.00011604 -0.00004419 - -0.00004430 -0.00004419 0.00011648 - #*EXTRAS*# Step: 28 Bead: 10 - 0.00011649 -0.00004459 -0.00004430 - -0.00004459 0.00011606 -0.00004419 - -0.00004430 -0.00004419 0.00011650 - #*EXTRAS*# Step: 29 Bead: 10 - 0.00011651 -0.00004459 -0.00004430 - -0.00004459 0.00011608 -0.00004420 - -0.00004430 -0.00004420 0.00011652 - #*EXTRAS*# Step: 30 Bead: 10 - 0.00011652 -0.00004460 -0.00004430 - -0.00004460 0.00011610 -0.00004420 - -0.00004430 -0.00004420 0.00011654 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_11 b/drivers/py/pes/friction/frictionH/120K/inst.fric_11 deleted file mode 100644 index 8b0f7ce81..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_11 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 - 0.00010562 -0.00003769 -0.00003763 - -0.00003769 0.00010562 -0.00003777 - -0.00003763 -0.00003777 0.00010544 - #*EXTRAS*# Step: 1 Bead: 11 - 0.00010821 -0.00004018 -0.00004019 - -0.00004018 0.00010822 -0.00004018 - -0.00004019 -0.00004018 0.00010825 - #*EXTRAS*# Step: 2 Bead: 11 - 0.00011087 -0.00004215 -0.00004223 - -0.00004215 0.00011089 -0.00004221 - -0.00004223 -0.00004221 0.00011095 - #*EXTRAS*# Step: 3 Bead: 11 - 0.00011213 -0.00004293 -0.00004296 - -0.00004293 0.00011209 -0.00004294 - -0.00004296 -0.00004294 0.00011219 - #*EXTRAS*# Step: 4 Bead: 11 - 0.00011298 -0.00004339 -0.00004336 - -0.00004339 0.00011285 -0.00004333 - -0.00004336 -0.00004333 0.00011303 - #*EXTRAS*# Step: 5 Bead: 11 - 0.00011358 -0.00004370 -0.00004360 - -0.00004370 0.00011339 -0.00004357 - -0.00004360 -0.00004357 0.00011363 - #*EXTRAS*# Step: 6 Bead: 11 - 0.00011403 -0.00004390 -0.00004376 - -0.00004390 0.00011378 -0.00004372 - -0.00004376 -0.00004372 0.00011407 - #*EXTRAS*# Step: 7 Bead: 11 - 0.00011437 -0.00004404 -0.00004387 - -0.00004404 0.00011409 -0.00004382 - -0.00004387 -0.00004382 0.00011441 - #*EXTRAS*# Step: 8 Bead: 11 - 0.00011465 -0.00004415 -0.00004395 - -0.00004415 0.00011434 -0.00004389 - -0.00004395 -0.00004389 0.00011468 - #*EXTRAS*# Step: 9 Bead: 11 - 0.00011488 -0.00004423 -0.00004401 - -0.00004423 0.00011454 -0.00004395 - -0.00004401 -0.00004395 0.00011491 - #*EXTRAS*# Step: 10 Bead: 11 - 0.00011507 -0.00004429 -0.00004405 - -0.00004429 0.00011472 -0.00004399 - -0.00004405 -0.00004399 0.00011510 - #*EXTRAS*# Step: 11 Bead: 11 - 0.00011523 -0.00004434 -0.00004409 - -0.00004434 0.00011487 -0.00004402 - -0.00004409 -0.00004402 0.00011526 - #*EXTRAS*# Step: 12 Bead: 11 - 0.00011538 -0.00004438 -0.00004412 - -0.00004438 0.00011500 -0.00004405 - -0.00004412 -0.00004405 0.00011540 - #*EXTRAS*# Step: 13 Bead: 11 - 0.00011550 -0.00004441 -0.00004415 - -0.00004441 0.00011512 -0.00004407 - -0.00004415 -0.00004407 0.00011553 - #*EXTRAS*# Step: 14 Bead: 11 - 0.00011561 -0.00004444 -0.00004417 - -0.00004444 0.00011522 -0.00004409 - -0.00004417 -0.00004409 0.00011564 - #*EXTRAS*# Step: 15 Bead: 11 - 0.00011571 -0.00004446 -0.00004419 - -0.00004446 0.00011531 -0.00004410 - -0.00004419 -0.00004410 0.00011573 - #*EXTRAS*# Step: 16 Bead: 11 - 0.00011580 -0.00004448 -0.00004420 - -0.00004448 0.00011540 -0.00004412 - -0.00004420 -0.00004412 0.00011582 - #*EXTRAS*# Step: 17 Bead: 11 - 0.00011588 -0.00004450 -0.00004422 - -0.00004450 0.00011547 -0.00004413 - -0.00004422 -0.00004413 0.00011590 - #*EXTRAS*# Step: 18 Bead: 11 - 0.00011595 -0.00004451 -0.00004423 - -0.00004451 0.00011554 -0.00004414 - -0.00004423 -0.00004414 0.00011597 - #*EXTRAS*# Step: 19 Bead: 11 - 0.00011602 -0.00004452 -0.00004424 - -0.00004452 0.00011561 -0.00004415 - -0.00004424 -0.00004415 0.00011604 - #*EXTRAS*# Step: 20 Bead: 11 - 0.00011608 -0.00004453 -0.00004425 - -0.00004453 0.00011566 -0.00004415 - -0.00004425 -0.00004415 0.00011610 - #*EXTRAS*# Step: 21 Bead: 11 - 0.00011613 -0.00004454 -0.00004426 - -0.00004454 0.00011571 -0.00004416 - -0.00004426 -0.00004416 0.00011615 - #*EXTRAS*# Step: 22 Bead: 11 - 0.00011618 -0.00004455 -0.00004426 - -0.00004455 0.00011576 -0.00004416 - -0.00004426 -0.00004416 0.00011620 - #*EXTRAS*# Step: 23 Bead: 11 - 0.00011623 -0.00004456 -0.00004427 - -0.00004456 0.00011581 -0.00004417 - -0.00004427 -0.00004417 0.00011624 - #*EXTRAS*# Step: 24 Bead: 11 - 0.00011627 -0.00004456 -0.00004427 - -0.00004456 0.00011585 -0.00004417 - -0.00004427 -0.00004417 0.00011628 - #*EXTRAS*# Step: 25 Bead: 11 - 0.00011631 -0.00004457 -0.00004428 - -0.00004457 0.00011588 -0.00004418 - -0.00004428 -0.00004418 0.00011632 - #*EXTRAS*# Step: 26 Bead: 11 - 0.00011634 -0.00004457 -0.00004428 - -0.00004457 0.00011592 -0.00004418 - -0.00004428 -0.00004418 0.00011636 - #*EXTRAS*# Step: 27 Bead: 11 - 0.00011637 -0.00004458 -0.00004429 - -0.00004458 0.00011595 -0.00004418 - -0.00004429 -0.00004418 0.00011639 - #*EXTRAS*# Step: 28 Bead: 11 - 0.00011640 -0.00004458 -0.00004429 - -0.00004458 0.00011598 -0.00004419 - -0.00004429 -0.00004419 0.00011642 - #*EXTRAS*# Step: 29 Bead: 11 - 0.00011643 -0.00004458 -0.00004429 - -0.00004458 0.00011600 -0.00004419 - -0.00004429 -0.00004419 0.00011644 - #*EXTRAS*# Step: 30 Bead: 11 - 0.00011645 -0.00004459 -0.00004430 - -0.00004459 0.00011603 -0.00004419 - -0.00004430 -0.00004419 0.00011647 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_12 b/drivers/py/pes/friction/frictionH/120K/inst.fric_12 deleted file mode 100644 index 2ad298472..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_12 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 - 0.00010410 -0.00003588 -0.00003581 - -0.00003588 0.00010410 -0.00003604 - -0.00003581 -0.00003604 0.00010377 - #*EXTRAS*# Step: 1 Bead: 12 - 0.00010683 -0.00003893 -0.00003890 - -0.00003893 0.00010683 -0.00003895 - -0.00003890 -0.00003895 0.00010677 - #*EXTRAS*# Step: 2 Bead: 12 - 0.00010976 -0.00004138 -0.00004145 - -0.00004138 0.00010978 -0.00004142 - -0.00004145 -0.00004142 0.00010983 - #*EXTRAS*# Step: 3 Bead: 12 - 0.00011124 -0.00004238 -0.00004246 - -0.00004238 0.00011124 -0.00004244 - -0.00004246 -0.00004244 0.00011131 - #*EXTRAS*# Step: 4 Bead: 12 - 0.00011224 -0.00004299 -0.00004301 - -0.00004299 0.00011219 -0.00004299 - -0.00004301 -0.00004299 0.00011230 - #*EXTRAS*# Step: 5 Bead: 12 - 0.00011296 -0.00004338 -0.00004335 - -0.00004338 0.00011283 -0.00004333 - -0.00004335 -0.00004333 0.00011301 - #*EXTRAS*# Step: 6 Bead: 12 - 0.00011349 -0.00004365 -0.00004357 - -0.00004365 0.00011330 -0.00004353 - -0.00004357 -0.00004353 0.00011353 - #*EXTRAS*# Step: 7 Bead: 12 - 0.00011390 -0.00004384 -0.00004372 - -0.00004384 0.00011366 -0.00004368 - -0.00004372 -0.00004368 0.00011394 - #*EXTRAS*# Step: 8 Bead: 12 - 0.00011423 -0.00004398 -0.00004382 - -0.00004398 0.00011396 -0.00004378 - -0.00004382 -0.00004378 0.00011426 - #*EXTRAS*# Step: 9 Bead: 12 - 0.00011450 -0.00004409 -0.00004391 - -0.00004409 0.00011420 -0.00004385 - -0.00004391 -0.00004385 0.00011453 - #*EXTRAS*# Step: 10 Bead: 12 - 0.00011473 -0.00004417 -0.00004397 - -0.00004417 0.00011441 -0.00004391 - -0.00004397 -0.00004391 0.00011476 - #*EXTRAS*# Step: 11 Bead: 12 - 0.00011492 -0.00004424 -0.00004402 - -0.00004424 0.00011458 -0.00004396 - -0.00004402 -0.00004396 0.00011495 - #*EXTRAS*# Step: 12 Bead: 12 - 0.00011509 -0.00004430 -0.00004406 - -0.00004430 0.00011474 -0.00004399 - -0.00004406 -0.00004399 0.00011512 - #*EXTRAS*# Step: 13 Bead: 12 - 0.00011525 -0.00004434 -0.00004409 - -0.00004434 0.00011488 -0.00004402 - -0.00004409 -0.00004402 0.00011527 - #*EXTRAS*# Step: 14 Bead: 12 - 0.00011538 -0.00004438 -0.00004412 - -0.00004438 0.00011500 -0.00004405 - -0.00004412 -0.00004405 0.00011540 - #*EXTRAS*# Step: 15 Bead: 12 - 0.00011550 -0.00004441 -0.00004415 - -0.00004441 0.00011511 -0.00004407 - -0.00004415 -0.00004407 0.00011552 - #*EXTRAS*# Step: 16 Bead: 12 - 0.00011560 -0.00004444 -0.00004417 - -0.00004444 0.00011521 -0.00004409 - -0.00004417 -0.00004409 0.00011563 - #*EXTRAS*# Step: 17 Bead: 12 - 0.00011570 -0.00004446 -0.00004419 - -0.00004446 0.00011530 -0.00004410 - -0.00004419 -0.00004410 0.00011572 - #*EXTRAS*# Step: 18 Bead: 12 - 0.00011579 -0.00004448 -0.00004420 - -0.00004448 0.00011538 -0.00004411 - -0.00004420 -0.00004411 0.00011581 - #*EXTRAS*# Step: 19 Bead: 12 - 0.00011587 -0.00004449 -0.00004421 - -0.00004449 0.00011546 -0.00004413 - -0.00004421 -0.00004413 0.00011589 - #*EXTRAS*# Step: 20 Bead: 12 - 0.00011594 -0.00004451 -0.00004423 - -0.00004451 0.00011553 -0.00004413 - -0.00004423 -0.00004413 0.00011596 - #*EXTRAS*# Step: 21 Bead: 12 - 0.00011600 -0.00004452 -0.00004424 - -0.00004452 0.00011559 -0.00004414 - -0.00004424 -0.00004414 0.00011602 - #*EXTRAS*# Step: 22 Bead: 12 - 0.00011606 -0.00004453 -0.00004425 - -0.00004453 0.00011565 -0.00004415 - -0.00004425 -0.00004415 0.00011608 - #*EXTRAS*# Step: 23 Bead: 12 - 0.00011612 -0.00004454 -0.00004425 - -0.00004454 0.00011570 -0.00004416 - -0.00004425 -0.00004416 0.00011614 - #*EXTRAS*# Step: 24 Bead: 12 - 0.00011617 -0.00004455 -0.00004426 - -0.00004455 0.00011575 -0.00004416 - -0.00004426 -0.00004416 0.00011618 - #*EXTRAS*# Step: 25 Bead: 12 - 0.00011621 -0.00004455 -0.00004427 - -0.00004455 0.00011579 -0.00004417 - -0.00004427 -0.00004417 0.00011623 - #*EXTRAS*# Step: 26 Bead: 12 - 0.00011626 -0.00004456 -0.00004427 - -0.00004456 0.00011584 -0.00004417 - -0.00004427 -0.00004417 0.00011627 - #*EXTRAS*# Step: 27 Bead: 12 - 0.00011629 -0.00004457 -0.00004428 - -0.00004457 0.00011587 -0.00004418 - -0.00004428 -0.00004418 0.00011631 - #*EXTRAS*# Step: 28 Bead: 12 - 0.00011633 -0.00004457 -0.00004428 - -0.00004457 0.00011591 -0.00004418 - -0.00004428 -0.00004418 0.00011634 - #*EXTRAS*# Step: 29 Bead: 12 - 0.00011636 -0.00004458 -0.00004429 - -0.00004458 0.00011594 -0.00004418 - -0.00004429 -0.00004418 0.00011638 - #*EXTRAS*# Step: 30 Bead: 12 - 0.00011639 -0.00004458 -0.00004429 - -0.00004458 0.00011597 -0.00004419 - -0.00004429 -0.00004419 0.00011641 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_13 b/drivers/py/pes/friction/frictionH/120K/inst.fric_13 deleted file mode 100644 index b1039c57f..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_13 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 - 0.00010310 -0.00003446 -0.00003442 - -0.00003446 0.00010308 -0.00003466 - -0.00003442 -0.00003466 0.00010270 - #*EXTRAS*# Step: 1 Bead: 13 - 0.00010583 -0.00003791 -0.00003786 - -0.00003791 0.00010582 -0.00003798 - -0.00003786 -0.00003798 0.00010567 - #*EXTRAS*# Step: 2 Bead: 13 - 0.00010890 -0.00004074 -0.00004078 - -0.00004074 0.00010892 -0.00004076 - -0.00004078 -0.00004076 0.00010897 - #*EXTRAS*# Step: 3 Bead: 13 - 0.00011055 -0.00004194 -0.00004202 - -0.00004194 0.00011057 -0.00004199 - -0.00004202 -0.00004199 0.00011063 - #*EXTRAS*# Step: 4 Bead: 13 - 0.00011167 -0.00004265 -0.00004271 - -0.00004265 0.00011166 -0.00004269 - -0.00004271 -0.00004269 0.00011174 - #*EXTRAS*# Step: 5 Bead: 13 - 0.00011248 -0.00004312 -0.00004313 - -0.00004312 0.00011240 -0.00004311 - -0.00004313 -0.00004311 0.00011253 - #*EXTRAS*# Step: 6 Bead: 13 - 0.00011307 -0.00004344 -0.00004340 - -0.00004344 0.00011293 -0.00004337 - -0.00004340 -0.00004337 0.00011312 - #*EXTRAS*# Step: 7 Bead: 13 - 0.00011353 -0.00004367 -0.00004358 - -0.00004367 0.00011334 -0.00004355 - -0.00004358 -0.00004355 0.00011357 - #*EXTRAS*# Step: 8 Bead: 13 - 0.00011390 -0.00004384 -0.00004372 - -0.00004384 0.00011366 -0.00004368 - -0.00004372 -0.00004368 0.00011394 - #*EXTRAS*# Step: 9 Bead: 13 - 0.00011420 -0.00004397 -0.00004382 - -0.00004397 0.00011393 -0.00004377 - -0.00004382 -0.00004377 0.00011424 - #*EXTRAS*# Step: 10 Bead: 13 - 0.00011446 -0.00004408 -0.00004389 - -0.00004408 0.00011417 -0.00004384 - -0.00004389 -0.00004384 0.00011449 - #*EXTRAS*# Step: 11 Bead: 13 - 0.00011468 -0.00004416 -0.00004396 - -0.00004416 0.00011436 -0.00004390 - -0.00004396 -0.00004390 0.00011471 - #*EXTRAS*# Step: 12 Bead: 13 - 0.00011488 -0.00004423 -0.00004401 - -0.00004423 0.00011454 -0.00004394 - -0.00004401 -0.00004394 0.00011490 - #*EXTRAS*# Step: 13 Bead: 13 - 0.00011504 -0.00004428 -0.00004405 - -0.00004428 0.00011469 -0.00004398 - -0.00004405 -0.00004398 0.00011507 - #*EXTRAS*# Step: 14 Bead: 13 - 0.00011520 -0.00004433 -0.00004408 - -0.00004433 0.00011483 -0.00004401 - -0.00004408 -0.00004401 0.00011522 - #*EXTRAS*# Step: 15 Bead: 13 - 0.00011533 -0.00004436 -0.00004411 - -0.00004436 0.00011496 -0.00004404 - -0.00004411 -0.00004404 0.00011535 - #*EXTRAS*# Step: 16 Bead: 13 - 0.00011545 -0.00004440 -0.00004414 - -0.00004440 0.00011507 -0.00004406 - -0.00004414 -0.00004406 0.00011547 - #*EXTRAS*# Step: 17 Bead: 13 - 0.00011556 -0.00004442 -0.00004416 - -0.00004442 0.00011517 -0.00004408 - -0.00004416 -0.00004408 0.00011558 - #*EXTRAS*# Step: 18 Bead: 13 - 0.00011566 -0.00004445 -0.00004418 - -0.00004445 0.00011526 -0.00004409 - -0.00004418 -0.00004409 0.00011568 - #*EXTRAS*# Step: 19 Bead: 13 - 0.00011575 -0.00004447 -0.00004419 - -0.00004447 0.00011535 -0.00004411 - -0.00004419 -0.00004411 0.00011577 - #*EXTRAS*# Step: 20 Bead: 13 - 0.00011583 -0.00004449 -0.00004421 - -0.00004449 0.00011542 -0.00004412 - -0.00004421 -0.00004412 0.00011585 - #*EXTRAS*# Step: 21 Bead: 13 - 0.00011590 -0.00004450 -0.00004422 - -0.00004450 0.00011549 -0.00004413 - -0.00004422 -0.00004413 0.00011592 - #*EXTRAS*# Step: 22 Bead: 13 - 0.00011597 -0.00004451 -0.00004423 - -0.00004451 0.00011556 -0.00004414 - -0.00004423 -0.00004414 0.00011599 - #*EXTRAS*# Step: 23 Bead: 13 - 0.00011603 -0.00004452 -0.00004424 - -0.00004452 0.00011562 -0.00004415 - -0.00004424 -0.00004415 0.00011605 - #*EXTRAS*# Step: 24 Bead: 13 - 0.00011609 -0.00004453 -0.00004425 - -0.00004453 0.00011567 -0.00004415 - -0.00004425 -0.00004415 0.00011611 - #*EXTRAS*# Step: 25 Bead: 13 - 0.00011614 -0.00004454 -0.00004426 - -0.00004454 0.00011572 -0.00004416 - -0.00004426 -0.00004416 0.00011616 - #*EXTRAS*# Step: 26 Bead: 13 - 0.00011619 -0.00004455 -0.00004426 - -0.00004455 0.00011577 -0.00004417 - -0.00004426 -0.00004417 0.00011621 - #*EXTRAS*# Step: 27 Bead: 13 - 0.00011623 -0.00004456 -0.00004427 - -0.00004456 0.00011581 -0.00004417 - -0.00004427 -0.00004417 0.00011625 - #*EXTRAS*# Step: 28 Bead: 13 - 0.00011627 -0.00004456 -0.00004427 - -0.00004456 0.00011585 -0.00004417 - -0.00004427 -0.00004417 0.00011629 - #*EXTRAS*# Step: 29 Bead: 13 - 0.00011631 -0.00004457 -0.00004428 - -0.00004457 0.00011589 -0.00004418 - -0.00004428 -0.00004418 0.00011633 - #*EXTRAS*# Step: 30 Bead: 13 - 0.00011634 -0.00004457 -0.00004428 - -0.00004457 0.00011592 -0.00004418 - -0.00004428 -0.00004418 0.00011636 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_14 b/drivers/py/pes/friction/frictionH/120K/inst.fric_14 deleted file mode 100644 index bbb8ff42c..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_14 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 - 0.00010253 -0.00003354 -0.00003351 - -0.00003354 0.00010248 -0.00003373 - -0.00003351 -0.00003373 0.00010211 - #*EXTRAS*# Step: 1 Bead: 14 - 0.00010519 -0.00003721 -0.00003715 - -0.00003721 0.00010519 -0.00003732 - -0.00003715 -0.00003732 0.00010497 - #*EXTRAS*# Step: 2 Bead: 14 - 0.00010833 -0.00004028 -0.00004030 - -0.00004028 0.00010834 -0.00004028 - -0.00004030 -0.00004028 0.00010838 - #*EXTRAS*# Step: 3 Bead: 14 - 0.00011008 -0.00004162 -0.00004169 - -0.00004162 0.00011011 -0.00004166 - -0.00004169 -0.00004166 0.00011016 - #*EXTRAS*# Step: 4 Bead: 14 - 0.00011129 -0.00004242 -0.00004249 - -0.00004242 0.00011129 -0.00004247 - -0.00004249 -0.00004247 0.00011136 - #*EXTRAS*# Step: 5 Bead: 14 - 0.00011215 -0.00004293 -0.00004297 - -0.00004293 0.00011210 -0.00004295 - -0.00004297 -0.00004295 0.00011221 - #*EXTRAS*# Step: 6 Bead: 14 - 0.00011278 -0.00004329 -0.00004327 - -0.00004329 0.00011267 -0.00004325 - -0.00004327 -0.00004325 0.00011283 - #*EXTRAS*# Step: 7 Bead: 14 - 0.00011328 -0.00004355 -0.00004348 - -0.00004355 0.00011311 -0.00004345 - -0.00004348 -0.00004345 0.00011332 - #*EXTRAS*# Step: 8 Bead: 14 - 0.00011367 -0.00004374 -0.00004364 - -0.00004374 0.00011347 -0.00004360 - -0.00004364 -0.00004360 0.00011371 - #*EXTRAS*# Step: 9 Bead: 14 - 0.00011400 -0.00004389 -0.00004375 - -0.00004389 0.00011376 -0.00004371 - -0.00004375 -0.00004371 0.00011404 - #*EXTRAS*# Step: 10 Bead: 14 - 0.00011428 -0.00004400 -0.00004384 - -0.00004400 0.00011400 -0.00004379 - -0.00004384 -0.00004379 0.00011431 - #*EXTRAS*# Step: 11 Bead: 14 - 0.00011452 -0.00004410 -0.00004391 - -0.00004410 0.00011422 -0.00004386 - -0.00004391 -0.00004386 0.00011455 - #*EXTRAS*# Step: 12 Bead: 14 - 0.00011472 -0.00004417 -0.00004397 - -0.00004417 0.00011440 -0.00004391 - -0.00004397 -0.00004391 0.00011476 - #*EXTRAS*# Step: 13 Bead: 14 - 0.00011491 -0.00004424 -0.00004402 - -0.00004424 0.00011457 -0.00004395 - -0.00004402 -0.00004395 0.00011494 - #*EXTRAS*# Step: 14 Bead: 14 - 0.00011507 -0.00004429 -0.00004405 - -0.00004429 0.00011472 -0.00004399 - -0.00004405 -0.00004399 0.00011510 - #*EXTRAS*# Step: 15 Bead: 14 - 0.00011522 -0.00004433 -0.00004409 - -0.00004433 0.00011485 -0.00004402 - -0.00004409 -0.00004402 0.00011524 - #*EXTRAS*# Step: 16 Bead: 14 - 0.00011535 -0.00004437 -0.00004412 - -0.00004437 0.00011497 -0.00004404 - -0.00004412 -0.00004404 0.00011537 - #*EXTRAS*# Step: 17 Bead: 14 - 0.00011546 -0.00004440 -0.00004414 - -0.00004440 0.00011508 -0.00004406 - -0.00004414 -0.00004406 0.00011549 - #*EXTRAS*# Step: 18 Bead: 14 - 0.00011557 -0.00004443 -0.00004416 - -0.00004443 0.00011518 -0.00004408 - -0.00004416 -0.00004408 0.00011559 - #*EXTRAS*# Step: 19 Bead: 14 - 0.00011567 -0.00004445 -0.00004418 - -0.00004445 0.00011527 -0.00004410 - -0.00004418 -0.00004410 0.00011569 - #*EXTRAS*# Step: 20 Bead: 14 - 0.00011575 -0.00004447 -0.00004420 - -0.00004447 0.00011535 -0.00004411 - -0.00004420 -0.00004411 0.00011577 - #*EXTRAS*# Step: 21 Bead: 14 - 0.00011583 -0.00004449 -0.00004421 - -0.00004449 0.00011543 -0.00004412 - -0.00004421 -0.00004412 0.00011585 - #*EXTRAS*# Step: 22 Bead: 14 - 0.00011591 -0.00004450 -0.00004422 - -0.00004450 0.00011550 -0.00004413 - -0.00004422 -0.00004413 0.00011593 - #*EXTRAS*# Step: 23 Bead: 14 - 0.00011597 -0.00004451 -0.00004423 - -0.00004451 0.00011556 -0.00004414 - -0.00004423 -0.00004414 0.00011599 - #*EXTRAS*# Step: 24 Bead: 14 - 0.00011604 -0.00004453 -0.00004424 - -0.00004453 0.00011562 -0.00004415 - -0.00004424 -0.00004415 0.00011605 - #*EXTRAS*# Step: 25 Bead: 14 - 0.00011609 -0.00004454 -0.00004425 - -0.00004454 0.00011568 -0.00004415 - -0.00004425 -0.00004415 0.00011611 - #*EXTRAS*# Step: 26 Bead: 14 - 0.00011614 -0.00004454 -0.00004426 - -0.00004454 0.00011573 -0.00004416 - -0.00004426 -0.00004416 0.00011616 - #*EXTRAS*# Step: 27 Bead: 14 - 0.00011619 -0.00004455 -0.00004426 - -0.00004455 0.00011577 -0.00004417 - -0.00004426 -0.00004417 0.00011621 - #*EXTRAS*# Step: 28 Bead: 14 - 0.00011623 -0.00004456 -0.00004427 - -0.00004456 0.00011582 -0.00004417 - -0.00004427 -0.00004417 0.00011625 - #*EXTRAS*# Step: 29 Bead: 14 - 0.00011627 -0.00004456 -0.00004427 - -0.00004456 0.00011585 -0.00004417 - -0.00004427 -0.00004417 0.00011629 - #*EXTRAS*# Step: 30 Bead: 14 - 0.00011631 -0.00004457 -0.00004428 - -0.00004457 0.00011589 -0.00004418 - -0.00004428 -0.00004418 0.00011633 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.fric_15 b/drivers/py/pes/friction/frictionH/120K/inst.fric_15 deleted file mode 100644 index 1fbc7b195..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.fric_15 +++ /dev/null @@ -1,124 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 - 0.00010230 -0.00003314 -0.00003313 - -0.00003314 0.00010224 -0.00003332 - -0.00003313 -0.00003332 0.00010188 - #*EXTRAS*# Step: 1 Bead: 15 - 0.00010491 -0.00003688 -0.00003681 - -0.00003688 0.00010491 -0.00003700 - -0.00003681 -0.00003700 0.00010465 - #*EXTRAS*# Step: 2 Bead: 15 - 0.00010805 -0.00004004 -0.00004004 - -0.00004004 0.00010805 -0.00004004 - -0.00004004 -0.00004004 0.00010808 - #*EXTRAS*# Step: 3 Bead: 15 - 0.00010985 -0.00004145 -0.00004152 - -0.00004145 0.00010987 -0.00004149 - -0.00004152 -0.00004149 0.00010992 - #*EXTRAS*# Step: 4 Bead: 15 - 0.00011109 -0.00004229 -0.00004237 - -0.00004229 0.00011110 -0.00004235 - -0.00004237 -0.00004235 0.00011117 - #*EXTRAS*# Step: 5 Bead: 15 - 0.00011198 -0.00004284 -0.00004288 - -0.00004284 0.00011195 -0.00004286 - -0.00004288 -0.00004286 0.00011204 - #*EXTRAS*# Step: 6 Bead: 15 - 0.00011264 -0.00004321 -0.00004321 - -0.00004321 0.00011255 -0.00004318 - -0.00004321 -0.00004318 0.00011269 - #*EXTRAS*# Step: 7 Bead: 15 - 0.00011315 -0.00004348 -0.00004343 - -0.00004348 0.00011300 -0.00004340 - -0.00004343 -0.00004340 0.00011320 - #*EXTRAS*# Step: 8 Bead: 15 - 0.00011356 -0.00004369 -0.00004359 - -0.00004369 0.00011336 -0.00004356 - -0.00004359 -0.00004356 0.00011360 - #*EXTRAS*# Step: 9 Bead: 15 - 0.00011390 -0.00004384 -0.00004372 - -0.00004384 0.00011367 -0.00004368 - -0.00004372 -0.00004368 0.00011394 - #*EXTRAS*# Step: 10 Bead: 15 - 0.00011419 -0.00004397 -0.00004381 - -0.00004397 0.00011392 -0.00004376 - -0.00004381 -0.00004376 0.00011422 - #*EXTRAS*# Step: 11 Bead: 15 - 0.00011443 -0.00004407 -0.00004389 - -0.00004407 0.00011414 -0.00004383 - -0.00004389 -0.00004383 0.00011447 - #*EXTRAS*# Step: 12 Bead: 15 - 0.00011465 -0.00004415 -0.00004395 - -0.00004415 0.00011433 -0.00004389 - -0.00004395 -0.00004389 0.00011468 - #*EXTRAS*# Step: 13 Bead: 15 - 0.00011484 -0.00004421 -0.00004400 - -0.00004421 0.00011451 -0.00004394 - -0.00004400 -0.00004394 0.00011487 - #*EXTRAS*# Step: 14 Bead: 15 - 0.00011501 -0.00004427 -0.00004404 - -0.00004427 0.00011466 -0.00004397 - -0.00004404 -0.00004397 0.00011503 - #*EXTRAS*# Step: 15 Bead: 15 - 0.00011516 -0.00004431 -0.00004407 - -0.00004431 0.00011480 -0.00004401 - -0.00004407 -0.00004401 0.00011518 - #*EXTRAS*# Step: 16 Bead: 15 - 0.00011529 -0.00004435 -0.00004410 - -0.00004435 0.00011492 -0.00004403 - -0.00004410 -0.00004403 0.00011532 - #*EXTRAS*# Step: 17 Bead: 15 - 0.00011541 -0.00004439 -0.00004413 - -0.00004439 0.00011503 -0.00004405 - -0.00004413 -0.00004405 0.00011544 - #*EXTRAS*# Step: 18 Bead: 15 - 0.00011552 -0.00004442 -0.00004415 - -0.00004442 0.00011514 -0.00004407 - -0.00004415 -0.00004407 0.00011555 - #*EXTRAS*# Step: 19 Bead: 15 - 0.00011562 -0.00004444 -0.00004417 - -0.00004444 0.00011523 -0.00004409 - -0.00004417 -0.00004409 0.00011565 - #*EXTRAS*# Step: 20 Bead: 15 - 0.00011572 -0.00004446 -0.00004419 - -0.00004446 0.00011532 -0.00004410 - -0.00004419 -0.00004410 0.00011574 - #*EXTRAS*# Step: 21 Bead: 15 - 0.00011580 -0.00004448 -0.00004420 - -0.00004448 0.00011540 -0.00004412 - -0.00004420 -0.00004412 0.00011582 - #*EXTRAS*# Step: 22 Bead: 15 - 0.00011588 -0.00004450 -0.00004422 - -0.00004450 0.00011547 -0.00004413 - -0.00004422 -0.00004413 0.00011590 - #*EXTRAS*# Step: 23 Bead: 15 - 0.00011595 -0.00004451 -0.00004423 - -0.00004451 0.00011553 -0.00004414 - -0.00004423 -0.00004414 0.00011596 - #*EXTRAS*# Step: 24 Bead: 15 - 0.00011601 -0.00004452 -0.00004424 - -0.00004452 0.00011560 -0.00004414 - -0.00004424 -0.00004414 0.00011603 - #*EXTRAS*# Step: 25 Bead: 15 - 0.00011607 -0.00004453 -0.00004425 - -0.00004453 0.00011565 -0.00004415 - -0.00004425 -0.00004415 0.00011609 - #*EXTRAS*# Step: 26 Bead: 15 - 0.00011612 -0.00004454 -0.00004425 - -0.00004454 0.00011570 -0.00004416 - -0.00004425 -0.00004416 0.00011614 - #*EXTRAS*# Step: 27 Bead: 15 - 0.00011617 -0.00004455 -0.00004426 - -0.00004455 0.00011575 -0.00004416 - -0.00004426 -0.00004416 0.00011619 - #*EXTRAS*# Step: 28 Bead: 15 - 0.00011622 -0.00004456 -0.00004427 - -0.00004456 0.00011580 -0.00004417 - -0.00004427 -0.00004417 0.00011623 - #*EXTRAS*# Step: 29 Bead: 15 - 0.00011626 -0.00004456 -0.00004427 - -0.00004456 0.00011584 -0.00004417 - -0.00004427 -0.00004417 0.00011627 - #*EXTRAS*# Step: 30 Bead: 15 - 0.00011630 -0.00004457 -0.00004428 - -0.00004457 0.00011587 -0.00004418 - -0.00004428 -0.00004418 0.00011631 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 deleted file mode 100644 index b166fd78a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ --1.920795128952092375e-03 9.590665278592439545e-05 9.531439153300798979e-05 -2.634788617689519212e-03 9.129668089011765911e-05 8.964512122550879765e-05 -4.126319266001262503e-03 8.160863461261790345e-05 7.822493453311501208e-05 -6.079001169949449154e-03 6.585541561690949868e-05 6.216889801991952631e-05 -8.000404735975946008e-03 4.310522452507650418e-05 4.237600186516288610e-05 -9.584780470576755723e-03 1.812953333510000339e-05 2.108092190617069121e-05 -1.075368533055318793e-02 7.344071389060295187e-06 6.594939908400681825e-06 -1.078859441166321424e-02 5.604808296137661117e-08 -3.993392363420405655e-09 -9.943430764024931492e-03 2.615170880645804813e-06 2.194626212395671035e-06 -8.695204200311565726e-03 1.108524985184118150e-05 1.120727783653646313e-05 -6.827238686291679098e-03 2.260531414067749534e-05 2.309346294132444600e-05 -4.773044701719947498e-03 3.529390401000342042e-05 3.537888819133866604e-05 -3.174149395806101243e-03 4.694183758039911135e-05 4.658032953214011893e-05 -2.081389829040176248e-03 5.625492716606427494e-05 5.549200126811749777e-05 -1.419204390668636412e-03 6.247154918095393264e-05 6.156020763871154972e-05 -1.135637492814115575e-03 6.547958516874539687e-05 6.456075897060048398e-05 1.062560859482537989e-14 5.511521611309602164e-01 4.150171587229554736e-11 1.112350482094941867e-14 5.511521611317115044e-01 4.197330568890809944e-11 1.206987391750340031e-14 5.511521611318793701e-01 4.172029054488204660e-11 1.240895302714524971e-14 5.511521611282655941e-01 3.797956451502651611e-11 1.063193592551308352e-14 5.511521611179805991e-01 2.810492807935979192e-11 9.569819725755972325e-15 5.511521611098890716e-01 2.042874392280736906e-11 1.343823193273284639e-14 5.511521611049013947e-01 1.547402174241131514e-11 -3.765268669254705800e-16 5.511521610906253699e-01 1.225620372218649413e-12 9.877296415510013850e-17 5.511521610901893853e-01 7.995781754624027154e-13 1.501470127241477755e-15 5.511521610962147877e-01 6.849008231039622387e-12 5.436815842161614387e-15 5.511521611097558448e-01 2.043271635798144969e-11 8.763975797947965353e-15 5.511521611190862702e-01 2.973631324774860340e-11 1.063947407519102756e-14 5.511521611233650697e-01 3.397391206704143417e-11 1.178032121783160465e-14 5.511521611256409159e-01 3.621891348477240141e-11 1.254106174610384359e-14 5.511521611270243648e-01 3.759624103496127279e-11 1.313654297394549623e-14 5.511521611280354449e-01 3.861178752087490844e-11 1.060807603363854453e-14 4.150171587229554736e-11 5.511521611308231039e-01 1.103196398392061619e-14 4.197330568890809944e-11 5.511521611310178370e-01 1.185138723408525581e-14 4.172029054488204660e-11 5.511521611303550339e-01 1.212295594879510255e-14 3.797956451502651611e-11 5.511521611264940113e-01 1.045127893449379574e-14 2.810492807935979192e-11 5.511521611170172585e-01 9.536943942472718422e-15 2.042874392280736906e-11 5.511521611097485174e-01 1.340573397068739869e-14 1.547402174241131514e-11 5.511521611048265656e-01 -3.735339321873972108e-16 1.225620372218649413e-12 5.511521610906058299e-01 9.878005533809378070e-17 7.995781754624027154e-13 5.511521610901894963e-01 1.506791463282965461e-15 6.849008231039622387e-12 5.511521610962631934e-01 5.454639987433230245e-15 2.043271635798144969e-11 5.511521611098896267e-01 8.775766510330244045e-15 2.973631324774860340e-11 5.511521611191662062e-01 1.063907013502761991e-14 3.397391206704143417e-11 5.511521611233626272e-01 1.176992860201736207e-14 3.621891348477240141e-11 5.511521611255768560e-01 1.252832768726508020e-14 3.759624103496127279e-11 5.511521611269479815e-01 1.312508883922968429e-14 3.861178752087490844e-11 5.511521611279680544e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 deleted file mode 100644 index c1df96056..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ --5.878234667419651206e-03 9.590665291788376672e-05 9.531439166374245655e-05 -6.316336480947132466e-03 9.129668101044936866e-05 8.964512134446801566e-05 -7.138177101058214638e-03 8.160863471345922225e-05 7.822493463253944127e-05 -8.146437443152283395e-03 6.585541569144349203e-05 6.216889809344431717e-05 -9.175761225479393129e-03 4.310522457467583977e-05 4.237600191442235820e-05 -1.014765275641482320e-02 1.812953337237509092e-05 2.108092194346294302e-05 -1.083623925364436864e-02 7.344071425888317034e-06 6.594939945222952318e-06 -1.086476269738883248e-02 5.604808220062536483e-08 -3.993393122613502624e-09 -1.033156319710173965e-02 2.615170880848178348e-06 2.194626212597770555e-06 -9.596527733139674499e-03 1.108524985483350835e-05 1.120727783953573565e-05 -8.661708292527747419e-03 2.260531415222009462e-05 2.309346295291298497e-05 -7.489349383555208607e-03 3.529390403463397301e-05 3.537888821602964257e-05 -6.271318137274248944e-03 4.694183761658495517e-05 4.658032956835164479e-05 -5.267969917379692127e-03 5.625492721079102302e-05 5.549200131282937195e-05 -4.597589830958836478e-03 6.247154923169445878e-05 6.156020768941403393e-05 -4.280114040669086815e-03 6.547958522329278724e-05 6.456075902510174155e-05 1.425849794914355324e-13 5.511521613776230177e-01 2.857203441093425379e-10 1.314552119721383729e-13 5.511521613577147205e-01 2.653362591896610668e-10 1.129111885611377354e-13 5.511521613190605295e-01 2.263437956595867285e-10 8.694295202737018394e-14 5.511521612624096234e-01 1.704406825861126794e-10 6.023126916251259573e-14 5.511521612025068739e-01 1.121380050341692723e-10 4.684490627592791190e-14 5.511521611645403551e-01 7.512503637196079451e-11 5.026625385076388949e-14 5.511521611327082626e-01 4.328524549211728400e-11 -1.137278114876552101e-15 5.511521610927805348e-01 3.376872857100559533e-12 3.011466225604095770e-16 5.511521610917597958e-01 2.367808099470678219e-12 4.493797547661399186e-15 5.511521611085491434e-01 1.921150663892255201e-11 1.697941462093610208e-14 5.511521611479777150e-01 5.880772147001799356e-11 3.339452528005196028e-14 5.511521611914508290e-01 1.022816692214290462e-10 4.682532073962808133e-14 5.511521612211023324e-01 1.317832370368432550e-10 5.650706966464156078e-14 5.511521612391474534e-01 1.496905321190999193e-10 6.328159324158610886e-14 5.511521612502244816e-01 1.607055186963784818e-10 6.768392903743545215e-14 5.511521612567807926e-01 1.672485049654924811e-10 1.413425423213085658e-13 2.857203441093425379e-10 5.511521613726217961e-01 1.299911810835016136e-13 2.653362591896610668e-10 5.511521613517713636e-01 1.112758189210462524e-13 2.263437956595867285e-10 5.511521613124558128e-01 8.564775191608676463e-14 1.704406825861126794e-10 5.511521612572933826e-01 5.971074980218513470e-14 1.121380050341692723e-10 5.511521612005599868e-01 4.682919527856788991e-14 7.512503637196079451e-11 5.511521611644898400e-01 5.022800450343286438e-14 4.328524549211728400e-11 5.511521611326422043e-01 -1.132727028801129931e-15 3.376872857100559533e-12 5.511521610927532233e-01 3.008795475484607635e-16 2.367808099470678219e-12 5.511521610917554659e-01 4.506064072257928718e-15 1.921150663892255201e-11 5.511521611086539485e-01 1.704317894314041225e-14 5.880772147001799356e-11 5.511521611484184735e-01 3.346674623874963064e-14 1.022816692214290462e-10 5.511521611918928087e-01 4.685059731440383668e-14 1.317832370368432550e-10 5.511521612212441079e-01 5.648180114438557780e-14 1.496905321190999193e-10 5.511521612390135605e-01 6.323080749326954813e-14 1.607055186963784818e-10 5.511521612499665768e-01 6.762634047947227161e-14 1.672485049654924811e-10 5.511521612564962425e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 deleted file mode 100644 index 45e23edce..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_10 +++ /dev/null @@ -1 +0,0 @@ --1.089498324337528912e-02 9.590665262859725477e-05 9.531439137743751412e-05 -1.090556472677337886e-02 9.129668074321014854e-05 8.964512108052688434e-05 -1.092256768367123876e-02 8.160863448526857336e-05 7.822493440779498320e-05 -1.093841645996890787e-02 6.585541551783197353e-05 6.216889792244496696e-05 -1.094349106548633647e-02 4.310522445796937025e-05 4.237600179870859774e-05 -1.092790838046363115e-02 1.812953328997720303e-05 2.108092186106657980e-05 -1.088342048566535124e-02 7.344071357073237734e-06 6.594939876455097646e-06 -1.080509625404797724e-02 5.604808367501939223e-08 -3.993391648996949735e-09 -1.070349645523251646e-02 2.615170878166376746e-06 2.194626209911648662e-06 -1.059465319704106130e-02 1.108524983634064289e-05 1.120727782096892422e-05 -1.048389650602382303e-02 2.260531409867364987e-05 2.309346289911177980e-05 -1.037746499029680754e-02 3.529390393939177238e-05 3.537888812049794641e-05 -1.028196810517585137e-02 4.694183748823865375e-05 4.658032943983002111e-05 -1.020375054766087079e-02 5.625492705902178050e-05 5.549200116101443031e-05 -1.014825393533603029e-02 6.247154906410474823e-05 6.156020752184679346e-05 -1.011945609026396881e-02 6.547958504627850022e-05 6.456075884812999591e-05 -1.467015569053729281e-13 5.511521614428016580e-01 3.491989387590762357e-10 -1.357840135198280913e-13 5.511521614162173677e-01 3.223975838641986511e-10 -1.152794617719644683e-13 5.511521613662880847e-01 2.725337780856983264e-10 -8.666857973778789985e-14 5.511521612965346595e-01 2.039808002091185478e-10 -5.647520192802647233e-14 5.511521612229567380e-01 1.324417611282986718e-10 -3.555297908747020106e-14 5.511521611719515379e-01 8.259422290517060331e-11 -1.854882586689795798e-14 5.511521611309342372e-01 4.152459219515861904e-11 3.371159182792803756e-16 5.511521610887670786e-01 -6.303927291776383845e-13 -2.380655080724673673e-15 5.511521610962872852e-01 6.910701481135367100e-12 -1.399906964673314612e-14 5.511521611247016672e-01 3.546636990039157592e-11 -3.656703365123797346e-14 5.511521611782302932e-01 8.930337638859001465e-11 -6.184767194125330028e-14 5.511521612368396328e-01 1.479669161487481259e-10 -8.152097589044820116e-14 5.511521612815387661e-01 1.924999650920022913e-10 -9.526217329941720156e-14 5.511521613123380181e-01 2.231123960476801438e-10 -1.043081072186742681e-13 5.511521613324975588e-01 2.431707281679375739e-10 -1.093303436194019907e-13 5.511521613437185829e-01 2.543609786357348007e-10 -1.449623932075728941e-13 3.491989387590762357e-10 5.511521614344684350e-01 -1.339499551311400238e-13 3.223975838641986511e-10 5.511521614074491593e-01 -1.134686488310077857e-13 2.725337780856983264e-10 5.511521613576575440e-01 -8.535160796153819483e-14 2.039808002091185478e-10 5.511521612902867684e-01 -5.600301116768699694e-14 1.324417611282986718e-10 5.511521612207317400e-01 -3.556716100163097318e-14 8.259422290517060331e-11 5.511521611720188174e-01 -1.853984938432112545e-14 4.152459219515861904e-11 5.511521611308949353e-01 3.408895232762104760e-16 -6.303927291776383845e-13 5.511521610887520906e-01 -2.385242741119769499e-15 6.910701481135367100e-12 5.511521610963143747e-01 -1.406074865433789701e-14 3.546636990039157592e-11 5.511521611250148611e-01 -3.675802073198469904e-14 8.930337638859001465e-11 5.511521611791613262e-01 -6.206494639797734362e-14 1.479669161487481259e-10 5.511521612378783574e-01 -8.167103442182267945e-14 1.924999650920022913e-10 5.511521612822465332e-01 -9.533314651658851503e-14 2.231123960476801438e-10 5.511521613126720842e-01 -1.043364357705893010e-13 2.431707281679375739e-10 5.511521613326286761e-01 -1.093454012304564464e-13 2.543609786357348007e-10 5.511521613437873057e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 deleted file mode 100644 index 4e466d4ea..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_11 +++ /dev/null @@ -1 +0,0 @@ --1.091901000604686249e-02 9.590665262549037857e-05 9.531439137436184940e-05 -1.092570096802708904e-02 9.129668074042202779e-05 8.964512107777017835e-05 -1.093577802860041387e-02 8.160863448305070230e-05 7.822493440560797124e-05 -1.094323378965814803e-02 6.585541551634253724e-05 6.216889792097695722e-05 -1.094046646480909511e-02 4.310522445718668470e-05 4.237600179793320345e-05 -1.091971704198727369e-02 1.812953328967685870e-05 2.108092186076514788e-05 -1.087459787604991984e-02 7.344071357093303945e-06 6.594939876474061020e-06 -1.080144242922339431e-02 5.604808381344291275e-08 -3.993391510540356051e-09 -1.070990901577809594e-02 2.615170878036389375e-06 2.194626209781911590e-06 -1.061266823472799443e-02 1.108524983581321750e-05 1.120727782044186813e-05 -1.051437223969751283e-02 2.260531409759358122e-05 2.309346289803124359e-05 -1.042040614327356327e-02 3.529390393773608725e-05 3.537888811884144135e-05 -1.033642951534872664e-02 4.694183748609095767e-05 4.658032943768262995e-05 -1.026784862235429786e-02 5.625492705648379874e-05 5.549200115847598098e-05 -1.021928632538044238e-02 6.247154906128509074e-05 6.156020751902731216e-05 -1.019411595408142683e-02 6.547958504330400511e-05 6.456075884515524331e-05 -1.498084319599595403e-13 5.511521614438842365e-01 3.502845303237780036e-10 -1.385721288344555810e-13 5.511521614171278616e-01 3.233098232036611216e-10 -1.174973305946947641e-13 5.511521613668892705e-01 2.731352882263446561e-10 -8.815802204940843115e-14 5.511521612967558159e-01 2.042018261029137638e-10 -5.725788644653787317e-14 5.511521612228161837e-01 1.323013303147408305e-10 -3.585332456353126421e-14 5.511521611715611835e-01 8.220451226359982181e-11 -1.852875962285178604e-14 5.511521611304838197e-01 4.107597816800457656e-11 4.755394364793937849e-16 5.511521610885042888e-01 -8.918827210950118876e-13 -2.510642576380772862e-15 5.511521610964887907e-01 7.110877485750889287e-12 -1.452649507479575738e-14 5.511521611254341924e-01 3.619483670409833440e-11 -3.764710231411338138e-14 5.511521611795574538e-01 9.062484591443908582e-11 -6.350335573986658715e-14 5.511521612387787483e-01 1.499001749878623118e-10 -8.366867116902902839e-14 5.511521612840540874e-01 1.950107484791475227e-10 -9.780015380776448765e-14 5.511521613153405053e-01 2.261124402826676694e-10 -1.071277652762179659e-13 5.511521613358519867e-01 2.465249296074799822e-10 -1.123048393904314499e-13 5.511521613472570857e-01 2.579007357868373858e-10 -1.480380575205051003e-13 3.502845303237780036e-10 5.511521614355571197e-01 -1.367066664862923706e-13 3.233098232036611216e-10 5.511521614083632059e-01 -1.156556670299705679e-13 2.731352882263446561e-10 5.511521613582593959e-01 -8.681961240966833907e-14 2.042018261029137638e-10 5.511521612905075918e-01 -5.677840524582161879e-14 1.323013303147408305e-10 5.511521612205915188e-01 -3.586859266931266751e-14 8.220451226359982181e-11 5.511521611716297953e-01 -1.852088622530398930e-14 4.107597816800457656e-11 5.511521611304481816e-01 4.793461173106711128e-16 -8.918827210950118876e-13 5.511521610884918543e-01 -2.514979766524124765e-15 7.110877485750889287e-12 5.511521610965132156e-01 -1.458780502993940601e-14 3.619483670409833440e-11 5.511521611257392816e-01 -3.783855658409795324e-14 9.062484591443908582e-11 5.511521611804771625e-01 -6.372145398711893222e-14 1.499001749878623118e-10 5.511521612398058156e-01 -8.381842837759980412e-14 1.950107484791475227e-10 5.511521612847527507e-01 -9.787159357721606314e-14 2.261124402826676694e-10 5.511521613156696864e-01 -1.071559197069954233e-13 2.465249296074799822e-10 5.511521613359826599e-01 -1.123201583373030940e-13 2.579007357868373858e-10 5.511521613473283621e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 deleted file mode 100644 index e9b047c4f..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_12 +++ /dev/null @@ -1 +0,0 @@ --1.093338983622127100e-02 9.590665262309754438e-05 9.531439137199271858e-05 -1.093719879127762543e-02 9.129668073828541767e-05 8.964512107565878948e-05 -1.094217712034293785e-02 8.160863448137205918e-05 7.822493440395326188e-05 -1.094353624372023694e-02 6.585541551524356281e-05 6.216889791989442201e-05 -1.093524010738374311e-02 4.310522445664381790e-05 4.237600179739520878e-05 -1.091117298151564156e-02 1.812953328950501605e-05 2.108092186059327811e-05 -1.086637942615386113e-02 7.344071357158057919e-06 6.594939876538594766e-06 -1.079817234366960664e-02 5.604808393284456143e-08 -3.993391392054397958e-09 -1.071539084721495269e-02 2.615170877918089366e-06 2.194626209664146481e-06 -1.062808371693989458e-02 1.108524983535319899e-05 1.120727781998214608e-05 -1.054035072380763924e-02 2.260531409667248371e-05 2.309346289711015964e-05 -1.045687747113803294e-02 3.529390393634189134e-05 3.537888811744813991e-05 -1.038255008227815385e-02 4.694183748429688090e-05 4.658032943588938667e-05 -1.032201322504243922e-02 5.625492705437163060e-05 5.549200115636501225e-05 -1.027922638230203967e-02 6.247154905894459641e-05 6.156020751668776650e-05 -1.025707348795989321e-02 6.547958504083843450e-05 6.456075884269007927e-05 -1.522012653722832934e-13 5.511521614445510364e-01 3.509526363367546982e-10 -1.407087373280393455e-13 5.511521614176625450e-01 3.238451381377626364e-10 -1.191759685313506261e-13 5.511521613671884756e-01 2.734343945448833563e-10 -8.925700117604163801e-14 5.511521612967700268e-01 2.042160488126752639e-10 -5.780075190491951093e-14 5.511521612225674938e-01 1.320531208616083255e-10 -3.602516646094962588e-14 5.511521611711456270e-01 8.178994243860113466e-11 -1.846400550587996651e-14 5.511521611300582713e-01 4.065231683979148092e-11 5.949410846704888179e-16 5.511521610882723632e-01 -1.122622715083587438e-12 -2.628942473856882593e-15 5.511521610966685358e-01 7.289393834175156511e-12 -1.498651393419773942e-14 5.511521611260783438e-01 3.683532320167894443e-11 -3.856820136161201082e-14 5.511521611807154164e-01 9.177746225113141412e-11 -6.489755446190492395e-14 5.511521612404618464e-01 1.515771477674624077e-10 -8.546274740602043521e-14 5.511521612862295694e-01 1.971804987531264162e-10 -9.991232520626494226e-14 5.511521613179313217e-01 2.286986603376695480e-10 -1.094682644605662882e-13 5.511521613387425633e-01 2.494122941278013829e-10 -1.147704127231353635e-13 5.511521613503044259e-01 2.609458281094461376e-10 -1.504071853319159476e-13 3.509526363367546982e-10 5.511521614362264732e-01 -1.388180490379072780e-13 3.238451381377626364e-10 5.511521614088991106e-01 -1.173103818914146230e-13 2.734343945448833563e-10 5.511521613585583790e-01 -8.790214296453293559e-14 2.042160488126752639e-10 5.511521612905218026e-01 -5.731640031235658805e-14 1.320531208616083255e-10 5.511521612203438281e-01 -3.604046186059805672e-14 8.178994243860113466e-11 5.511521611712161262e-01 -1.845635255406387667e-14 4.065231683979148092e-11 5.511521611300264079e-01 5.978320756042892601e-16 -1.122622715083587438e-12 5.511521610882622602e-01 -2.632744979722890274e-15 7.289393834175156511e-12 5.511521610966905182e-01 -1.504752776728702984e-14 3.683532320167894443e-11 5.511521611263761056e-01 -3.875964088948581759e-14 9.177746225113141412e-11 5.511521611816244670e-01 -6.511475666565580299e-14 1.515771477674624077e-10 5.511521612414767013e-01 -8.561167498726068733e-14 1.971804987531264162e-10 5.511521612869167974e-01 -9.998256471973101665e-14 2.286986603376695480e-10 5.511521613182512880e-01 -1.094954664601630096e-13 2.494122941278013829e-10 5.511521613388667973e-01 -1.147853163782996418e-13 2.609458281094461376e-10 5.511521613503711503e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 deleted file mode 100644 index 9342e5165..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_13 +++ /dev/null @@ -1 +0,0 @@ --1.094099109617489157e-02 9.590665262124845112e-05 9.531439137016361530e-05 -1.094265456604626673e-02 9.129668073664459966e-05 8.964512107403878815e-05 -1.094386590291126886e-02 8.160863448010119805e-05 7.822493440270195705e-05 -1.094079551860349317e-02 6.585541551443813613e-05 6.216889791910193799e-05 -1.092863712739638830e-02 4.310522445627779125e-05 4.237600179703326822e-05 -1.090256191465246126e-02 1.812953328942643849e-05 2.108092186051394501e-05 -1.085873012945542081e-02 7.344071357254306273e-06 6.594939876633470079e-06 -1.079523250971501681e-02 5.604808403578214617e-08 -3.993391289814489608e-09 -1.072013088396654712e-02 2.615170877809345159e-06 2.194626209555379404e-06 -1.064143178733134402e-02 1.108524983494712123e-05 1.120727781957731854e-05 -1.056276946772432071e-02 2.260531409587700457e-05 2.309346289631513790e-05 -1.048824767452061733e-02 3.529390393515477806e-05 3.537888811626118925e-05 -1.042211347197564628e-02 4.694183748277965516e-05 4.658032943437350262e-05 -1.036838448923052027e-02 5.625492705259241418e-05 5.549200115458854699e-05 -1.033047506694807251e-02 6.247154905697786722e-05 6.156020751472266361e-05 -1.031086735721710446e-02 6.547958503876836730e-05 6.456075884062216692e-05 -1.540503533496230681e-13 5.511521614449117479e-01 3.513136922459400135e-10 -1.423495532718905846e-13 5.511521614179220041e-01 3.241046903703147018e-10 -1.204468309693071292e-13 5.511521613672691888e-01 2.735149754124764076e-10 -9.006242931413376025e-14 5.511521612966383543e-01 2.040846598724315432e-10 -5.816677912850284046e-14 5.511521612222476385e-01 1.317340171692277690e-10 -3.610374524036282540e-14 5.511521611707204116e-01 8.136590545441546344e-11 -1.836775733833092000e-14 5.511521611296584799e-01 4.025430099768143012e-11 6.978786664261069412e-16 5.511521610880673050e-01 -1.326692178725889785e-12 -2.737686850057627369e-15 5.511521610968298512e-01 7.449639217390079030e-12 -1.539259186577017829e-14 5.511521611266489984e-01 3.740265825918086741e-11 -3.936368169128684078e-14 5.511521611817339350e-01 9.279096640620452579e-11 -6.608466472259043030e-14 5.511521612419348903e-01 1.530442015971205239e-10 -8.697997321064085385e-14 5.511521612881271626e-01 1.990719014761981554e-10 -1.016915396654547497e-13 5.511521613201861847e-01 2.309477929720546597e-10 -1.114349984909346416e-13 5.511521613412549980e-01 2.519197671027137782e-10 -1.168404796054463835e-13 5.511521613529515307e-01 2.635885405875070738e-10 -1.522362909025645793e-13 3.513136922459400135e-10 5.511521614365879618e-01 -1.404380464680562836e-13 3.241046903703147018e-10 5.511521614091586807e-01 -1.185616926713230032e-13 2.735149754124764076e-10 5.511521613586388701e-01 -8.869463295632733894e-14 2.040846598724315432e-10 5.511521612903906853e-01 -5.767834110682301474e-14 1.317340171692277690e-10 5.511521612200255271e-01 -3.611979504646544150e-14 8.136590545441546344e-11 5.511521611707932422e-01 -1.836147742297913242e-14 4.025430099768143012e-11 5.511521611296301693e-01 7.000719840134584325e-16 -1.326692178725889785e-12 5.511521610880592004e-01 -2.741511853715277215e-15 7.449639217390079030e-12 5.511521610968497242e-01 -1.545235524397748261e-14 3.740265825918086741e-11 5.511521611269400989e-01 -3.955466137840298842e-14 9.279096640620452579e-11 5.511521611826329936e-01 -6.630170721927827198e-14 1.530442015971205239e-10 5.511521612429377548e-01 -8.712756074674647490e-14 1.990719014761981554e-10 5.511521612888019561e-01 -1.017590304840314306e-13 2.309477929720546597e-10 5.511521613204947156e-01 -1.114605745718134475e-13 2.519197671027137782e-10 5.511521613413692400e-01 -1.168532267919588331e-13 2.635885405875070738e-10 5.511521613530093733e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 deleted file mode 100644 index f1e7a7e10..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_14 +++ /dev/null @@ -1 +0,0 @@ --1.094377114735101131e-02 9.590665261981392968e-05 9.531439136874532978e-05 -1.094383719621513755e-02 9.129668073538033861e-05 8.964512107279097987e-05 -1.094227035431528244e-02 8.160863447913919901e-05 7.822493440175546211e-05 -1.093600285605765381e-02 6.585541551385182670e-05 6.216889791852583361e-05 -1.092120356175853638e-02 4.310522445604181464e-05 4.237600179680028672e-05 -1.089406094550794679e-02 1.812953328941328577e-05 2.108092186049986055e-05 -1.085161203389047903e-02 7.344071357368036540e-06 6.594939876746536272e-06 -1.079257298000100077e-02 5.604808412499219219e-08 -3.993391201323078254e-09 -1.072426753035723990e-02 2.615170877708877734e-06 2.194626209455791623e-06 -1.065310070690216569e-02 1.108524983458760995e-05 1.120727781921799192e-05 -1.058230958718674522e-02 2.260531409518537507e-05 2.309346289562392852e-05 -1.051550800421923934e-02 3.529390393413482164e-05 3.537888811524218829e-05 -1.045640861103268836e-02 4.694183748148593769e-05 4.658032943308149278e-05 -1.040850665019359134e-02 5.625492705108205279e-05 5.549200115308017104e-05 -1.037476325422193382e-02 6.247154905531178729e-05 6.156020751305986340e-05 -1.035732692769641625e-02 6.547958503701788223e-05 6.456075883887387736e-05 -1.554848795515392041e-13 5.511521614450460849e-01 3.514481116773328771e-10 -1.436138150649267179e-13 5.511521614179792916e-01 3.241619357747401865e-10 -1.214088280049405348e-13 5.511521613671916953e-01 2.734375778260169036e-10 -9.064873589778962536e-14 5.511521612964044303e-01 2.038513729439911711e-10 -5.840275580132369440e-14 5.511521612218823751e-01 1.313698482978148480e-10 -3.611689638104230168e-14 5.511521611702957513e-01 8.094258325062681274e-11 -1.825402694656909905e-14 5.511521611292840017e-01 3.988161837932737289e-11 7.870887139059492923e-16 5.511521610878848954e-01 -1.508126665946266722e-12 -2.838154468842329428e-15 5.511521610969754015e-01 7.594223741952718552e-12 -1.575210346908771459e-14 5.511521611271575916e-01 3.790825802976108353e-11 -4.005531244888422726e-14 5.511521611826357692e-01 9.368811947566348543e-11 -6.710461932015001681e-14 5.511521612432331851e-01 1.543366935001283176e-10 -8.827368808063492969e-14 5.511521612897942735e-01 2.007326762681757623e-10 -1.032019042805244688e-13 5.511521613221629368e-01 2.329182250766984207e-10 -1.131010814554447100e-13 5.511521613434547939e-01 2.541135072396222330e-10 -1.185909664238089381e-13 5.511521613552677890e-01 2.658991067215359175e-10 -1.536545805444528035e-13 3.514481116773328771e-10 5.511521614367224098e-01 -1.416858580925189208e-13 3.241619357747401865e-10 5.511521614092158572e-01 -1.195081825358537495e-13 2.734375778260169036e-10 5.511521613585615986e-01 -8.927074261074080811e-14 2.038513729439911711e-10 5.511521612901579825e-01 -5.791132513576275744e-14 1.313698482978148480e-10 5.511521612196624842e-01 -3.613387843745887909e-14 8.094258325062681274e-11 5.511521611703712464e-01 -1.824841160879710856e-14 3.988161837932737289e-11 5.511521611292592437e-01 7.885633951180854948e-16 -1.508126665946266722e-12 5.511521610878786781e-01 -2.841099463084636705e-15 7.594223741952718552e-12 5.511521610969933871e-01 -1.581168210643426608e-14 3.790825802976108353e-11 5.511521611274426968e-01 -4.024586945637163845e-14 9.368811947566348543e-11 5.511521611835255019e-01 -6.732071125662656442e-14 1.543366935001283176e-10 5.511521612442243923e-01 -8.841957001253336405e-14 2.007326762681757623e-10 5.511521612904564105e-01 -1.032674052550901312e-13 2.329182250766984207e-10 5.511521613224588112e-01 -1.131233767516611150e-13 2.541135072396222330e-10 5.511521613435569344e-01 -1.186015180401600492e-13 2.658991067215359175e-10 5.511521613553141963e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 deleted file mode 100644 index 5177ecf67..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_15 +++ /dev/null @@ -1 +0,0 @@ --1.094310242038760636e-02 9.590665261869931563e-05 9.531439136764392945e-05 -1.094198486613785250e-02 9.129668073440668440e-05 8.964512107183125766e-05 -1.093838462419274501e-02 8.160863447841347474e-05 7.822493440104217905e-05 -1.092984362858553243e-02 6.585541551343248440e-05 6.216889791811460928e-05 -1.091330966313199848e-02 4.310522445590235914e-05 4.237600179666267436e-05 -1.088578104218074390e-02 1.812953328944622180e-05 2.108092186053258651e-05 -1.084498819490786921e-02 7.344071357492404694e-06 6.594939876870148025e-06 -1.079015522579358094e-02 5.604808420210071819e-08 -3.993391124724866438e-09 -1.072790518099790702e-02 2.615170877616709114e-06 2.194626209363156288e-06 -1.066338179595489703e-02 1.108524983426640490e-05 1.120727781889751192e-05 -1.059947991989336306e-02 2.260531409458055289e-05 2.309346289501959423e-05 -1.053939667654083152e-02 3.529390393325222008e-05 3.537888811436159251e-05 -1.048639331705779852e-02 4.694183748037444751e-05 4.658032943197187961e-05 -1.044352558184303940e-02 5.625492704979012426e-05 5.549200115179080394e-05 -1.041337417086176352e-02 6.247154905389117074e-05 6.156020751164136104e-05 -1.039780787463031632e-02 6.547958503552635885e-05 6.456075883738507804e-05 -1.565994983235329469e-13 5.511521614450132223e-01 3.514153061505900702e-10 -1.445874644155010612e-13 5.511521614178882533e-01 3.240710022816425346e-10 -1.221345460291461083e-13 5.511521613670001818e-01 2.732465642940652608e-10 -9.106807477578230137e-14 5.511521612961000072e-01 2.035478886973174761e-10 -5.854221146943116511e-14 5.511521612214901333e-01 1.309789626178793912e-10 -3.608395952683663110e-14 5.511521611698784184e-01 8.052675947415263402e-11 -1.812965839994103021e-14 5.511521611289341704e-01 3.953345450608363422e-11 8.641972401928370728e-16 5.511521610877220256e-01 -1.670163754622268873e-12 -2.930323228319251838e-15 5.511521610971072960e-01 7.725232611359872975e-12 -1.607330898074460132e-14 5.511521611276132271e-01 3.836112901045018906e-11 -4.066013476463407328e-14 5.511521611834386825e-01 9.448673684705775403e-11 -6.798721893569504855e-14 5.511521612443841533e-01 1.554821731314830691e-10 -8.938517545872516836e-14 5.511521612912677615e-01 2.021999186344617485e-10 -1.044938356628464866e-13 5.511521613239065420e-01 2.346552986159662022e-10 -1.145216992239209110e-13 5.511521613453926882e-01 2.560448763393084783e-10 -1.200824837885183682e-13 5.511521613573070466e-01 2.679320501182533849e-10 -1.547559797728247006e-13 3.514153061505900702e-10 5.511521614366896582e-01 -1.426455844147302953e-13 3.240710022816425346e-10 5.511521614091250409e-01 -1.202214657771812697e-13 2.732465642940652608e-10 5.511521613583710844e-01 -8.968196962893110274e-14 2.035478886973174761e-10 5.511521612898554467e-01 -5.804893599102793000e-14 1.309789626178793912e-10 5.511521612192729069e-01 -3.610115372243744080e-14 8.052675947415263402e-11 5.511521611699569112e-01 -1.812479990006975405e-14 3.953345450608363422e-11 5.511521611289127431e-01 8.651616072687769281e-16 -1.670163754622268873e-12 5.511521610877174737e-01 -2.933734948978268482e-15 7.725232611359872975e-12 5.511521610971235052e-01 -1.613216265680684739e-14 3.836112901045018906e-11 5.511521611278928923e-01 -4.085020221840889500e-14 9.448673684705775403e-11 5.511521611843198665e-01 -6.820130806256200272e-14 1.554821731314830691e-10 5.511521612453643693e-01 -8.952918233508994379e-14 2.021999186344617485e-10 5.511521612919174640e-01 -1.045567737187638661e-13 2.346552986159662022e-10 5.511521613241893158e-01 -1.145418778692298207e-13 2.560448763393084783e-10 5.511521613454818391e-01 -1.200903208322631125e-13 2.679320501182533849e-10 5.511521613573407974e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 deleted file mode 100644 index 05e88edb4..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_16 +++ /dev/null @@ -1 +0,0 @@ --1.093996894327028957e-02 9.590665261783557242e-05 9.531439136679123155e-05 -1.093798371348113363e-02 9.129668073365949292e-05 8.964512107109498952e-05 -1.093291708450144090e-02 8.160863447787096707e-05 7.822493440050987644e-05 -1.092280172032512528e-02 6.585541551313911285e-05 6.216889791782770228e-05 -1.090521103700463172e-02 4.310522445583447453e-05 4.237600179659636185e-05 -1.087779138668330120e-02 1.812953328951247332e-05 2.108092186059766575e-05 -1.083882393617841694e-02 7.344071357621467951e-06 6.594939876998668334e-06 -1.078794882596150612e-02 5.604808426909911188e-08 -3.993391057752020225e-09 -1.073112425349973496e-02 2.615170877530457867e-06 2.194626209277573773e-06 -1.067249864839077585e-02 1.108524983397865764e-05 1.120727781861049311e-05 -1.061466952011998546e-02 2.260531409404672900e-05 2.309346289448661061e-05 -1.056047651209296619e-02 3.529390393248425258e-05 3.537888811359434329e-05 -1.051279635240090667e-02 4.694183747941350557e-05 4.658032943101336358e-05 -1.047431193363406766e-02 5.625492704867847822e-05 5.549200115068154314e-05 -1.044728200483079593e-02 6.247154905267067080e-05 6.156020751042407305e-05 -1.043333897309760977e-02 6.547958503424720358e-05 6.456075883610939222e-05 -1.574632402930721154e-13 5.511521614448574580e-01 3.512597530592398224e-10 -1.453346594888014897e-13 5.511521614176891903e-01 3.238723038289457967e-10 -1.226770536697947916e-13 5.511521613667277331e-01 2.729748636726122584e-10 -9.136144378643062084e-14 5.511521612957482885e-01 2.031974805559949799e-10 -5.861009408318368903e-14 5.511521612210841248e-01 1.305745223877567651e-10 -3.601770734692193275e-14 5.511521611694730760e-01 8.012292564205275006e-11 -1.800059504849744793e-14 5.511521611286077649e-01 3.920872537155955352e-11 9.311956347085052676e-16 5.511521610875759203e-01 -1.815443932585212927e-12 -3.016574590202426825e-15 5.511521610972272001e-01 7.844347601860824800e-12 -1.636105551021592708e-14 5.511521611280230104e-01 3.876847851762972903e-11 -4.119395953763922588e-14 5.511521611841568857e-01 9.520097869670244871e-11 -6.875518695057700981e-14 5.511521612454096664e-01 1.565024465534335438e-10 -9.034611775594595515e-14 5.511521612925768254e-01 2.035029223539553034e-10 -1.056054808615142471e-13 5.511521613254525276e-01 2.361947794112405835e-10 -1.157422038798274557e-13 5.511521613471088710e-01 2.577543712084096916e-10 -1.213616358508509730e-13 5.511521613591119362e-01 2.697303557530767974e-10 -1.556086758553690465e-13 3.512597530592398224e-10 5.511521614365343380e-01 -1.433818463273497595e-13 3.238723038289457967e-10 5.511521614089267551e-01 -1.207537749967918717e-13 2.729748636726122584e-10 5.511521613581001899e-01 -8.996887190257600179e-14 2.031974805559949799e-10 5.511521612895062816e-01 -5.811524764372641469e-14 1.305745223877567651e-10 5.511521612188700070e-01 -3.603607492200160848e-14 8.012292564205275006e-11 5.511521611695545664e-01 -1.799627932804132932e-14 3.920872537155955352e-11 5.511521611285896682e-01 9.321344532406331142e-16 -1.815443932585212927e-12 5.511521610875729227e-01 -3.019317416577113988e-15 7.844347601860824800e-12 5.511521610972418550e-01 -1.641918148595236261e-14 3.876847851762972903e-11 5.511521611282977906e-01 -4.138318508166129408e-14 9.520097869670244871e-11 5.511521611850301872e-01 -6.896855778550946715e-14 1.565024465534335438e-10 5.511521612463794462e-01 -9.048769919848012265e-14 2.035029223539553034e-10 5.511521612932144265e-01 -1.056660332964738268e-13 2.361947794112405835e-10 5.511521613257223118e-01 -1.157591640188596347e-13 2.577543712084096916e-10 5.511521613471846992e-01 -1.213659999081631662e-13 2.697303557530767974e-10 5.511521613591324753e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 deleted file mode 100644 index 5406906a1..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_17 +++ /dev/null @@ -1 +0,0 @@ --1.093508910251102945e-02 9.590665261716866611e-05 9.531439136613314793e-05 -1.093247933806439261e-02 9.129668073308971757e-05 8.964512107053388779e-05 -1.092638129572676489e-02 8.160863447747030016e-05 7.822493440011736815e-05 -1.091522428994995582e-02 6.585541551294371251e-05 6.216889791763738414e-05 -1.089708627626557493e-02 4.310522445581945155e-05 4.237600179658266702e-05 -1.087013403536022174e-02 1.812953328960108991e-05 2.108092186068515747e-05 -1.083308726115018300e-02 7.344071357751916954e-06 6.594939877128449029e-06 -1.078592927811228286e-02 5.604808432769764526e-08 -3.993390999758369281e-09 -1.073398795316468819e-02 2.615170877450809665e-06 2.194626209197856962e-06 -1.068062643088632871e-02 1.108524983371998902e-05 1.120727781835272913e-05 -1.062818207112251404e-02 2.260531409357605651e-05 2.309346289401618884e-05 -1.057918561236426483e-02 3.529390393181195914e-05 3.537888811292351352e-05 -1.053618385971802351e-02 4.694183747857812779e-05 4.658032943018016099e-05 -1.050154115795129232e-02 5.625492704771601162e-05 5.549200114972159732e-05 -1.047724190053088249e-02 6.247154905161838483e-05 6.156020750937413167e-05 -1.046471736183681757e-02 6.547958503314480036e-05 6.456075883500967240e-05 -1.581301410339462850e-13 5.511521614446123207e-01 3.510151120579448960e-10 -1.459044407414612677e-13 5.511521614174125228e-01 3.235963408797620862e-10 -1.230777146630655725e-13 5.511521613663988850e-01 2.726471747034959343e-10 -9.155684311477451318e-14 5.511521612953665938e-01 2.028173988015552690e-10 -5.862511718603961738e-14 5.511521612206738974e-01 1.301660299744394184e-10 -3.592909200193865789e-14 5.511521611690826106e-01 7.973400727293638419e-11 -1.787014577152262566e-14 5.511521611283036748e-01 3.890622584144399467e-11 9.897941676970027226e-16 5.511521610874444699e-01 -1.946136993412545153e-12 -3.096222696638326402e-15 5.511521610973365570e-01 7.952950819270403055e-12 -1.661972451926460353e-14 5.511521611283929367e-01 3.913616900992654728e-11 -4.166463275544941627e-14 5.511521611848018143e-01 9.584228204242503477e-11 -6.942747908884494197e-14 5.511521612463271547e-01 1.574150498389597316e-10 -9.118149708619586303e-14 5.511521612937447800e-01 2.046651856363983143e-10 -1.065679469748961656e-13 5.511521613268294262e-01 2.375653192381056252e-10 -1.167944888381943224e-13 5.511521613486355387e-01 2.592744141282000205e-10 -1.224640393270257353e-13 5.511521613607166525e-01 2.713284308473332333e-10 -1.562667560549379425e-13 3.510151120579448960e-10 5.511521614362902000e-01 -1.439429423526016683e-13 3.235963408797620862e-10 5.511521614086514198e-01 -1.211462767595711009e-13 2.726471747034959343e-10 5.511521613577735623e-01 -9.015918935457735607e-14 2.028173988015552690e-10 5.511521612891278066e-01 -5.812894072851993968e-14 1.301660299744394184e-10 5.511521612184632213e-01 -3.594858381845933590e-14 7.973400727293638419e-11 5.511521611691672096e-01 -1.786649832639765230e-14 3.890622584144399467e-11 5.511521611282886868e-01 9.901281041454580666e-16 -1.946136993412545153e-12 5.511521610874429156e-01 -3.099034416258516527e-15 7.952950819270403055e-12 5.511521610973497687e-01 -1.667694555053302440e-14 3.913616900992654728e-11 5.511521611286632760e-01 -4.185360533535158087e-14 9.584228204242503477e-11 5.511521611856678993e-01 -6.963938509658389845e-14 1.574150498389597316e-10 5.511521612472872755e-01 -9.132089899758788256e-14 2.046651856363983143e-10 5.511521612943709458e-01 -1.066259802729709025e-13 2.375653192381056252e-10 5.511521613270865538e-01 -1.168091020571043729e-13 2.592744141282000205e-10 5.511521613486981552e-01 -1.224657237659422882e-13 2.713284308473332333e-10 5.511521613607239800e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 deleted file mode 100644 index 321c87df0..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_18 +++ /dev/null @@ -1 +0,0 @@ --1.092899488606968554e-02 9.590665261665742413e-05 9.531439136562904813e-05 -1.092594871567176273e-02 9.129668073265956036e-05 8.964512107011117091e-05 -1.091915454943928956e-02 8.160863447718088594e-05 7.822493439983431007e-05 -1.090736327784146489e-02 6.585541551282343383e-05 6.216889791752030386e-05 -1.088906086701060122e-02 4.310522445584519458e-05 4.237600179660785439e-05 -1.086283297460423174e-02 1.812953328970364866e-05 2.108092186078768573e-05 -1.082774879019794342e-02 7.344071357881081855e-06 6.594939877256822801e-06 -1.078407645118310137e-02 5.604808437937109535e-08 -3.993390948173530916e-09 -1.073654680775290582e-02 2.615170877376740868e-06 2.194626209124204059e-06 -1.068790483854981967e-02 1.108524983348633837e-05 1.120727781811934614e-05 -1.064025893791839712e-02 2.260531409315648382e-05 2.309346289359771051e-05 -1.059587124486814982e-02 3.529390393122075047e-05 3.537888811233384307e-05 -1.055700372467344855e-02 4.694183747784933387e-05 4.658032942945300014e-05 -1.052574690024242476e-02 5.625492704687932603e-05 5.549200114888789328e-05 -1.050384996561076062e-02 6.247154905070456503e-05 6.156020750846405236e-05 -1.049257204645416379e-02 6.547958503219064824e-05 6.456075883405846118e-05 -1.586413895204933683e-13 5.511521614443035677e-01 3.507070751720880194e-10 -1.463345943566971901e-13 5.511521614170815653e-01 3.232663256556837670e-10 -1.233671232630855184e-13 5.511521613660325114e-01 2.722821684096517634e-10 -9.167712838022516919e-14 5.511521612949679128e-01 2.024205106944196051e-10 -5.859937099342327660e-14 5.511521612202664455e-01 1.297603555757924670e-10 -3.582653422004574726e-14 5.511521611687089095e-01 7.936183816902555553e-11 -1.774098120873289097e-14 5.511521611280206789e-01 3.862470871344679563e-11 1.041467617493438428e-15 5.511521610873258981e-01 -2.064046929005242571e-12 -3.170291570425776040e-15 5.511521610974364771e-01 8.052193402209305901e-12 -1.685337540677426431e-14 5.511521611287278910e-01 3.946903428539928835e-11 -4.208420591229167633e-14 5.511521611853829050e-01 9.642001244381040199e-11 -7.001868978994256961e-14 5.511521612471508291e-01 1.582342806631896729e-10 -9.191029146336774596e-14 5.511521612947908322e-01 2.057058171695312242e-10 -1.074046340336586380e-13 5.511521613280603304e-01 2.387901837358993893e-10 -1.177083140832525918e-13 5.511521613499987815e-01 2.606313135688219000e-10 -1.234181972025838308e-13 5.511521613621488402e-01 2.727541868244603656e-10 -1.567708535032725721e-13 3.507070751720880194e-10 5.511521614359828902e-01 -1.443656598689460644e-13 3.232663256556837670e-10 5.511521614083223497e-01 -1.214293291096900178e-13 2.722821684096517634e-10 5.511521613574099643e-01 -9.027627450686161936e-14 2.024205106944196051e-10 5.511521612887326782e-01 -5.810375510398947371e-14 1.297603555757924670e-10 5.511521612180593221e-01 -3.584605691667147705e-14 7.936183816902555553e-11 5.511521611687966171e-01 -1.773812435052166780e-14 3.862470871344679563e-11 5.511521611280086885e-01 1.041712942658686060e-15 -2.064046929005242571e-12 5.511521610873256760e-01 -3.172687456888010340e-15 8.052193402209305901e-12 5.511521610974483565e-01 -1.691032847941060561e-14 3.946903428539928835e-11 5.511521611289941225e-01 -4.227208304622542819e-14 9.642001244381040199e-11 5.511521611862423287e-01 -7.022905242130190874e-14 1.582342806631896729e-10 5.511521612481020682e-01 -9.204806000290850362e-14 2.057058171695312242e-10 5.511521612954062288e-01 -1.074596871329026941e-13 2.387901837358993893e-10 5.511521613283054677e-01 -1.177191784874346151e-13 2.606313135688219000e-10 5.511521613500487415e-01 -1.234169348892719956e-13 2.727541868244603656e-10 5.511521613621432891e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 deleted file mode 100644 index c2acb1896..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_19 +++ /dev/null @@ -1 +0,0 @@ --1.092208452489277191e-02 9.590665261626951015e-05 9.531439136524725989e-05 -1.091874793154559188e-02 9.129668073233969362e-05 8.964512106979764675e-05 -1.091151665324902736e-02 8.160863447697899395e-05 7.822493439963745961e-05 -1.089940280383444766e-02 6.585541551275961498e-05 6.216889791746015774e-05 -1.088122284423898717e-02 4.310522445589814430e-05 4.237600179666205772e-05 -1.085589990721899135e-02 1.812953328981642602e-05 2.108092186089949069e-05 -1.082278154853561977e-02 7.344071358007541333e-06 6.594939877382418305e-06 -1.078237351692204644e-02 5.604808442444457721e-08 -3.993390903411653784e-09 -1.073884183380559125e-02 2.615170877307631450e-06 2.194626209055292846e-06 -1.069444706624502785e-02 1.108524983327591845e-05 1.120727781790913120e-05 -1.065109506422311225e-02 2.260531409278287453e-05 2.309346289322453152e-05 -1.061081314972881634e-02 3.529390393069933732e-05 3.537888811181336504e-05 -1.057561603786664681e-02 4.694183747720972913e-05 4.658032942881586873e-05 -1.054735762032614661e-02 5.625492704614870252e-05 5.549200114815975665e-05 -1.052758440458246778e-02 6.247154904990999391e-05 6.156020750767154123e-05 -1.051740741675309503e-02 6.547958503136029845e-05 6.456075883323137755e-05 -1.590293083370207186e-13 5.511521614439508499e-01 3.503553758089887313e-10 -1.466544662889621501e-13 5.511521614167140815e-01 3.229000293736930863e-10 -1.235690118580501965e-13 5.511521613656427121e-01 2.718940323655569414e-10 -9.174095049009480828e-14 5.511521612945619042e-01 2.020164441362571517e-10 -5.854641852381591106e-14 5.511521612198666542e-01 1.293624474027657984e-10 -3.571375623726932231e-14 5.511521611683529720e-01 7.900748163880835522e-11 -1.761452151954441413e-14 5.511521611277574451e-01 3.836293144941190813e-11 1.086541097637579808e-15 5.511521610872186505e-01 -2.170687801565946457e-12 -3.239401042850968507e-15 5.511521610975279595e-01 8.143047496732594871e-12 -1.706379557486487850e-14 5.511521611290318701e-01 3.977111158880362318e-11 -4.245781667146521124e-14 5.511521611859079295e-01 9.694193788607531993e-11 -7.054010273688953926e-14 5.511521612478926802e-01 1.589719453329112191e-10 -9.254989423194003855e-14 5.511521612957306360e-01 2.066405527057509433e-10 -1.081352571355171867e-13 5.511521613291643362e-01 2.398885013594232810e-10 -1.185028795097548920e-13 5.511521613512202489e-01 2.618466817760135166e-10 -1.242485410565685764e-13 5.511521613634313699e-01 2.740305449425874428e-10 -1.571526356979987230e-13 3.503553758089887313e-10 5.511521614356321708e-01 -1.446791836720431990e-13 3.229000293736930863e-10 5.511521614079573084e-01 -1.216261773340478412e-13 2.718940323655569414e-10 5.511521613570234956e-01 -9.033642406360229231e-14 2.020164441362571517e-10 5.511521612883305554e-01 -5.804955354079776331e-14 1.293624474027657984e-10 5.511521612176633056e-01 -3.573425220555343642e-14 7.900748163880835522e-11 5.511521611684437882e-01 -1.761252856638167895e-14 3.836293144941190813e-11 5.511521611277483412e-01 1.086474819963315997e-15 -2.170687801565946457e-12 5.511521610872196497e-01 -3.241598734580086469e-15 8.143047496732594871e-12 5.511521610975386176e-01 -1.712054355485748564e-14 3.977111158880362318e-11 5.511521611292943268e-01 -4.264526088837127962e-14 9.694193788607531993e-11 5.511521611867612469e-01 -7.074952798810357173e-14 1.589719453329112191e-10 5.511521612488355926e-01 -9.268519396091591930e-14 2.066405527057509433e-10 5.511521612963359296e-01 -1.081878226012312525e-13 2.398885013594232810e-10 5.511521613293981492e-01 -1.185116961598046800e-13 2.618466817760135166e-10 5.511521613512581075e-01 -1.242440193711708430e-13 2.740305449425874428e-10 5.511521613634134953e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 deleted file mode 100644 index 618ed8966..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ --8.211277439097993541e-03 9.590665282295331487e-05 9.531439156956755809e-05 -8.438399618710804018e-03 9.129668091828660036e-05 8.964512125330587110e-05 -8.855057842807533344e-03 8.160863462622363783e-05 7.822493454657866176e-05 -9.403856018757907054e-03 6.585541561619724562e-05 6.216889801932867679e-05 -1.000813382349499160e-02 4.310522451702817329e-05 4.237600185727366867e-05 -1.057171288556930759e-02 1.812953332439839262e-05 2.108092189550233157e-05 -1.090539116140276307e-02 7.344071373629329322e-06 6.594939893003735344e-06 -1.088163610573746401e-02 5.604808315100294248e-08 -3.993392176048664292e-09 -1.053200695647494266e-02 2.615170880120984469e-06 2.194626211868411660e-06 -1.006519486388061414e-02 1.108524984793031519e-05 1.120727783260670290e-05 -9.525374228500284313e-03 2.260531412878916092e-05 2.309346292938895218e-05 -8.933703740708625815e-03 3.529390399165743217e-05 3.537888817296283513e-05 -8.287183521648741613e-03 4.694183755970978951e-05 4.658032951145211169e-05 -7.682671601552028967e-03 5.625492714532271489e-05 5.549200124739548046e-05 -7.219726302428351554e-03 6.247154916083513831e-05 6.156020761861460207e-05 -6.970854563418589847e-03 6.547958514888369398e-05 6.456075895075787661e-05 4.765452386086405555e-14 5.511521613927503616e-01 3.002531606587599567e-10 3.929244488274652717e-14 5.511521613686460874e-01 2.759603502362768052e-10 2.567560239902810493e-14 5.511521613242370554e-01 2.315472556548936152e-10 1.169670586493828175e-14 5.511521612637271250e-01 1.718742385918807902e-10 2.583599464164925762e-15 5.511521612025853667e-01 1.122448983017548171e-10 -1.131790842415280720e-15 5.511521611645697760e-01 7.514880224019233791e-11 -1.992733965811594709e-15 5.511521611327452330e-01 4.332179357443122707e-11 -1.869005339928035399e-16 5.511521610927939685e-01 3.389650496447597014e-12 -4.260471117443892053e-16 5.511521610926103376e-01 3.239339324367628320e-12 -2.409394859443054934e-15 5.511521611100669293e-01 2.079268826405982407e-11 -6.451520656871410231e-15 5.511521611503297224e-01 6.121625195303666981e-11 -9.582017489585119025e-15 5.511521611944709687e-01 1.052785096893976639e-10 -1.004984381250041783e-14 5.511521612239963508e-01 1.345921832624437780e-10 -8.961236649085139330e-15 5.511521612413378124e-01 1.517914022944668065e-10 -7.577720480204281361e-15 5.511521612517199520e-01 1.621349387390427418e-10 -6.725157862666915667e-15 5.511521612579017848e-01 1.683205557756817021e-10 4.716764765942923074e-14 3.002531606587599567e-10 5.511521613865835167e-01 3.882903232998273277e-14 2.759603502362768052e-10 5.511521613620968818e-01 2.531503697522069588e-14 2.315472556548936152e-10 5.511521613176864065e-01 1.153211014980404332e-14 1.718742385918807902e-10 5.511521612588532459e-01 2.562063094898254987e-15 1.122448983017548171e-10 5.511521612007055371e-01 -1.131414887003981900e-15 7.514880224019233791e-11 5.511521611645090468e-01 -1.991212321060647787e-15 4.332179357443122707e-11 5.511521611326782866e-01 -1.861621907249851139e-16 3.389650496447597014e-12 5.511521610927654358e-01 -4.284795241110781036e-16 3.239339324367628320e-12 5.511521610926485293e-01 -2.422969169215416454e-15 2.079268826405982407e-11 5.511521611103011864e-01 -6.480853552892015097e-15 6.121625195303666981e-11 5.511521611508848340e-01 -9.600058394959141279e-15 1.052785096893976639e-10 5.511521611948665411e-01 -1.004893865717874053e-14 1.345921832624437780e-10 5.511521612239704826e-01 -8.952093699533600988e-15 1.517914022944668065e-10 5.511521612410286153e-01 -7.568624405559267973e-15 1.621349387390427418e-10 5.511521612513328172e-01 -6.717527394217957806e-15 1.683205557756817021e-10 5.511521612575215334e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 deleted file mode 100644 index ba259becd..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_20 +++ /dev/null @@ -1 +0,0 @@ --1.091465837705730274e-02 9.590665261598004172e-05 9.531439136496328024e-05 -1.091114469345994334e-02 9.129668073210763369e-05 8.964512106957016758e-05 -1.090367630122524543e-02 8.160863447684476972e-05 7.822493439950772127e-05 -1.089147772922693935e-02 6.585541551274110223e-05 6.216889791744244459e-05 -1.087363331644119503e-02 4.310522445597332695e-05 4.237600179673645432e-05 -1.084933804428116037e-02 1.812953328993438382e-05 2.108092186101693689e-05 -1.081816070345330283e-02 7.344071358128755136e-06 6.594939877503374610e-06 -1.078080618336883442e-02 5.604808446448615397e-08 -3.993390863954471857e-09 -1.074090677973905256e-02 2.615170877243267958e-06 2.194626208991426985e-06 -1.070034614258284084e-02 1.108524983308378597e-05 1.120727781771794908e-05 -1.066085016644074610e-02 2.260531409244863533e-05 2.309346289289131214e-05 -1.062423992047939122e-02 3.529390393023800252e-05 3.537888811135258589e-05 -1.059231447760891447e-02 4.694183747664736024e-05 4.658032942825480089e-05 -1.056672227758857080e-02 5.625492704550891481e-05 5.549200114752226611e-05 -1.054883435449781304e-02 6.247154904921548111e-05 6.156020750697956275e-05 -1.053963374648837770e-02 6.547958503063695942e-05 6.456075883251001719e-05 -1.593187709731387152e-13 5.511521614435694882e-01 3.499752298149528361e-10 -1.468865213666251956e-13 5.511521614163237270e-01 3.225111050073071756e-10 -1.237032296979054811e-13 5.511521613652404783e-01 2.714935726957507427e-10 -9.175946094412912923e-14 5.511521612941557846e-01 2.016123991888795691e-10 -5.847123290505383858e-14 5.511521612194781872e-01 1.289758306988389007e-10 -3.559579904556660651e-14 5.511521611680153532e-01 7.867145086293159933e-11 -1.749330745845902405e-14 5.511521611275128629e-01 3.811968179938965423e-11 1.126582675133258297e-15 5.511521610871215060e-01 -2.267342343071216973e-12 -3.303764568436111488e-15 5.511521610976117813e-01 8.226344035537594949e-12 -1.725592848134330215e-14 5.511521611293083156e-01 4.004581174087296100e-11 -4.279205682680005554e-14 5.511521611863833270e-01 9.741457542663256704e-11 -7.100143617080369048e-14 5.511521612485624777e-01 1.596379044718764597e-10 -9.311226248432510667e-14 5.511521612965772920e-01 2.074824973638871986e-10 -1.087750463198623345e-13 5.511521613301573197e-01 2.408761755756689754e-10 -1.191973984415588847e-13 5.511521613523178154e-01 2.629384705986432054e-10 -1.249718849068816009e-13 5.511521613645832263e-01 2.751765368344882270e-10 -1.574366111469788414e-13 3.499752298149528361e-10 5.511521614352532517e-01 -1.449066572550042230e-13 3.225111050073071756e-10 5.511521614075698405e-01 -1.217559222375649873e-13 2.714935726957507427e-10 5.511521613566248146e-01 -9.035414360110787616e-14 2.016123991888795691e-10 5.511521612879285437e-01 -5.797515825819150824e-14 1.289758306988389007e-10 5.511521612172786133e-01 -3.561680519677833456e-14 7.867145086293159933e-11 5.511521611681092780e-01 -1.749157227634237457e-14 3.811968179938965423e-11 5.511521611275064236e-01 1.125932001663184211e-15 -2.267342343071216973e-12 5.511521610871235044e-01 -3.305464384538687823e-15 8.226344035537594949e-12 5.511521610976213292e-01 -1.731172515275667864e-14 4.004581174087296100e-11 5.511521611295673306e-01 -4.297848052239123865e-14 9.741457542663256704e-11 5.511521611872310933e-01 -7.121030641307617287e-14 1.596379044718764597e-10 5.511521612494977296e-01 -9.324626171177993486e-14 2.074824973638871986e-10 5.511521612971732598e-01 -1.088253160778243841e-13 2.408761755756689754e-10 5.511521613303804745e-01 -1.192036735502724118e-13 2.629384705986432054e-10 5.511521613523442387e-01 -1.249653740670898396e-13 2.751765368344882270e-10 5.511521613645535833e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 deleted file mode 100644 index 4bb804de3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_21 +++ /dev/null @@ -1 +0,0 @@ --1.090694396647134794e-02 9.590665261576947610e-05 9.531439136475589947e-05 -1.090334100230360044e-02 9.129668073194477298e-05 8.964512106941127775e-05 -1.089578943179757634e-02 8.160863447676417284e-05 7.822493439943022792e-05 -1.088368653771538616e-02 6.585541551275451923e-05 6.216889791745839591e-05 -1.086633371815436816e-02 4.310522445606170975e-05 4.237600179682514206e-05 -1.084314465752767541e-02 1.812953329005470994e-05 2.108092186113626689e-05 -1.081386331081378091e-02 7.344071358246027695e-06 6.594939877619742538e-06 -1.077936214047001996e-02 5.604808449944646610e-08 -3.993390829314275312e-09 -1.074276975117526706e-02 2.615170877183948970e-06 2.194626208931952567e-06 -1.070567949664820266e-02 1.108524983291024586e-05 1.120727781754460718e-05 -1.066965678090943392e-02 2.260531409214927017e-05 2.309346289259219093e-05 -1.063634075842166161e-02 3.529390392982696115e-05 3.537888811094339444e-05 -1.060734163497350710e-02 4.694183747615062624e-05 4.658032942776004555e-05 -1.058412872525643471e-02 5.625492704494643073e-05 5.549200114696179457e-05 -1.056792052595085206e-02 6.247154904860643054e-05 6.156020750637362926e-05 -1.055958902078880240e-02 6.547958503000318904e-05 6.456075883187886244e-05 -1.595293332571126048e-13 5.511521614431711402e-01 3.495783869235534952e-10 -1.470493804314415849e-13 5.511521614159210491e-01 3.221100510025750101e-10 -1.237838225037912216e-13 5.511521613648339146e-01 2.710890145671483258e-10 -9.174603744193211030e-14 5.511521612937549941e-01 2.012137346977776079e-10 -5.838285180612791938e-14 5.511521612191034869e-01 1.286029654322602117e-10 -3.547547319519967252e-14 5.511521611676962751e-01 7.835386358611322763e-11 -1.737603451235520738e-14 5.511521611272857113e-01 3.789379195162308765e-11 1.161542984678529312e-15 5.511521610870332433e-01 -2.355106552121157336e-12 -3.363083553733534267e-15 5.511521610976887198e-01 8.302801195030240324e-12 -1.742946852426526271e-14 5.511521611295601142e-01 4.029604652186085336e-11 -4.309142177511592437e-14 5.511521611868147597e-01 9.784344960502202922e-11 -7.141248022613435309e-14 5.511521612491685485e-01 1.602404789063223442e-10 -9.360899761827169292e-14 5.511521612973417916e-01 2.082426772838445817e-10 -1.093375331022366260e-13 5.511521613310527146e-01 2.417665627165940627e-10 -1.198064501334756104e-13 5.511521613533064690e-01 2.639217413959564651e-10 -1.256056577783842014e-13 5.511521613656203966e-01 2.762081226781971223e-10 -1.576439859436390559e-13 3.495783869235534952e-10 5.511521614348579012e-01 -1.450655435360464672e-13 3.221100510025750101e-10 5.511521614071703823e-01 -1.218334192051513119e-13 2.710890145671483258e-10 5.511521613562222477e-01 -9.033818728371969499e-14 2.012137346977776079e-10 5.511521612875319720e-01 -5.788647255888008022e-14 1.286029654322602117e-10 5.511521612169075768e-01 -3.549747555255481313e-14 7.835386358611322763e-11 5.511521611677931975e-01 -1.737520473382959265e-14 3.789379195162308765e-11 5.511521611272818255e-01 1.160572197983006360e-15 -2.355106552121157336e-12 5.511521610870362409e-01 -3.364938699855408939e-15 8.302801195030240324e-12 5.511521610976972685e-01 -1.748506760976125242e-14 4.029604652186085336e-11 5.511521611298160206e-01 -4.327760191697586292e-14 9.784344960502202922e-11 5.511521611876574189e-01 -7.161949589129716762e-14 1.602404789063223442e-10 5.511521612500968059e-01 -9.374101615442475394e-14 2.082426772838445817e-10 5.511521612979290996e-01 -1.093857846244196846e-13 2.417665627165940627e-10 5.511521613312658774e-01 -1.198096099198538307e-13 2.639217413959564651e-10 5.511521613533221231e-01 -1.255965224556769041e-13 2.762081226781971223e-10 5.511521613655796514e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 deleted file mode 100644 index 642158506..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_22 +++ /dev/null @@ -1 +0,0 @@ --1.089911382755496920e-02 9.590665261562092685e-05 9.531439136461079256e-05 -1.089548929907907873e-02 9.129668073183740986e-05 8.964512106930657093e-05 -1.088797228414149602e-02 8.160863447672485696e-05 7.822493439939345991e-05 -1.087610047020595889e-02 6.585541551279350985e-05 6.216889791749824034e-05 -1.085935092053966211e-02 4.310522445616033149e-05 4.237600179692367571e-05 -1.083731283866002162e-02 1.812953329017500894e-05 2.108092186125616610e-05 -1.080986808894644075e-02 7.344071358356961906e-06 6.594939877730220198e-06 -1.077803065163608284e-02 5.604808453103967669e-08 -3.993390798336525154e-09 -1.074445440784762597e-02 2.615170877127984232e-06 2.194626208876565930e-06 -1.071051230696700753e-02 1.108524983275181342e-05 1.120727781738658980e-05 -1.067762615183764918e-02 2.260531409187991708e-05 2.309346289232385089e-05 -1.064727405968715970e-02 3.529390392946149692e-05 3.537888811057886534e-05 -1.062090019806325933e-02 4.694183747571083995e-05 4.658032942732211597e-05 -1.059981712585020622e-02 5.625492704445059797e-05 5.549200114646809633e-05 -1.058511025136823006e-02 6.247154904807147163e-05 6.156020750584010692e-05 -1.057755484659019668e-02 6.547958502944658675e-05 6.456075883132510618e-05 -1.596778867378964988e-13 5.511521614427650206e-01 3.491739100820903245e-10 -1.471567395691660095e-13 5.511521614155141524e-01 3.217049246109934022e-10 -1.238231340585956290e-13 5.511521613644294604e-01 2.706865930529394709e-10 -9.170704970278866032e-14 5.511521612933635295e-01 2.008243993013213960e-10 -5.828422709324625708e-14 5.511521612187441077e-01 1.282455069544284689e-10 -3.535517391193455816e-14 5.511521611673955157e-01 7.805455247611171445e-11 -1.726510024463133651e-14 5.511521611270748799e-01 3.768414569367295191e-11 1.193136196141934923e-15 5.511521610869529741e-01 -2.434924274836761008e-12 -3.419048356756951908e-15 5.511521610977594410e-01 8.373045872497134627e-12 -1.758790053141162398e-14 5.511521611297898193e-01 4.052432498398489961e-11 -4.336077491619758654e-14 5.511521611872068904e-01 9.823328737775621897e-11 -7.177794567261399191e-14 5.511521612497179978e-01 1.607867553908566322e-10 -9.404878294440451537e-14 5.511521612980335716e-01 2.089304549118663940e-10 -1.098333639254543335e-13 5.511521613318617341e-01 2.425709822710860412e-10 -1.203414035905658621e-13 5.511521613541989773e-01 2.648092447680089625e-10 -1.261622594750147202e-13 5.511521613665563146e-01 2.771388074005144695e-10 -1.577890912404110487e-13 3.491739100820903245e-10 5.511521614344550013e-01 -1.451702441801589508e-13 3.217049246109934022e-10 5.511521614067670383e-01 -1.218701907137172398e-13 2.706865930529394709e-10 5.511521613558219013e-01 -9.029834599137222081e-14 2.008243993013213960e-10 5.511521612871447262e-01 -5.778794171061784111e-14 1.282455069544284689e-10 5.511521612165519723e-01 -3.537757708046730602e-14 7.805455247611171445e-11 5.511521611674953247e-01 -1.726472736765123576e-14 3.768414569367295191e-11 5.511521611270733256e-01 1.191549948121451620e-15 -2.434924274836761008e-12 5.511521610869568599e-01 -3.420325523887346523e-15 8.373045872497134627e-12 5.511521610977671015e-01 -1.764308492628224630e-14 4.052432498398489961e-11 5.511521611300429502e-01 -4.354594106056779363e-14 9.823328737775621897e-11 5.511521611880448868e-01 -7.198402726276831845e-14 1.607867553908566322e-10 5.511521612506399270e-01 -9.417894609903620722e-14 2.089304549118663940e-10 5.511521612986128860e-01 -1.098794808588550188e-13 2.425709822710860412e-10 5.511521613320656821e-01 -1.203431340753243004e-13 2.648092447680089625e-10 5.511521613542046394e-01 -1.261502852121336241e-13 2.771388074005144695e-10 5.511521613665051333e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 deleted file mode 100644 index 472131dd0..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_23 +++ /dev/null @@ -1 +0,0 @@ --1.089129847077502031e-02 9.590665261552200696e-05 9.531439136451417659e-05 -1.088770419037663091e-02 9.129668073177208667e-05 8.964512106924455456e-05 -1.088031086752268457e-02 8.160863447671767412e-05 7.822493439938866232e-05 -1.086877013348016424e-02 6.585541551285110809e-05 6.216889791755677371e-05 -1.085270090815242637e-02 4.310522445626542457e-05 4.237600179702786076e-05 -1.083183274034231307e-02 1.812953329029363421e-05 2.108092186137376477e-05 -1.080615522656194413e-02 7.344071358462711428e-06 6.594939877835198920e-06 -1.077680224992991383e-02 5.604808455852632596e-08 -3.993390770107827043e-09 -1.074598085954941822e-02 2.615170877077020378e-06 2.194626208824983317e-06 -1.071489999792239398e-02 1.108524983260771618e-05 1.120727781724359031e-05 -1.068485261036486618e-02 2.260531409163720148e-05 2.309346289208172822e-05 -1.065717379279769624e-02 3.529390392913532825e-05 3.537888811025357080e-05 -1.063316125102804245e-02 4.694183747532132677e-05 4.658032942693352436e-05 -1.061398990014171886e-02 5.625492704401263450e-05 5.549200114603182693e-05 -1.060062864101904596e-02 6.247154904759970816e-05 6.156020750537106751e-05 -1.059376824597261894e-02 6.547958502895743539e-05 6.456075883083775731e-05 -1.597768082206550186e-13 5.511521614423581239e-01 3.487687617371800307e-10 -1.472220690170250093e-13 5.511521614151092541e-01 3.213018778541096672e-10 -1.238303151459541243e-13 5.511521613640317785e-01 2.702909959609022075e-10 -9.164945468353396733e-14 5.511521612929842773e-01 2.004472530926121760e-10 -5.817913701217672628e-14 5.511521612184012708e-01 1.279044990565438032e-10 -3.523654846895618054e-14 5.511521611671127419e-01 7.777314523369157012e-11 -1.715935064986031298e-14 5.511521611268793697e-01 3.748968158711814988e-11 1.220622842833967009e-15 5.511521610868799215e-01 -2.507614126969960531e-12 -3.470012372763114815e-15 5.511521610978243890e-01 8.437630145859517506e-12 -1.773199786269858646e-14 5.511521611299996515e-01 4.073282729592975912e-11 -4.360348901051600323e-14 5.511521611875639381e-01 9.858816718066526787e-11 -7.210411272547982662e-14 5.511521612502170431e-01 1.612828200405163505e-10 -9.443829293598577788e-14 5.511521612986606256e-01 2.095538458985146064e-10 -1.102713296429658270e-13 5.511521613325941482e-01 2.432991062598451573e-10 -1.208131643144799962e-13 5.511521613550062204e-01 2.656118629907576756e-10 -1.266514121451997009e-13 5.511521613674024156e-01 2.779801110222163381e-10 -1.578857038529343025e-13 3.487687617371800307e-10 5.511521614340515463e-01 -1.452322659125568882e-13 3.213018778541096672e-10 5.511521614063659147e-01 -1.218749926165763842e-13 2.702909959609022075e-10 5.511521613554284382e-01 -9.023981392233637666e-14 2.004472530926121760e-10 5.511521612867696929e-01 -5.768375529989318433e-14 1.279044990565438032e-10 5.511521612162127992e-01 -3.525997828088457518e-14 7.777314523369157012e-11 5.511521611672153265e-01 -1.715974905857602145e-14 3.748968158711814988e-11 5.511521611268799248e-01 1.219778645975572961e-15 -2.507614126969960531e-12 5.511521610868845844e-01 -3.471908165255758154e-15 8.437630145859517506e-12 5.511521610978312724e-01 -1.778608473755637754e-14 4.073282729592975912e-11 5.511521611302501178e-01 -4.378806348896060514e-14 9.858816718066526787e-11 5.511521611883976046e-01 -7.230932437837906926e-14 1.612828200405163505e-10 5.511521612511330881e-01 -9.456753947432597205e-14 2.095538458985146064e-10 5.511521612992326125e-01 -1.103157520908714609e-13 2.432991062598451573e-10 5.511521613327895475e-01 -1.208121695530087603e-13 2.656118629907576756e-10 5.511521613550026677e-01 -1.266376328687885959e-13 2.779801110222163381e-10 5.511521613673416864e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 deleted file mode 100644 index cb845a82e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_24 +++ /dev/null @@ -1 +0,0 @@ --1.088359596945801498e-02 9.590665261546260623e-05 9.531439136445689006e-05 -1.088007111442532669e-02 9.129668073174197296e-05 8.964512106921571479e-05 -1.087286795229581646e-02 8.160863447673628174e-05 7.822493439940820506e-05 -1.086173036871837527e-02 6.585541551292163544e-05 6.216889791762803289e-05 -1.084639147450843985e-02 4.310522445637324847e-05 4.237600179713535263e-05 -1.082669247026305653e-02 1.812953329040922711e-05 2.108092186148900190e-05 -1.080270634412457478e-02 7.344071358562131073e-06 6.594939877934507604e-06 -1.077566850783796826e-02 5.604808458286691619e-08 -3.993390745610132049e-09 -1.074736634580151715e-02 2.615170877028171564e-06 2.194626208776974337e-06 -1.071889012750033322e-02 1.108524983247645826e-05 1.120727781711190379e-05 -1.069141687960097932e-02 2.260531409141888382e-05 2.309346289186338006e-05 -1.066615430635944016e-02 3.529390392884277662e-05 3.537888810996215081e-05 -1.064427052526302660e-02 4.694183747497367734e-05 4.658032942658780616e-05 -1.062681921752767385e-02 5.625492704362471374e-05 5.549200114564572899e-05 -1.061466697986412043e-02 6.247154904718285953e-05 6.156020750495665834e-05 -1.060843053153304183e-02 6.547958502852590937e-05 6.456075883040800667e-05 -1.598362111128415268e-13 5.511521614419557791e-01 3.483682509023912012e-10 -1.472521830543058619e-13 5.511521614147110171e-01 3.209055657590038942e-10 -1.238117046234272068e-13 5.511521613636443107e-01 2.699057003231726162e-10 -9.157892234499176142e-14 5.511521612926192359e-01 2.000843110637638212e-10 -5.807131643655671224e-14 5.511521612180755314e-01 1.275805190207767441e-10 -3.512095662045778631e-14 5.511521611668473986e-01 7.750912359488742653e-11 -1.705993109641728575e-14 5.511521611266980702e-01 3.730940010289248682e-11 1.244963431382222942e-15 5.511521610868133081e-01 -2.573890758000038197e-12 -3.518861168504728292e-15 5.511521610978842300e-01 8.497043970743268977e-12 -1.786325661457314155e-14 5.511521611301914980e-01 4.092346197431666331e-11 -4.382180530946230105e-14 5.511521611878893445e-01 9.891163425574290406e-11 -7.239666259659924038e-14 5.511521612506709022e-01 1.617339387187474757e-10 -9.478594467941361490e-14 5.511521612992299479e-01 2.101197638522745511e-10 -1.106592478485263890e-13 5.511521613332582836e-01 2.439592599565981591e-10 -1.212300167508121637e-13 5.511521613557376353e-01 2.663389517744265001e-10 -1.270829352752311542e-13 5.511521613681686915e-01 2.787419320295152670e-10 -1.579429922893568791e-13 3.483682509023912012e-10 5.511521614336528652e-01 -1.452611105002808879e-13 3.209055657590038942e-10 5.511521614059715635e-01 -1.218554468794581317e-13 2.699057003231726162e-10 5.511521613550453003e-01 -9.016854868365703144e-14 2.000843110637638212e-10 5.511521612864088704e-01 -5.757626409964413515e-14 1.275805190207767441e-10 5.511521612158906125e-01 -3.514474104493318962e-14 7.750912359488742653e-11 5.511521611669526477e-01 -1.706044016740553111e-14 3.730940010289248682e-11 5.511521611267006238e-01 1.244276341031489123e-15 -2.573890758000038197e-12 5.511521610868186372e-01 -3.519917038622227561e-15 8.497043970743268977e-12 5.511521610978903363e-01 -1.791777184236935766e-14 4.092346197431666331e-11 5.511521611304396329e-01 -4.400641313288273809e-14 9.891163425574290406e-11 5.511521611887191252e-01 -7.260074401006987229e-14 1.617339387187474757e-10 5.511521612515815072e-01 -9.491325877231459501e-14 2.101197638522745511e-10 5.511521612997951625e-01 -1.107018491762551031e-13 2.439592599565981591e-10 5.511521613334458003e-01 -1.212265787494048364e-13 2.663389517744265001e-10 5.511521613557255339e-01 -1.270673886741022407e-13 2.787419320295152670e-10 5.511521613680990805e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 deleted file mode 100644 index 5b64a6fcb..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_25 +++ /dev/null @@ -1 +0,0 @@ --1.087607916180600813e-02 9.590665261543380711e-05 9.531439136443027290e-05 -1.087265284872133281e-02 9.129668073173802917e-05 8.964512106921328888e-05 -1.086568831494738076e-02 8.160863447677215528e-05 7.822493439944567780e-05 -1.085500389740945079e-02 6.585541551300228653e-05 6.216889791770852135e-05 -1.084042423235363241e-02 4.310522445648207527e-05 4.237600179724391515e-05 -1.082187874784066965e-02 1.812953329052152673e-05 2.108092186160029865e-05 -1.079951260180682208e-02 7.344071358655534243e-06 6.594939878027340721e-06 -1.077462186246241210e-02 5.604808460569273359e-08 -3.993390724168217599e-09 -1.074862575974497129e-02 2.615170876983727322e-06 2.194626208732267091e-06 -1.072252383431652675e-02 1.108524983235652517e-05 1.120727781699252296e-05 -1.069738860351442632e-02 2.260531409122106097e-05 2.309346289166632971e-05 -1.067431400340333736e-02 3.529390392858098246e-05 3.537888810970134598e-05 -1.065435317383742024e-02 4.694183747466457808e-05 4.658032942627974367e-05 -1.063845271429178854e-02 5.625492704327957831e-05 5.549200114530247058e-05 -1.062738913623222786e-02 6.247154904681405461e-05 6.156020750458880209e-05 -1.062171407948998315e-02 6.547958502814314535e-05 6.456075883002821065e-05 -1.598650116186008921e-13 5.511521614415620940e-01 3.479763783045806579e-10 -1.472561218600414842e-13 5.511521614143228831e-01 3.205194611786318901e-10 -1.237758273390874339e-13 5.511521613632697214e-01 2.695332313143491664e-10 -9.149827067997238706e-14 5.511521612922697377e-01 1.997369297187146203e-10 -5.796249229963672882e-14 5.511521612177671114e-01 1.272737880266123708e-10 -3.500865582273936638e-14 5.511521611665989306e-01 7.726186736093883708e-11 -1.696652780215058591e-14 5.511521611265305376e-01 3.714279282795668553e-11 1.267789250053043179e-15 5.511521610867524679e-01 -2.634381688389226120e-12 -3.563305419684334103e-15 5.511521610979392971e-01 8.551725145455025005e-12 -1.798318949667704289e-14 5.511521611303670243e-01 4.109791076270627267e-11 -4.401962843450515035e-14 5.511521611881863292e-01 9.920679092386066264e-11 -7.265846005223852310e-14 5.511521612510841273e-01 1.621446980613230149e-10 -9.509504324652362346e-14 5.511521612997475339e-01 2.106342115964121706e-10 -1.110043834814207890e-13 5.511521613338613568e-01 2.445586568507851738e-10 -1.215988215838436409e-13 5.511521613564012156e-01 2.669986073238897414e-10 -1.274656960880058310e-13 5.511521613688636911e-01 2.794328313553187125e-10 -1.579696058661129269e-13 3.479763783045806579e-10 5.511521614332628438e-01 -1.452635364959018187e-13 3.205194611786318901e-10 5.511521614055874263e-01 -1.218179790877732299e-13 2.695332313143491664e-10 5.511521613546749299e-01 -9.008806410484280057e-14 1.997369297187146203e-10 5.511521612860635910e-01 -5.746769876186245445e-14 1.272737880266123708e-10 5.511521612155856342e-01 -3.503344356585678904e-14 7.726186736093883708e-11 5.511521611667066223e-01 -1.696760705886516458e-14 3.714279282795668553e-11 5.511521611265349785e-01 1.265718255236475359e-15 -2.634381688389226120e-12 5.511521610867584631e-01 -3.564624073562386971e-15 8.551725145455025005e-12 5.511521610979446262e-01 -1.803715332830595062e-14 4.109791076270627267e-11 5.511521611306130497e-01 -4.420346370493866207e-14 9.920679092386066264e-11 5.511521611890125572e-01 -7.286154884396444597e-14 1.621446980613230149e-10 5.511521612519898472e-01 -9.522132303947201732e-14 2.106342115964121706e-10 5.511521613003065312e-01 -1.110451057769577090e-13 2.445586568507851738e-10 5.511521613340415460e-01 -1.215944403562044728e-13 2.669986073238897414e-10 5.511521613563812316e-01 -1.274471793750330182e-13 2.794328313553187125e-10 5.511521613687858645e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 deleted file mode 100644 index c35e2fa59..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_26 +++ /dev/null @@ -1 +0,0 @@ --1.086880113890865279e-02 9.590665261542975491e-05 9.531439136442623424e-05 -1.086549446723246611e-02 9.129668073175354682e-05 8.964512106923086651e-05 -1.085880273024589573e-02 8.160863447682255713e-05 7.822493439949679793e-05 -1.084860409206484834e-02 6.585541551308835863e-05 6.216889791779494582e-05 -1.083479613596765104e-02 4.310522445659037351e-05 4.237600179735160353e-05 -1.081737739487390569e-02 1.812953329062837486e-05 2.108092186170698753e-05 -1.079656928416714359e-02 7.344071358742837929e-06 6.594939878114224279e-06 -1.077365548021687672e-02 5.604808462489146326e-08 -3.993390704291995576e-09 -1.074977205548276367e-02 2.615170876942123181e-06 2.194626208691270273e-06 -1.072583696079697571e-02 1.108524983224637531e-05 1.120727781688285761e-05 -1.070282830634894378e-02 2.260531409104206597e-05 2.309346289148764641e-05 -1.068173818567844970e-02 3.529390392834562927e-05 3.537888810946702279e-05 -1.066351746483088642e-02 4.694183747438805909e-05 4.658032942600440375e-05 -1.064901791556978859e-02 5.625492704297312856e-05 5.549200114499726767e-05 -1.063893651653291007e-02 6.247154904648612411e-05 6.156020750426298579e-05 -1.063376756568772119e-02 6.547958502780582295e-05 6.456075882969114575e-05 -1.598690647506254066e-13 5.511521614411799552e-01 3.475961057375096208e-10 -1.472406015559138880e-13 5.511521614139475167e-01 3.201461002239378235e-10 -1.237254283154461738e-13 5.511521613629097871e-01 2.691753636580359162e-10 -9.141220319720824616e-14 5.511521612919367819e-01 1.994059516922362366e-10 -5.785419320792676792e-14 5.511521612174758999e-01 1.269842561119422345e-10 -3.490180681399605658e-14 5.511521611663665610e-01 7.703068759046320272e-11 -1.687922385344035087e-14 5.511521611263764386e-01 3.698956124141852144e-11 1.286987981137787497e-15 5.511521610866968457e-01 -2.689640856442677474e-12 -3.604909545539200354e-15 5.511521610979899233e-01 8.602067116485445319e-12 -1.809333933773642042e-14 5.511521611305277846e-01 4.125766416648245793e-11 -4.419862230530095192e-14 5.511521611884575567e-01 9.947636797218097149e-11 -7.289381634380744341e-14 5.511521612514608259e-01 1.625191168944847366e-10 -9.537156396790431451e-14 5.511521613002186015e-01 2.111024321941733156e-10 -1.113108336285525073e-13 5.511521613344095849e-01 2.451035841875002992e-10 -1.219267499883977958e-13 5.511521613570041778e-01 2.675978772406128503e-10 -1.278030239072816124e-13 5.511521613694949639e-01 2.800602566720315724e-10 -1.579736493201991973e-13 3.475961057375096208e-10 5.511521614328844798e-01 -1.452459575173187517e-13 3.201461002239378235e-10 5.511521614052160567e-01 -1.217668647442366006e-13 2.691753636580359162e-10 5.511521613543191034e-01 -9.000163336520795011e-14 1.994059516922362366e-10 5.511521612857346319e-01 -5.736001266244778067e-14 1.269842561119422345e-10 5.511521612152977534e-01 -3.492675351805852492e-14 7.703068759046320272e-11 5.511521611664765841e-01 -1.688072367385989684e-14 3.698956124141852144e-11 5.511521611263826559e-01 1.285594477429145533e-15 -2.689640856442677474e-12 5.511521610867035070e-01 -3.605620700945492666e-15 8.602067116485445319e-12 5.511521610979946972e-01 -1.814681835602082349e-14 4.125766416648245793e-11 5.511521611307718116e-01 -4.438214681839096766e-14 9.947636797218097149e-11 5.511521611892804540e-01 -7.309586885966744275e-14 1.625191168944847366e-10 5.511521612523619940e-01 -9.549666236057879506e-14 2.111024321941733156e-10 5.511521613007719367e-01 -1.113503055142689779e-13 2.451035841875002992e-10 5.511521613345831128e-01 -1.219202532249988550e-13 2.675978772406128503e-10 5.511521613569768663e-01 -1.277842411123744091e-13 2.800602566720315724e-10 5.511521613694094768e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 deleted file mode 100644 index f8b484879..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_27 +++ /dev/null @@ -1 +0,0 @@ --1.086179947940717726e-02 9.590665261544330743e-05 9.531439136444180610e-05 -1.085862716423796788e-02 9.129668073178576117e-05 8.964512106926335192e-05 -1.085223104851380273e-02 8.160863447688293363e-05 7.822493439955782496e-05 -1.084253710865111520e-02 6.585541551317842873e-05 6.216889791788509723e-05 -1.082950064866678927e-02 4.310522445669663888e-05 4.237600179745744199e-05 -1.081317370701866641e-02 1.812953329073099121e-05 2.108092186180953611e-05 -1.079385747078666011e-02 7.344071358824566444e-06 6.594939878195701225e-06 -1.077276315105271665e-02 5.604808464274464800e-08 -3.993390686578985685e-09 -1.075081656957860114e-02 2.615170876903352789e-06 2.194626208652419412e-06 -1.072886093504417035e-02 1.108524983214693026e-05 1.120727781678336851e-05 -1.070778892883249810e-02 2.260531409087970670e-05 2.309346289132619177e-05 -1.068850128141538708e-02 3.529390392813382360e-05 3.537888810925556270e-05 -1.067185767260792409e-02 4.694183747414077968e-05 4.658032942575826275e-05 -1.065862569554195186e-02 5.625492704269988929e-05 5.549200114472526167e-05 -1.064943194157444775e-02 6.247154904619570701e-05 6.156020750397354446e-05 -1.064472006150514113e-02 6.547958502750469935e-05 6.456075882939243450e-05 -1.598555146713272187e-13 5.511521614408115832e-01 3.472295684179013216e-10 -1.472083930181822125e-13 5.511521614135866942e-01 3.197872755685870464e-10 -1.236650564896941777e-13 5.511521613625656180e-01 2.688332799301974049e-10 -9.132213158823086785e-14 5.511521612916207014e-01 1.990918190064360896e-10 -5.774792916897965472e-14 5.511521612172017859e-01 1.267116682405534549e-10 -3.479918888716959858e-14 5.511521611661496234e-01 7.681485188377896585e-11 -1.679749572734562474e-14 5.511521611262347742e-01 3.684866600900886248e-11 1.304841167270847646e-15 5.511521610866459975e-01 -2.740159532567657358e-12 -3.643680052885433165e-15 5.511521610980365526e-01 8.648425273943646973e-12 -1.819278377214417589e-14 5.511521611306751112e-01 4.140404997349794002e-11 -4.436098298501405309e-14 5.511521611887054695e-01 9.972278181430269185e-11 -7.310562130343633475e-14 5.511521612518045510e-01 1.628607353130657200e-10 -9.561884254000671226e-14 5.511521613006478137e-01 2.115290296130412269e-10 -1.115840701679858491e-13 5.511521613349086302e-01 2.455995511497033182e-10 -1.222171670437804117e-13 5.511521613575526279e-01 2.681429289618432910e-10 -1.281041455324269476e-13 5.511521613700689493e-01 2.806307215254518927e-10 -1.579580811478028991e-13 3.472295684179013216e-10 5.511521614325197715e-01 -1.452134690406089887e-13 3.197872755685870464e-10 5.511521614048591200e-01 -1.217058406800084856e-13 2.688332799301974049e-10 5.511521613539790421e-01 -8.991148264166778143e-14 1.990918190064360896e-10 5.511521612854224372e-01 -5.725417170276319568e-14 1.267116682405534549e-10 5.511521612150267480e-01 -3.482420584423003968e-14 7.681485188377896585e-11 5.511521611662618669e-01 -1.679924682102316676e-14 3.684866600900886248e-11 5.511521611262425457e-01 1.303307486986424660e-15 -2.740159532567657358e-12 5.511521610866533250e-01 -3.644471563424533098e-15 8.648425273943646973e-12 5.511521610980407715e-01 -1.824630817612015172e-14 4.140404997349794002e-11 5.511521611309172508e-01 -4.454360302335406944e-14 9.972278181430269185e-11 5.511521611895253692e-01 -7.330732656441497739e-14 1.628607353130657200e-10 5.511521612527015002e-01 -9.574280220264669583e-14 2.115290296130412269e-10 5.511521613011959309e-01 -1.116223091761974374e-13 2.455995511497033182e-10 5.511521613350760518e-01 -1.222096900568195271e-13 2.681429289618432910e-10 5.511521613575185441e-01 -1.280829478982308544e-13 2.806307215254518927e-10 5.511521613699764677e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 deleted file mode 100644 index c8ef061f9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_28 +++ /dev/null @@ -1 +0,0 @@ --1.085509955243740658e-02 9.590665261547191682e-05 9.531439136447102535e-05 -1.085207123594016977e-02 9.129668073182923768e-05 8.964512106930757381e-05 -1.084598459319774735e-02 8.160863447695027614e-05 7.822493439962562825e-05 -1.083680354556124797e-02 6.585541551326982697e-05 6.216889791797588561e-05 -1.082452864793547950e-02 4.310522445680046479e-05 4.237600179756025823e-05 -1.080925273779440032e-02 1.812953329082883368e-05 2.108092186190650106e-05 -1.079135856323053255e-02 7.344071358899968470e-06 6.594939878270825424e-06 -1.077193920490872488e-02 5.604808465880920356e-08 -3.993390671585116992e-09 -1.075176927652454761e-02 2.615170876867358971e-06 2.194626208616629729e-06 -1.073162347055377913e-02 1.108524983205452066e-05 1.120727781669167888e-05 -1.071231704530322890e-02 2.260531409073270921e-05 2.309346289117933658e-05 -1.069466860907628512e-02 3.529390392794379006e-05 3.537888810906609160e-05 -1.067945636553791107e-02 4.694183747391891804e-05 4.658032942553722781e-05 -1.066737301465978636e-02 5.625492704245541525e-05 5.549200114448256979e-05 -1.065898271240749672e-02 6.247154904593568822e-05 6.156020750371576184e-05 -1.065468427322964137e-02 6.547958502723748417e-05 6.456075882912676431e-05 -1.598269117384301696e-13 5.511521614404584213e-01 3.468782437718925282e-10 -1.471649127331277436e-13 5.511521614132417479e-01 3.194441899425734377e-10 -1.235977110126338538e-13 5.511521613622381022e-01 2.685076959932778133e-10 -9.123073137290250861e-14 5.511521612913217183e-01 1.987946624756856520e-10 -5.764410276150573425e-14 5.511521612169442141e-01 1.264556160747368003e-10 -3.470134592605084444e-14 5.511521611659473407e-01 7.661360373787266178e-11 -1.672209371804493017e-14 5.511521611261044340e-01 3.671908849061737830e-11 1.320905723154172551e-15 5.511521610865994791e-01 -2.786375210551865006e-12 -3.679674012192963268e-15 5.511521610980795183e-01 8.691122012723350659e-12 -1.828519385090169890e-14 5.511521611308101143e-01 4.153825631913450131e-11 -4.450798012317911129e-14 5.511521611889322880e-01 9.994818063722965885e-11 -7.329565760283974775e-14 5.511521612521184110e-01 1.631726865154904565e-10 -9.584070477900277987e-14 5.511521613010392784e-01 2.119180659583369919e-10 -1.118285430225711332e-13 5.511521613353632665e-01 2.460514082543336152e-10 -1.224771835119816657e-13 5.511521613580520063e-01 2.686391854716262323e-10 -1.283713595677841145e-13 5.511521613705914202e-01 2.811499496788089121e-10 -1.579288675176873794e-13 3.468782437718925282e-10 5.511521614321702733e-01 -1.451692485119232297e-13 3.194441899425734377e-10 5.511521614045179485e-01 -1.216380417415798064e-13 2.685076959932778133e-10 5.511521613536554121e-01 -8.982068946200730533e-14 1.987946624756856520e-10 5.511521612851271179e-01 -5.715135810182342338e-14 1.264556160747368003e-10 5.511521612147721738e-01 -3.472724251411381514e-14 7.661360373787266178e-11 5.511521611660616937e-01 -1.672412241608283824e-14 3.671908849061737830e-11 5.511521611261137599e-01 1.318301355559537163e-15 -2.786375210551865006e-12 5.511521610866073617e-01 -3.680261258271571974e-15 8.691122012723350659e-12 5.511521610980831820e-01 -1.833799791773700869e-14 4.153825631913450131e-11 5.511521611310505886e-01 -4.469045862801948374e-14 9.994818063722965885e-11 5.511521611897494122e-01 -7.349679721185449521e-14 1.631726865154904565e-10 5.511521612530115855e-01 -9.596383532076135751e-14 2.119180659583369919e-10 5.511521613015826215e-01 -1.118650040403125949e-13 2.460514082543336152e-10 5.511521613355251370e-01 -1.224674772313387498e-13 2.686391854716262323e-10 5.511521613580117052e-01 -1.283486225462022538e-13 2.811499496788089121e-10 5.511521613704924993e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 deleted file mode 100644 index 0262efc6d..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_29 +++ /dev/null @@ -1 +0,0 @@ --1.084871711923132351e-02 9.590665261551078547e-05 9.531439136451043609e-05 -1.084583842817175327e-02 9.129668073188045268e-05 8.964512106935947999e-05 -1.084006804732302355e-02 8.160863447702219940e-05 7.822493439969756507e-05 -1.083139974679788939e-02 6.585541551336083219e-05 6.216889791806708056e-05 -1.081986913388058649e-02 4.310522445690012329e-05 4.237600179765953050e-05 -1.080559951771556393e-02 1.812953329092135339e-05 2.108092186199855660e-05 -1.078905563083878624e-02 7.344071358970452623e-06 6.594939878341158805e-06 -1.077117844474075221e-02 5.604808467312774629e-08 -3.993390656143215018e-09 -1.075263899463795546e-02 2.615170876834259041e-06 2.194626208583586551e-06 -1.073414912791843118e-02 1.108524983197079314e-05 1.120727781660796492e-05 -1.071645383917438354e-02 2.260531409059925409e-05 2.309346289104636935e-05 -1.070029778908024136e-02 3.529390392777094113e-05 3.537888810889449628e-05 -1.068638623603992630e-02 4.694183747371998727e-05 4.658032942533959131e-05 -1.067534510824135092e-02 5.625492704223761936e-05 5.549200114426499752e-05 -1.066768306112365200e-02 6.247154904570482092e-05 6.156020750348527402e-05 -1.066375913117856983e-02 6.547958502699961021e-05 6.456075882888990679e-05 -1.597880398748206921e-13 5.511521614401214686e-01 3.465430863483889422e-10 -1.471136910398418573e-13 5.511521614129132329e-01 3.191175786879842261e-10 -1.235257938040439645e-13 5.511521613619274618e-01 2.681989609131709317e-10 -9.113972360636650149e-14 5.511521612910396106e-01 1.985143726166915664e-10 -5.754444762113119274e-14 5.511521612167027406e-01 1.262155786797609730e-10 -3.460882626787765043e-14 5.511521611657589359e-01 7.642617734249862848e-11 -1.665160959761737273e-14 5.511521611259845299e-01 3.659990166005040088e-11 1.335224262784404919e-15 5.511521610865569576e-01 -2.828679003333548620e-12 -3.712774004051750389e-15 5.511521610981190422e-01 8.730450781511935213e-12 -1.836892079780318346e-14 5.511521611309340152e-01 4.166135043077661725e-11 -4.464143427861877411e-14 5.511521611891398997e-01 1.001544818972949419e-10 -7.346850481404400165e-14 5.511521612524051816e-01 1.634577551104440438e-10 -9.603963264178457070e-14 5.511521613013965482e-01 2.122731403744509994e-10 -1.120463362676341034e-13 5.511521613357779348e-01 2.464634442128155211e-10 -1.227080525424285198e-13 5.511521613585070867e-01 2.690914354031100631e-10 -1.286092304713893184e-13 5.511521613710673728e-01 2.816229922115363724e-10 -1.578894548878357177e-13 3.465430863483889422e-10 5.511521614318368734e-01 -1.451173457508263074e-13 3.191175786879842261e-10 5.511521614041932082e-01 -1.215661029544457259e-13 2.681989609131709317e-10 5.511521613533485464e-01 -8.972949184711690412e-14 1.985143726166915664e-10 5.511521612848485629e-01 -5.705208796421698858e-14 1.262155786797609730e-10 5.511521612145335869e-01 -3.463518841177665177e-14 7.642617734249862848e-11 5.511521611658752873e-01 -1.665378891877211254e-14 3.659990166005040088e-11 5.511521611259952991e-01 1.333743257486449992e-15 -2.828679003333548620e-12 5.511521610865652843e-01 -3.713304407404046318e-15 8.730450781511935213e-12 5.511521610981222619e-01 -1.842171103431524106e-14 4.166135043077661725e-11 5.511521611311729352e-01 -4.482342438995797160e-14 1.001544818972949419e-10 5.511521611899544704e-01 -7.366839347742252845e-14 1.634577551104440438e-10 5.511521612532949144e-01 -9.616147295882634267e-14 2.122731403744509994e-10 5.511521613019355614e-01 -1.120825760381342720e-13 2.464634442128155211e-10 5.511521613359345872e-01 -1.226979608181510819e-13 2.690914354031100631e-10 5.511521613584611234e-01 -1.285854734337258598e-13 2.816229922115363724e-10 5.511521613709625678e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 deleted file mode 100644 index 487daa118..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ --9.355410162965290335e-03 9.590665272192731578e-05 9.531439146962954233e-05 -9.497253759272124979e-03 9.129668082624237601e-05 8.964512116241954757e-05 -9.760983316589273012e-03 8.160863455078132701e-05 7.822493447228633708e-05 -1.010963417578185711e-02 6.585541556269006592e-05 6.216889796665123701e-05 -1.049045250563568170e-02 4.310522448424977362e-05 4.237600182479492892e-05 -1.079977007702043190e-02 1.812953330416872168e-05 2.108092187527199656e-05 -1.094045452979859785e-02 7.344071362719620347e-06 6.594939882100207168e-06 -1.085791616025431720e-02 5.604808242438758714e-08 -3.993392897625356465e-09 -1.058081367511344746e-02 2.615170879319648949e-06 2.194626211062071023e-06 -1.023572513367495933e-02 1.108524984269189414e-05 1.120727782733021788e-05 -9.849581505306098661e-03 2.260531411391340906e-05 2.309346291441708579e-05 -9.452071341134812496e-03 3.529390396551575925e-05 3.537888814673085494e-05 -9.065534612177199650e-03 4.694183752475508437e-05 4.658032947646401312e-05 -8.705464160017857903e-03 5.625492710446860145e-05 5.549200120656473157e-05 -8.425610554910541172e-03 6.247154911622634465e-05 6.156020757405845998e-05 -8.273100118887152105e-03 6.547958510215772453e-05 6.456075890409285287e-05 -5.337147299472235383e-14 5.511521614016191561e-01 3.086987821112395192e-10 -5.275178401486984813e-14 5.511521613781059648e-01 2.849048877269487628e-10 -4.976671428158847918e-14 5.511521613343207671e-01 2.410346128833301949e-10 -4.181047265329025904e-14 5.511521612734487929e-01 1.811165642864906683e-10 -3.019479696390845519e-14 5.511521612103400525e-01 1.198282999503465344e-10 -2.136146214140645244e-14 5.511521611686767130e-01 7.928722282459301452e-11 -1.290244312392205481e-14 5.511521611334890824e-01 4.407260401084727832e-11 -9.135158905257876777e-16 5.511521610921371606e-01 2.729898969141407811e-12 -1.227382799086963047e-15 5.511521610936235271e-01 4.258867368387143070e-12 -7.647816347566813326e-15 5.511521611140800525e-01 2.485554044043031961e-11 -2.132727154262538083e-14 5.511521611579901503e-01 6.900338489276487732e-11 -3.572368845179870539e-14 5.511521612063638997e-01 1.173280454966240656e-10 -4.500455034535087698e-14 5.511521612410069659e-01 1.517246015104331556e-10 -4.981535271659613451e-14 5.511521612624880051e-01 1.729828305353491457e-10 -5.218650771171730805e-14 5.511521612754829436e-01 1.858714794450768920e-10 -5.345112919177994376e-14 5.511521612828451655e-01 1.932058919212480157e-10 -5.277036766569375707e-14 3.086987821112395192e-10 5.511521613946260834e-01 -5.205728555285849656e-14 2.849048877269487628e-10 5.511521613705541167e-01 -4.897729286157439736e-14 2.410346128833301949e-10 5.511521613266127106e-01 -4.114533575362772727e-14 1.811165642864906683e-10 5.511521612676398840e-01 -2.991667364124794599e-14 1.198282999503465344e-10 5.511521612081214938e-01 -2.136174900106245113e-14 7.928722282459301452e-11 5.511521611686791555e-01 -1.289474017562743170e-14 4.407260401084727832e-11 5.511521611334361248e-01 -9.077388829594699028e-16 2.729898969141407811e-12 5.511521610921027436e-01 -1.234820140612994021e-15 4.258867368387143070e-12 5.511521610936744864e-01 -7.699454770896373217e-15 2.485554044043031961e-11 5.511521611144143407e-01 -2.145271867956777274e-14 6.900338489276487732e-11 5.511521611588008351e-01 -3.583203609733999246e-14 1.173280454966240656e-10 5.511521612070747755e-01 -4.503703932347714699e-14 1.517246015104331556e-10 5.511521612412255688e-01 -4.978284435967812836e-14 1.729828305353491457e-10 5.511521612622612976e-01 -5.212477096863361775e-14 1.858714794450768920e-10 5.511521612750429622e-01 -5.338254820297116964e-14 1.932058919212480157e-10 5.511521612823488958e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 deleted file mode 100644 index 3107e60b0..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ --9.967998193617863545e-03 9.590665268848954500e-05 9.531439143666133951e-05 -1.006541799080274899e-02 9.129668079713744303e-05 8.964512113377859890e-05 -1.024694329250254096e-02 8.160863452878108955e-05 7.822493445068844705e-05 -1.048442257671991854e-02 6.585541554839735394e-05 6.216889795260175224e-05 -1.072001912696859613e-02 4.310522447615908431e-05 4.237600181676970509e-05 -1.088960495023780575e-02 1.812953329959836568e-05 2.108092187069438657e-05 -1.094232257171415951e-02 7.344071360404448909e-06 6.594939879786468063e-06 -1.084322531929218097e-02 5.604808243287709397e-08 -3.993392886934568998e-09 -1.061603437539516449e-02 2.615170879303587510e-06 2.194626211046839253e-06 -1.034517938365398307e-02 1.108524984197396426e-05 1.120727782660861866e-05 -1.004948293443999607e-02 2.260531411168453672e-05 2.309346291216660395e-05 -9.750292624073031780e-03 3.529390396088978029e-05 3.537888814206762686e-05 -9.471559625406935495e-03 4.694183751730225153e-05 4.658032946897408023e-05 -9.234885369666556015e-03 5.625492709422933514e-05 5.549200119630035921e-05 -9.056150116986903462e-03 6.247154910385149145e-05 6.156020756167147727e-05 -8.958606452857743527e-03 6.547958508859833980e-05 6.456075889052895515e-05 -8.680924804667768964e-14 5.511521614132357527e-01 3.198327955261253981e-10 -8.185672326867208444e-14 5.511521613892796934e-01 2.956319150042617297e-10 -7.176695618034347204e-14 5.511521613444482215e-01 2.508094748091472265e-10 -5.610318953189988679e-14 5.511521612817350535e-01 1.892167200042533501e-10 -3.828548562135057604e-14 5.511521612156807803e-01 1.251505481087495985e-10 -2.593181705836933372e-14 5.511521611709252477e-01 8.155826169608292705e-11 -1.521761469612118111e-14 5.511521611335442605e-01 4.412810721717738110e-11 -9.050263810892229457e-16 5.511521610913351354e-01 1.927334112006412664e-12 -1.243444424387506836e-15 5.511521610942069493e-01 4.842524143796522061e-12 -8.365746779342912487e-15 5.511521611166301238e-01 2.741940138061779234e-11 -2.355614518345810674e-14 5.511521611630191275e-01 7.408675112641386874e-11 -4.034966550336971717e-14 5.511521612140513060e-01 1.251102873203431267e-10 -5.245738607229009805e-14 5.511521612515141166e-01 1.623372641625517461e-10 -6.005461990047111881e-14 5.511521612760932332e-01 1.866784304767359368e-10 -6.456135599985337313e-14 5.511521612915138979e-01 2.019668342927952565e-10 -6.701051146969949533e-14 5.511521613001412190e-01 2.105485231331982248e-10 -8.573857161830792264e-14 3.198327955261253981e-10 5.511521614052975471e-01 -8.069823394444050306e-14 2.956319150042617297e-10 5.511521613808523234e-01 -7.057518273768721782e-14 2.508094748091472265e-10 5.511521613360472749e-01 -5.519481827999863658e-14 1.892167200042533501e-10 5.511521612755581057e-01 -3.794189925663673495e-14 1.251505481087495985e-10 5.511521612134253623e-01 -2.593935826628813317e-14 8.155826169608292705e-11 5.511521611709729873e-01 -1.520847951661602797e-14 4.412810721717738110e-11 5.511521611334919690e-01 -8.970480958966285741e-16 1.927334112006412664e-12 5.511521610912996083e-01 -1.250051707842214327e-15 4.842524143796522061e-12 5.511521610942583527e-01 -8.421053934202913564e-15 2.741940138061779234e-11 5.511521611169920565e-01 -2.370319964936566979e-14 7.408675112641386874e-11 5.511521611639391693e-01 -4.049526498634824920e-14 1.251102873203431267e-10 5.511521612149530291e-01 -5.252696967022034080e-14 1.623372641625517461e-10 5.511521612519447721e-01 -6.004721704146287912e-14 1.866784304767359368e-10 5.511521612760478250e-01 -6.451175183035521735e-14 2.019668342927952565e-10 5.511521612912029244e-01 -6.694644311984170193e-14 2.105485231331982248e-10 5.511521612997382080e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 deleted file mode 100644 index 751058856..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ --1.033306601675545826e-02 9.590665266950519207e-05 9.531439141793460656e-05 -1.040378001118455117e-02 9.129668078029794015e-05 8.964512111718908594e-05 -1.053194309569139772e-02 8.160863451554192392e-05 7.822493443766324872e-05 -1.068767536527196090e-02 6.585541553936760325e-05 6.216889794370057437e-05 -1.083253933085586741e-02 4.310522447082162478e-05 4.237600181146797002e-05 -1.092656815210828192e-02 1.812953329672165883e-05 2.108092186781441695e-05 -1.093474907990647609e-02 7.344071359375216634e-06 6.594939878757751631e-06 -1.083338727938064523e-02 5.604808268304135971e-08 -3.993392636831342568e-09 -1.064208426521699030e-02 2.615170879013891655e-06 2.194626210756965097e-06 -1.042076026497613939e-02 1.108524984051061150e-05 1.120727782513997534e-05 -1.018349737515533704e-02 2.260531410812947507e-05 2.309346290859144390e-05 -9.946510748117408721e-03 3.529390395481420947e-05 3.537888813596047188e-05 -9.727768263756812750e-03 4.694183750892388273e-05 4.658032946056277879e-05 -9.544960820500790477e-03 5.625492708391828110e-05 5.549200118596241019e-05 -9.413499018379978614e-03 6.247154909202997438e-05 6.156020754982902154e-05 -9.344607686908609420e-03 6.547958507588788537e-05 6.456075887780050296e-05 -1.057936059986373190e-13 5.511521614227351540e-01 3.291404051205063161e-10 -9.869622739071983013e-14 5.511521613982069967e-01 3.043951935714348375e-10 -8.500612200727941883e-14 5.511521613521389584e-01 2.583910738617517131e-10 -6.513293442845432437e-14 5.511521612873615528e-01 1.948054643135526753e-10 -4.362294384147005936e-14 5.511521612188943209e-01 1.283704718378075430e-10 -2.880852481339728757e-14 5.511521611720404668e-01 8.268053074465917602e-11 -1.624684694034301238e-14 5.511521611332849124e-01 4.386856090528780290e-11 -6.548621151279837768e-16 5.511521610907862412e-01 1.379973431287087001e-12 -1.533140368176572505e-15 5.511521610947412997e-01 5.374720194925105636e-12 -9.829099711028416234e-15 5.511521611187365499e-01 2.952612817220648716e-11 -2.711120520699018315e-14 5.511521611670563425e-01 7.814411923615235598e-11 -4.642523327165301606e-14 5.511521612201610854e-01 1.312690972884975061e-10 -6.083575619756927009e-14 5.511521612596104180e-01 1.705048336427992856e-10 -7.036567402810750875e-14 5.511521612859475727e-01 1.966101689552022188e-10 -7.638287637706926328e-14 5.511521613028789179e-01 2.134070683611967414e-10 -7.972096380268212404e-14 5.511521613124068519e-01 2.228866460899433108e-10 -1.044653013690010250e-13 3.291404051205063161e-10 5.511521614144172521e-01 -9.728774086694824988e-14 3.043951935714348375e-10 5.511521613894546645e-01 -8.360037914263669776e-14 2.583910738617517131e-10 5.511521613435212963e-01 -6.409600249815509708e-14 1.948054643135526753e-10 5.511521612811093318e-01 -4.324363272139842602e-14 1.283704718378075430e-10 5.511521612166516704e-01 -2.881932640724370452e-14 8.268053074465917602e-11 5.511521611721024172e-01 -1.623719576416436400e-14 4.386856090528780290e-11 5.511521611332321768e-01 -6.469448693440610999e-16 1.379973431287087001e-12 5.511521610907537116e-01 -1.539925927528334604e-15 5.374720194925105636e-12 5.511521610947883731e-01 -9.889697934585014324e-15 2.952612817220648716e-11 5.511521611190991488e-01 -2.727835895106623896e-14 7.814411923615235598e-11 5.511521611680167965e-01 -4.660241748506462439e-14 1.312690972884975061e-10 5.511521612211612853e-01 -6.093826998645051177e-14 1.705048336427992856e-10 5.511521612601842923e-01 -7.038516828967339988e-14 1.966101689552022188e-10 5.511521612860574848e-01 -7.635420825824598414e-14 2.134070683611967414e-10 5.511521613027188238e-01 -7.967489797057285479e-14 2.228866460899433108e-10 5.511521613121491692e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 deleted file mode 100644 index edd0f1663..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ --1.056397842881712061e-02 9.590665265499028641e-05 9.531439140358490621e-05 -1.061290444391981870e-02 9.129668076716674751e-05 8.964512110422387110e-05 -1.069906745862823048e-02 8.160863450482159034e-05 7.822493442709447305e-05 -1.080103014135370618e-02 6.585541553163954569e-05 6.216889793607441826e-05 -1.089122468482083168e-02 4.310522446604656802e-05 4.237600180672596110e-05 -1.094072273093216544e-02 1.812953329401480580e-05 2.108092186510594440e-05 -1.092438810445030620e-02 7.344071358182429920e-06 6.594939877565815338e-06 -1.082552092754870791e-02 5.604808289417120395e-08 -3.993392426093937621e-09 -1.066087990002451483e-02 2.615170878855307182e-06 2.194626210599242903e-06 -1.047469509577531217e-02 1.108524983952537497e-05 1.120727782415370711e-05 -1.027795230542445475e-02 2.260531410570251561e-05 2.309346290615542458e-05 -1.008345880961149243e-02 3.529390395064557409e-05 3.537888813177479419e-05 -9.905264049110695107e-03 4.694183750315081109e-05 4.658032945476910054e-05 -9.757121608259835405e-03 5.625492707683194248e-05 5.549200117885418423e-05 -9.650959755100971954e-03 6.247154908398133179e-05 6.156020754175847807e-05 -9.595555070786103077e-03 6.547958506729521723e-05 6.456075886918583907e-05 -1.203085137159266409e-13 5.511521614300686212e-01 3.364299927208931677e-10 -1.118274164643488479e-13 5.511521614049021967e-01 3.110562780437835938e-10 -9.572645161809516379e-14 5.511521613575688372e-01 2.638023237497959918e-10 -7.286099163374294107e-14 5.511521612911199908e-01 1.985610551188528054e-10 -4.839800334232557194e-14 5.511521612208932774e-01 1.303748946117488464e-10 -3.151537833534200675e-14 5.511521611725465064e-01 8.318859512228465199e-11 -1.743963399427177392e-14 5.511521611328673576e-01 4.345155714859553604e-11 -4.437322704435224497e-16 5.511521610902427870e-01 8.386113297816960084e-13 -1.691724710748947054e-15 5.511521610951477523e-01 5.778807209279247983e-12 -1.081433665709040048e-14 5.511521611203743509e-01 3.115946962699567551e-11 -2.953816307082608624e-14 5.511521611701896139e-01 8.128118321503398243e-11 -5.059386785410073077e-14 5.511521612248951874e-01 1.360237360906966293e-10 -6.660882448772103279e-14 5.511521612658796254e-01 1.768136644254011820e-10 -7.745201430732583658e-14 5.511521612935249559e-01 2.042415438171958215e-10 -8.443151912847303896e-14 5.511521613114034324e-01 2.219935613616426477e-10 -8.831363085873893081e-14 5.511521613214317439e-01 2.319766087797221491e-10 -1.188150000700097358e-13 3.364299927208931677e-10 5.511521614216632337e-01 -1.102529610343951186e-13 3.110562780437835938e-10 5.511521613960818078e-01 -9.416915539900896195e-14 2.638023237497959918e-10 5.511521613489139826e-01 -7.172216260123912201e-14 1.985610551188528054e-10 5.511521612848621077e-01 -4.798564416538848256e-14 1.303748946117488464e-10 5.511521612186615071e-01 -3.152779996241535095e-14 8.318859512228465199e-11 5.511521611726124537e-01 -1.742913207709484271e-14 4.345155714859553604e-11 5.511521611328157322e-01 -4.362074640149108371e-16 8.386113297816960084e-13 5.511521610902144763e-01 -1.697648021942106372e-15 5.778807209279247983e-12 5.511521610951900518e-01 -1.087596590303818798e-14 3.115946962699567551e-11 5.511521611207280680e-01 -2.971437680955996673e-14 8.128118321503398243e-11 5.511521611711576174e-01 -5.078809838724731776e-14 1.360237360906966293e-10 5.511521612259364655e-01 -6.673195043526990710e-14 1.768136644254011820e-10 5.511521612665329917e-01 -7.749339352325572455e-14 2.042415438171958215e-10 5.511521612937432257e-01 -8.442475443104789666e-14 2.219935613616426477e-10 5.511521613113677942e-01 -8.828956238360888246e-14 2.319766087797221491e-10 5.511521613213047344e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 deleted file mode 100644 index a69516cf8..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ --1.070704923600961610e-02 9.590665264543965789e-05 9.531439139412617738e-05 -1.074071029419736145e-02 9.129668075847219148e-05 8.964512109562496880e-05 -1.079922903748575802e-02 8.160863449766759072e-05 7.822493442003341667e-05 -1.086649201710983802e-02 6.585541552651084929e-05 6.216889793101057070e-05 -1.092184577105243838e-02 4.310522446295776412e-05 4.237600180365882092e-05 -1.094372364105911273e-02 1.812953329238082504e-05 2.108092186347079811e-05 -1.091354653816558121e-02 7.344071357638929535e-06 6.594939877021915154e-06 -1.081922354136362688e-02 5.604808312536211697e-08 -3.993392196314127732e-09 -1.067534963437232094e-02 2.615170878642820496e-06 2.194626210386702855e-06 -1.051552098348847684e-02 1.108524983848711417e-05 1.120727782311460267e-05 -1.034860235144822137e-02 2.260531410332143823e-05 2.309346290376646980e-05 -1.018500528053676787e-02 3.529390394675210245e-05 3.537888812786970803e-05 -1.003604623754423414e-02 4.694183749794504147e-05 4.658032944954926339e-05 -9.912748877628193081e-03 5.625492707059362614e-05 5.549200117260081781e-05 -9.824647772162841200e-03 6.247154907701019642e-05 6.156020753477102546e-05 -9.778745342621837297e-03 6.547958505991871223e-05 6.456075886179217657e-05 -1.298591462914885764e-13 5.511521614351690967e-01 3.415372207698701941e-10 -1.205219734136297542e-13 5.511521614094899713e-01 3.156494660850225659e-10 -1.028804491080669016e-13 5.511521613612111459e-01 2.674478333198038195e-10 -7.798968963314317353e-14 5.511521612935431635e-01 2.009868600944651299e-10 -5.148680913353014180e-14 5.511521612220536825e-01 1.315377984985043261e-10 -3.314936010271762060e-14 5.511521611726650782e-01 8.330742978544804850e-11 -1.798313439336129056e-14 5.511521611323919601e-01 4.297727196051056421e-11 -2.125413543902290102e-16 5.511521610897962553e-01 3.940349974161936644e-13 -1.904211194207688632e-15 5.511521610955002481e-01 6.129033807487406623e-12 -1.185259737605543893e-14 5.511521611217425898e-01 3.252221101804142105e-11 -3.191924198516412843e-14 5.511521611727657755e-01 8.385507274949977790e-11 -5.448733739928970617e-14 5.511521612287541005e-01 1.398896693016713257e-10 -7.181459230452751458e-14 5.511521612709645579e-01 1.819184668392482052e-10 -8.369033256031732205e-14 5.511521612996523878e-01 2.104012952906939078e-10 -9.140264912224607956e-14 5.511521613182850388e-01 2.289168017022558459e-10 -9.569014021349925332e-14 5.511521613287075905e-01 2.392990558728726938e-10 -1.282737307431118853e-13 3.415372207698701941e-10 5.511521614267772540e-01 -1.188518654693748182e-13 3.156494660850225659e-10 5.511521614006803516e-01 -1.012302179753177918e-13 2.674478333198038195e-10 5.511521613525626195e-01 -7.678601032422692406e-14 2.009868600944651299e-10 5.511521612872904985e-01 -5.105278537757835586e-14 1.315377984985043261e-10 5.511521612198269082e-01 -3.316294468987558005e-14 8.330742978544804850e-11 5.511521611727315806e-01 -1.797303245670672152e-14 4.297727196051056421e-11 5.511521611323425551e-01 -2.064276543062290903e-16 3.940349974161936644e-13 5.511521610897718304e-01 -1.910188163332873348e-15 6.129033807487406623e-12 5.511521610955379957e-01 -1.191507118981336216e-14 3.252221101804142105e-11 5.511521611220854266e-01 -3.210333199232560435e-14 8.385507274949977790e-11 5.511521611737292270e-01 -5.469318136474525074e-14 1.398896693016713257e-10 5.511521612298093675e-01 -7.195178772932810867e-14 1.819184668392482052e-10 5.511521612716577811e-01 -8.374676137127816038e-14 2.104012952906939078e-10 5.511521612999354947e-01 -9.141220438575931199e-14 2.289168017022558459e-10 5.511521613183330004e-01 -9.568322013134978671e-14 2.392990558728726938e-10 5.511521613286741728e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 deleted file mode 100644 index a43d68ce9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_8 +++ /dev/null @@ -1 +0,0 @@ --1.079810327176170849e-02 9.590665263806430485e-05 9.531439138681879026e-05 -1.082133986197232091e-02 9.129668075176909799e-05 8.964512108899335135e-05 -1.086104770533694898e-02 8.160863449218595941e-05 7.822493441462198744e-05 -1.090486487629455450e-02 6.585541552262542107e-05 6.216889792717478539e-05 -1.093699389747385987e-02 4.310522446066718374e-05 4.237600180138493725e-05 -1.094102170378864237e-02 1.812953329121437936e-05 2.108092186230421013e-05 -1.090294142063227313e-02 7.344071357286399505e-06 6.594939876669453733e-06 -1.081385188975930028e-02 5.604808333265849523e-08 -3.993391989261059679e-09 -1.068669846587412021e-02 2.615170878469684421e-06 2.194626210213913639e-06 -1.054746866101786799e-02 1.108524983766220403e-05 1.120727782228946213e-05 -1.040349887828524722e-02 2.260531410148688345e-05 2.309346290192826939e-05 -1.026343648015519069e-02 3.529390394380398733e-05 3.537888812491527066e-05 -1.013659798195091707e-02 4.694183749402758185e-05 4.658032944562455995e-05 -1.003201474286635059e-02 5.625492706590676923e-05 5.549200116790511787e-05 -9.957477156249913350e-03 6.247154907177446216e-05 6.156020752952489641e-05 -9.918698476542184284e-03 6.547958505438113608e-05 6.456075885624255222e-05 -1.372345051540735491e-13 5.511521614387121515e-01 3.450934816673409683e-10 -1.272250687983872486e-13 5.511521614126460022e-01 3.188152447307481149e-10 -1.083620778579741356e-13 5.511521613636577444e-01 2.698992410316920175e-10 -8.187512337654252173e-14 5.511521612950849303e-01 2.025304413536532515e-10 -5.377739064604713816e-14 5.511521612226746303e-01 1.321595452694798836e-10 -3.431580511106814791e-14 5.511521611725501701e-01 8.319245420060866337e-11 -1.833566459123447916e-14 5.511521611318969116e-01 4.248368808307077740e-11 -5.244974867519171904e-18 5.511521610894049017e-01 4.461376480120404405e-15 -2.077347404759383418e-15 5.511521610957995643e-01 6.426340798515867453e-12 -1.267750823417400180e-14 5.511521611228864526e-01 3.366070289956308567e-11 -3.375379770006157135e-14 5.511521611748972926e-01 8.598181199456600083e-11 -5.743545374605908976e-14 5.511521612319260077e-01 1.430617097970324829e-10 -7.573205426397560856e-14 5.511521612751275612e-01 1.860896870779573597e-10 -8.837718764265274939e-14 5.511521613046572732e-01 2.154231466443203548e-10 -9.663838841903948489e-14 5.511521613238987705e-01 2.345548248411923024e-10 -1.012277105406046841e-13 5.511521613346396231e-01 2.452596021237108103e-10 -1.355811164218337284e-13 3.450934816673409683e-10 5.511521614303468430e-01 -1.254834857180638160e-13 3.188152447307481149e-10 5.511521614038559225e-01 -1.066416406361404335e-13 2.698992410316920175e-10 5.511521613550187659e-01 -8.062179794613987743e-14 2.025304413536532515e-10 5.511521612888358179e-01 -5.332666918400598888e-14 1.321595452694798836e-10 5.511521612204494103e-01 -3.432953189457771998e-14 8.319245420060866337e-11 5.511521611726165615e-01 -1.832549354608158398e-14 4.248368808307077740e-11 5.511521611318505043e-01 6.254136042124746183e-19 4.461376480120404405e-15 5.511521610893840295e-01 -2.082977547153305715e-15 6.426340798515867453e-12 5.511521610958333151e-01 -1.274021189859703854e-14 3.366070289956308567e-11 5.511521611232186313e-01 -3.394153143302436854e-14 8.598181199456600083e-11 5.511521611758511963e-01 -5.764762021101389148e-14 1.430617097970324829e-10 5.511521612329814968e-01 -7.587649208599053527e-14 1.860896870779573597e-10 5.511521612758372157e-01 -8.844246024549246475e-14 2.154231466443203548e-10 5.511521613049743529e-01 -9.665833786968677757e-14 2.345548248411923024e-10 5.511521613239954709e-01 -1.012328486483025335e-13 2.452596021237108103e-10 5.511521613346633819e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 b/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 deleted file mode 100644 index 1bf7fcf3c..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton.hess_9 +++ /dev/null @@ -1 +0,0 @@ --1.085696372905541572e-02 9.590665263268892534e-05 9.531439138149214564e-05 -1.087285026672958968e-02 9.129668074690197891e-05 8.964512108417805713e-05 -1.089934659661038335e-02 8.160863448823787785e-05 7.822493441072447037e-05 -1.092682686540792300e-02 6.585541551986992125e-05 6.216889792445530818e-05 -1.094302784897970351e-02 4.310522445909330843e-05 4.237600179982345573e-05 -1.093527680815354307e-02 1.812953329046918349e-05 2.108092186155901765e-05 -1.089287161528582938e-02 7.344071357129744996e-06 6.594939876512081788e-06 -1.080919798872607106e-02 5.604808351519654382e-08 -3.993391807973187881e-09 -1.069588929542673698e-02 2.615170878308496592e-06 2.194626210053400472e-06 -1.057328834728593799e-02 1.108524983694688809e-05 1.120727782157434102e-05 -1.044759393770748959e-02 2.260531409994671328e-05 2.309346290038548358e-05 -1.032610521628437271e-02 3.529390394137225061e-05 3.537888812247984088e-05 -1.021661944063230812e-02 4.694183749082698993e-05 4.658032944241987516e-05 -1.012665834692254296e-02 5.625492706209476860e-05 5.549200116408882109e-05 -1.006269191828215032e-02 6.247154906752440319e-05 6.156020752526919959e-05 -1.002945765489209572e-02 6.547958504988935424e-05 6.456075885174450911e-05 -1.426098877749689628e-13 5.511521614411500902e-01 3.475414238766908071e-10 -1.320921894986668461e-13 5.511521614147902870e-01 3.209665411206837040e-10 -1.123101594909046259e-13 5.511521613652671236e-01 2.715115181134816178e-10 -8.463062761270496658e-14 5.511521612960196270e-01 2.034657580607797225e-10 -5.535126492102893174e-14 5.511521612229358658e-01 1.324208826049501644e-10 -3.506099971958651147e-14 5.511521611722933756e-01 8.293567698182739019e-11 -1.849231877642635688e-14 5.511521611314073033e-01 4.199581709678307785e-11 1.772930712047402462e-16 5.511521610890652845e-01 -3.335942107773004525e-13 -2.238535038211716216e-15 5.511521610960595785e-01 6.684575267222625209e-12 -1.339282445131259646e-14 5.511521611238613394e-01 3.463057584800269050e-11 -3.529396899725199245e-14 5.511521611766948547e-01 8.777378273058947547e-11 -5.986719046956684354e-14 5.511521612345834376e-01 1.457157943700589480e-10 -7.893264298332067380e-14 5.511521612786011159e-01 1.895646971066138161e-10 -9.218918789089945512e-14 5.511521613088231630e-01 2.195963003662377120e-10 -1.008884457477245563e-13 5.511521613285653709e-01 2.392338730603222662e-10 -1.057194886646725717e-13 5.511521613395681252e-01 2.502036541336534931e-10 -1.409077674744445075e-13 3.475414238766908071e-10 5.511521614328048768e-01 -1.302987810057701414e-13 3.209665411206837040e-10 5.511521614060141960e-01 -1.105391644434757785e-13 2.715115181134816178e-10 5.511521613566340294e-01 -8.334127062186571575e-14 2.034657580607797225e-10 5.511521612897717359e-01 -5.488815399957808363e-14 1.324208826049501644e-10 5.511521612207108678e-01 -3.507472473785358565e-14 8.293567698182739019e-11 5.511521611723598779e-01 -1.848286527359958550e-14 4.199581709678307785e-11 5.511521611313643376e-01 1.819132850479378267e-16 -3.335942107773004525e-13 5.511521610890475209e-01 -2.243490806533228033e-15 6.684575267222625209e-12 5.511521610960897766e-01 -1.345533259438369492e-14 3.463057584800269050e-11 5.511521611241835261e-01 -3.548431676155173012e-14 8.777378273058947547e-11 5.511521611776375451e-01 -6.008304928116954753e-14 1.457157943700589480e-10 5.511521612356322652e-01 -7.908117933379183647e-14 1.895646971066138161e-10 5.511521612793136571e-01 -9.225875569644150163e-14 2.195963003662377120e-10 5.511521613091547867e-01 -1.009140294601478637e-13 2.392338730603222662e-10 5.511521613286870513e-01 -1.057308899933572344e-13 2.502036541336534931e-10 5.511521613396230812e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener deleted file mode 100644 index e813a21b5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.10536570559224986 -1 0.10796937940537532 -2 0.11345960616975363 -3 0.1212624516109319 -4 0.13012394556425977 -5 0.13827782900531155 -6 0.14409064567424526 -7 0.1461902163768674 -8 0.14401559329086475 -9 0.1387049765671873 -10 0.1317616524444068 -11 0.12404435388233291 -12 0.11649826568505901 -13 0.11020034438699838 -14 0.10586150314813286 -15 0.10381457460636012 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz deleted file mode 100644 index 09c0da4a8..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.2338795766224093 -9.185751638307675e-06 -9.170594808261747e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.24478871062029 -9.405715807785623e-06 -9.328311511138299e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.26843265725372 -9.694546100464719e-06 -9.519057200421615e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.3044024213512357 -9.688289515450733e-06 -9.46497554037383e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.35178958288926 -8.952562167125351e-06 -8.800440971467672e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4090217878182414 -7.265583994519626e-06 -7.2406448204059026e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.473765291436546 -4.82102199576491e-06 -4.8093632178294764e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.54280841527487 -1.6558231290973311e-06 -1.6426613404654877e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.612485481280858 2.008439605194964e-06 2.0085838049465735e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.679250280047245 5.721026671731593e-06 5.741302436633021e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.740116443143028 9.125784238663506e-06 9.155702353045912e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.7926940222652745 1.19825512684691e-05 1.1998672079359658e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.8353763556322398 1.4164426280512515e-05 1.4163913412556703e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.86731134260644 1.5672671201531046e-05 1.5658821371351862e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.8881333553815858 1.658675162646438e-05 1.656988716663592e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.89771729893857 1.7011046116345982e-05 1.6996213671995334e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener deleted file mode 100644 index 5820aa4d5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.1218827567373583 -1 0.12376633885695405 -2 0.1272969907469428 -3 0.13190915937202585 -4 0.13685949957851087 -5 0.14135193350855776 -6 0.14464774056006036 -7 0.14614388040422033 -8 0.14551668791135072 -9 0.14303144824806435 -10 0.13935284143118107 -11 0.13518027539170005 -12 0.1310216710169069 -13 0.12736166466603177 -14 0.1246476483143118 -15 0.12321605103328478 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz deleted file mode 100644 index b792d0040..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.3074350985754792 -2.7549445591001885e-05 -2.7352321788586044e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.3168534649703165 -2.7260928517143696e-05 -2.6974934202558762e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.3355469623666747 -2.642582115050647e-05 -2.6021711310764623e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.3627851998948883 -2.4559776062448903e-05 -2.414989419429872e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.397472083680028 -2.120326802291498e-05 -2.0979659457108357e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4382415063512237 -1.6370401337991057e-05 -1.6352966160034544e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4835124163588627 -1.047798943323511e-05 -1.046722632809185e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.531489196698338 -3.559836390180045e-06 -3.543215189221622e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.58026448188705 4.0579951057478135e-06 4.0552552916313585e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.62790168507653 1.1727872727649345e-05 1.1761852754709526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.672529003922486 1.888166459121651e-05 1.89506807423656e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.7123277954572282 2.5099938374188027e-05 2.5148831092684477e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.7456996311400164 3.0094852780727954e-05 3.0106086573283223e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.771492611065614 3.375683321126147e-05 3.373742662541981e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7889712631403287 3.610981351920346e-05 3.607855987506698e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.79771729893857 3.7245504823328295e-05 3.721360291543399e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener deleted file mode 100644 index 36ef3dadc..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14507181525154492 -1 0.14517396274559144 -2 0.14536020010596862 -3 0.14559719728719883 -4 0.14584153592877977 -5 0.14604655231091665 -6 0.14616982161609277 -7 0.14618011947798115 -8 0.1460637857497645 -9 0.14583053706701643 -10 0.14550850210083763 -11 0.14513816768301444 -12 0.1447661137386723 -13 0.14443854893646796 -14 0.14419551128446056 -15 0.1440662831199471 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz deleted file mode 100644 index 6b6053094..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_10.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4921767953462934 -1.3276389746729271e-05 -1.324801755887069e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.494497114585103 -1.2759547064663646e-05 -1.272522095159673e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4990467736972333 -1.1744052734906709e-05 -1.1701948101932387e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5056472301255868 -1.0268051923100385e-05 -1.0224677958437996e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5140392262604623 -8.393785262540042e-06 -8.358809081030318e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5238930310716605 -6.211726529627295e-06 -6.186768006408851e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.53482187169405 -3.820271240190022e-06 -3.800476568943432e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5463980832822752 -1.2858885684741117e-06 -1.2788605237250551e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.558171191740101 1.308792148574084e-06 1.3002737348858843e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5696867327550046 3.877095658024553e-06 3.853930788802308e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.580504240525519 6.323072173381118e-06 6.288352976581608e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.590213910889867 8.547855163974295e-06 8.504365987738271e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5984514157282512 1.0455862728803362e-05 1.0406695256470188e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6049104261124336 1.196345037510925e-05 1.191124379427906e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6093526089185066 1.3004831922907856e-05 1.2951744118472913e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.611615033378179 1.3536150880341274e-05 1.34831404698838e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener deleted file mode 100644 index 99f382be3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14531323720381514 -1 0.14539501057208679 -2 0.1455438423654375 -3 0.14573259137473488 -4 0.1459259428647639 -5 0.14608600813779535 -6 0.14617843093734958 -7 0.14617805039150303 -8 0.1460740846473999 -9 0.1458745071982089 -10 0.14560224510858077 -11 0.14529055039961306 -12 0.14497793405448836 -13 0.14470283037066778 -14 0.14449871442730322 -15 0.14439016793831194 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz deleted file mode 100644 index 08def2ace..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_11.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4978555023581333 -1.2071018496214084e-05 -1.203923044164549e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.49995146175012 -1.159974886440837e-05 -1.1563146170658848e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.504061177182041 -1.0674312787077109e-05 -1.0631686822341612e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5100233895979915 -9.330312702677288e-06 -9.287672265204843e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.517604060487807 -7.625174315496494e-06 -7.591155216011376e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5265056888640256 -5.641359832505317e-06 -5.617393332533097e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.536379434307516 -3.46832568206946e-06 -3.4499738958467935e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.546839594093882 -1.1674862110622496e-06 -1.161037596283524e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5574797381760384 1.18620997085083e-06 1.1785208265130847e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5678894827351475 3.514678993818643e-06 3.4935318092411517e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.577670638152364 5.731756721937326e-06 5.699561223752687e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5864522703240316 7.748501196500922e-06 7.70741444267704e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.593904178618752 9.478622143726496e-06 9.431224555566321e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5997483789029516 1.0846228967869923e-05 1.0794926821529138e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.603768349252438 1.179132053602039e-05 1.1738298758559682e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.6058159391614715 1.2273668234503348e-05 1.2220204461951872e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener deleted file mode 100644 index 3550e922e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14550101339861735 -1 0.14556675210023756 -2 0.1456861697310506 -3 0.14583703672906578 -4 0.145990460893933 -5 0.14611549593391732 -6 0.14618415515819438 -7 0.14617604972762438 -8 0.1460826468388222 -9 0.1459105789285923 -10 0.14567871570277854 -11 0.14541457937245958 -12 0.14515021484922705 -13 0.14491776126564382 -14 0.14474533099623108 -15 0.14465363689020355 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz deleted file mode 100644 index c5322fc3a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_12.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5028344185254014 -1.0998857461509992e-05 -1.0964989009268716e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5047339371603576 -1.0568391128665952e-05 -1.0530644802286103e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.508458483914699 -9.723480503540058e-06 -9.681130401288073e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.513861970972987 -8.497279064483644e-06 -8.455877207131806e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5207324587689746 -6.942764133383971e-06 -6.910045026918555e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5288006367668006 -5.135257690500479e-06 -5.112452162180002e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5377507914815913 -3.1562851274023217e-06 -3.1392897684000942e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5472338351114856 -1.0625004038976983e-06 -1.0565759409439783e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5568817751983746 1.0779378009300926e-06 1.0709773250782013e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5663227478104065 3.194409293559749e-06 3.1750913899470306e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.575195581335811 5.209202131829228e-06 5.179433754904148e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.583163459254346 7.042001563913517e-06 7.003466566123488e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5899262150302516 8.6146743912908e-06 8.569537838211026e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.59523087619049 9.85822848948752e-06 9.808670596465747e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5988802144393963 1.0717883450075976e-05 1.0666052909407505e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.600739179487716 1.115674053118084e-05 1.1104109729942373e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener deleted file mode 100644 index 04bc6d28b..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14564842751143234 -1 0.14570141332180533 -2 0.14579745710500014 -3 0.14591827012574327 -4 0.14604010724900124 -5 0.1461375772861378 -6 0.14618778013720085 -7 0.14617412667941082 -8 0.14608985984227116 -9 0.1459405609456761 -10 0.1457418873591575 -11 0.14551676472400318 -12 0.1452919980213605 -13 0.14509457961024028 -14 0.14494820383507648 -15 0.14487037696387775 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz deleted file mode 100644 index e3fad801b..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_13.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.507238145205192 -1.0039596728063162e-05 -1.0004717858277204e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5089641612449 -9.645842953496683e-06 -9.607845582073404e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5123485324157397 -8.87330205483223e-06 -8.831830426322087e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.517258592047131 -7.752792367168526e-06 -7.712978793325162e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5235019240245604 -6.3331838743707035e-06 -6.301976425246004e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.530834087351979 -4.683394356581847e-06 -4.661835876327377e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5389685590181283 -2.877867992649277e-06 -2.862141783938421e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5475884965277293 -9.68819939041767e-07 -9.633720190439805e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.556359766856151 9.816351953312563e-07 9.753194399855342e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.564944479793461 2.909430850626571e-06 2.8917717977094113e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5730141719900153 4.74423769796953e-06 4.7167662405370145e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5802622364283145 6.413310974895875e-06 6.377351608392685e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.586415161513248 7.845730194260783e-06 7.803110931407914e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5912422234466983 8.97866880883221e-06 8.931359898617449e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5945633922587232 9.762066968886341e-06 9.712142709639232e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5962553148988246 1.0162077821842475e-05 1.0111116188322759e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener deleted file mode 100644 index 5e9148deb..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14576493287455977 -1 0.14580769251267692 -2 0.14588501062246853 -3 0.14598178813813772 -4 0.14607844165879905 -5 0.14615406542689888 -6 0.14618985880914565 -7 0.14617228628322373 -8 0.14609600373935153 -9 0.1459657554081768 -10 0.1457946237623688 -11 0.14560180806316425 -12 0.1454098282194614 -13 0.1452414357007765 -14 0.14511666075804922 -15 0.1450503367677918 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz deleted file mode 100644 index 9301db52e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_14.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5111606798170047 -9.17716465201022e-06 -9.14209699398304e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.512732368612636 -8.816577868396755e-06 -8.779002960870806e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5158141698633125 -8.109353634134987e-06 -8.069194533296695e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.520285365072544 -7.08409947991164e-06 -7.0461012662288805e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.525970900784018 -5.785893776645757e-06 -5.756316663153289e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.532648428931612 -4.277880063268686e-06 -4.257600290609066e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.540057335642029 -2.6281451152008435e-06 -2.6136027364501277e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.547909388594844 -8.847882149724919e-07 -8.797751920618605e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5559005074643006 8.954870475966005e-07 8.897450771580096e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5637229909940498 2.6544170639033133e-06 2.6382637982080897e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5710774875741813 4.32817859546898e-06 4.302859819205327e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.577684328375182 5.850720214094866e-06 5.817285713819333e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5832938181144174 7.157537779143814e-06 7.117541342107683e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.587695151905635 8.191337616671355e-06 8.146558542657256e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.590723724972326 8.906336552771299e-06 8.85875252889686e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5922666906740184 9.271483047664874e-06 9.22271432125168e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener deleted file mode 100644 index 13a714d47..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14585742968318877 -1 0.145891937157076 -2 0.1459541591543073 -3 0.1460315965354697 -4 0.1461080550645742 -5 0.14616627709284385 -6 0.14619079018478412 -7 0.1461705308587385 -8 0.14610128567098943 -9 0.14598712295446123 -10 0.14583903975605428 -11 0.14567318811527613 -12 0.1455085575411223 -13 0.14536438269747914 -14 0.1452576384569077 -15 0.1452009197308146 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz deleted file mode 100644 index 4bf2ce396..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_15.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.514674653724253 -8.39865755125476e-06 -8.364013558493722e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.516108280977219 -8.068135746999766e-06 -8.0314748015058e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.518919407184956 -7.4200697244202336e-06 -7.381521127264969e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.522998005935406 -6.4809847053834766e-06 -6.444935451178229e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.528184548668528 -5.292459045693392e-06 -5.264565366422552e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.534276425503741 -3.912408013486879e-06 -3.893402865711144e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5410361558768186 -2.403184668353743e-06 -2.389744168663515e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5482010474481345 -8.090838370567383e-07 -8.044688204007217e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5554938583688744 8.180580447487112e-07 8.12829237991536e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.562633876668864 2.425150202622308e-06 2.4103654611660335e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5693478151015254 3.954144548228666e-06 3.930830819117997e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5753801633443465 5.344945341010591e-06 5.313941110176764e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5805026225785443 6.538785515546165e-06 6.501420455437681e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5845223140253974 7.483354024743117e-06 7.44123557359131e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5872885365407745 8.136749433453178e-06 8.091746728393349e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.588697925294315 8.470480065963727e-06 8.424211181622526e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener deleted file mode 100644 index e0fcd9f41..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14593106259329333 -1 0.14595887867467452 -2 0.14600887285703046 -3 0.14607067729174922 -4 0.1461308736865991 -5 0.1461751888260367 -6 0.14619086815873902 -7 0.1461688610702842 -8 0.1461058623930108 -9 0.14600538807848898 -10 0.14587673126746956 -11 0.14573353408884454 -12 0.1455918594797743 -13 0.14546801044261723 -14 0.1453764026933027 -15 0.14532774930608364 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz deleted file mode 100644 index 0610d73e0..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_16.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.517837351297163 -7.693557681738099e-06 -7.65978157136043e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5191468862314457 -7.390364970425837e-06 -7.354964567677565e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.521714726159168 -6.796035141959011e-06 -6.759289056756867e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5254404537010084 -5.935139664155653e-06 -5.9011033185232035e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.530178484065014 -4.84602590940882e-06 -4.819822787504635e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.535743924427901 -3.5818589458487313e-06 -3.564100898688256e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5419200498331627 -2.1998008250091734e-06 -2.187384316190748e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.548467081360569 -7.406360840098942e-07 -7.36386075477269e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.555131866109404 7.481939173454505e-07 7.434259394522509e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5616579408849867 2.218234569241501e-06 2.2046951623524977e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5677954671898977 3.616594321568272e-06 3.59514050566153e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.573310701115036 4.888504508967804e-06 4.859811291683616e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.577994651715873 5.9803497755125294e-06 5.9455626502972934e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5816706410529053 6.844319777815635e-06 6.80489224755034e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.584200550541177 7.442042295574501e-06 7.399729706863217e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5854896054640495 7.747370095026103e-06 7.703757656100504e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener deleted file mode 100644 index 6fcc384cd..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14598973741002735 -1 0.14601210828441796 -2 0.14605216363214474 -3 0.14610129075562694 -4 0.14614835559959635 -5 0.14618153787961302 -6 0.14619031288778522 -7 0.1461672764641134 -8 0.1461098547743081 -9 0.1460211074781575 -10 0.1459089249914491 -11 0.1457848694949361 -12 0.14566256546387363 -13 0.14555586142969185 -14 0.1454770217211532 -15 0.14543517240934076 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz deleted file mode 100644 index 9fdc6474b..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_17.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.520694797519738 -7.053174252077996e-06 -7.0205781154123785e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.521892363610902 -6.7748808218525835e-06 -6.7409747064577144e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.52424068517744 -6.2294792284398454e-06 -6.1946467671376885e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5276480112230924 -5.439713181387034e-06 -5.407702564909302e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.531981327034601 -4.440947231092299e-06 -4.416409847539191e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5370717042698536 -3.2820185989588404e-06 -3.265465010442283e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.542721115180289 -2.0153748000622902e-06 -2.003908754351896e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5487104225683987 -6.785647664080169e-07 -6.74650026074427e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.554808184260509 6.849517828777304e-07 6.80599055551547e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5607798124592698 2.030893776139899e-06 2.0184889466718176e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5663966476849414 3.3109961189352297e-06 3.2912627840369e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5714446316598942 4.475275678490811e-06 4.448761662494998e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5757322596510925 5.4747598370227585e-06 5.442458342815548e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.579097545637557 6.265714171047673e-06 6.228941068648433e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.58141379522039 6.8129799670672295e-06 6.773375946871023e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.58259404028119 7.092557601957448e-06 7.051654331632527e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener deleted file mode 100644 index 3a2e811d9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14603646512958915 -1 0.14605439378948806 -2 0.1460863515906229 -3 0.14612517657160506 -4 0.14616162130895852 -5 0.14618588913954697 -6 0.14618929153422708 -7 0.1461657758250755 -8 0.1461133576078558 -9 0.14603471600903162 -10 0.14593657907753424 -11 0.14582877642876602 -12 0.14572289203991054 -13 0.14563071208607467 -14 0.1455626868287929 -15 0.145526600516353 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz deleted file mode 100644 index 8b2bcd8d6..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_18.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.523284584451226 -6.47023323319693e-06 -6.4390268806534315e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.524380797466942 -6.214668248711744e-06 -6.182403556526163e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5265304115002776 -5.713905244778648e-06 -5.6810366719330255e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5296495149164144 -4.988981976704162e-06 -4.9589729553182325e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.533616459651903 -4.0725091289968685e-06 -4.049590822640548e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.538276748882584 -3.0093719988153825e-06 -2.9939707999300376e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5434492539272147 -1.8477251095915333e-06 -1.8371404324609802e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5489334961943726 -6.221366261480392e-07 -6.18530194368931e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5545176677016523 6.275505231842509e-07 6.235730517543269e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5599869811897107 1.8608259450387533e-06 1.849455902294815e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5651319682364666 3.0335919678956673e-06 3.015447041766392e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5697564296726676 4.100180080736201e-06 4.075708611375547e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5736847439979718 5.015814391586227e-06 4.985882839789928e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5767682860357963 5.740459838167104e-06 5.706261023178329e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5788907613907677 6.241887573706787e-06 6.204949503891107e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.579972314504694 6.498065818503665e-06 6.45985324511668e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener deleted file mode 100644 index b98dcf026..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.1460735971871513 -1 0.14608789614671538 -2 0.14611324715300134 -3 0.1461436909117923 -4 0.14617154286582434 -5 0.1461886807404172 -6 0.14618793236211292 -7 0.1461643573934218 -8 0.14611644634392668 -9 0.14604655825255256 -10 0.14596045242238306 -11 0.14586650885993263 -12 0.1457745978511565 -13 0.14569476746313498 -14 0.1456359344767502 -15 0.1456047461994885 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz deleted file mode 100644 index e0d3da7d8..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_19.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5256378739057546 -5.938574594729835e-06 -5.908889481380335e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5266421000577486 -5.703788758458451e-06 -5.673246880528651e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5286113670481285 -5.2438170855883446e-06 -5.2129175115151606e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5314688720740617 -4.578108004979984e-06 -4.550050229661182e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5351032719557587 -3.736729654294182e-06 -3.7153692237762658e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5393731505600194 -2.7609521147986166e-06 -2.7466457477416266e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.544112695358054 -1.6950123616966028e-06 -1.6852443346424786e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5491383414196433 -5.707333470162801e-07 -5.674106746568626e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5542560872367845 5.753347033394243e-07 5.716971655395702e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.559269117643049 1.7060982588058524e-06 1.6956728984135393e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.563985400341855 2.7812259951572505e-06 2.764545516129739e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.56822497954963 3.758951238064402e-06 3.7363857395284642e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.571826695865793 4.59830133176426e-06 4.570611087755387e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5746541022474894 5.262605091030425e-06 5.230872802877559e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.576600392415166 5.7223079571569885e-06 5.687952735042317e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5775922044085027 5.957181798528656e-06 5.921593408148685e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener deleted file mode 100644 index b30ede3ad..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13215069260352774 -1 0.13328510893692233 -2 0.13537171624379446 -3 0.13807397493098747 -4 0.14095577438872078 -5 0.14354714187596584 -6 0.14540427362568062 -7 0.14618109793552514 -8 0.14570515432718495 -9 0.1441159919601345 -10 0.14176328813689582 -11 0.1390588814734445 -12 0.1363878226794033 -13 0.13405004067180762 -14 0.1323142173401438 -15 0.13138958915111779 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz deleted file mode 100644 index 4f36e38a9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.364323858992897 -3.21302890404229e-05 -3.175314716381922e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.371732200103478 -3.1199701014820686e-05 -3.080300747127244e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.3862532218151973 -2.9210080225181126e-05 -2.882046577736939e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.407302347150796 -2.6000751756865886e-05 -2.5717840765881742e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4340446487983325 -2.155840078508938e-05 -2.1463327430153236e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.465425594656004 -1.6144076871256915e-05 -1.6169971894384257e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5001954966012505 -1.0092185154133942e-05 -1.008591965354794e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.536967358603013 -3.4054648798906628e-06 -3.3960013603990644e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.574299236618819 3.6694180957604696e-06 3.6570839783610146e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6107522769358993 1.075195020401925e-05 1.0745134983323968e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6449471097364863 1.7442300096795135e-05 1.7476725846182658e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.675607563100251 2.342081851187232e-05 2.348266006265242e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.7015854291772983 2.8423387207892355e-05 2.8483746211964207e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.721912113759738 3.226358216224244e-05 3.2305154771168974e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7358556128588702 3.4841327445866185e-05 3.48661069562564e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.7429409318400273 3.612747322621849e-05 3.614435816544613e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener deleted file mode 100644 index 950b0691b..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14610299004434638 -1 0.1461143209598003 -2 0.1461342783876785 -3 0.14615790239061627 -4 0.1461788061086883 -5 0.14619025589256793 -6 0.1461863345517825 -7 0.14616301901253184 -8 0.14611918183653605 -9 0.1460569107242362 -10 0.14598115347414642 -11 0.14589907256290216 -12 0.14581909458534859 -13 0.1457497990455623 -14 0.14569880371011887 -15 0.1456717908416544 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz deleted file mode 100644 index b80f1ace6..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_20.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5277808418497556 -5.452925524068329e-06 -5.42483363862466e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5287013982173656 -5.2371609529024105e-06 -5.208373910028507e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5305066216494785 -4.814514792107188e-06 -4.785556332805183e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.53312616912275 -4.20295704234877e-06 -4.176782056877412e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.536458059884827 -3.4302084192261946e-06 -3.4103354230298626e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5403727606321893 -2.5342269647285205e-06 -2.520955123512588e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.544718372378705 -1.5556684004871101e-06 -1.5466565488753794e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5493266981027154 -5.238277483652123e-07 -5.207664039120683e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5540199230508613 5.277479728753768e-07 5.244190003218137e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5586175818812276 1.5650691111766743e-06 1.5555069079532224e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.562943518832399 2.5512175767689772e-06 2.5358859085943824e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.566832582923334 3.4479642010519137e-06 3.427171289175369e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5701368089654286 4.217790380669289e-06 4.192206928982363e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5727308707494965 4.827088608811384e-06 4.7976986257294955e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.574516633425285 5.248747712360092e-06 5.216866304574428e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5754266734728652 5.464193183270067e-06 5.43113090463804e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener deleted file mode 100644 index 639fe4989..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14612612279116377 -1 0.1461350267093396 -2 0.1461505819585336 -3 0.14616866054111322 -4 0.14618395507536927 -5 0.14619088557470014 -6 0.14618457518693487 -7 0.14616175823119754 -8 0.1461216137483958 -9 0.14606599780158838 -10 0.14599917528797074 -11 0.1459272826323046 -12 0.14585752694622905 -13 0.1457972442301277 -14 0.14575294990845486 -15 0.14572950589787578 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz deleted file mode 100644 index bb46c0468..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_21.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.52973573867271 -5.0087287787006606e-06 -4.9822574328182e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.53058005119123 -4.810394468681984e-06 -4.783357666260589e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5322357875234007 -4.421939911959253e-06 -4.394871053742768e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5346384848970596 -3.8599615838512295e-06 -3.8355889276088e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.537694684111002 -3.150013021798432e-06 -3.1315516323148965e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.541285666748163 -2.3270144144971515e-06 -2.3147159563690284e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5452721975666908 -1.4283429244929488e-06 -1.420030843153231e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5495000702842656 -4.809658507586134e-07 -4.781452830815349e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.553806213166685 4.843131636964261e-07 4.81264767554189e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.558025063045915 1.4363297927933545e-06 1.4275568451289175e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5619949468550884 2.34126627470156e-06 2.327176005143067e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5655642304934694 3.1641074797345885e-06 3.1449588857964234e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.568597005791832 3.870477428330999e-06 3.846865145413501e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5709781173404282 4.429562648566767e-06 4.402382072557114e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5726173666838354 4.816486256329617e-06 4.786954018590488e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5734527684351556 5.014190225610846e-06 4.983536204383933e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener deleted file mode 100644 index 7de805b43..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14614418278334312 -1 0.1461511035560609 -2 0.1461630693292825 -3 0.14617664564525049 -4 0.14618742430857115 -5 0.14619078503245037 -6 0.14618271433122174 -7 0.14616057237945188 -8 0.14612378303936388 -9 0.14607400335879525 -10 0.14601492117017711 -11 0.14595180562976995 -12 0.14589083135291916 -13 0.14583827944530695 -14 0.14579972847939024 -15 0.14577934216293614 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz deleted file mode 100644 index fe2721f0f..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_22.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5315216793696282 -4.602011240208584e-06 -4.577154591411419e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5322964091397244 -4.419662847648406e-06 -4.3943449658836e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5338157155731813 -4.062557173436959e-06 -4.037309955681831e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5360204965025828 -3.546016001788472e-06 -3.523357790763477e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.538825060726089 -2.89359224519452e-06 -2.8764640494584878e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.542120548223945 -2.137417112457624e-06 -2.126031386125557e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.545779268558212 -1.3118627806760578e-06 -1.3041979371296326e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.549659773218942 -4.4175320031170183e-07 -4.391545426149361e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5536124402712583 4.4461720572807357e-07 4.41824311576397e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.557485310575888 1.3186602512223475e-06 1.310609454980475e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5611299420944924 2.1493796890311382e-06 2.136431345200618e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.564407059213267 2.9046857864460114e-06 2.88705949071574e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.567191786247367 3.553066228186324e-06 3.5312915779178104e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.569378281266869 4.066258585751773e-06 4.041151261937213e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.570883617934708 4.421430526770461e-06 4.394114520208813e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5716507963235253 4.602915077930829e-06 4.574540090111892e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener deleted file mode 100644 index 38975a898..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14615812909106254 -1 0.14616343172038415 -2 0.14617247580050768 -3 0.1461824056338953 -4 0.1461895627721617 -5 0.1461901259896966 -6 0.14618079878596005 -7 0.14615945862716437 -8 0.14612572381364505 -9 0.14608107940432186 -10 0.14602872374740541 -11 0.14597319097959752 -12 0.1459197797372712 -13 0.14587387478245173 -14 0.14584025745137436 -15 0.14582249656697024 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz deleted file mode 100644 index c649e6885..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_23.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.533155240853861 -4.229282179290134e-06 -4.206010178061339e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.533866386465488 -4.061605168717239e-06 -4.037955804953958e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5352610216228846 -3.7332629722343146e-06 -3.7097584755565822e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5372849371236734 -3.258395504358826e-06 -3.2373598556163697e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5398595319307926 -2.6587089932251337e-06 -2.642835019901316e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5428849444029606 -1.963772247285397e-06 -1.9532400063965197e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5462440230624956 -1.2052005703102147e-06 -1.19813409787814e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5498069687260685 -4.058443215955202e-07 -4.034502264481451e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5534364460172436 4.0829955070153903e-07 4.0573961723986964e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5569929309311856 1.2109951129995598e-06 1.203605444914069e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5603400839284802 1.973818026790387e-06 1.9619196886794158e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5633499419218846 2.667345271738591e-06 2.651126108086472e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5659077352082464 3.2626773914567663e-06 3.242611024805476e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5679161589040147 3.733883410277202e-06 3.7107136715848386e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.56929895639391 4.060003071619387e-06 4.034767229283991e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5700037022766216 4.226645679118118e-06 4.200415126068886e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener deleted file mode 100644 index ffa263bcf..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14616874025221727 -1 0.1461727254172044 -2 0.1461793974084925 -3 0.14618638384830412 -4 0.14619065184196486 -5 0.14618904583456696 -6 0.14617886492060966 -7 0.14615841403139432 -8 0.14612746471130686 -9 0.14608735258981947 -10 0.14604085936079714 -11 0.1459918947094713 -12 0.14594501271606516 -13 0.1459048354288914 -14 0.1458754649902771 -15 0.14585996290783465 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz deleted file mode 100644 index ea08080c4..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_24.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5346509193829942 -3.887453674774563e-06 -3.8657189902232226e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.535303900839933 -3.733249119924355e-06 -3.7112046739105024e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5365844893286424 -3.4313138357341044e-06 -3.4094663567745863e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5384429464725558 -2.9946928173374698e-06 -2.975186392982657e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.540807149719152 -2.4433879145691504e-06 -2.4286900885055556e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5435854599504024 -1.804612330238178e-06 -1.7948763489608578e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5466703573547615 -1.107450169101976e-06 -1.1009366575163458e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5499426920644583 -3.729344934468321e-07 -3.707289917205797e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.553276365229327 3.750431841890309e-07 3.726958871258823e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5565432317894605 1.1123972845607282e-06 1.1056131779103886e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.559618033739103 1.8130510219760318e-06 1.8021178846221581e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.562383172981317 2.450015390435012e-06 2.4350952961157357e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5647331453127133 2.9967775801389704e-06 2.9782956680054374e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.566578477609787 3.4295391450468866e-06 3.408174362223273e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5678490351342225 3.7290548791470592e-06 3.705763622182854e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5684965929418655 3.882105285768668e-06 3.857883436314316e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener deleted file mode 100644 index b24127a6a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.1461766507293472 -1 0.146179566395736 -2 0.14618431909114293 -3 0.14618894022920037 -4 0.1461909190369592 -5 0.14618765463214942 -6 0.14617694092210726 -7 0.14615743557583016 -8 0.14612902997047988 -9 0.14609292918179909 -10 0.14605155908052586 -11 0.14600829764961157 -12 0.14596706506110194 -13 0.14593183352281472 -14 0.14590612596563124 -15 0.14589257091101612 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz deleted file mode 100644 index a26a5bfb6..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_25.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.536021485178015 -3.573777717926147e-06 -3.5535210802891476e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5366212135342963 -3.4319502142174583e-06 -3.4114384018567856e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.537797382470495 -3.1542699230836596e-06 -3.133990131533218e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5395043423639603 -2.752768197649831e-06 -2.734698076880939e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.541675895655521 -2.245874070849589e-06 -2.2322762416932765e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.544227923836711 -1.6586342604108595e-06 -1.6496397335949948e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5470617179652018 -1.0178074350705e-06 -1.011804723333238e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.550067872608832 -3.427532676585266e-07 -3.407216461935098e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.553130574762637 3.4456756858726693e-07 3.4241453582850976e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5561321011478846 1.022037212335664e-06 1.0158080104582596e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5589573490002135 1.6657240813160248e-06 1.6556779969493021e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5614982244819515 2.250863196412341e-06 2.23714122464981e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5636577244432113 2.753123805802293e-06 2.736108833130909e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5653535652650445 3.150659418555622e-06 3.1309716933366696e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.566521234670779 3.425796732214583e-06 3.4043174617758943e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5671163668873884 3.566391209606492e-06 3.5440441645352604e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener deleted file mode 100644 index 2b368dd13..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14618237910356155 -1 0.14618442987650948 -2 0.1461876364679404 -3 0.14619036770110008 -4 0.14619054863757955 -5 0.1461860405496274 -6 0.14617504847183463 -7 0.14615652020452657 -8 0.14613044024849883 -9 0.14609789890702132 -10 0.14606101724055306 -11 0.1460227195597517 -12 0.14598638550157045 -13 0.14595543295165522 -14 0.14593289044274196 -15 0.14592101667920937 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz deleted file mode 100644 index 123813ca3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_26.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5372782604979167 -3.285795984739361e-06 -3.266950289034529e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5378291962716126 -3.155343259848787e-06 -3.1362865569717127e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.5389096897857013 -2.8999499351693045e-06 -2.881147242095078e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.540477833584269 -2.530709560241822e-06 -2.513984597901145e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5424728530963976 -2.064599979903166e-06 -2.05202863245128e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.544817513870714 -1.5246746689731614e-06 -1.5163694555426748e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5474211734408443 -9.355548458583541e-07 -9.30023819296776e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5501833499150903 -3.150593076775602e-07 -3.1318800161787926e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5529976532474845 3.16623041822788e-07 3.146476295757116e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.555755912365839 9.391764124431578e-07 9.334558881635222e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.558352337334431 1.5306313929103749e-06 1.5214004125435196e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.560687554902231 2.0682570225195394e-06 2.055639198318159e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.562672366166669 2.529719142226776e-06 2.514060323416191e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.564231090947336 2.8949590068551013e-06 2.876826248774337e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.565304383270155 3.1477445744580268e-06 3.1279493454026916e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.565851424573891 3.276918086601852e-06 3.256315808502098e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener deleted file mode 100644 index 57dd8f5c6..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14618635013361636 -1 0.14618770484402785 -2 0.14618967287951382 -3 0.14619090499047527 -4 0.14618968999375448 -5 0.14618427410300944 -6 0.14617320389548485 -7 0.14615566485049944 -8 0.14613171326299673 -9 0.1461023379594032 -10 0.14606939812575723 -11 0.14603543021814674 -12 0.14600335229271724 -13 0.14597610887362863 -14 0.14595630613217556 -15 0.14594588669530625 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz deleted file mode 100644 index 1b6dc0c18..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_27.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.5384313403265324 -3.0212993287421566e-06 -3.0037927690519255e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.538937542993439 -2.901303231325987e-06 -2.883621482489473e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.53993031923794 -2.666394772466744e-06 -2.648979086875019e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.541371188767723 -2.3268003533173225e-06 -2.311332145242199e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5432043437873295 -1.8981590708775887e-06 -1.8865437970912612e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5453588554391344 -1.4016900657919814e-06 -1.3940248185490666e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.547751471205801 -8.600491356987235e-07 -8.549535305333467e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5502898864182515 -2.896362352161764e-07 -2.8791273258843257e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.552876349134074 2.909863231874774e-07 2.8917342493767116e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5554114488393234 8.631542494184115e-07 8.579001805097841e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5577979407606226 1.4066943341887998e-06 1.3982122605269146e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.55994445735569 1.9007373056600699e-06 1.8891363803349417e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5617689676686286 2.3247771315169712e-06 2.310370560648445e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.563201859252653 2.660393258248543e-06 2.64369981814146e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5641885351157097 2.892675557593884e-06 2.874442156078576e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.564691438318159 3.011372225757741e-06 2.9923898841104494e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener deleted file mode 100644 index 5348c7e5f..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14618891219376745 -1 0.14618971008791523 -2 0.14619069285692718 -3 0.14619074675827123 -4 0.14618846409317182 -5 0.14618241151631267 -6 0.14617141921891547 -7 0.14615486646029333 -8 0.14613286429786435 -9 0.1461063113759214 -10 0.1460768412658764 -11 0.14604665821587223 -12 0.14601828558184748 -13 0.14599426324267784 -14 0.1459768362587751 -15 0.14596767693653578 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz deleted file mode 100644 index 2997257f5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_28.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.539489769388331 -2.778294786708683e-06 -2.7620532322187327e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.5399549397086063 -2.6679134056017637e-06 -2.651525781648829e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.540867253810237 -2.451837953321239e-06 -2.4357209647274565e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5421913717972884 -2.1394934218971788e-06 -2.1251969696172193e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.543876037350898 -1.745284095938837e-06 -1.7345578885411274e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5458561006146945 -1.288740699207388e-06 -1.2816689125315263e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.548055083072409 -7.907112501068292e-07 -7.860174682037419e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5503881775583714 -2.662892556584396e-07 -2.6470201249509634e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5527655550425323 2.6745687298069853e-07 2.6579275507732033e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5550958436025497 7.933772213693751e-07 7.885510138635856e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.557289642902563 1.2929439691975601e-06 1.2851499278869605e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5592629379497356 1.7469929280399153e-06 1.736328070915664e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5609402838161444 2.136692905306344e-06 2.1234415222088143e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5622576454300225 2.4451251556212313e-06 2.4297621411462015e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.5631647924890286 2.658592346747734e-06 2.6418049339364744e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.5636271678982587 2.7676745259933693e-06 2.7501933407670717e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener deleted file mode 100644 index 9226a811d..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14619035118482168 -1 0.14619070699962955 -2 0.14619091286669983 -3 0.1461900516834462 -4 0.14618696880233711 -5 0.14618049740360584 -6 0.14616970302480536 -7 0.14615412201583527 -8 0.1461339066076566 -9 0.14610987493352684 -10 0.14608346566825425 -11 0.14605659799922505 -12 0.1460314573249148 -13 0.1460102372726762 -14 0.14599487391951996 -15 0.14598680823928564 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz deleted file mode 100644 index c1495b71f..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_29.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.540461685335739 -2.5549784228003915e-06 -2.5399272013561747e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.540889201874614 -2.4534391447011732e-06 -2.4382655931849438e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.541727677502115 -2.2546812873915327e-06 -2.239777382154798e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5429446512904574 -1.967389528172729e-06 -1.954183674554429e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.544493039798159 -1.604829398997112e-06 -1.5949288116853977e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5463129920858996 -1.184977307557958e-06 -1.1784553051410164e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5483342419943114 -7.270181088389714e-07 -7.226950406123698e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.550478859856288 -2.4484239066381697e-07 -2.433807543641649e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5526642868502076 2.4585391534848e-07 2.443260745761545e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.554806530261252 7.293101936704286e-07 7.248765463383169e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5568233936762144 1.188506726603352e-06 1.1813447597905433e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5586376170955685 1.605841851793353e-06 1.5960383058374792e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5601798087781122 1.9640195362154016e-06 1.9518329665617193e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5613910616601223 2.2474983314934323e-06 2.233363695994186e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.562225161548596 2.443693865256606e-06 2.4282433063293773e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.562650311001014 2.543950076112425e-06 2.527857795030063e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener deleted file mode 100644 index 9f2b4b6e4..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13730005931925504 -1 0.1380263193144624 -2 0.1393625420912121 -3 0.1410935303665471 -4 0.14293716379640234 -5 0.14458341448204173 -6 0.14574172573696764 -7 0.1461897719489444 -8 0.14582003550694525 -9 0.14471614537009053 -10 0.14309284388477816 -11 0.1412151846162187 -12 0.13935144743980363 -13 0.1377361662400586 -14 0.1365475347377668 -15 0.13591719426786755 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz deleted file mode 100644 index ad1c76860..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4009608426328675 -2.8904657150706698e-05 -2.868143364165211e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.406903467268721 -2.7875295723634033e-05 -2.7659716158651015e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4185613652253113 -2.580148534367715e-05 -2.5613442592225842e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4354858070567995 -2.2693024412792684e-05 -2.257318915222118e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4570177815148266 -1.864543495098748e-05 -1.8614701027679715e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.482306753584194 -1.3878704557412737e-05 -1.3887232390480516e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5103404521592325 -8.614572871996745e-06 -8.594436618526293e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5399967096545355 -2.9013507939016763e-06 -2.889667543851606e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.570100048241808 3.0644119809364467e-06 3.0482615874032357e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.599477620286296 9.022352945822206e-06 8.994113891237364e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6270081717226104 1.4684831611597494e-05 1.4673629731984437e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6516641085675476 1.9794118555610665e-05 1.9808189702512577e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.672543755587326 2.413005768173983e-05 2.41596788632578e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6888916205073716 2.7515183754154874e-05 2.7547500590664236e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7001222861407768 2.9825165719030634e-05 2.9855533864465776e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.705837935326308 3.099247302498524e-05 3.1021310943403594e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener deleted file mode 100644 index 556bc6be1..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14012532125120616 -1 0.140626954863258 -2 0.14154940993031565 -3 0.14274279732691947 -4 0.14400919179695326 -5 0.14513203307607322 -6 0.14591020433901125 -7 0.14619092247254367 -8 0.14590119314633332 -9 0.1450942228590483 -10 0.14391274217389113 -11 0.14254020802020273 -12 0.14116887538107245 -13 0.1399739292874756 -14 0.13909626148316284 -15 0.13863276345665468 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz deleted file mode 100644 index 8eb74a343..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4257239412264444 -2.5494602628807726e-05 -2.5413055981510076e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4306778163137257 -2.454126163066722e-05 -2.445895661313423e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4403961930089575 -2.264938940188235e-05 -2.257108318180708e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4545045975384263 -1.98650875665116e-05 -1.980877230413782e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4724528231310012 -1.6291177429746135e-05 -1.6268591835590522e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.493531330038712 -1.2102897505880344e-05 -1.2093638832877361e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.516900603954207 -7.486762530355334e-06 -7.460655021618994e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5416295172338623 -2.5198428232604326e-06 -2.507899226777324e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.56673936043896 2.6318656088017365e-06 2.6155652555991164e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5912505533001795 7.76660003321155e-06 7.731566331945259e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6142243454573175 1.265718805377277e-05 1.2624045980761357e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.634798608525713 1.7086294277400142e-05 1.7066968150502447e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.652217378499661 2.0860212055635625e-05 2.0857014989239654e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.665852654372874 2.382187802324463e-05 2.382966189870507e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6752188234096943 2.5854316828847134e-05 2.5868733971239862e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.679985437728454 2.6885985767812875e-05 2.690376779925973e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener deleted file mode 100644 index 3cb39cd44..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14186095700325374 -1 0.1422245723072115 -2 0.1428923768233226 -3 0.14375398748087362 -4 0.14466418806756076 -5 0.14546495780119817 -6 0.1460103114107636 -7 0.146190081464537 -8 0.14595236309497425 -9 0.14533364698494589 -10 0.14443465567724204 -11 0.1433889186155001 -12 0.14234009106122228 -13 0.1414223057874322 -14 0.1407457473380864 -15 0.1403876736568159 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz deleted file mode 100644 index f9f4f59b1..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4438887872435737 -2.256442473822189e-05 -2.2542048410747825e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4481243921507145 -2.1707400387203864e-05 -2.167714895860535e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.45643228450216 -2.0015115858108776e-05 -1.9974198412513763e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4684899062092254 -1.753820832738212e-05 -1.749751537278912e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4838246194765468 -1.4369394865396784e-05 -1.4342977923739563e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5018306576401033 -1.0661327398684874e-05 -1.064293807693066e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.521793514829252 -6.581367084899604e-06 -6.554475237527975e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5429210517181167 -2.2147906126130797e-06 -2.203668589794198e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.564380097960494 2.2939628889330877e-06 2.2790330292705258e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.585335197461291 6.779087636264441e-06 6.743887921550519e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6049837040493293 1.1053321960841031e-05 1.1012179461363124e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6225864031189676 1.4931339522322942e-05 1.4894727775748625e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6374932295276428 1.8242780671599406e-05 1.8216526194915964e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6491634473376284 2.0846673663446312e-05 2.083110250306828e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6571802497690458 2.2637390369739697e-05 2.2630517523418283e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.6612603231089462 2.3548067310400284e-05 2.354613029350873e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener deleted file mode 100644 index 92f1a53fd..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14299471108667383 -1 0.14326718277069492 -2 0.14376687644554512 -3 0.14440991683561794 -4 0.14508631706760527 -5 0.1456768082582106 -6 0.14607164376689302 -7 0.14618846607926103 -8 0.14598894195393086 -9 0.14549933015005198 -10 0.14479383634993914 -11 0.14397328994593528 -12 0.14314838669730912 -13 0.14242442763806792 -14 0.1418893690287784 -15 0.14160569574970738 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz deleted file mode 100644 index bd9b5bb1b..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4577759016511185 -2.0089600595352772e-05 -2.0082045223699492e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4614600121790113 -1.932128515330706e-05 -1.9303177568408475e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.468685004390671 -1.780656372481563e-05 -1.77732214974945e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4791687442734744 -1.5593717376448624e-05 -1.5554479394960527e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.492499637365905 -1.2768315878182564e-05 -1.27375604654154e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.508151688447839 -9.466141408434825e-06 -9.442988513947507e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5255055330938885 -5.836214728563187e-06 -5.810233616182793e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5438751134372652 -1.96401503111777e-06 -1.9538744380996838e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5625386472611393 2.023156222690062e-06 2.009830716151849e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5807712558339873 5.983790654526376e-06 5.950731977184681e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.597874925247827 9.758579539384151e-06 9.715879551066107e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.613205068829001 1.3187095623195786e-05 1.3142930712137036e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.626193189633324 1.611907740633869e-05 1.607941508303544e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.636365048455572 1.8427972727788205e-05 1.8395160570537605e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6433542850005005 2.0017796548255627e-05 1.9991871709330826e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.6469118563384204 2.0827031849996838e-05 2.0805462630372526e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener deleted file mode 100644 index 62db10435..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14377875551042651 -1 0.14398761054192102 -2 0.14437010837394207 -3 0.14486107396291503 -4 0.14537522169216768 -5 0.1458203195743522 -6 0.14611179126660812 -7 0.1461864899688813 -8 0.14601540777031038 -9 0.14561821691015167 -10 0.14505136708502023 -11 0.144393078764371 -12 0.14373059929391033 -13 0.14314812074876274 -14 0.14271686361712765 -15 0.14248794108248958 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz deleted file mode 100644 index d103efae0..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4688652684983596 -1.7995788720794388e-05 -1.7985470376468053e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.47210915165591 -1.730365418890276e-05 -1.728317883311388e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4784703032118096 -1.5940547997913913e-05 -1.5905593871264364e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.48769973095205 -1.3952372200641325e-05 -1.3911370325481488e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4994348223480203 -1.1418236002772119e-05 -1.138461493285238e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.51321298415292 -8.459981794908749e-06 -8.434782996020102e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5284902868922963 -5.211189425502463e-06 -5.186690122539128e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.544664681082524 -1.7537628735476904e-06 -1.7445478680424073e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5611026204674263 1.7990042510120013e-06 1.7871558638938058e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5771669861459845 5.323972677812135e-06 5.293545911590901e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.592243041989607 8.683135231544175e-06 8.641402928397508e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.605761770425662 1.1736099379345333e-05 1.1689299447288859e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.61722004812727 1.4349739564573503e-05 1.4303145908847323e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6261971093564545 1.6410394776107766e-05 1.636694918010539e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.632367160246647 1.7830824405050523e-05 1.7791659417682672e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.6355083317159504 1.855440219286576e-05 1.8518265750177555e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener deleted file mode 100644 index 394626853..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.1443415212514584 -1 0.14450429320192903 -2 0.14480197581564375 -3 0.1451830561143355 -4 0.14558024262510605 -5 0.1459209319827529 -6 0.14613875121468506 -7 0.14618438290008173 -8 0.14603549672164207 -9 0.1457072917786887 -10 0.14524375676267556 -11 0.14470680723254467 -12 0.14416638086222233 -13 0.14369073097424398 -14 0.1433381654975646 -15 0.14315085822533646 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz deleted file mode 100644 index 80c7ff6b9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4779733736532457 -1.6199128115022177e-05 -1.618210056259022e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.480855988851664 -1.5573139454345886e-05 -1.5547324168506138e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4865084425270276 -1.4341426185491592e-05 -1.4303360396389102e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.494709153787839 -1.2547345866982495e-05 -1.25047210494146e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5051358362347678 -1.0263962083165892e-05 -1.0228900390207792e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.517377890016099 -7.601154611766094e-06 -7.575308201253294e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5309530437755026 -4.679084794951699e-06 -4.6561827908489125e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5453277746773257 -1.5747801382078563e-06 -1.5663837043097211e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.559940491981288 1.6102670739087558e-06 1.5996974691515773e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.574225768131435 4.767436907947184e-06 4.739619444469484e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5876371020525366 7.775546888241825e-06 7.735843085281448e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.599667627935302 1.0510555061787517e-05 1.046370660420573e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.609868218286932 1.2853829441749569e-05 1.2804292809530049e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6178624686625933 1.4703026909016015e-05 1.4653802624564793e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6233583757441026 1.5978811402118406e-05 1.593162394552983e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.6261567784904654 1.6629125125270316e-05 1.6583725085174496e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener deleted file mode 100644 index b1c4b55a8..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14475752696215818 -1 0.14488591362315625 -2 0.14512036367388953 -3 0.145419641169109 -4 0.1457299591047261 -5 0.14599340301571234 -6 0.1461571777012834 -7 0.14618223982735462 -8 0.14605119452067217 -9 0.14577607558040856 -10 0.14539180283491723 -11 0.14494814472736822 -12 0.14450189142460493 -13 0.1441089683947489 -14 0.14381752705849982 -15 0.14366260976626766 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz deleted file mode 100644 index d2f507f3a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_9.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4856288630682744 -1.4641108049347733e-05 -1.4617689817446023e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4882082336279727 -1.4073060171678857e-05 -1.4042341885938395e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4932659154258783 -1.2956221692278461e-05 -1.2915618671769397e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5006034838356146 -1.1331340030326807e-05 -1.1287916610159982e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.5099326070233756 -9.265861766431932e-06 -9.230454653045516e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5208863095035574 -6.859323149729073e-06 -6.833670848433326e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5330338963264767 -4.22027315102714e-06 -4.198955612506105e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5458990570455406 -1.4204478426098045e-06 -1.4127749648568141e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.558980259353228 1.4487604569802692e-06 1.4392908863007146e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5717720099747763 4.290650779012598e-06 4.265263977787478e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.583785013599074 6.997783499000428e-06 6.960513890766284e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.594564693637405 9.459744651843743e-06 9.414213541417848e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6037075318548175 1.1570280091178532e-05 1.1520202989004062e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6108747507863064 1.3236987496643801e-05 1.3185220092522197e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6158031201294785 1.4387660592986321e-05 1.4336229812797567e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.61831287719198 1.4974501663497568e-05 1.4923876263255433e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 deleted file mode 100644 index 9618462d8..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL.hess_29 +++ /dev/null @@ -1 +0,0 @@ --1.084284095859499968e-02 1.007962075856828980e-07 4.029725098037312568e-08 -1.084014631477705007e-02 9.284686790711813411e-08 3.597176435166755601e-08 -1.083474698859391606e-02 7.815764173087119183e-08 2.812688640808025874e-08 -1.082664073607738850e-02 5.898851292852728707e-08 1.824931170370135060e-08 -1.081586538298754882e-02 3.834685046070548597e-08 8.273561788772440425e-09 -1.080254506387894921e-02 1.957295984016525322e-08 2.762893991249801198e-10 -1.078717014372265054e-02 5.915874074887245997e-09 -3.850069342421443526e-09 -1.077054482796756946e-02 -1.824446412487979138e-10 -2.737871396674359854e-09 -1.075329915410792869e-02 2.381444680552640775e-09 4.200025444090992507e-09 -1.073609644990415959e-02 1.337074778748020793e-08 1.667397634287409299e-08 -1.071963115199171639e-02 3.127445132286798301e-08 3.353776330315823309e-08 -1.070459695170799912e-02 5.355314855478380059e-08 5.293835040844515653e-08 -1.069165081589418080e-02 7.702930065636355187e-08 7.257306057740378169e-08 -1.068137570009095906e-02 9.835847905862783893e-08 9.001491014134276676e-08 -1.067424521429065874e-02 1.145116072054391498e-07 1.030574674552284286e-07 -1.067059354225899370e-02 1.232019355323211077e-07 1.100287082081263299e-07 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 5.293955920339377119e-20 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.058791184067875424e-19 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener deleted file mode 100644 index 9226a811d..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.14619035118482168 -1 0.14619070699962955 -2 0.14619091286669983 -3 0.1461900516834462 -4 0.14618696880233711 -5 0.14618049740360584 -6 0.14616970302480536 -7 0.14615412201583527 -8 0.1461339066076566 -9 0.14610987493352684 -10 0.14608346566825425 -11 0.14605659799922505 -12 0.1460314573249148 -13 0.1460102372726762 -14 0.14599487391951996 -15 0.14598680823928564 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz deleted file mode 100644 index c1495b71f..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_29.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.540461685335739 -2.5549784228003915e-06 -2.5399272013561747e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.540889201874614 -2.4534391447011732e-06 -2.4382655931849438e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.541727677502115 -2.2546812873915327e-06 -2.239777382154798e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.5429446512904574 -1.967389528172729e-06 -1.954183674554429e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.544493039798159 -1.604829398997112e-06 -1.5949288116853977e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.5463129920858996 -1.184977307557958e-06 -1.1784553051410164e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5483342419943114 -7.270181088389714e-07 -7.226950406123698e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.550478859856288 -2.4484239066381697e-07 -2.433807543641649e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5526642868502076 2.4585391534848e-07 2.443260745761545e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.554806530261252 7.293101936704286e-07 7.248765463383169e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.5568233936762144 1.188506726603352e-06 1.1813447597905433e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.5586376170955685 1.605841851793353e-06 1.5960383058374792e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.5601798087781122 1.9640195362154016e-06 1.9518329665617193e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.5613910616601223 2.2474983314934323e-06 2.233363695994186e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.562225161548596 2.443693865256606e-06 2.4282433063293773e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.562650311001014 2.543950076112425e-06 2.527857795030063e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz deleted file mode 100644 index 030b7b1a3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_FINAL_forces_29.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00011973230763163059 1.4081818792631968e-06 1.3998863660371818e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00011509625372325318 1.3522182867033563e-06 1.343855350993785e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00010600721269165184 1.2426724641136511e-06 1.2344581445337531e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -9.282377338216272e-05 1.0843309901570352e-06 1.0770525553962788e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -7.606524145895317e-05 8.84505191437045e-07 8.790484613441395e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -5.639016075929571e-05 6.531028039024552e-07 6.495081881757276e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -3.456892854567335e-05 4.006976018377204e-07 3.98314933442092e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.1451224759424999e-05 1.3494541274065538e-07 1.3413982873537544e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.2068249494091018e-05 -1.3550291675660268e-07 -1.3466084401313497e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 3.5084996643494734e-05 -4.019608893459782e-07 -3.9951727503737663e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 5.6719700124994184e-05 -6.550480508367141e-07 -6.511007173501841e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 7.615132062453702e-05 -8.850632069836942e-07 -8.796599614437753e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 9.264711211890754e-05 -1.0824736118069e-06 -1.0757569576060065e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00010558862380752233 -1.2387135624474032e-06 -1.230923227545783e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00011449302578724121 -1.346847154877063e-06 -1.3383315459342817e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00011902933909488406 -1.402103582152881e-06 -1.3932342866574796e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz deleted file mode 100644 index 030f567ed..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0028419991035877347 5.062746866683679e-06 5.054393147048601e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002793834979617636 5.183980594053684e-06 5.141319048678907e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0026688676902036977 5.343170034051847e-06 5.246448947545891e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002431842707736466 5.339721703700351e-06 5.2166417237352526e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00205276095335753 4.934223985698249e-06 4.850382059964017e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.001520616099574181 4.004442320155974e-06 3.990697040447411e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0008469331323838957 2.6571166916253136e-06 2.650690930970538e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -9.429910312659437e-05 9.126104959837899e-07 9.053563477355476e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006384043076482472 -1.1069558288207254e-06 -1.1070353048254536e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0012861757625815828 -3.1531562137749073e-06 -3.1643312454180697e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0018093472218503536 -5.029695704774884e-06 -5.046185138172467e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002182467057456169 -6.604209026981155e-06 -6.613094046741999e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0024153144993051038 -7.806754155095822e-06 -7.806471486813624e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002547283374935045 -8.638026602767284e-06 -8.630393238933302e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0026149170903637057 -9.141824004378798e-06 -9.132529120898736e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0026413497719772455 -9.375674829415361e-06 -9.367499895657264e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz deleted file mode 100644 index e374031dc..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0024096189902823827 1.5183936474295252e-05 1.5075291264591607e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002338646530670779 1.5024919665527123e-05 1.486729328098436e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0021897912379574185 1.4564648435663347e-05 1.4341922424172144e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001956229162260046 1.353617365269018e-05 1.3310266375267851e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0016335881897426594 1.1686226992987147e-05 1.1562984648704727e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0012241041850990723 9.02258207533441e-06 9.0129726393247e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0007413108758320752 5.774966519999323e-06 5.769034411339583e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00021727972678136368 1.962011519572385e-06 1.9528507087442488e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0003055110062857292 -2.236572772223075e-06 -2.2350627177518076e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0007934074128259909 -6.463842398825255e-06 -6.4825705641733495e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0012239240923483557 -1.040667024441399e-05 -1.0444708645269884e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.001580575378050864 -1.383388527814424e-05 -1.3860832605605093e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.001852921740110504 -1.6586843147765253e-05 -1.6593034676809315e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0020425111591152872 -1.8605151575920847e-05 -1.8594455594194852e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002159008042864835 -1.9902001757643856e-05 -1.9884776244136116e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0022133357377163783 -2.0527940474242685e-05 -2.0510357668763867e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz deleted file mode 100644 index 2b3edabf2..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_10.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0006469584070418139 7.317310900374855e-06 7.301673507721764e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0006216357515445657 7.03245193921115e-06 7.01353302781252e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005719331725159142 6.4727600447915925e-06 6.44955398533592e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0004997441005905709 5.6592590075948435e-06 5.635353353236153e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0004079077294620783 4.626252887169216e-06 4.606975689143477e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0003001580915122788 3.4236065009003804e-06 3.4098505568909346e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00018099615901557146 2.1055507499783745e-06 2.0946408741427624e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -5.54708784172378e-05 7.087202634346486e-07 7.048467413829733e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 7.115825393442633e-05 -7.213436211034323e-07 -7.166486789901275e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00019387202161374694 -2.1368696506705223e-06 -2.124102282937329e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.000308028838998208 -3.4849748930831883e-06 -3.465839332735851e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00040950453264166 -4.711168846303534e-06 -4.687199692837052e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0004948153006350525 -5.762771339033978e-06 -5.7356725804022475e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0005611824463089646 -6.593681528327137e-06 -6.564907758479488e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0006065489040327796 -7.167641218914951e-06 -7.138381760773142e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0006295652116164723 -7.46047881053214e-06 -7.4312620082482685e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz deleted file mode 100644 index 9da072536..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_11.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005849527791760563 6.65296793073839e-06 6.635447875766081e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.000562043395503843 6.39322665471287e-06 6.373053000951128e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0005170969400813506 5.8831705607416584e-06 5.859677168159168e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0004518548843910347 5.142422009720374e-06 5.118920640457638e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00036890684580645483 4.202631302669202e-06 4.183881602469664e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00027162863003553584 3.109247663168184e-06 3.0960384749147466e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00016405829682361822 1.911575195034415e-06 1.901460568397942e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -5.070192480995396e-05 6.434625482690225e-07 6.399083802976948e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 6.375284976245724e-05 -6.537821889402171e-07 -6.495443004215406e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0001747984114747149 -1.9371229229786275e-06 -1.925467606497787e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00027823531583167954 -3.1590701041343944e-06 -3.1413254857325813e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0003703067665882218 -4.270603179655206e-06 -4.247958126493026e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00044781319607434966 -5.224163078664604e-06 -5.198039795519698e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00050817945177643 -5.977922535311851e-06 -5.949647246487603e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0005494819060998364 -6.498811795525342e-06 -6.469588728293071e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0005704487369456588 -6.764658771940718e-06 -6.73519209815898e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz deleted file mode 100644 index aea383272..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_12.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0005305165529754937 6.062044059425393e-06 6.043377388779862e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0005097366979459261 5.824791609802176e-06 5.803987640444737e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0004689809829134694 5.359117292836652e-06 5.3357759424581135e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0004098473365608618 4.68329371976979e-06 4.660474996617209e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.000334697117728535 3.826519456048481e-06 3.808486249811153e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0002465880763048142 2.8303083738702484e-06 2.817739057651632e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0001491566137819299 1.7395933689820901e-06 1.7302263401395222e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -4.644484236239546e-05 5.855993937665661e-07 5.823341132063293e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 5.734544326379536e-05 -5.941077485025651e-07 -5.902714671945847e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00015814702865143406 -1.760605585549487e-06 -1.7499584812256208e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00025214737274791406 -2.871063012509136e-06 -2.8546561072347544e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0003359161220468191 -3.881214380345799e-06 -3.859975733036249e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0004065118705842106 -4.74799640784135e-06 -4.723119299067306e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00046154983934345895 -5.4333839364940384e-06 -5.406069996656053e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0004992357948363227 -5.907184625813581e-06 -5.878618111313721e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.000518376185083123 -6.1490616544739075e-06 -6.120054074631461e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz deleted file mode 100644 index 74345482e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_13.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00048233560210906624 5.53334543313798e-06 5.514121868679095e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00046344698400184437 5.3163271893485605e-06 5.295384855972904e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00042640894958059783 4.890539603519708e-06 4.867682425842446e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00037268569514812677 4.27296826764226e-06 4.251024930377798e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00030443068895691296 3.4905479789358885e-06 3.4733479259087236e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00022441827309099707 2.5812629208639375e-06 2.5693809178818833e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0001359332086147518 1.5861431634786335e-06 1.5774756295619025e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -4.261618991669887e-05 5.339672031093609e-07 5.309645702291387e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 5.17494459744188e-05 -5.410303593082273e-07 -5.375494171005207e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00014348028989874767 -1.6035391008629768e-06 -1.593806275684892e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00022910566990879834 -2.614796859957659e-06 -2.5996559068254525e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0003054874228286244 -3.5347102035521635e-06 -3.5148911209925252e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00036991934421988764 -4.32419115189111e-06 -4.300701453065714e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00042019405226509626 -4.9486127176937714e-06 -4.922538309590121e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0004546410893646778 -5.380384306601057e-06 -5.352868443226226e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0004721437812978583 -5.60085115266704e-06 -5.572763538220003e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz deleted file mode 100644 index 6fd372a73..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_14.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00043940844593298 5.0580141306285915e-06 5.038686515122568e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00042220848605860453 4.859275945579758e-06 4.838566454094098e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.000388487129681147 4.469487780491596e-06 4.447354005277164e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0003395849821936595 3.904416737725524e-06 3.883473940136735e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002774665378915646 3.188907858831961e-06 3.1726063688118008e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00020465274121994804 2.3577628417517522e-06 2.3465856012240015e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00012411823057369715 1.4485078598994685e-06 1.4404927964236312e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -3.915293886803376e-05 4.876529367885126e-07 4.848899983777275e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 4.6824225803481386e-05 -4.935496215104239e-07 -4.90384922094283e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00013046765237429063 -1.4629877012028644e-06 -1.4540847939062907e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00020861109481144416 -2.385484986473569e-06 -2.3715304882197175e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00027837944973229913 -3.224637089927763e-06 -3.20620959284596e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0003372813664654398 -3.9448924150540655e-06 -3.922848292345726e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00038327442238268153 -4.5146734296412304e-06 -4.489993346226777e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00041480555628700536 -4.90874663844933e-06 -4.882520600857603e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00043083241188148516 -5.109997918224139e-06 -5.083118929267929e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz deleted file mode 100644 index 35895f264..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_15.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0004009548183899554 4.6289382596237845e-06 4.609844148144774e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0003852694393984675 4.446770452921481e-06 4.426564693584901e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.000354520959552341 4.089587464048166e-06 4.068341321419078e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0003099363188342583 3.5720087263593854e-06 3.552140101998503e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002533083551508387 2.9169502405110032e-06 2.9015765789001456e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00018693074130178564 2.1563321316967407e-06 2.1458574034283207e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00011350293981092548 1.3245204234600541e-06 1.317112663009664e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -3.6005894571996434e-05 4.4592830529631713e-07 4.433847288928901e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 4.246173323710321e-05 -4.50874459259813e-07 -4.4799259111567707e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00011885401560099262 -1.3366267751416568e-06 -1.3284781329368834e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00019027748321612866 -2.1793353130160586e-06 -2.166485900833661e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0002540949761226556 -2.9458781756026535e-06 -2.9287901267756753e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.000308011849995943 -3.603865767793269e-06 -3.5832719341652435e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00035013888778072974 -4.124466742934154e-06 -4.1012530675600964e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0003790337490961829 -4.484587034490588e-06 -4.459783696341995e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0003937251791150122 -4.668523393820506e-06 -4.643022198224658e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz deleted file mode 100644 index c384fc9b1..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_16.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00036635513991257123 4.24032094275583e-06 4.2217051665279845e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0003520333471401015 4.073215624689526e-06 4.05370461621138e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0003239600685832195 3.7456494553301473e-06 3.725396771059411e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002832580159346273 3.271165052266744e-06 3.252405846815834e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00023156410694801823 2.670897652665847e-06 2.656455745401067e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00017096760707927932 1.9741492987218925e-06 1.964361912652669e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00010392257166807846 1.2124249786700287e-06 1.205581593001568e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -3.313593434224535e-05 4.082031782828361e-07 4.058607768954314e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 3.857714965694062e-05 -4.1236869445888143e-07 -4.09740813139018e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00010843834686535922 -1.2225847766406453e-06 -1.2151225032739025e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00017379983853663163 -1.9932937761159697e-06 -1.9814694591153547e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0002322405010335472 -2.6943098246128324e-06 -2.6784954958980444e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0002816461151649669 -3.2960827028441783e-06 -3.276909703603714e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00032026964679492153 -3.7722616367299404e-06 -3.7505310682178056e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0003467727745315619 -4.101697694124531e-06 -4.07837701941502e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00036025178465370607 -4.269979770632949e-06 -4.245942680668726e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz deleted file mode 100644 index 5c8225897..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_17.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00033510883320539935 3.887372231572829e-06 3.869406800406409e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00032201858364892864 3.7339902060871135e-06 3.715302777313085e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0002963605676171618 3.433390939216086e-06 3.4141929528933395e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002591620937488119 2.9981096756279044e-06 2.9804669551783985e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00021191840612190213 2.4476376637004632e-06 2.434113831727688e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00015653447395928846 1.8088916435517363e-06 1.7997680974670515e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -9.524456342522268e-05 1.1107781764594284e-06 1.1044586405869948e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -3.0511273287376415e-05 3.7399243744489556e-07 3.718348198499338e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 3.5102752893514545e-05 -3.775126553750917e-07 -3.751136403026329e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 9.905938935552108e-05 -1.119331493662497e-06 -1.1124945450932185e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0001589329440790485 -1.8248626663097343e-06 -1.8139865961350194e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0002124990350289756 -2.4665578616709964e-06 -2.4519446044557454e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00025780918357575536 -3.0174257156204897e-06 -2.999622677281769e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00029324824389740484 -3.4533619061413405e-06 -3.4330943312840378e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0003175753427750489 -3.7549886323078235e-06 -3.733160790988857e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00032995059838944484 -3.909078449969829e-06 -3.886534524134625e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz deleted file mode 100644 index 2fc831be3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_18.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0003068051764132814 3.5660830292288783e-06 3.548883580584812e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00029483018417422117 3.4252278357310916e-06 3.407445080906125e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0002713587742745814 3.1492312239197517e-06 3.1311156389639626e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00023733102344392385 2.749688198096515e-06 2.7331486611074825e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00019411337895239853 2.244572207502893e-06 2.2319407334260983e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00014344428627055628 1.658621880668995e-06 1.6501334766199696e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -8.736046232015943e-05 1.0183776872505036e-06 1.0125439195755657e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -2.8105630253568423e-05 3.428919459943536e-07 3.409042533254767e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 3.198360853618852e-05 -3.4587582704577713e-07 -3.4368363507150326e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 9.058568797309145e-05 -1.0255982410193154e-06 -1.019331617389315e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0001454764399141629 -1.671970768969112e-06 -1.6619701537201546e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00019461109057378206 -2.259823112353427e-06 -2.2463356091302693e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0002361935960106102 -2.7644769415460123e-06 -2.747980102088723e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00026873110541702133 -3.1638668454526487e-06 -3.1450180946648893e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.000291073844640012 -3.4402298255255045e-06 -3.4198713285201213e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0003024420289277167 -3.58142301876939e-06 -3.5603620763663666e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz deleted file mode 100644 index 0b1b9411c..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_19.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00028110245159870654 3.2730582216758963e-06 3.2566972073011365e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00027013968347326737 3.1436555006217434e-06 3.1268222785970058e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00024865246814137986 2.8901411190794824e-06 2.8731107520523057e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002175011694192386 2.5232341206453543e-06 2.507770017143035e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00017793507158341365 2.0595066243710477e-06 2.047733776929298e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00013154186911978625 1.5217047247355788e-06 1.513819739614781e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -8.018018276721527e-05 9.342097262223132e-07 9.288260570018531e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -2.589691252421566e-05 3.145609176138035e-07 3.1272961956231856e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.9174537547561275e-05 -3.1709696509524674e-07 -3.150921282758128e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 8.290853771121643e-05 -9.403197423716907e-07 -9.345737824613317e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00013326424777006558 -1.5328787177089077e-06 -1.5236852356448886e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0001783611835182684 -2.0717540982888335e-06 -2.0593170750046914e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00021654363132713695 -2.534363716342092e-06 -2.5191021785155087e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0002464321061885786 -2.900496168881444e-06 -2.883006849689681e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00026696185621710126 -3.153862397006086e-06 -3.134927442092879e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0002774095115166701 -3.2833136222614478e-06 -3.263699003993833e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz deleted file mode 100644 index 2b52e6396..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001942488736533234 1.7708678241055824e-05 1.7500815680728397e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0018755571302828315 1.7195782639661253e-05 1.6977144135844428e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0017407839313963798 1.6099198841703034e-05 1.5884461996799946e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001537596126726083 1.4330370520745385e-05 1.4174443516668533e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0012675650279661901 1.1881959182333212e-05 1.1829559297298138e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0009367218164458175 8.897842856386484e-06 8.91211495434458e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0005593753653598348 5.56232965781518e-06 5.558876413626898e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00015766836241444602 1.8769293280657584e-06 1.8717134888464523e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00024268500351367695 -2.022407713418897e-06 -2.0156097379590567e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0006207953003033021 -5.925960590870717e-06 -5.922204367256211e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0009611962948718237 -9.613361392718313e-06 -9.63233521889037e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0012525278190936209 -1.2908434737300818e-05 -1.294251884165839e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0014873394065651963 -1.5665611285110394e-05 -1.5698878280645796e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0016616006439549708 -1.778214303320501e-05 -1.7805055866456995e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0017755277393403477 -1.9202872917012223e-05 -1.9216530197714526e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0018314977913995085 -1.9911734943329393e-05 -1.9921041114074572e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz deleted file mode 100644 index 95a08269c..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_20.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00025771278129141525 3.005391686849754e-06 2.9899087834783997e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002476704675618749 2.8864725771651322e-06 2.8706065362738073e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00022798729392492766 2.6535302322667117e-06 2.637569714840592e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0001994508034341319 2.316468856856395e-06 2.302042457047373e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00016320363055996208 1.8905667832435368e-06 1.8796137384426076e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0001206967704025343 1.3967446683011293e-06 1.3894298643333328e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -7.362787336075505e-05 8.574100008669454e-07 8.52443099375723e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -2.3866275633114933e-05 2.8870879555007587e-07 2.8702152893888655e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6637920270054808e-05 -2.9086943576080867e-07 -2.890346653437051e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 7.593688266967666e-05 -8.625912228792748e-07 -8.573209939078933e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00012215691558652484 -1.4061090808454584e-06 -1.3976589987979248e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0001635680496116411 -1.9003529207686137e-06 -1.8888928624525153e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00019864385333495776 -2.324644283327919e-06 -2.310543908642544e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00022610990161142498 -2.660460318516371e-06 -2.6442619658264075e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0002449806863823722 -2.892858644680256e-06 -2.8752871378806157e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0002545856725336847 -3.01160188156921e-06 -2.993379535250629e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz deleted file mode 100644 index 204b8c39c..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_21.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00023639091596852136 2.7605716906914896e-06 2.745981951201427e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002271869506258345 2.6512593071065235e-06 2.6363579150230242e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00020914672926884852 2.437161738683769e-06 2.422242678979531e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0001829912764002115 2.1274261686616295e-06 2.1139931265021256e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00014976608292601712 1.7361364844239252e-06 1.7259614497133617e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00011079800543266905 1.2825390234362664e-06 1.275760701660884e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -6.763888524996669e-05 7.87234289611028e-07 7.826530680174917e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -2.1997434105332816e-05 2.650853680558068e-07 2.635308060850861e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.4342084399095783e-05 -2.669302468153247e-07 -2.652501166936742e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 6.959356878417362e-05 -7.91636269335133e-07 -7.868010402707544e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00011203598772248051 -1.29039396698747e-06 -1.2826280844699746e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00015007744096860447 -1.7439046753748215e-06 -1.7333508864439786e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00018231066741164552 -2.133221999072334e-06 -2.120208038314101e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0002075585782059146 -2.4413630264384153e-06 -2.4263823932310407e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0002249094398706824 -2.6546168090334136e-06 -2.638340052381687e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00023374210493246595 -2.7635817789587133e-06 -2.7466867489134205e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz deleted file mode 100644 index a2080731e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_22.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00021692582264259744 2.5364084403986244e-06 2.522708644696627e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00020848646151021483 2.435906729767906e-06 2.421952724519028e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00019194457375082917 2.2390871656889836e-06 2.2251721070617504e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00016796041941363166 1.954394382643274e-06 1.941906260670429e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00013749094845308374 1.5948096192504596e-06 1.5853693771549832e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00010175014111137444 1.178042060680463e-06 1.171766793006972e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -6.215751633924113e-05 7.230360066223457e-07 7.188115115373213e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -2.027615098227697e-05 2.434732310199486e-07 2.4204097521444466e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.226010054907552e-05 -2.4505173379455367e-07 -2.435124241471632e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 6.381254592628994e-05 -7.267824472038746e-07 -7.223452334566764e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00010279979901188739 -1.1846352606111528e-06 -1.177498752926433e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0001377567394944893 -1.6009238484853534e-06 -1.5912090775016137e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.000167386000472903 -1.95828013015862e-06 -1.946278984606163e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0001906006488779127 -2.241127207085376e-06 -2.22728925130581e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00020655756707602344 -2.436880989936139e-06 -2.4218257138873558e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00021468169942489836 -2.5369065925125142e-06 -2.521267656655222e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz deleted file mode 100644 index 464ac82f0..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_23.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00019913428807005328 2.3309780129726023e-06 2.318151599202477e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0001913930774397338 2.238562466230343e-06 2.2255280682838207e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00017621924712729096 2.057595955061942e-06 2.0446414009226913e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00015421754167710506 1.7958717239113192e-06 1.7842778806469975e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00012626416189529996 1.4653532073238285e-06 1.4566042326213311e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -9.347033634362213e-05 1.0823373179787145e-06 1.0765324506516957e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -5.713530850652855e-05 6.6424889887264e-07 6.603541973204235e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.868985411176576e-05 2.236819749132283e-07 2.2236246419889893e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.036886983821329e-05 -2.2503517974098012e-07 -2.2362426688133604e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 5.853674966501004e-05 -6.674425735983973e-07 -6.633697420633458e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 9.436028892365987e-05 -1.0878740710627176e-06 -1.081316276299483e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00012649087352458984 -1.4701131108902903e-06 -1.4611738837923626e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00015373250579760528 -1.7982316952388899e-06 -1.7871720738938195e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00017508173392019027 -2.057937910830101e-06 -2.0451678592779288e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00018975920326074684 -2.237679466952586e-06 -2.223770677912522e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00019723281560443348 -2.3295249002050828e-06 -2.315067874205429e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz deleted file mode 100644 index 86a039500..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_24.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0001828559924770512 2.142578493986891e-06 2.1305993756258235e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00017575287808721928 2.0575883203313716e-06 2.045438476270818e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00016182940565544446 1.8911760359407753e-06 1.8791347506978823e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00014163959003037709 1.65053141807442e-06 1.6397804101361384e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0001159859467506171 1.3466785294944848e-06 1.3385777908962188e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -8.588607616477934e-05 9.946159857393317e-07 9.892499786180107e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -5.252974570164826e-05 6.103735539993643e-07 6.067836180126635e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.7227344410214232e-05 2.0554365200799846e-07 2.0432808496528803e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8648423125042018e-05 -2.067058614676305e-07 -2.0541214361855735e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 5.371647616563443e-05 -6.131001673756144e-07 -6.093610923342188e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 8.66405566655992e-05 -9.99266988927417e-07 -9.932411666473423e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0001161791821392477 -1.3503312771405222e-06 -1.3421080349127957e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00014122987798703484 -1.651680439597826e-06 -1.641494093784365e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00016086647054514247 -1.8901979113332501e-06 -1.87842266510881e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00017436881287051544 -2.0552766554628355e-06 -2.0424396288525254e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00018124479559771716 -2.139630717827945e-06 -2.126280793155597e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz deleted file mode 100644 index 5d7136860..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_25.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00016794967023450668 1.9696953124881043e-06 1.9585308228780667e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00016143024884836724 1.8915267773171466e-06 1.880221647606702e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0001486505309750213 1.7384826847668228e-06 1.7273054338273545e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00013011816437542723 1.517194141112849e-06 1.5072347549999281e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00010656838908735511 1.2378183476833766e-06 1.2303238747577507e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -7.893341559552015e-05 9.14159857082347e-07 9.092025041898068e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -4.83032431035117e-05 5.60966767411955e-07 5.576583598655665e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.587857138161942e-05 1.8890920419044703e-07 1.8778947162948744e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.7081376105408368e-05 -1.8990916006818875e-07 -1.8872251141030352e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 4.930812007045217e-05 -5.632980182925768e-07 -5.598647802159833e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 7.957296198146117e-05 -9.180674271959658e-07 -9.125305060867602e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.00010673297801243678 -1.2405681150192337e-06 -1.2330052206279072e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00012977198695154438 -1.5173901353145795e-06 -1.5080122963558694e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00014783532955733734 -1.7364927473935718e-06 -1.725641815092212e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00016025779815232604 -1.8881352724130372e-06 -1.8762969260921307e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00016658447001652535 -1.965624222464822e-06 -1.95330760027985e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz deleted file mode 100644 index 937dc5c7e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_26.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00015429008413988886 1.8109735578879385e-06 1.8005867119729877e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00014830496901885947 1.7390742566444995e-06 1.7285711136705615e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00013657224579711317 1.5983136738195984e-06 1.587950528897438e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0001195571718844778 1.3948060432168599e-06 1.3855880440786571e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -9.793353313844745e-05 1.137908740708741e-06 1.1309800153928286e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -7.255560292753811e-05 8.403277387628081e-07 8.357503024322869e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -4.44223582995722e-05 5.156330751124829e-07 5.125846378700264e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.4634458669652642e-05 1.736456182978143e-07 1.726142439189615e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.5652500250267065e-05 -1.7450747375132588e-07 -1.734187210223073e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 4.5273182369224036e-05 -5.176291093622267e-07 -5.144762300429412e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 7.309763215399845e-05 -8.436108000338162e-07 -8.385231252556502e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 9.807363067299498e-05 -1.1399243276499512e-06 -1.1329699865731143e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00011926462259063699 -1.3942601721874853e-06 -1.3856297803599241e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0001358821089257375 -1.5955629128933832e-06 -1.5855690040906587e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00014731182773465977 -1.7348862247699437e-06 -1.7239760414968362e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00015313340500133053 -1.8060804851435191e-06 -1.7947254950454753e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz deleted file mode 100644 index 251e98086..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_27.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0001417656127074023 1.6651956543341626e-06 1.6555468761276515e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00013626989104104667 1.599059545920948e-06 1.5893142118378634e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0001254961763879581 1.469589241162498e-06 1.4599905484117654e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00010987096118387319 1.2824210431543982e-06 1.2738957068456136e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -9.001186841356518e-05 1.0461744740056116e-06 1.039772690756632e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -6.670198732216875e-05 7.725445089387797e-07 7.683197913555627e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -4.085717235131521e-05 4.7401793978341336e-07 4.712094859844578e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.3486766155481002e-05 1.596336369691905e-07 1.5868372477126622e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.4348382100804214e-05 -1.603777408722338e-07 -1.5937855808401794e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 4.157748278554364e-05 -4.757293299204477e-07 -4.728335384869452e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 6.716127630527174e-05 -7.753026222803575e-07 -7.706277090510901e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 9.013104339768651e-05 -1.047595473677772e-06 -1.041201598614191e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00010962370150619367 -1.2813059400867716e-06 -1.2733657274186958e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00012491193967025386 -1.466281493631328e-06 -1.457080868040293e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00013542871029727477 -1.5943043848983252e-06 -1.5842550062491527e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0001407857104609576 -1.659724310070945e-06 -1.6492621514495033e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz deleted file mode 100644 index 81e5d6086..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_28.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00013027630621939476 1.531263175837876e-06 1.522311607981289e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0001252290715268004 1.470426239096766e-06 1.4613941647399859e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00011533423264378396 1.3513357866139876e-06 1.3424528735202712e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00010098282272806282 1.179186423115164e-06 1.171306902545153e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -8.274111522235065e-05 9.61917101191632e-07 9.560053288040914e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -6.132714296317802e-05 7.102922214520033e-07 7.06394590942839e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -3.758078879854758e-05 4.35802214294072e-07 4.3321522625450323e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.2427979970945812e-05 1.4676589873103404e-07 1.4589108623138308e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.3157149704192617e-05 -1.4740943354152246e-07 -1.46492251362768e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 3.819052776986281e-05 -4.372715701168264e-07 -4.3461159542014466e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 6.171623367865153e-05 -7.126088627907289e-07 -7.083131600787719e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 8.284243003277869e-05 -9.628589276970803e-07 -9.569809686453397e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00010077382599899981 -1.1776429123439589e-06 -1.1703393839123319e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00011483968260038076 -1.3476360136546727e-06 -1.3391686550259122e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00012451668428226163 -1.4652889173657265e-06 -1.4560364985157007e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00012944627674919872 -1.5254097961932984e-06 -1.5157750031774206e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz deleted file mode 100644 index 030b7b1a3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_29.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00011973230763163059 1.4081818792631968e-06 1.3998863660371818e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00011509625372325318 1.3522182867033563e-06 1.343855350993785e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00010600721269165184 1.2426724641136511e-06 1.2344581445337531e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -9.282377338216272e-05 1.0843309901570352e-06 1.0770525553962788e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -7.606524145895317e-05 8.84505191437045e-07 8.790484613441395e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -5.639016075929571e-05 6.531028039024552e-07 6.495081881757276e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -3.456892854567335e-05 4.006976018377204e-07 3.98314933442092e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -1.1451224759424999e-05 1.3494541274065538e-07 1.3413982873537544e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.2068249494091018e-05 -1.3550291675660268e-07 -1.3466084401313497e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 3.5084996643494734e-05 -4.019608893459782e-07 -3.9951727503737663e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 5.6719700124994184e-05 -6.550480508367141e-07 -6.511007173501841e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 7.615132062453702e-05 -8.850632069836942e-07 -8.796599614437753e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 9.264711211890754e-05 -1.0824736118069e-06 -1.0757569576060065e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.00010558862380752233 -1.2387135624474032e-06 -1.230923227545783e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00011449302578724121 -1.346847154877063e-06 -1.3383315459342817e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00011902933909488406 -1.402103582152881e-06 -1.3932342866574796e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz deleted file mode 100644 index 79562e9b5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015997353295855248 1.5930864254159885e-05 1.580783413473849e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001541527266267262 1.5363529479086726e-05 1.5244712335959626e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0014254252116202358 1.4220544406483882e-05 1.4116904237644298e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0012526720705998582 1.2507309446764971e-05 1.2441261983926278e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.001026566716575589 1.0276471767688393e-05 1.0259532699438564e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007544092705801225 7.649278009939194e-06 7.65397814356391e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0004483849610588376 4.747940455263038e-06 4.736842315646555e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00012477592270326588 1.5990857601373261e-06 1.5926465116236819e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00019825417662815354 -1.688957285761341e-06 -1.6800559614630677e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.000505391052658601 -4.972689324201132e-06 -4.957125308239575e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0007845053898521544 -8.09357667796575e-06 -8.087402737808747e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.001026212836696366 -1.0909571218784411e-05 -1.0917326561808406e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0012240615123930085 -1.3299333438502542e-05 -1.3315659216710191e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0013741424545329409 -1.5165052988874129e-05 -1.518286448315584e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.001474453266401624 -1.6438204540892925e-05 -1.645494200987778e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0015245416535162861 -1.7081568485225238e-05 -1.7097462566282833e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz deleted file mode 100644 index 0bb6174e7..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001352897446106711 1.4051405334982619e-05 1.4006460724094925e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0013022290969887673 1.3525969383602364e-05 1.3480606795320555e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001201685464746267 1.2483259916202582e-05 1.2440101273781356e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0010532713923880883 1.0948685942512837e-05 1.0917647663953214e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0008611029761241688 8.978917647095275e-06 8.96646954806692e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0006321781372618436 6.6705381158093385e-06 6.665435178174924e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00037660167975875927 4.126345348168412e-06 4.1119561383077174e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00010707102223743735 1.388816817645577e-06 1.3822340786327324e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00016257700146894154 -1.45055841798792e-06 -1.4415744430937755e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00042028059695594565 -4.280578392621473e-06 -4.261269492457597e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0006560346391297529 -6.9760365491516715e-06 -6.957770223988448e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0008617694685882201 -9.417148015998365e-06 -9.406496379393212e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.001031539327170419 -1.1497150955246521e-05 -1.1495388885193234e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0011613806573221805 -1.3129479553719122e-05 -1.3133769653500796e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0012489242629694641 -1.4249662593708879e-05 -1.4257608632895365e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.001292939836436456 -1.4818269158948647e-05 -1.482806976400914e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz deleted file mode 100644 index 217b0589e..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0011651994476994086 1.2436431458209886e-05 1.242409869696531e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001120719268129897 1.1964080635040069e-05 1.194740749479196e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001032794679783166 1.1031374359651172e-05 1.1008822621085224e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0009038012503573595 9.666221421272592e-06 9.643793411407546e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0007379177093872525 7.919723033610221e-06 7.905163279126471e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0005414950253256717 5.876013635866692e-06 5.865878321440889e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00032309893969528715 3.6273346917649946e-06 3.6125131919704353e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -9.307932900071863e-05 1.2206866325021927e-06 1.2145567055898805e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00013746953299157422 -1.2643226036943314e-06 -1.2560939792765493e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0003586381138928681 -3.7363088009415104e-06 -3.716908402107203e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0005619326650862302 -6.092062285934348e-06 -6.06938650843448e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0007403007891600282 -8.22944004568771e-06 -8.209261402442017e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0008883064639514655 -1.0054547991431765e-05 -1.0040077779869414e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0010020831638114975 -1.1489689241133705e-05 -1.1481107162440682e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.001079118568021899 -1.2476646623706178e-05 -1.2472858639603295e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0011179614217618988 -1.2978568187605533e-05 -1.2977500596559688e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz deleted file mode 100644 index 2035b8776..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0010184967424853955 1.1072426783551374e-05 1.1068262624136835e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0009791900377285128 1.0648968067269532e-05 1.0638988032720566e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0009017023555525088 9.814126078508071e-06 9.7957494378645e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0007884590474024353 8.59451103144683e-06 8.572884933152881e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0006434362774554568 7.037284889732291e-06 7.020333977520473e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00047233842684876005 5.217284294436615e-06 5.2045235266044545e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00028254742190227073 3.216642360229328e-06 3.202322813993367e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -8.275111390696106e-05 1.0824711288126043e-06 1.076882119055958e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00011783804954294355 -1.1150669243570748e-06 -1.1077225426309278e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00031083223461712904 -3.2979791507487072e-06 -3.2797587892890757e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0004888690348186878 -5.378462202294279e-06 -5.354928011454296e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0006457046148057629 -7.268096251216791e-06 -7.243754665042442e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0007763767842706277 -8.884064347270727e-06 -8.862204372068315e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0008772079007673931 -1.015661699341681e-05 -1.0138532502038136e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0009456850645508932 -1.1032851827818818e-05 -1.101856329681952e-05 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0009802802737958304 -1.1478863613203312e-05 -1.1466975691194362e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz deleted file mode 100644 index 13c900b6b..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0008997627463000563 9.918417843973894e-06 9.912730866199571e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0008648110810106837 9.536946400957231e-06 9.525661364365115e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0007960289707608371 8.7856674779994e-06 8.76640243555751e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0006957573590033695 7.689880090706992e-06 7.667281818603931e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005676913722149911 6.293185448756531e-06 6.274655123412129e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0004169490448817828 4.662737249040853e-06 4.648848876576519e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00024997318112084354 2.8721583137118584e-06 2.8586554699384333e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -7.420860506282331e-05 9.66590197794148e-07 9.615113275954607e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0001025079625106135 -9.91525080754264e-07 -9.849948165886467e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00027293147576229953 -2.9343190469570247e-06 -2.9175492689992295e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.000430586963613739 -4.785728747896992e-06 -4.762727898830469e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0005698946839023279 -6.468376535686028e-06 -6.442582651994266e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0006863220870150119 -7.908889972084607e-06 -7.883209778038069e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0007764158999230311 -9.04462454518183e-06 -9.020679411055303e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.000837740705884535 -9.82749740484903e-06 -9.8059115374222e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0008687684069783927 -1.022629886631968e-05 -1.0206382187837991e-05 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz deleted file mode 100644 index 16560eb14..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0008014128304263328 8.928184468358369e-06 8.918799696037431e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0007701588965992417 8.583169465209178e-06 8.56894131462946e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0007087266120328677 7.904308035237657e-06 7.883327993310245e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0006193207300967056 6.915496790523427e-06 6.89200403020484e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0005053395168560157 5.657004883476438e-06 5.637680555631129e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00037138075312716056 4.189392791049465e-06 4.175147486038933e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00022312189449646635 2.5788876966581334e-06 2.566265207603605e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -6.703800914890985e-05 8.679434764139081e-07 8.633157637255067e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 9.008864670563171e-05 -8.87502177715899e-07 -8.816767172121195e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0002419090833059637 -2.627583154672409e-06 -2.6122514995606497e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0003826691140738087 -4.285509471106363e-06 -4.263626634301284e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0005073479261658599 -5.792915136553217e-06 -5.767094507913309e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0006117996835296403 -7.084415875094702e-06 -7.057113653193823e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0006928028527195079 -8.10360505545963e-06 -8.07647498470626e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0007480361701971623 -8.806756435917344e-06 -8.780748967242239e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0007760134212092255 -9.165178249818607e-06 -9.14015591960625e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz deleted file mode 100644 index 0a5cb65b9..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instanton_forces_9.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0007182977580545463 8.069478342141267e-06 8.056571333019744e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.000690219311888673 7.756397526761822e-06 7.739467077191006e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0006350747943917446 7.140849585252506e-06 7.118471142752179e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0005549145619050528 6.245292545753333e-06 6.221359633886494e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00045284840586458375 5.106899736924511e-06 5.0873850298636505e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0003330152439561386 3.7805307775836593e-06 3.7663924562875925e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00020045544119329462 2.3260126675761376e-06 2.314263460151163e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -6.0862904931442946e-05 7.828828981691554e-07 7.7865397501382e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 7.981810559244398e-05 -7.984874567655275e-07 -7.932682824209022e-07 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00021596480138263145 -2.3648014493326674e-06 -2.350809458974296e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00034242409358652457 -3.856843498309758e-06 -3.8363022731885556e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0004546545639110861 -5.213758708217477e-06 -5.188664138309446e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0005488584148251506 -6.376984876662591e-06 -6.3493847735780384e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0006220407851281898 -7.295594265088463e-06 -7.2670625484328545e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0006720101581977793 -7.929790228845066e-06 -7.90144404319752e-06 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0006973435607920697 -8.253228953073352e-06 -8.225326654323882e-06 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 b/drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 deleted file mode 100644 index aa2c39b08..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.instantonfric_FINAL.hess_29 +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_00 b/drivers/py/pes/friction/frictionH/120K/inst.raw_00 deleted file mode 100644 index 8004b6aaf..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_00 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 0 -{"friction": [[0.00013193989684352265, -3.134869831308944e-05, -3.130135232364516e-05], [-3.134869831308944e-05, 0.00013218469188182357, -3.131381385930119e-05], [-3.130135232364516e-05, -3.131381385930119e-05, 0.00013172694812111298]]} - #*EXTRAS*# Step: 1 Bead: 0 -{"friction": [[0.00012916430146574795, -3.645237368525803e-05, -3.615395576970892e-05], [-3.645237368525803e-05, 0.0001293313759649921, -3.6490431093944096e-05], [-3.615395576970892e-05, -3.6490431093944096e-05, 0.00012882075498913686]]} - #*EXTRAS*# Step: 2 Bead: 0 -{"friction": [[0.00012595089970628777, -4.0421501510817485e-05, -3.9866142920872695e-05], [-4.0421501510817485e-05, 0.00012602225450494825, -4.051358415297014e-05], [-3.9866142920872695e-05, -4.051358415297014e-05, 0.00012562674779050386]]} - #*EXTRAS*# Step: 3 Bead: 0 -{"friction": [[0.00012376434106479127, -4.2368012819481104e-05, -4.1979929741135886e-05], [-4.2368012819481104e-05, 0.00012383011512419038, -4.246604850431206e-05], [-4.1979929741135886e-05, -4.246604850431206e-05, 0.0001235400937041879]]} - #*EXTRAS*# Step: 4 Bead: 0 -{"friction": [[0.00012250611376514513, -4.316391112626397e-05, -4.300175727471778e-05], [-4.316391112626397e-05, 0.00012257064793810658, -4.3226410524069893e-05], [-4.300175727471778e-05, -4.3226410524069893e-05, 0.00012236317853948347]]} - #*EXTRAS*# Step: 5 Bead: 0 -{"friction": [[0.0001216515438771965, -4.357577689514659e-05, -4.353183200131704e-05], [-4.357577689514659e-05, 0.00012168486042063468, -4.358415522016535e-05], [-4.353183200131704e-05, -4.358415522016535e-05, 0.00012155889162865568]]} - #*EXTRAS*# Step: 6 Bead: 0 -{"friction": [[0.00012099722480741191, -4.3840515569208874e-05, -4.38347209370581e-05], [-4.3840515569208874e-05, 0.00012098097244879934, -4.3789364392777254e-05], [-4.38347209370581e-05, -4.3789364392777254e-05, 0.00012093478809575148]]} - #*EXTRAS*# Step: 7 Bead: 0 -{"friction": [[0.00012047513368860672, -4.402801098715234e-05, -4.401713798666564e-05], [-4.402801098715234e-05, 0.00012040444761002372, -4.392044529322349e-05], [-4.401713798666564e-05, -4.392044529322349e-05, 0.00012043092816211719]]} - #*EXTRAS*# Step: 8 Bead: 0 -{"friction": [[0.00012004676854326849, -4.416576891284262e-05, -4.413387426792877e-05], [-4.416576891284262e-05, 0.00011992563201858145, -4.400926794893067e-05], [-4.413387426792877e-05, -4.400926794893067e-05, 0.0001200144224083326]]} - #*EXTRAS*# Step: 9 Bead: 0 -{"friction": [[0.00011968882469468762, -4.4269135670842615e-05, -4.421152802475037e-05], [-4.4269135670842615e-05, 0.00011952363631048464, -4.407157997328812e-05], [-4.421152802475037e-05, -4.407157997328812e-05, 0.00011966466098936051]]} - #*EXTRAS*# Step: 10 Bead: 0 -{"friction": [[0.00011938455780870601, -4.4348150253567044e-05, -4.426464614037495e-05], [-4.4348150253567044e-05, 0.00011918167219130908, -4.4116465676835725e-05], [-4.426464614037495e-05, -4.4116465676835725e-05, 0.00011936631821480854]]} - #*EXTRAS*# Step: 11 Bead: 0 -{"friction": [[0.00011912235714428107, -4.440939882327652e-05, -4.4301615589291735e-05], [-4.440939882327652e-05, 0.00011888744133866298, -4.414939133140123e-05], [-4.4301615589291735e-05, -4.414939133140123e-05, 0.00011910857476612228]]} - #*EXTRAS*# Step: 12 Bead: 0 -{"friction": [[0.00011889383432569592, -4.445738420448903e-05, -4.4327576486406434e-05], [-4.445738420448903e-05, 0.00011863174482938656, -4.417384029431445e-05], [-4.4327576486406434e-05, -4.417384029431445e-05, 0.00011888351382008126]]} - #*EXTRAS*# Step: 13 Bead: 0 -{"friction": [[0.00011869282786796049, -4.4495266885301666e-05, -4.43458195385756e-05], [-4.4495266885301666e-05, 0.00011840766991069549, -4.419212187815734e-05], [-4.43458195385756e-05, -4.419212187815734e-05, 0.00011868526826213154]]} - #*EXTRAS*# Step: 14 Bead: 0 -{"friction": [[0.00011851468932455356, -4.4525329121196115e-05, -4.4358534692477954e-05], [-4.4525329121196115e-05, 0.0001182099178100371, -4.4205823870079256e-05], [-4.4358534692477954e-05, -4.4205823870079256e-05, 0.00011850938129380904]]} - #*EXTRAS*# Step: 15 Bead: 0 -{"friction": [[0.00011835584030688029, -4.454925714372388e-05, -4.436722539957501e-05], [-4.454925714372388e-05, 0.00011803436298363648, -4.421607025478889e-05], [-4.436722539957501e-05, -4.421607025478889e-05, 0.00011835240359100794]]} - #*EXTRAS*# Step: 16 Bead: 0 -{"friction": [[0.00011821347000711615, -4.4568322669551e-05, -4.4372951355663276e-05], [-4.4568322669551e-05, 0.00011787773849084485, -4.422367684526005e-05], [-4.4372951355663276e-05, -4.422367684526005e-05, 0.00011821161386157358]]} - #*EXTRAS*# Step: 17 Bead: 0 -{"friction": [[0.00011808533148585529, -4.4583501577174214e-05, -4.437647595046647e-05], [-4.4583501577174214e-05, 0.00011773741792728616, -4.422924823410091e-05], [-4.437647595046647e-05, -4.422924823410091e-05, 0.00011808482883534399]]} - #*EXTRAS*# Step: 18 Bead: 0 -{"friction": [[0.00011796959928200177, -4.4595553958497464e-05, -4.437835921057119e-05], [-4.4595553958497464e-05, 0.00011761125961548476, -4.423324040524595e-05], [-4.437835921057119e-05, -4.423324040524595e-05, 0.00011797026935441294]]} - #*EXTRAS*# Step: 19 Bead: 0 -{"friction": [[0.00011786476869850275, -4.4605079310303514e-05, -4.43790181741619e-05], [-4.4605079310303514e-05, 0.00011749749451946986, -4.423600231899259e-05], [-4.43790181741619e-05, -4.423600231899259e-05, 0.00011786646506783663]]} - #*EXTRAS*# Step: 20 Bead: 0 -{"friction": [[0.00011776958304677086, -4.461255547010909e-05, -4.437876720488774e-05], [-4.461255547010909e-05, 0.00011739464416134118, -4.423780427515735e-05], [-4.437876720488774e-05, -4.423780427515735e-05, 0.00011777218522480207]]} - #*EXTRAS*# Step: 21 Bead: 0 -{"friction": [[0.00011768298030370451, -4.46183666394908e-05, -4.437784557057352e-05], [-4.46183666394908e-05, 0.00011730145974318679, -4.423885771333731e-05], [-4.437784557057352e-05, -4.423885771333731e-05, 0.00011768638771591833]]} - #*EXTRAS*# Step: 22 Bead: 0 -{"friction": [[0.00011760405338609765, -4.462282393914277e-05, -4.437643672670115e-05], [-4.462282393914277e-05, 0.00011721687635453845, -4.423932933264973e-05], [-4.437643672670115e-05, -4.423932933264973e-05, 0.00011760818098397374]]} - #*EXTRAS*# Step: 23 Bead: 0 -{"friction": [[0.00011753202016186403, -4.46261807493954e-05, -4.437468206759167e-05], [-4.46261807493954e-05, 0.00011713997809113728, -4.423935135625017e-05], [-4.437468206759167e-05, -4.423935135625017e-05, 0.0001175367951791919]]} - #*EXTRAS*# Step: 24 Bead: 0 -{"friction": [[0.00011746620051475942, -4.46286443440893e-05, -4.4372690908424515e-05], [-4.46286443440893e-05, 0.00011706997115585587, -4.4239029125289767e-05], [-4.4372690908424515e-05, -4.4239029125289767e-05, 0.00011747156003702819]]} - #*EXTRAS*# Step: 25 Bead: 0 -{"friction": [[0.00011740599859012817, -4.463038484392481e-05, -4.437054784861467e-05], [-4.463038484392481e-05, 0.00011700616287359589, -4.4238446807377235e-05], [-4.437054784861467e-05, -4.4238446807377235e-05, 0.00011741188771020598]]} - #*EXTRAS*# Step: 26 Bead: 0 -{"friction": [[0.00011735088889163575, -4.463154219974536e-05, -4.436831828280235e-05], [-4.463154219974536e-05, 0.00011694794513704876, -4.423767175010732e-05], [-4.436831828280235e-05, -4.423767175010732e-05, 0.00011735725929369392]]} - #*EXTRAS*# Step: 27 Bead: 0 -{"friction": [[0.00011730040527518005, -4.463223170540547e-05, -4.436605257957682e-05], [-4.463223170540547e-05, 0.00011689478121102554, -4.4236757844754e-05], [-4.436605257957682e-05, -4.4236757844754e-05, 0.00011730721413502656]]} - #*EXTRAS*# Step: 28 Bead: 0 -{"friction": [[0.00011725413213554819, -4.463254839715351e-05, -4.436378928666611e-05], [-4.463254839715351e-05, 0.00011684619509870085, -4.423574815541906e-05], [-4.436378928666611e-05, -4.423574815541906e-05, 0.00011726134125725034]]} - #*EXTRAS*# Step: 29 Bead: 0 -{"friction": [[0.00011721169727724889, -4.4632570597751505e-05, -4.436155761466786e-05], [-4.4632570597751505e-05, 0.00011680176289032746, -4.423467699516372e-05], [-4.436155761466786e-05, -4.423467699516372e-05, 0.00011721927240789482]]} - #*EXTRAS*# Step: 30 Bead: 0 -{"friction": [[0.00011717276610196376, -4.463236279532042e-05, -4.435937937968362e-05], [-4.463236279532042e-05, 0.00011676110567197261, -4.423357158053323e-05], [-4.435937937968362e-05, -4.423357158053323e-05, 0.00011718067638181571]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_01 b/drivers/py/pes/friction/frictionH/120K/inst.raw_01 deleted file mode 100644 index 388b8cfb6..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_01 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 1 -{"friction": [[0.00013154835182754853, -3.2245612347009654e-05, -3.218171211344349e-05], [-3.2245612347009654e-05, 0.00013178701661774967, -3.222276035226155e-05], [-3.218171211344349e-05, -3.222276035226155e-05, 0.00013130290733224788]]} - #*EXTRAS*# Step: 1 Bead: 1 -{"friction": [[0.0001286893030419792, -3.713190846506013e-05, -3.6780546449829285e-05], [-3.713190846506013e-05, 0.00012883988334197165, -3.71800304546541e-05], [-3.6780546449829285e-05, -3.71800304546541e-05, 0.0001283395631744918]]} - #*EXTRAS*# Step: 2 Bead: 1 -{"friction": [[0.0001255595515977443, -4.0815699620643985e-05, -4.025919338060738e-05], [-4.0815699620643985e-05, 0.00012562459621110223, -4.09116300219017e-05], [-4.025919338060738e-05, -4.09116300219017e-05, 0.00012524752298817733]]} - #*EXTRAS*# Step: 3 Bead: 1 -{"friction": [[0.00012350571430261051, -4.255206510784103e-05, -4.220874106329722e-05], [-4.255206510784103e-05, 0.00012357346288949112, -4.264636647064302e-05], [-4.220874106329722e-05, -4.264636647064302e-05, 0.0001232977676889637]]} - #*EXTRAS*# Step: 4 Bead: 1 -{"friction": [[0.00012230328948442814, -4.3269924034515715e-05, -4.314105387634043e-05], [-4.3269924034515715e-05, 0.00012236342268980444, -4.332199011090386e-05], [-4.314105387634043e-05, -4.332199011090386e-05, 0.0001221730939406554]]} - #*EXTRAS*# Step: 5 Bead: 1 -{"friction": [[0.00012147618519366912, -4.365027247032027e-05, -4.3621756634808554e-05], [-4.365027247032027e-05, 0.00012149855954658759, -4.364421119871324e-05], [-4.3621756634808554e-05, -4.364421119871324e-05, 0.00012139246480726636]]} - #*EXTRAS*# Step: 6 Bead: 1 -{"friction": [[0.00012083987908020374, -4.389922015919029e-05, -4.389476232172296e-05], [-4.389922015919029e-05, 0.00012080832854013111, -4.3831668419567127e-05], [-4.389476232172296e-05, -4.3831668419567127e-05, 0.00012078343296628643]]} - #*EXTRAS*# Step: 7 Bead: 1 -{"friction": [[0.0001203338361525274, -4.407509549710837e-05, -4.405869414739484e-05], [-4.407509549710837e-05, 0.00012024692259340631, -4.395152391087184e-05], [-4.405869414739484e-05, -4.395152391087184e-05, 0.00012029381847057779]]} - #*EXTRAS*# Step: 8 Bead: 1 -{"friction": [[0.00011991985249526275, -4.420367424041907e-05, -4.416337261974183e-05], [-4.420367424041907e-05, 0.0001197832091927444, -4.403256592890761e-05], [-4.416337261974183e-05, -4.403256592890761e-05, 0.0001198905714885945]]} - #*EXTRAS*# Step: 9 Bead: 1 -{"friction": [[0.00011957458155028012, -4.429977958002725e-05, -4.4232805895842314e-05], [-4.429977958002725e-05, 0.00011939521727819696, -4.408928715038095e-05], [-4.4232805895842314e-05, -4.408928715038095e-05, 0.00011955274456049951]]} - #*EXTRAS*# Step: 10 Bead: 1 -{"friction": [[0.00011928146135970337, -4.4373005213093815e-05, -4.428012424228152e-05], [-4.4373005213093815e-05, 0.00011906590109778443, -4.413003933839957e-05], [-4.428012424228152e-05, -4.413003933839957e-05, 0.00011926504076207387]]} - #*EXTRAS*# Step: 11 Bead: 1 -{"friction": [[0.00011902909292312528, -4.442960188875862e-05, -4.431289703776373e-05], [-4.442960188875862e-05, 0.00011878298380230162, -4.4159843246860896e-05], [-4.431289703776373e-05, -4.4159843246860896e-05, 0.00011901676778594759]]} - #*EXTRAS*# Step: 12 Bead: 1 -{"friction": [[0.00011880927943212927, -4.447382236214496e-05, -4.433576335952819e-05], [-4.447382236214496e-05, 0.00011853737756075751, -4.418189630939627e-05], [-4.433576335952819e-05, -4.418189630939627e-05, 0.0001188001506608638]]} - #*EXTRAS*# Step: 13 Bead: 1 -{"friction": [[0.00011861602184271071, -4.4508640091453794e-05, -4.435169274499617e-05], [-4.4508640091453794e-05, 0.00011832230221041995, -4.4198316819653946e-05], [-4.435169274499617e-05, -4.4198316819653946e-05, 0.000118609454132268]]} - #*EXTRAS*# Step: 14 Bead: 1 -{"friction": [[0.00011844480650239423, -4.453619561321111e-05, -4.436266104439535e-05], [-4.453619561321111e-05, 0.00011813258775016587, -4.421056029868031e-05], [-4.436266104439535e-05, -4.421056029868031e-05, 0.00011844033661133822]]} - #*EXTRAS*# Step: 15 Bead: 1 -{"friction": [[0.00011829216637024726, -4.4558066334736826e-05, -4.437002438598791e-05], [-4.4558066334736826e-05, 0.00011796422506221574, -4.421965644943181e-05], [-4.437002438598791e-05, -4.421965644943181e-05, 0.00011828944716130923]]} - #*EXTRAS*# Step: 16 Bead: 1 -{"friction": [[0.00011815538288185508, -4.4575439256941875e-05, -4.437473831782914e-05], [-4.4575439256941875e-05, 0.00011781404940212054, -4.4226352186395634e-05], [-4.437473831782914e-05, -4.4226352186395634e-05, 0.0001181541479154643]]} - #*EXTRAS*# Step: 17 Bead: 1 -{"friction": [[0.00011803228599344999, -4.4589223481923176e-05, -4.437749092009111e-05], [-4.4589223481923176e-05, 0.0001176795229789203, -4.423120069005218e-05], [-4.437749092009111e-05, -4.423120069005218e-05, 0.00011803232635759161]]} - #*EXTRAS*# Step: 18 Bead: 1 -{"friction": [[0.00011792111484134104, -4.4600125869282194e-05, -4.437878670771937e-05], [-4.4600125869282194e-05, 0.00011755858064433288, -4.423461889270867e-05], [-4.437878670771937e-05, -4.423461889270867e-05, 0.0001179222635627531]]} - #*EXTRAS*# Step: 19 Bead: 1 -{"friction": [[0.00011782041943975717, -4.460870306046284e-05, -4.437900113112342e-05], [-4.460870306046284e-05, 0.00011744951946421967, -4.4236925642735836e-05], [-4.437900113112342e-05, -4.4236925642735836e-05, 0.00011782254073540414]]} - #*EXTRAS*# Step: 20 Bead: 1 -{"friction": [[0.00011772898981542528, -4.461539809738384e-05, -4.437841696682741e-05], [-4.461539809738384e-05, 0.00011735091818470088, -4.4238367724485585e-05], [-4.437841696682741e-05, -4.4238367724485585e-05, 0.00011773197152292492]]} - #*EXTRAS*# Step: 21 Bead: 1 -{"friction": [[0.00011764580414358632, -4.4620566725717444e-05, -4.437724921232335e-05], [-4.4620566725717444e-05, 0.00011726157770944987, -4.4239138016471056e-05], [-4.437724921232335e-05, -4.4239138016471056e-05, 0.0001176495522896419]]} - #*EXTRAS*# Step: 22 Bead: 1 -{"friction": [[0.00011756999018304595, -4.462449665429248e-05, -4.437566249340663e-05], [-4.462449665429248e-05, 0.00011718047645699442, -4.4239388436178474e-05], [-4.437566249340663e-05, -4.4239388436178474e-05, 0.00011757442502074185]]} - #*EXTRAS*# Step: 23 Bead: 1 -{"friction": [[0.00011750079620301943, -4.462742190588291e-05, -4.437378347823869e-05], [-4.462742190588291e-05, 0.00011710673644116104, -4.423923934798909e-05], [-4.437378347823869e-05, -4.423923934798909e-05, 0.00011750584927712997]]} - #*EXTRAS*# Step: 24 Bead: 1 -{"friction": [[0.00011743756877501353, -4.462953368486984e-05, -4.4371709889632625e-05], [-4.462953368486984e-05, 0.00011703959717177546, -4.4238786521853864e-05], [-4.4371709889632625e-05, -4.4238786521853864e-05, 0.0001174431807187092]]} - #*EXTRAS*# Step: 25 Bead: 1 -{"friction": [[0.00011737973560039088, -4.4630988729962166e-05, -4.436951715398817e-05], [-4.4630988729962166e-05, 0.00011697839533412392, -4.4238106363234706e-05], [-4.436951715398817e-05, -4.4238106363234706e-05, 0.00011738585445991506]]} - #*EXTRAS*# Step: 26 Bead: 1 -{"friction": [[0.00011732679207633813, -4.463191582118126e-05, -4.436726337839459e-05], [-4.463191582118126e-05, 0.00011692254878800253, -4.4237259901075464e-05], [-4.436726337839459e-05, -4.4237259901075464e-05, 0.0001173333720217664]]} - #*EXTRAS*# Step: 27 Bead: 1 -{"friction": [[0.00011727829067122374, -4.46324209110383e-05, -4.4364993125255296e-05], [-4.46324209110383e-05, 0.00011687154383424474, -4.423629586865712e-05], [-4.4364993125255296e-05, -4.423629586865712e-05, 0.00011728529099281853]]} - #*EXTRAS*# Step: 28 Bead: 1 -{"friction": [[0.00011723383242419078, -4.4632591215110264e-05, -4.4362740308075076e-05], [-4.4632591215110264e-05, 0.00011682492496913069, -4.423525311138311e-05], [-4.4362740308075076e-05, -4.423525311138311e-05, 0.00011724121674230699]]} - #*EXTRAS*# Step: 29 Bead: 1 -{"friction": [[0.00011719306007485499, -4.463249850424318e-05, -4.436053043585729e-05], [-4.463249850424318e-05, 0.00011678228656072049, -4.423416248789445e-05], [-4.436053043585729e-05, -4.423416248789445e-05, 0.00011720079571106209]]} - #*EXTRAS*# Step: 30 Bead: 1 -{"friction": [[0.00011715565246611227, -4.463220177642326e-05, -4.435838236889387e-05], [-4.463220177642326e-05, 0.00011674326603496645, -4.4233048384971744e-05], [-4.435838236889387e-05, -4.4233048384971744e-05, 0.00011716370993702515]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_02 b/drivers/py/pes/friction/frictionH/120K/inst.raw_02 deleted file mode 100644 index 47c2186b1..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_02 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 2 -{"friction": [[0.0001305169912654799, -3.426881693488592e-05, -3.4119381770048507e-05], [-3.426881693488592e-05, 0.0001307291042872236, -3.427459924542595e-05], [-3.4119381770048507e-05, -3.427459924542595e-05, 0.00013021252399325722]]} - #*EXTRAS*# Step: 1 Bead: 2 -{"friction": [[0.00012764551331568468, -3.850180210646839e-05, -3.8045061678663234e-05], [-3.850180210646839e-05, 0.00012776121411998785, -3.8569693883882985e-05], [-3.8045061678663234e-05, -3.8569693883882985e-05, 0.00012729360618623438]]} - #*EXTRAS*# Step: 2 Bead: 2 -{"friction": [[0.00012481705695948644, -4.1511877530974883e-05, -4.0988404850469854e-05], [-4.1511877530974883e-05, 0.00012487670267123975, -4.161268905104676e-05], [-4.0988404850469854e-05, -4.161268905104676e-05, 0.00012453487425264872]]} - #*EXTRAS*# Step: 3 Bead: 2 -{"friction": [[0.00012300687956360998, -4.287676646943353e-05, -4.2624874997748286e-05], [-4.287676646943353e-05, 0.0001230760677290978, -4.2959007241281915e-05], [-4.2624874997748286e-05, -4.2959007241281915e-05, 0.00012283141513291218]]} - #*EXTRAS*# Step: 4 Bead: 2 -{"friction": [[0.00012190186636446617, -4.346408483593067e-05, -4.339222385981733e-05], [-4.346408483593067e-05, 0.00012194796017468636, -4.349110183051057e-05], [-4.339222385981733e-05, -4.349110183051057e-05, 0.00012179552993034382]]} - #*EXTRAS*# Step: 5 Bead: 2 -{"friction": [[0.00012112560676830857, -4.3791243771149345e-05, -4.378223042535306e-05], [-4.3791243771149345e-05, 0.00012112095649036673, -4.375295540431018e-05], [-4.378223042535306e-05, -4.375295540431018e-05, 0.00012105792885398685]]} - #*EXTRAS*# Step: 6 Bead: 2 -{"friction": [[0.00012052639461504323, -4.401053703948868e-05, -4.400128207320046e-05], [-4.401053703948868e-05, 0.00012046146767696096, -4.390872352051814e-05], [-4.400128207320046e-05, -4.390872352051814e-05, 0.00012048059722912726]]} - #*EXTRAS*# Step: 7 Bead: 2 -{"friction": [[0.00012005380156402715, -4.416362877435841e-05, -4.413217436724489e-05], [-4.416362877435841e-05, 0.00011993351898855064, -4.40079375075526e-05], [-4.413217436724489e-05, -4.40079375075526e-05, 0.00012002127998685366]]} - #*EXTRAS*# Step: 8 Bead: 2 -{"friction": [[0.00011966916063008429, -4.427449267124667e-05, -4.421530742823892e-05], [-4.427449267124667e-05, 0.0001195015328371423, -4.407470176652937e-05], [-4.421530742823892e-05, -4.407470176652937e-05, 0.00011964540661617181]]} - #*EXTRAS*# Step: 9 Bead: 2 -{"friction": [[0.00011934943113081695, -4.43567297598357e-05, -4.427005924362731e-05], [-4.43567297598357e-05, 0.0001191422177601824, -4.412118236754615e-05], [-4.427005924362731e-05, -4.412118236754615e-05, 0.00011933182137279275]]} - #*EXTRAS*# Step: 10 Bead: 2 -{"friction": [[0.00011907860086704502, -4.441898261484874e-05, -4.430702783926561e-05], [-4.441898261484874e-05, 0.00011883841757471843, -4.415437669092292e-05], [-4.430702783926561e-05, -4.415437669092292e-05, 0.00011906551007536217]]} - #*EXTRAS*# Step: 11 Bead: 2 -{"friction": [[0.00011884578829501208, -4.446681343285873e-05, -4.4332320721245e-05], [-4.446681343285873e-05, 0.00011857810502867646, -4.417848320355585e-05], [-4.4332320721245e-05, -4.417848320355585e-05, 0.00011883615054201828]]} - #*EXTRAS*# Step: 12 Bead: 2 -{"friction": [[0.00011864323086319824, -4.450397333611357e-05, -4.434968044638086e-05], [-4.450397333611357e-05, 0.00011835252678921346, -4.419617207741108e-05], [-4.434968044638086e-05, -4.419617207741108e-05, 0.00011863631553761937]]} - #*EXTRAS*# Step: 13 Bead: 2 -{"friction": [[0.00011846528314414116, -4.453306647183387e-05, -4.4361501586671284e-05], [-4.453306647183387e-05, 0.00011815523110779781, -4.420920969114531e-05], [-4.4361501586671284e-05, -4.420920969114531e-05, 0.00011846057015737144]]} - #*EXTRAS*# Step: 14 Bead: 2 -{"friction": [[0.00011830771756915197, -4.4555956740591634e-05, -4.436937652725228e-05], [-4.4555956740591634e-05, 0.00011798134200712491, -4.4218808096644284e-05], [-4.436937652725228e-05, -4.4218808096644284e-05, 0.00011830482474949939]]} - #*EXTRAS*# Step: 15 Bead: 2 -{"friction": [[0.00011816729932766309, -4.457401099993811e-05, -4.437439741871986e-05], [-4.457401099993811e-05, 0.00011782710451191198, -4.4225823586214036e-05], [-4.437439741871986e-05, -4.4225823586214036e-05, 0.0001181659379849296]]} - #*EXTRAS*# Step: 16 Bead: 2 -{"friction": [[0.00011804149980024013, -4.458825349950427e-05, -4.4377333123307516e-05], [-4.458825349950427e-05, 0.00011768957066794128, -4.423087644393697e-05], [-4.4377333123307516e-05, -4.423087644393697e-05, 0.0001180414465300192]]} - #*EXTRAS*# Step: 17 Bead: 2 -{"friction": [[0.00011792830574901703, -4.459946579527583e-05, -4.4378736683151555e-05], [-4.459946579527583e-05, 0.0001175663869763385, -4.423442542449515e-05], [-4.4378736683151555e-05, -4.423442542449515e-05, 0.00011792938392434554]]} - #*EXTRAS*# Step: 18 Bead: 2 -{"friction": [[0.00011782608703211786, -4.460825356253272e-05, -4.43790130470396e-05], [-4.460825356253272e-05, 0.00011745564516092206, -4.4236815784285184e-05], [-4.43790130470396e-05, -4.4236815784285184e-05, 0.00011782815431267261]]} - #*EXTRAS*# Step: 19 Bead: 2 -{"friction": [[0.00011773350370017236, -4.4615092318952734e-05, -4.4378463057352886e-05], [-4.4615092318952734e-05, 0.00011735577630323227, -4.4238311140210803e-05], [-4.4378463057352886e-05, -4.4238311140210803e-05, 0.00011773644339208856]]} - #*EXTRAS*# Step: 20 Bead: 2 -{"friction": [[0.00011764943926422315, -4.46203594744731e-05, -4.437731281632646e-05], [-4.46203594744731e-05, 0.00011726547417565379, -4.423911517294183e-05], [-4.437731281632646e-05, -4.423911517294183e-05, 0.00011765315421502596]]} - #*EXTRAS*# Step: 21 Bead: 2 -{"friction": [[0.00011757295201057719, -4.4624357268589914e-05, -4.4375733773914075e-05], [-4.4624357268589914e-05, 0.00011718363890987785, -4.423938676174965e-05], [-4.4375733773914075e-05, -4.423938676174965e-05, 0.00011757736021312136]]} - #*EXTRAS*# Step: 22 Bead: 2 -{"friction": [[0.00011750323889718257, -4.4627329510400734e-05, -4.4373856773573614e-05], [-4.4627329510400734e-05, 0.00011710933495859636, -4.423925076714043e-05], [-4.4373856773573614e-05, -4.423925076714043e-05, 0.0001175082702705337]]} - #*EXTRAS*# Step: 23 Bead: 2 -{"friction": [[0.00011743960840133045, -4.462947401549749e-05, -4.437178206962282e-05], [-4.462947401549749e-05, 0.0001170417592943114, -4.4238805863108184e-05], [-4.437178206962282e-05, -4.4238805863108184e-05, 0.00011744520239732043]]} - #*EXTRAS*# Step: 24 Bead: 2 -{"friction": [[0.00011738145982342166, -4.463095199914259e-05, -4.43695866005868e-05], [-4.463095199914259e-05, 0.00011698021703486482, -4.423813032769555e-05], [-4.43695866005868e-05, -4.423813032769555e-05, 0.00011738756362206805]]} - #*EXTRAS*# Step: 25 Bead: 2 -{"friction": [[0.00011732826731505682, -4.46318952781318e-05, -4.436732935638911e-05], [-4.46318952781318e-05, 0.00011692410253229474, -4.4237286393370604e-05], [-4.436732935638911e-05, -4.4237286393370604e-05, 0.00011733483444611214]]} - #*EXTRAS*# Step: 26 Bead: 2 -{"friction": [[0.00011727956740685803, -4.463241186867728e-05, -4.436505539715684e-05], [-4.463241186867728e-05, 0.00011687288452932602, -4.4236323563278616e-05], [-4.436505539715684e-05, -4.4236323563278616e-05, 0.00011728655668376484]]} - #*EXTRAS*# Step: 27 Bead: 2 -{"friction": [[0.00011723494916119953, -4.463259039159929e-05, -4.4362798902123126e-05], [-4.463259039159929e-05, 0.00011682609438177876, -4.423528117251963e-05], [-4.4362798902123126e-05, -4.423528117251963e-05, 0.00011724232384675485]]} - #*EXTRAS*# Step: 28 Bead: 2 -{"friction": [[0.00011719404630623569, -4.4632503577400756e-05, -4.436058550945369e-05], [-4.4632503577400756e-05, 0.00011678331660793783, -4.4234190389388246e-05], [-4.436058550945369e-05, -4.4234190389388246e-05, 0.00011720177345200835]]} - #*EXTRAS*# Step: 29 Bead: 2 -{"friction": [[0.00011715653088795427, -4.4632211082204615e-05, -4.435843413034881e-05], [-4.4632211082204615e-05, 0.00011674418123021799, -4.4233075795137536e-05], [-4.435843413034881e-05, -4.4233075795137536e-05, 0.00011716458080527474]]} - #*EXTRAS*# Step: 30 Bead: 2 -{"friction": [[0.00011712210810572925, -4.463176176934067e-05, -4.435635836871432e-05], [-4.463176176934067e-05, 0.00011670835752050712, -4.423195664256965e-05], [-4.435635836871432e-05, -4.423195664256965e-05, 0.00011713045393714701]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_03 b/drivers/py/pes/friction/frictionH/120K/inst.raw_03 deleted file mode 100644 index c79b19538..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_03 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 3 -{"friction": [[0.0001286764741586319, -3.714973769009648e-05, -3.679697296268993e-05], [-3.714973769009648e-05, 0.0001288266109833087, -3.7198122442431674e-05], [-3.679697296268993e-05, -3.7198122442431674e-05, 0.00012832661431276367]]} - #*EXTRAS*# Step: 1 Bead: 3 -{"friction": [[0.00012607892059406545, -4.0288583109172084e-05, -3.973582745361572e-05], [-4.0288583109172084e-05, 0.00012615275147890532, -4.037924424954023e-05], [-3.973582745361572e-05, -4.037924424954023e-05, 0.00012575129623192152]]} - #*EXTRAS*# Step: 2 Bead: 3 -{"friction": [[0.00012381853838111173, -4.23280851350682e-05, -4.193102726934131e-05], [-4.23280851350682e-05, 0.00012388385533028312, -4.242671454221878e-05], [-4.193102726934131e-05, -4.242671454221878e-05, 0.00012359095074737653]]} - #*EXTRAS*# Step: 3 Bead: 3 -{"friction": [[0.0001222896436444234, -4.3276857013088666e-05, -4.315013300660784e-05], [-4.3276857013088666e-05, 0.00012234941992498726, -4.332816833973328e-05], [-4.315013300660784e-05, -4.332816833973328e-05, 0.00012216029121227468]]} - #*EXTRAS*# Step: 4 Bead: 3 -{"friction": [[0.0001213039234894172, -4.372077094610197e-05, -4.370380020826626e-05], [-4.372077094610197e-05, 0.00012131388911362992, -4.3699427712531235e-05], [-4.370380020826626e-05, -4.3699427712531235e-05, 0.0001212284006399647]]} - #*EXTRAS*# Step: 5 Bead: 3 -{"friction": [[0.00012059967507318385, -4.3985198130420605e-05, -4.3977873114727344e-05], [-4.3985198130420605e-05, 0.00012054284808431733, -4.3891545632933004e-05], [-4.3977873114727344e-05, -4.3891545632933004e-05, 0.0001205515319716067]]} - #*EXTRAS*# Step: 6 Bead: 3 -{"friction": [[0.00012006141092944255, -4.416130859883897e-05, -4.413032734131131e-05], [-4.416130859883897e-05, 0.00011994205156798663, -4.400649334505393e-05], [-4.413032734131131e-05, -4.400649334505393e-05, 0.00012002869885638584]]} - #*EXTRAS*# Step: 7 Bead: 3 -{"friction": [[0.00011964150096950147, -4.428197006103948e-05, -4.4220540793822016e-05], [-4.428197006103948e-05, 0.00011947044103697907, -4.407904072328e-05], [-4.4220540793822016e-05, -4.407904072328e-05, 0.00011961831667836554]]} - #*EXTRAS*# Step: 8 Bead: 3 -{"friction": [[0.00011930180668763787, -4.436817874924817e-05, -4.427716773238298e-05], [-4.436817874924817e-05, 0.00011908874076224151, -4.412742539967289e-05], [-4.427716773238298e-05, -4.412742539967289e-05, 0.00011928503416732887]]} - #*EXTRAS*# Step: 9 Bead: 3 -{"friction": [[0.00011902056210380947, -4.4431407526848796e-05, -4.431388127964052e-05], [-4.4431407526848796e-05, 0.00011877343576385875, -4.4160766571658334e-05], [-4.431388127964052e-05, -4.4160766571658334e-05, 0.0001190083671277332]]} - #*EXTRAS*# Step: 10 Bead: 3 -{"friction": [[0.0001187829562549342, -4.447879166692809e-05, -4.4338159164083715e-05], [-4.447879166692809e-05, 0.00011850803065037355, -4.418429572086999e-05], [-4.4338159164083715e-05, -4.418429572086999e-05, 0.00011877418932181912]]} - #*EXTRAS*# Step: 11 Bead: 3 -{"friction": [[0.00011857907460137818, -4.451485186157124e-05, -4.435430608245401e-05], [-4.451485186157124e-05, 0.00011828129199036966, -4.4201141695240664e-05], [-4.435430608245401e-05, -4.4201141695240664e-05, 0.00011857297246829036]]} - #*EXTRAS*# Step: 12 Bead: 3 -{"friction": [[0.00011840190819559462, -4.454260251739774e-05, -4.436495761530357e-05], [-4.454260251739774e-05, 0.00011808519301113097, -4.4213289797498375e-05], [-4.436495761530357e-05, -4.4213289797498375e-05, 0.00011839794108275895]]} - #*EXTRAS*# Step: 13 Bead: 3 -{"friction": [[0.00011824639834974987, -4.456411672202455e-05, -4.43717978308197e-05], [-4.456411672202455e-05, 0.00011791389895421148, -4.42220500288845e-05], [-4.43717978308197e-05, -4.42220500288845e-05, 0.00011824418417021745]]} - #*EXTRAS*# Step: 14 Bead: 3 -{"friction": [[0.00011810877809847195, -4.458086684841404e-05, -4.437594489218746e-05], [-4.458086684841404e-05, 0.00011776304501892846, -4.422831914393404e-05], [-4.437594489218746e-05, -4.422831914393404e-05, 0.00011810803231540454]]} - #*EXTRAS*# Step: 15 Bead: 3 -{"friction": [[0.00011798617849466853, -4.459392547194097e-05, -4.437816429086111e-05], [-4.459392547194097e-05, 0.00011762929712663583, -4.4232729167385156e-05], [-4.437816429086111e-05, -4.4232729167385156e-05, 0.00011798668324320589]]} - #*EXTRAS*# Step: 16 Bead: 3 -{"friction": [[0.00011787636529271008, -4.460409167072655e-05, -4.437899374679194e-05], [-4.460409167072655e-05, 0.0001175100545879108, -4.4235736820400855e-05], [-4.437899374679194e-05, -4.4235736820400855e-05, 0.00011787794967890633]]} - #*EXTRAS*# Step: 17 Bead: 3 -{"friction": [[0.0001177775651701928, -4.461197202675179e-05, -4.43788190315069e-05], [-4.461197202675179e-05, 0.00011740325202641066, -4.423767903863494e-05], [-4.43788190315069e-05, -4.423767903863494e-05, 0.00011778009226273695]]} - #*EXTRAS*# Step: 18 Bead: 3 -{"friction": [[0.00011768834594466655, -4.461803440124803e-05, -4.437792172035237e-05], [-4.461803440124803e-05, 0.00011730722194018015, -4.4238808717332046e-05], [-4.437792172035237e-05, -4.4238808717332046e-05, 0.00011769170394502538]]} - #*EXTRAS*# Step: 19 Bead: 3 -{"friction": [[0.00011760753290939386, -4.462264450477936e-05, -4.437651019012073e-05], [-4.462264450477936e-05, 0.00011722059816574596, -4.423931838556963e-05], [-4.437651019012073e-05, -4.423931838556963e-05, 0.00011761162900741673]]} - #*EXTRAS*# Step: 20 Bead: 3 -{"friction": [[0.00011753414899389916, -4.4626091391096076e-05, -4.4374740302066454e-05], [-4.4626091391096076e-05, 0.00011714224652061415, -4.4239356311824285e-05], [-4.4374740302066454e-05, -4.4239356311824285e-05, 0.00011753890499964158]]} - #*EXTRAS*# Step: 21 Bead: 3 -{"friction": [[0.00011746737127410753, -4.4628605613976706e-05, -4.437272954423699e-05], [-4.4628605613976706e-05, 0.00011707121419007879, -4.423903772174218e-05], [-4.437272954423699e-05, -4.423903772174218e-05, 0.00011747272045239761]]} - #*EXTRAS*# Step: 22 Bead: 3 -{"friction": [[0.00011740649882682482, -4.4630372420903386e-05, -4.437056691697352e-05], [-4.4630372420903386e-05, 0.00011700669217711562, -4.423845278166325e-05], [-4.437056691697352e-05, -4.423845278166325e-05, 0.00011741238356383853]]} - #*EXTRAS*# Step: 23 Bead: 3 -{"friction": [[0.00011735092862537703, -4.4631541516824966e-05, -4.4368319982125235e-05], [-4.4631541516824966e-05, 0.00011694798704377899, -4.42376723925005e-05], [-4.4368319982125235e-05, -4.42376723925005e-05, 0.00011735729868149518]]} - #*EXTRAS*# Step: 24 Bead: 3 -{"friction": [[0.00011730013721534131, -4.463223441217138e-05, -4.4366039981301515e-05], [-4.463223441217138e-05, 0.0001168944993526933, -4.423675247011439e-05], [-4.4366039981301515e-05, -4.423675247011439e-05, 0.00011730694839800605]]} - #*EXTRAS*# Step: 25 Bead: 3 -{"friction": [[0.00011725366660772874, -4.4632550038359574e-05, -4.4363765613337175e-05], [-4.4632550038359574e-05, 0.00011684570701171363, -4.4235737159185784e-05], [-4.4363765613337175e-05, -4.4235737159185784e-05, 0.00011726087974960589]]} - #*EXTRAS*# Step: 26 Bead: 3 -{"friction": [[0.00011721111328823937, -4.4632569099606635e-05, -4.436152586353928e-05], [-4.4632569099606635e-05, 0.0001168011522521748, -4.423466128195034e-05], [-4.436152586353928e-05, -4.423466128195034e-05, 0.00011721869345024434]]} - #*EXTRAS*# Step: 27 Bead: 3 -{"friction": [[0.00011717211955808389, -4.4632357488128966e-05, -4.435934215093207e-05], [-4.4632357488128966e-05, 0.00011676043133430275, -4.423355222873854e-05], [-4.435934215093207e-05, -4.423355222873854e-05, 0.0001171800353999881]]} - #*EXTRAS*# Step: 28 Bead: 3 -{"friction": [[0.00011713636663086333, -4.463196899452722e-05, -4.435722997671107e-05], [-4.463196899452722e-05, 0.00011672318631448188, -4.423243143460344e-05], [-4.435722997671107e-05, -4.423243143460344e-05, 0.00011714458990820767]]} - #*EXTRAS*# Step: 29 Bead: 3 -{"friction": [[0.00011710356907232242, -4.463144748006077e-05, -4.4355200202751565e-05], [-4.463144748006077e-05, 0.0001166890983949936, -4.423131554456257e-05], [-4.4355200202751565e-05, -4.423131554456257e-05, 0.00011711207422949394]]} - #*EXTRAS*# Step: 30 Bead: 3 -{"friction": [[0.000117073470284729, -4.4630828632825386e-05, -4.4353260052509936e-05], [-4.4630828632825386e-05, 0.0001166578825084951, -4.423021734167244e-05], [-4.4353260052509936e-05, -4.423021734167244e-05, 0.00011708223412188392]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_04 b/drivers/py/pes/friction/frictionH/120K/inst.raw_04 deleted file mode 100644 index aa904f7ce..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_04 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 4 -{"friction": [[0.000126076844382827, -4.029075427069417e-05, -3.973794837135237e-05], [-4.029075427069417e-05, 0.000126150633634249, -4.038143906978131e-05], [-3.973794837135237e-05, -4.038143906978131e-05, 0.00012574927445048358]]} - #*EXTRAS*# Step: 1 Bead: 4 -{"friction": [[0.0001242118005630554, -4.202450696574452e-05, -4.1567902994536414e-05], [-4.202450696574452e-05, 0.0001242738742018483, -4.212575489224792e-05], [-4.1567902994536414e-05, -4.212575489224792e-05, 0.00012396098561636316]]} - #*EXTRAS*# Step: 2 Bead: 4 -{"friction": [[0.000122624904103985, -4.309915312971374e-05, -4.291647728941369e-05], [-4.309915312971374e-05, 0.00012269127980020533, -4.316709253616962e-05], [-4.291647728941369e-05, -4.316709253616962e-05, 0.00012247435599409097]]} - #*EXTRAS*# Step: 3 Bead: 4 -{"friction": [[0.0001213557878445288, -4.3699808185378466e-05, -4.3679751608971045e-05], [-4.3699808185378466e-05, 0.00012136966506918443, -4.368317953126223e-05], [-4.3679751608971045e-05, -4.368317953126223e-05, 0.0001212778593567503]]} - #*EXTRAS*# Step: 4 Bead: 4 -{"friction": [[0.00012050407534820509, -4.4018170781963954e-05, -4.4008237789471113e-05], [-4.4018170781963954e-05, 0.00012043664988824233, -4.391385682831017e-05], [-4.4008237789471113e-05, -4.391385682831017e-05, 0.00012045897594746194]]} - #*EXTRAS*# Step: 5 Bead: 4 -{"friction": [[0.0001199063680743773, -4.4207621384405064e-05, -4.416637736622521e-05], [-4.4207621384405064e-05, 0.00011976806789360359, -4.4034962703691124e-05], [-4.416637736622521e-05, -4.4034962703691124e-05, 0.0001198774017644541]]} - #*EXTRAS*# Step: 6 Bead: 4 -{"friction": [[0.00011945651015345047, -4.433022140693853e-05, -4.4253101939380295e-05], [-4.433022140693853e-05, 0.0001192625132567544, -4.41065059131423e-05], [-4.4253101939380295e-05, -4.41065059131423e-05, 0.00011943694688636502]]} - #*EXTRAS*# Step: 7 Bead: 4 -{"friction": [[0.00011910939059299636, -4.44122581475971e-05, -4.4303241562306134e-05], [-4.44122581475971e-05, 0.00011887291103844794, -4.41508837543843e-05], [-4.4303241562306134e-05, -4.41508837543843e-05, 0.00011909581463524801]]} - #*EXTRAS*# Step: 8 Bead: 4 -{"friction": [[0.00011883013068512436, -4.446983593356149e-05, -4.433381427130158e-05], [-4.446983593356149e-05, 0.00011856063471019628, -4.417995912856348e-05], [-4.433381427130158e-05, -4.417995912856348e-05, 0.00011882071224498145]]} - #*EXTRAS*# Step: 9 Bead: 4 -{"friction": [[0.00011859976441216682, -4.4511391198934054e-05, -4.435285952476713e-05], [-4.4511391198934054e-05, 0.000118304252413566, -4.419957222291216e-05], [-4.435285952476713e-05, -4.419957222291216e-05, 0.00011859340246997805]]} - #*EXTRAS*# Step: 10 Bead: 4 -{"friction": [[0.00011840558516319614, -4.4542061272838076e-05, -4.436476777142602e-05], [-4.4542061272838076e-05, 0.00011808925307518387, -4.421306114628768e-05], [-4.436476777142602e-05, -4.421306114628768e-05, 0.0001184015752951598]]} - #*EXTRAS*# Step: 11 Bead: 4 -{"friction": [[0.00011823921633763981, -4.4565044615619234e-05, -4.437205813588116e-05], [-4.4565044615619234e-05, 0.00011790600856767983, -4.4222411653389576e-05], [-4.437205813588116e-05, -4.4222411653389576e-05, 0.00011823708062241249]]} - #*EXTRAS*# Step: 12 Bead: 4 -{"friction": [[0.000118094782357607, -4.4582447322553376e-05, -4.4376267989850055e-05], [-4.4582447322553376e-05, 0.00011774774501860025, -4.422887860792521e-05], [-4.4376267989850055e-05, -4.422887860792521e-05, 0.00011809418193975138]]} - #*EXTRAS*# Step: 13 Bead: 4 -{"friction": [[0.00011796807433135647, -4.4595702085058035e-05, -4.4378375889050864e-05], [-4.4595702085058035e-05, 0.0001176096011387571, -4.4233286408924316e-05], [-4.4378375889050864e-05, -4.4233286408924316e-05, 0.00011796875956720269]]} - #*EXTRAS*# Step: 14 Bead: 4 -{"friction": [[0.00011785597458622951, -4.4605817221714796e-05, -4.437902870206821e-05], [-4.4605817221714796e-05, 0.00011748797399318313, -4.4236197007858894e-05], [-4.437902870206821e-05, -4.4236197007858894e-05, 0.00011785775563162551]]} - #*EXTRAS*# Step: 15 Bead: 4 -{"friction": [[0.00011775611945899513, -4.46135213835161e-05, -4.4378667081409935e-05], [-4.46135213835161e-05, 0.0001173801323307823, -4.4238004764108554e-05], [-4.4378667081409935e-05, -4.4238004764108554e-05, 0.00011775884794083997]]} - #*EXTRAS*# Step: 16 Bead: 4 -{"friction": [[0.0001176666747877808, -4.4619353551771966e-05, -4.437759878678848e-05], [-4.4619353551771966e-05, 0.00011728395842060013, -4.4238993391320516e-05], [-4.437759878678848e-05, -4.4238993391320516e-05, 0.00011767023199038482]]} - #*EXTRAS*# Step: 17 Bead: 4 -{"friction": [[0.0001175861891453161, -4.462372019705838e-05, -4.43760431321599e-05], [-4.462372019705838e-05, 0.00011719777864942468, -4.423937121028195e-05], [-4.43760431321599e-05, -4.423937121028195e-05, 0.00011759047812570277]]} - #*EXTRAS*# Step: 18 Bead: 4 -{"friction": [[0.00011751349316684174, -4.4626932919655545e-05, -4.4374158915510944e-05], [-4.4626932919655545e-05, 0.00011712024712397131, -4.423929378205606e-05], [-4.4374158915510944e-05, -4.423929378205606e-05, 0.00011751843334693357]]} - #*EXTRAS*# Step: 19 Bead: 4 -{"friction": [[0.00011744762961992548, -4.4629233864394175e-05, -4.437206251793386e-05], [-4.4629233864394175e-05, 0.00011705026466374876, -4.423887886124528e-05], [-4.437206251793386e-05, -4.423887886124528e-05, 0.00011745315298356145]]} - #*EXTRAS*# Step: 20 Bead: 4 -{"friction": [[0.00011738780358845689, -4.463081332682e-05, -4.4369839957794265e-05], [-4.463081332682e-05, 0.00011698692101674914, -4.423821654497569e-05], [-4.4369839957794265e-05, -4.423821654497569e-05, 0.00011739385194900655]]} - #*EXTRAS*# Step: 21 Bead: 4 -{"friction": [[0.00011733334640478732, -4.4631822222405206e-05, -4.4367555120524354e-05], [-4.4631822222405206e-05, 0.00011692945296249422, -4.423737632767856e-05], [-4.4367555120524354e-05, -4.423737632767856e-05, 0.00011733986940355956]]} - #*EXTRAS*# Step: 22 Bead: 4 -{"friction": [[0.00011728368907584373, -4.463238110197935e-05, -4.436525550362457e-05], [-4.463238110197935e-05, 0.00011687721340009478, -4.423641211304196e-05], [-4.436525550362457e-05, -4.423641211304196e-05, 0.00011729064269009751]]} - #*EXTRAS*# Step: 23 Bead: 4 -{"friction": [[0.0001172383424156295, -4.4632586793431197e-05, -4.43629763092775e-05], [-4.4632586793431197e-05, 0.00011682964820160394, -4.4235365846045575e-05], [-4.43629763092775e-05, -4.4235365846045575e-05, 0.00011724568782849715]]} - #*EXTRAS*# Step: 24 Bead: 4 -{"friction": [[0.0001171968819823881, -4.463251737978226e-05, -4.436074341381048e-05], [-4.463251737978226e-05, 0.00011678627863353075, -4.423427019304463e-05], [-4.436074341381048e-05, -4.423427019304463e-05, 0.00011720458471408661]]} - #*EXTRAS*# Step: 25 Bead: 4 -{"friction": [[0.00011715893651165148, -4.4632235989489705e-05, -4.435857555840678e-05], [-4.4632235989489705e-05, 0.00011674668783343752, -4.423315055222995e-05], [-4.435857555840678e-05, -4.423315055222995e-05, 0.000117166965742108]]} - #*EXTRAS*# Step: 26 Bead: 4 -{"friction": [[0.00011712417892549652, -4.4631793723902244e-05, -4.4356485989657975e-05], [-4.4631793723902244e-05, 0.0001167105102783188, -4.423202658437022e-05], [-4.4356485989657975e-05, -4.423202658437022e-05, 0.00011713250695906716]]} - #*EXTRAS*# Step: 27 Bead: 4 -{"friction": [[0.00011709231926477995, -4.4631231947573914e-05, -4.4354483704705436e-05], [-4.4631231947573914e-05, 0.00011667742348925151, -4.423091339399117e-05], [-4.4354483704705436e-05, -4.423091339399117e-05, 0.00011710092110171828]]} - #*EXTRAS*# Step: 28 Bead: 4 -{"friction": [[0.00011706309906640859, -4.463058410065597e-05, -4.435257440712073e-05], [-4.463058410065597e-05, 0.00011664714142023798, -4.4229822451473455e-05], [-4.435257440712073e-05, -4.4229822451473455e-05, 0.00011707195205547787]]} - #*EXTRAS*# Step: 29 Bead: 4 -{"friction": [[0.00011703628684358028, -4.4629877147541886e-05, -4.435076124822384e-05], [-4.4629877147541886e-05, 0.00011661940913523149, -4.4228762320351386e-05], [-4.435076124822384e-05, -4.4228762320351386e-05, 0.00011704537039699232]]} - #*EXTRAS*# Step: 30 Bead: 4 -{"friction": [[0.00011701167442199444, -4.462913274511881e-05, -4.434904540742788e-05], [-4.462913274511881e-05, 0.00011659399848647701, -4.4227739236348115e-05], [-4.434904540742788e-05, -4.4227739236348115e-05, 0.00011702096977865009]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_05 b/drivers/py/pes/friction/frictionH/120K/inst.raw_05 deleted file mode 100644 index 203c3e8ed..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_05 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 5 -{"friction": [[0.00012328931016894538, -4.269780502417281e-05, -4.239371038048879e-05], [-4.269780502417281e-05, 0.00012335820237912475, -4.278771985526015e-05], [-4.239371038048879e-05, -4.278771985526015e-05, 0.00012309535072690375]]} - #*EXTRAS*# Step: 1 Bead: 5 -{"friction": [[0.00012223076292839058, -4.3306492543579546e-05, -4.318887864472367e-05], [-4.3306492543579546e-05, 0.0001222889067552836, -4.335446989368814e-05], [-4.318887864472367e-05, -4.335446989368814e-05, 0.00012210502556903082]]} - #*EXTRAS*# Step: 2 Bead: 5 -{"friction": [[0.00012120416686832614, -4.376049141196621e-05, -4.3748484396564264e-05], [-4.376049141196621e-05, 0.00012120617916689671, -4.3729807756148584e-05], [-4.3748484396564264e-05, -4.3729807756148584e-05, 0.00012113311512355723]]} - #*EXTRAS*# Step: 3 Bead: 5 -{"friction": [[0.00012018059087079129, -4.4124341688729956e-05, -4.410032428342652e-05], [-4.4124341688729956e-05, 0.00012007558350951433, -4.3983233205862365e-05], [-4.410032428342652e-05, -4.3983233205862365e-05, 0.0001201448014243005]]} - #*EXTRAS*# Step: 4 Bead: 5 -{"friction": [[0.00011951693113786782, -4.431480077689574e-05, -4.424292799197493e-05], [-4.431480077689574e-05, 0.00011933041712524518, -4.4097831004381743e-05], [-4.424292799197493e-05, -4.4097831004381743e-05, 0.00011949622047533918]]} - #*EXTRAS*# Step: 5 Bead: 5 -{"friction": [[0.00011906793206063026, -4.442129122581269e-05, -4.430831538246247e-05], [-4.442129122581269e-05, 0.00011882646861551708, -4.4155570323284035e-05], [-4.430831538246247e-05, -4.4155570323284035e-05, 0.00011905500776047484]]} - #*EXTRAS*# Step: 6 Bead: 5 -{"friction": [[0.00011873339050609555, -4.448795593295757e-05, -4.434247540317718e-05], [-4.448795593295757e-05, 0.00011845281388286366, -4.4188674172580735e-05], [-4.434247540317718e-05, -4.4188674172580735e-05, 0.00011872529348725702]]} - #*EXTRAS*# Step: 7 Bead: 5 -{"friction": [[0.0001184777052830482, -4.453114595287143e-05, -4.436077820099795e-05], [-4.453114595287143e-05, 0.00011816897398214691, -4.420837530855102e-05], [-4.436077820099795e-05, -4.420837530855102e-05, 0.0001184728438256015]]} - #*EXTRAS*# Step: 8 Bead: 5 -{"friction": [[0.00011827269359676414, -4.456066951770743e-05, -4.437080319116576e-05], [-4.456066951770743e-05, 0.00011794280377335238, -4.422069366187113e-05], [-4.437080319116576e-05, -4.422069366187113e-05, 0.00011827019032966963]]} - #*EXTRAS*# Step: 9 Bead: 5 -{"friction": [[0.0001181039450017804, -4.458141521990199e-05, -4.4376058509997604e-05], [-4.458141521990199e-05, 0.0001177577606307272, -4.422851397244622e-05], [-4.4376058509997604e-05, -4.422851397244622e-05, 0.00011810324949618356]]} - #*EXTRAS*# Step: 10 Bead: 5 -{"friction": [[0.00011796184485516009, -4.4596304275584707e-05, -4.437844183633171e-05], [-4.4596304275584707e-05, 0.00011760282727274567, -4.423347255073492e-05], [-4.437844183633171e-05, -4.423347255073492e-05, 0.0001179625919596174]]} - #*EXTRAS*# Step: 11 Bead: 5 -{"friction": [[0.00011784015093051801, -4.460712090861291e-05, -4.437903030350969e-05], [-4.460712090861291e-05, 0.00011747085250779493, -4.4236532871513734e-05], [-4.437903030350969e-05, -4.4236532871513734e-05, 0.00011784208381409806]]} - #*EXTRAS*# Step: 12 Bead: 5 -{"friction": [[0.00011773450289261969, -4.4615024282045496e-05, -4.4378473018638704e-05], [-4.4615024282045496e-05, 0.00011735685183552438, -4.423829840929034e-05], [-4.4378473018638704e-05, -4.423829840929034e-05, 0.00011773743327775395]]} - #*EXTRAS*# Step: 13 Bead: 5 -{"friction": [[0.00011764179745355345, -4.462079317746615e-05, -4.437717778039293e-05], [-4.462079317746615e-05, 0.00011725728377924701, -4.423916204777161e-05], [-4.437717778039293e-05, -4.423916204777161e-05, 0.00011764558215806325]]} - #*EXTRAS*# Step: 14 Bead: 5 -{"friction": [[0.00011755974442911601, -4.4624969895579986e-05, -4.437541010775329e-05], [-4.4624969895579986e-05, 0.00011716954046617503, -4.423938913400873e-05], [-4.437541010775329e-05, -4.423938913400873e-05, 0.0001175642712914766]]} - #*EXTRAS*# Step: 15 Bead: 5 -{"friction": [[0.0001174866137319667, -4.462794253432514e-05, -4.4373347884613664e-05], [-4.462794253432514e-05, 0.00011709165608981416, -4.42391641283876e-05], [-4.4373347884613664e-05, -4.42391641283876e-05, 0.00011749179263426363]]} - #*EXTRAS*# Step: 16 Bead: 5 -{"friction": [[0.00011742106633542397, -4.4629995603466744e-05, -4.4371112958437565e-05], [-4.4629995603466744e-05, 0.00011702211281080716, -4.423861840402645e-05], [-4.4371112958437565e-05, -4.423861840402645e-05, 0.00011742682330927183]]} - #*EXTRAS*# Step: 17 Bead: 5 -{"friction": [[0.00011736204491655979, -4.463134183752252e-05, -4.4368790205124e-05], [-4.463134183752252e-05, 0.00011695971514772929, -4.4237847371808724e-05], [-4.4368790205124e-05, -4.4237847371808724e-05, 0.00011736831813230383]]} - #*EXTRAS*# Step: 18 Bead: 5 -{"friction": [[0.00011730869901499813, -4.463214295930265e-05, -4.43664394095985e-05], [-4.463214295930265e-05, 0.00011690350415360935, -4.423692140779459e-05], [-4.43664394095985e-05, -4.423692140779459e-05, 0.00011731543598114691]]} - #*EXTRAS*# Step: 19 Bead: 5 -{"friction": [[0.0001172603333071181, -4.4632523589881964e-05, -4.436410291813146e-05], [-4.4632523589881964e-05, 0.00011685269813369067, -4.42358930385164e-05], [-4.436410291813146e-05, -4.42358930385164e-05, 0.00011726748886554383]]} - #*EXTRAS*# Step: 20 Bead: 5 -{"friction": [[0.00011721637086547228, -4.463258081740697e-05, -4.436181070001666e-05], [-4.463258081740697e-05, 0.00011680665057338299, -4.4234801794245246e-05], [-4.436181070001666e-05, -4.4234801794245246e-05, 0.0001172239057258324]]} - #*EXTRAS*# Step: 21 Bead: 5 -{"friction": [[0.00011717632664400384, -4.463239093234793e-05, -4.435958378351939e-05], [-4.463239093234793e-05, 0.00011676481978848138, -4.4233677569179584e-05], [-4.435958378351939e-05, -4.4233677569179584e-05, 0.0001171842062914663]]} - #*EXTRAS*# Step: 22 Bead: 5 -{"friction": [[0.00011713978799389308, -4.463201427050411e-05, -4.435743664149997e-05], [-4.463201427050411e-05, 0.0001167267466286236, -4.423254300019232e-05], [-4.435743664149997e-05, -4.423254300019232e-05, 0.00011714798186080167]]} - #*EXTRAS*# Step: 23 Bead: 5 -{"friction": [[0.00011710640013374706, -4.463149876366196e-05, -4.435537888325825e-05], [-4.463149876366196e-05, 0.0001166920378493255, -4.4231415185762524e-05], [-4.435537888325825e-05, -4.4231415185762524e-05, 0.00011711488096121253]]} - #*EXTRAS*# Step: 24 Bead: 5 -{"friction": [[0.0001170758551593119, -4.463088258954916e-05, -4.435341647746978e-05], [-4.463088258954916e-05, 0.00011666035353100688, -4.423030695152644e-05], [-4.435341647746978e-05, -4.423030695152644e-05, 0.00011708459849769093]]} - #*EXTRAS*# Step: 25 Bead: 5 -{"friction": [[0.0001170478836227872, -4.463019618196321e-05, -4.435155265173285e-05], [-4.463019618196321e-05, 0.00011663139743449313, -4.422922779805797e-05], [-4.435155265173285e-05, -4.422922779805797e-05, 0.00011705686743519111]]} - #*EXTRAS*# Step: 26 Bead: 5 -{"friction": [[0.00011702224800154225, -4.4629463778173874e-05, -4.434978856463429e-05], [-4.4629463778173874e-05, 0.00011660490951536063, -4.422818462164849e-05], [-4.434978856463429e-05, -4.422818462164849e-05, 0.0001170314523447866]]} - #*EXTRAS*# Step: 27 Bead: 5 -{"friction": [[0.00011699873757420249, -4.4628704625996236e-05, -4.434812381488574e-05], [-4.4628704625996236e-05, 0.00011658066004658321, -4.422718227004636e-05], [-4.434812381488574e-05, -4.422718227004636e-05, 0.00011700814433866793]]} - #*EXTRAS*# Step: 28 Bead: 5 -{"friction": [[0.00011697716435204287, -4.462793393636416e-05, -4.434655683136418e-05], [-4.462793393636416e-05, 0.000116558444948328, -4.422622397595371e-05], [-4.434655683136418e-05, -4.422622397595371e-05, 0.0001169867570468995]]} - #*EXTRAS*# Step: 29 Bead: 5 -{"friction": [[0.00011695735981473897, -4.46271636427991e-05, -4.4345085174945564e-05], [-4.46271636427991e-05, 0.0001165380820385937, -4.422531169869854e-05], [-4.4345085174945564e-05, -4.422531169869854e-05, 0.00011696712338847653]]} - #*EXTRAS*# Step: 30 Bead: 5 -{"friction": [[0.00011693917226886894, -4.4626403012481605e-05, -4.434370577429959e-05], [-4.4626403012481605e-05, 0.00011651940799717335, -4.422444639609778e-05], [-4.434370577429959e-05, -4.422444639609778e-05, 0.00011694909295755758]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_06 b/drivers/py/pes/friction/frictionH/120K/inst.raw_06 deleted file mode 100644 index f55e71a07..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_06 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 6 -{"friction": [[0.00012028748904337296, -4.4090190695074945e-05, -4.407165498061319e-05], [-4.4090190695074945e-05, 0.00012019515217934021, -4.396133059277882e-05], [-4.407165498061319e-05, -4.396133059277882e-05, 0.00012024878352738596]]} - #*EXTRAS*# Step: 1 Bead: 6 -{"friction": [[0.0001198548064858176, -4.422257112080887e-05, -4.417764172601042e-05], [-4.422257112080887e-05, 0.00011971015746790889, -4.404398961956702e-05], [-4.417764172601042e-05, -4.404398961956702e-05, 0.00011982702469475154]]} - #*EXTRAS*# Step: 2 Bead: 6 -{"friction": [[0.0001194689463364501, -4.43270745688243e-05, -4.425104392503369e-05], [-4.43270745688243e-05, 0.0001192764884432658, -4.410474369105259e-05], [-4.425104392503369e-05, -4.410474369105259e-05, 0.00011944914962116194]]} - #*EXTRAS*# Step: 3 Bead: 6 -{"friction": [[0.00011879942837598193, -4.447569033330348e-05, -4.433666840123911e-05], [-4.447569033330348e-05, 0.00011852639312732992, -4.41828002795822e-05], [-4.433666840123911e-05, -4.41828002795822e-05, 0.00011879043551673835]]} - #*EXTRAS*# Step: 4 Bead: 6 -{"friction": [[0.00011838906579207015, -4.4544481216329614e-05, -4.436561040598471e-05], [-4.4544481216329614e-05, 0.00011807101603000202, -4.421408059771616e-05], [-4.436561040598471e-05, -4.421408059771616e-05, 0.00011838524751619824]]} - #*EXTRAS*# Step: 5 Bead: 6 -{"friction": [[0.00011812328152236298, -4.457920488123231e-05, -4.4375590980226725e-05], [-4.457920488123231e-05, 0.00011777890834419397, -4.4227724165082204e-05], [-4.4375590980226725e-05, -4.4227724165082204e-05, 0.00011812238435852369]]} - #*EXTRAS*# Step: 6 Bead: 6 -{"friction": [[0.00011792511627966524, -4.45997593420968e-05, -4.437875944497409e-05], [-4.45997593420968e-05, 0.00011756292425060756, -4.4234511707933374e-05], [-4.437875944497409e-05, -4.4234511707933374e-05, 0.00011792622576389648]]} - #*EXTRAS*# Step: 7 Bead: 6 -{"friction": [[0.0001177749338028414, -4.4612165249048866e-05, -4.4378802566602044e-05], [-4.4612165249048866e-05, 0.0001174004140284537, -4.423772084784118e-05], [-4.4378802566602044e-05, -4.423772084784118e-05, 0.00011777748566482419]]} - #*EXTRAS*# Step: 8 Bead: 6 -{"friction": [[0.0001176543282831259, -4.46200780362073e-05, -4.437739655338743e-05], [-4.46200780362073e-05, 0.00011727071580110775, -4.423908288866641e-05], [-4.437739655338743e-05, -4.423908288866641e-05, 0.00011765799854730069]]} - #*EXTRAS*# Step: 9 Bead: 6 -{"friction": [[0.00011755494720907587, -4.4625186704846266e-05, -4.437528884218614e-05], [-4.4625186704846266e-05, 0.00011716442208890498, -4.423938674290609e-05], [-4.437528884218614e-05, -4.423938674290609e-05, 0.00011755951709906983]]} - #*EXTRAS*# Step: 10 Bead: 6 -{"friction": [[0.00011747108737750134, -4.462848145340952e-05, -4.4372851407657126e-05], [-4.462848145340952e-05, 0.00011707516023593863, -4.4239064319350594e-05], [-4.4372851407657126e-05, -4.4239064319350594e-05, 0.00011747640371098227]]} - #*EXTRAS*# Step: 11 Bead: 6 -{"friction": [[0.00011739912166735163, -4.463055214413687e-05, -4.437028357263012e-05], [-4.463055214413687e-05, 0.00011699888790535713, -4.423836274440028e-05], [-4.437028357263012e-05, -4.423836274440028e-05, 0.00011740507101514014]]} - #*EXTRAS*# Step: 12 Bead: 6 -{"friction": [[0.00011733650530765713, -4.463177496743265e-05, -4.4367694445107935e-05], [-4.463177496743265e-05, 0.00011693278144625965, -4.423743126460891e-05], [-4.4367694445107935e-05, -4.423743126460891e-05, 0.00011734300084776743]]} - #*EXTRAS*# Step: 13 Bead: 6 -{"friction": [[0.00011728143723398357, -4.463239820916022e-05, -4.436514635208854e-05], [-4.463239820916022e-05, 0.00011687484821853032, -4.423636389661547e-05], [-4.436514635208854e-05, -4.423636389661547e-05, 0.0001172884103336274]]} - #*EXTRAS*# Step: 14 Bead: 6 -{"friction": [[0.00011723258891014006, -4.463259192183014e-05, -4.4362674940704685e-05], [-4.463259192183014e-05, 0.00011682362289701377, -4.423522175116332e-05], [-4.4362674940704685e-05, -4.423522175116332e-05, 0.00011723998395364425]]} - #*EXTRAS*# Step: 15 Bead: 6 -{"friction": [[0.0001171889585994066, -4.4632475895211614e-05, -4.436030053926903e-05], [-4.4632475895211614e-05, 0.00011677800357496698, -4.423404564307429e-05], [-4.436030053926903e-05, -4.423404564307429e-05, 0.00011719672954166438]]} - #*EXTRAS*# Step: 16 Bead: 6 -{"friction": [[0.00011714977143171659, -4.463213656706563e-05, -4.435803419334234e-05], [-4.463213656706563e-05, 0.00011673714017734707, -4.423286332517414e-05], [-4.435803419334234e-05, -4.423286332517414e-05, 0.0001171578794701899]]} - #*EXTRAS*# Step: 17 Bead: 6 -{"friction": [[0.00011711441581450753, -4.463163752987774e-05, -4.435588123170152e-05], [-4.463163752987774e-05, 0.00011670036350199838, -4.423169389987634e-05], [-4.435588123170152e-05, -4.423169389987634e-05, 0.00011712282775561857]]} - #*EXTRAS*# Step: 18 Bead: 6 -{"friction": [[0.0001170823997381476, -4.463102629730139e-05, -4.435384335577709e-05], [-4.463102629730139e-05, 0.0001166671366157721, -4.4230550563920194e-05], [-4.435384335577709e-05, -4.4230550563920194e-05, 0.00011709108682652692]]} - #*EXTRAS*# Step: 19 Bead: 6 -{"friction": [[0.000117053320737941, -4.463033879214942e-05, -4.435191993185581e-05], [-4.463033879214942e-05, 0.00011663702148968597, -4.4229442385850947e-05], [-4.435191993185581e-05, -4.4229442385850947e-05, 0.00011706225779692236]]} - #*EXTRAS*# Step: 20 Bead: 6 -{"friction": [[0.00011702684457383589, -4.462960240342753e-05, -4.435010880166702e-05], [-4.462960240342753e-05, 0.00011660965535874563, -4.4228375484561925e-05], [-4.435010880166702e-05, -4.4228375484561925e-05, 0.00011703600936226446]]} - #*EXTRAS*# Step: 21 Bead: 6 -{"friction": [[0.00011700268988415533, -4.462883812119166e-05, -4.434840680802213e-05], [-4.462883812119166e-05, 0.00011658473372508604, -4.4227353833745014e-05], [-4.434840680802213e-05, -4.4227353833745014e-05, 0.00011701206260611028]]} - #*EXTRAS*# Step: 22 Bead: 6 -{"friction": [[0.00011698061692714172, -4.462806206107202e-05, -4.434681014303348e-05], [-4.462806206107202e-05, 0.00011656199790045469, -4.4226379823907074e-05], [-4.434681014303348e-05, -4.4226379823907074e-05, 0.00011699017985198396]]} - #*EXTRAS*# Step: 23 Bead: 6 -{"friction": [[0.00011696041920220626, -4.462728657595344e-05, -4.4345314584923794e-05], [-4.462728657595344e-05, 0.0001165412257406137, -4.42254546644035e-05], [-4.4345314584923794e-05, -4.42254546644035e-05, 0.00011697015636548172]]} - #*EXTRAS*# Step: 24 Bead: 6 -{"friction": [[0.00011694191712405422, -4.462652108216246e-05, -4.4343915662737736e-05], [-4.462652108216246e-05, 0.00011652222465235028, -4.422457867712795e-05], [-4.4343915662737736e-05, -4.422457867712795e-05, 0.00011695181408856141]]} - #*EXTRAS*# Step: 25 Bead: 6 -{"friction": [[0.00011692495318472664, -4.4625772685412006e-05, -4.434260877322443e-05], [-4.4625772685412006e-05, 0.00011650482624477993, -4.4223751515349625e-05], [-4.434260877322443e-05, -4.4223751515349625e-05, 0.0001169349968468792]]} - #*EXTRAS*# Step: 26 Bead: 6 -{"friction": [[0.00011690938817540727, -4.4625046732035465e-05, -4.434138924825843e-05], [-4.4625046732035465e-05, 0.00011648888208337185, -4.422297233210126e-05], [-4.434138924825843e-05, -4.422297233210126e-05, 0.00011691956660147006]]} - #*EXTRAS*# Step: 27 Bead: 6 -{"friction": [[0.00011689509825383158, -4.462434718331205e-05, -4.4340252417437815e-05], [-4.462434718331205e-05, 0.00011647426044718899, -4.4222239907871954e-05], [-4.4340252417437815e-05, -4.4222239907871954e-05, 0.00011690540054290346]]} - #*EXTRAS*# Step: 28 Bead: 6 -{"friction": [[0.0001168819726834083, -4.462367677411842e-05, -4.433919368824602e-05], [-4.462367677411842e-05, 0.00011646084396151559, -4.422155274519579e-05], [-4.433919368824602e-05, -4.422155274519579e-05, 0.00011689238886047363]]} - #*EXTRAS*# Step: 29 Bead: 6 -{"friction": [[0.00011686991196662621, -4.462303725875829e-05, -4.433820857833586e-05], [-4.462303725875829e-05, 0.00011644852752266723, -4.4220909147309025e-05], [-4.433820857833586e-05, -4.4220909147309025e-05, 0.00011688043289142464]]} - #*EXTRAS*# Step: 30 Bead: 6 -{"friction": [[0.00011685882633253899, -4.462242961819965e-05, -4.433729273748883e-05], [-4.462242961819965e-05, 0.00011643721660690309, -4.4220307281025854e-05], [-4.433729273748883e-05, -4.4220307281025854e-05, 0.00011686944362041007]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_07 b/drivers/py/pes/friction/frictionH/120K/inst.raw_07 deleted file mode 100644 index c5dab43d3..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_07 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 7 -{"friction": [[0.00011665083949596382, -4.4607528816683966e-05, -4.431825914901668e-05], [-4.4607528816683966e-05, 0.0001162267076263409, -4.4207173972077276e-05], [-4.431825914901668e-05, -4.4207173972077276e-05, 0.00011666327977368902]]} - #*EXTRAS*# Step: 1 Bead: 7 -{"friction": [[0.00011707891217668889, -4.46309505115423e-05, -4.4353616310137535e-05], [-4.46309505115423e-05, 0.0001166635215736113, -4.4230421163181805e-05], [-4.4353616310137535e-05, -4.4230421163181805e-05, 0.00011708762923983617]]} - #*EXTRAS*# Step: 2 Bead: 7 -{"friction": [[0.00011753332963488428, -4.4626125855306844e-05, -4.437471793425248e-05], [-4.4626125855306844e-05, 0.0001171413734018756, -4.4239354444974335e-05], [-4.437471793425248e-05, -4.4239354444974335e-05, 0.00011753809295876609]]} - #*EXTRAS*# Step: 3 Bead: 7 -{"friction": [[0.00011731288927327987, -4.4632094443179e-05, -4.4366632667408705e-05], [-4.4632094443179e-05, 0.0001169079129339023, -4.42370020363133e-05], [-4.4366632667408705e-05, -4.42370020363133e-05, 0.00011731958989693389]]} - #*EXTRAS*# Step: 4 Bead: 7 -{"friction": [[0.00011719138693096597, -4.4632489575470356e-05, -4.436043681996216e-05], [-4.4632489575470356e-05, 0.00011678053923410327, -4.423411498026411e-05], [-4.436043681996216e-05, -4.423411498026411e-05, 0.00011719913697047943]]} - #*EXTRAS*# Step: 5 Bead: 7 -{"friction": [[0.00011712603374402624, -4.463182180872578e-05, -4.435660000061163e-05], [-4.463182180872578e-05, 0.00011671243874371549, -4.423208894619376e-05], [-4.435660000061163e-05, -4.423208894619376e-05, 0.00011713434583590743]]} - #*EXTRAS*# Step: 6 Bead: 7 -{"friction": [[0.00011707441290608794, -4.463085006072258e-05, -4.435332193488867e-05], [-4.463085006072258e-05, 0.00011665885913092833, -4.423025281336454e-05], [-4.435332193488867e-05, -4.423025281336454e-05, 0.00011708316864103276]]} - #*EXTRAS*# Step: 7 Bead: 7 -{"friction": [[0.00011703632371085136, -4.46298781938961e-05, -4.435076378149751e-05], [-4.46298781938961e-05, 0.00011661944723159962, -4.422876381695637e-05], [-4.435076378149751e-05, -4.422876381695637e-05, 0.00011704540694712734]]} - #*EXTRAS*# Step: 8 Bead: 7 -{"friction": [[0.00011700483048355072, -4.462890943033354e-05, -4.434855955059436e-05], [-4.462890943033354e-05, 0.00011658694054429899, -4.4227446237300544e-05], [-4.434855955059436e-05, -4.4227446237300544e-05, 0.00011701418477029538]]} - #*EXTRAS*# Step: 9 Bead: 7 -{"friction": [[0.00011697840261655181, -4.462798009826642e-05, -4.434664779238195e-05], [-4.462798009826642e-05, 0.00011655971910974103, -4.4226279979647125e-05], [-4.434664779238195e-05, -4.4226279979647125e-05, 0.00011698798463376871]]} - #*EXTRAS*# Step: 10 Bead: 7 -{"friction": [[0.00011695564944126729, -4.462709428763521e-05, -4.434495659216609e-05], [-4.462709428763521e-05, 0.00011653632483881043, -4.422523144784585e-05], [-4.434495659216609e-05, -4.422523144784585e-05, 0.00011696542778219125]]} - #*EXTRAS*# Step: 11 Bead: 7 -{"friction": [[0.00011693578607542971, -4.462625574815559e-05, -4.4343446008158735e-05], [-4.462625574815559e-05, 0.00011651593402460488, -4.422428237901223e-05], [-4.4343446008158735e-05, -4.422428237901223e-05, 0.00011694573603787239]]} - #*EXTRAS*# Step: 12 Bead: 7 -{"friction": [[0.00011691822152100408, -4.462546333134982e-05, -4.434208374213752e-05], [-4.462546333134982e-05, 0.00011649792831626166, -4.422341690668108e-05], [-4.434208374213752e-05, -4.422341690668108e-05, 0.00011692832344743819]]} - #*EXTRAS*# Step: 13 Bead: 7 -{"friction": [[0.00011690254503178857, -4.4624715680254065e-05, -4.434084690038066e-05], [-4.4624715680254065e-05, 0.0001164818781355021, -4.422262362996951e-05], [-4.434084690038066e-05, -4.422262362996951e-05, 0.00011691278275663289]]} - #*EXTRAS*# Step: 14 Bead: 7 -{"friction": [[0.0001168884484460412, -4.462401086619195e-05, -4.433971777275251e-05], [-4.462401086619195e-05, 0.00011646746160751188, -4.4221893496913e-05], [-4.433971777275251e-05, -4.4221893496913e-05, 0.00011689880842012539]]} - #*EXTRAS*# Step: 15 Bead: 7 -{"friction": [[0.00011687569902777843, -4.462334692248588e-05, -4.433868272845587e-05], [-4.462334692248588e-05, 0.00011645443590274963, -4.422121942010463e-05], [-4.433868272845587e-05, -4.422121942010463e-05, 0.0001168861696798821]]} - #*EXTRAS*# Step: 16 Bead: 7 -{"friction": [[0.00011686411515599825, -4.4622721884362746e-05, -4.4337730914267064e-05], [-4.4622721884362746e-05, 0.00011644261174423125, -4.4220595655743385e-05], [-4.4337730914267064e-05, -4.4220595655743385e-05, 0.00011687468646016041]]} - #*EXTRAS*# Step: 17 Bead: 7 -{"friction": [[0.00011685355241787298, -4.462213387474316e-05, -4.433685354194385e-05], [-4.462213387474316e-05, 0.00011643183879295039, -4.422001748050363e-05], [-4.433685354194385e-05, -4.422001748050363e-05, 0.00011686421557808133]]} - #*EXTRAS*# Step: 18 Bead: 7 -{"friction": [[0.00011684389350604696, -4.462158110454959e-05, -4.433604333899582e-05], [-4.462158110454959e-05, 0.00011642199506244531, -4.421948092561562e-05], [-4.433604333899582e-05, -4.421948092561562e-05, 0.00011685464072645085]]} - #*EXTRAS*# Step: 19 Bead: 7 -{"friction": [[0.00011683504144196802, -4.4621061871740944e-05, -4.433529417986437e-05], [-4.4621061871740944e-05, 0.00011641297981910889, -4.421898259812338e-05], [-4.433529417986437e-05, -4.421898259812338e-05, 0.00011684586575446165]]} - #*EXTRAS*# Step: 20 Bead: 7 -{"friction": [[0.00011682691471676164, -4.4620574550224356e-05, -4.433460081623793e-05], [-4.4620574550224356e-05, 0.00011640470849677822, -4.421851954756836e-05], [-4.433460081623793e-05, -4.421851954756836e-05, 0.00011683780984974542]]} - #*EXTRAS*# Step: 21 Bead: 7 -{"friction": [[0.00011681944381806568, -4.462011757992904e-05, -4.433395868335107e-05], [-4.462011757992904e-05, 0.0001163971090629232, -4.421808916978723e-05], [-4.433395868335107e-05, -4.421808916978723e-05, 0.00011683040409464775]]} - #*EXTRAS*# Step: 22 Bead: 7 -{"friction": [[0.00011681256868396455, -4.461968945787736e-05, -4.43333637572059e-05], [-4.461968945787736e-05, 0.0001163901193557121, -4.421768913562653e-05], [-4.43333637572059e-05, -4.421768913562653e-05, 0.00011682358894175012]]} - #*EXTRAS*# Step: 23 Bead: 7 -{"friction": [[0.0001168062368173602, -4.461928873153732e-05, -4.433281244886693e-05], [-4.461928873153732e-05, 0.00011638368511190247, -4.4217317338196004e-05], [-4.433281244886693e-05, -4.4217317338196004e-05, 0.0001168173123442282]]} - #*EXTRAS*# Step: 24 Bead: 7 -{"friction": [[0.00011680040186858627, -4.461891399420118e-05, -4.433230152524436e-05], [-4.461891399420118e-05, 0.00011637775848430873, -4.421697185346533e-05], [-4.433230152524436e-05, -4.421697185346533e-05, 0.00011681152835048164]]} - #*EXTRAS*# Step: 25 Bead: 7 -{"friction": [[0.00011679502255772284, -4.461856388217167e-05, -4.433182804926244e-05], [-4.461856388217167e-05, 0.00011637229691427216, -4.42166509107074e-05], [-4.433182804926244e-05, -4.42166509107074e-05, 0.00011680619603558084]]} - #*EXTRAS*# Step: 26 Bead: 7 -{"friction": [[0.0001167900618453171, -4.4618237073354815e-05, -4.433138933424305e-05], [-4.4618237073354815e-05, 0.00011636726226368093, -4.421635287018044e-05], [-4.433138933424305e-05, -4.421635287018044e-05, 0.0001168012786790117]]} - #*EXTRAS*# Step: 27 Bead: 7 -{"friction": [[0.00011678548628789152, -4.461793228695133e-05, -4.433098290888733e-05], [-4.461793228695133e-05, 0.00011636262014003678, -4.421607620621752e-05], [-4.433098290888733e-05, -4.421607620621752e-05, 0.00011679674312563878]]} - #*EXTRAS*# Step: 28 Bead: 7 -{"friction": [[0.00011678126552844322, -4.461764828369676e-05, -4.43306064898648e-05], [-4.461764828369676e-05, 0.00011635833936267074, -4.421581949413249e-05], [-4.43306064898648e-05, -4.421581949413249e-05, 0.00011679255928051496]]} - #*EXTRAS*# Step: 29 Bead: 7 -{"friction": [[0.00011677737189005628, -4.4617383866497443e-05, -4.43302579601986e-05], [-4.4617383866497443e-05, 0.00011635439153678354, -4.421558140002578e-05], [-4.43302579601986e-05, -4.421558140002578e-05, 0.00011678869970592958]]} - #*EXTRAS*# Step: 30 Bead: 7 -{"friction": [[0.00011677378005168247, -4.4617137881513786e-05, -4.432993535233617e-05], [-4.4617137881513786e-05, 0.00011635075071334173, -4.421536067296672e-05], [-4.432993535233617e-05, -4.421536067296672e-05, 0.00011678513929992788]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_08 b/drivers/py/pes/friction/frictionH/120K/inst.raw_08 deleted file mode 100644 index 7d256ee81..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_08 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 8 -{"friction": [[0.00011321589094004546, -4.351814646398022e-05, -4.345964836559014e-05], [-4.351814646398022e-05, 0.00011306154132995574, -4.343115956369095e-05], [-4.345964836559014e-05, -4.343115956369095e-05, 0.00011326318332248197]]} - #*EXTRAS*# Step: 1 Bead: 8 -{"friction": [[0.00011440034439429883, -4.405360655166109e-05, -4.3876723047773454e-05], [-4.405360655166109e-05, 0.00011411195530043661, -4.382567914108882e-05], [-4.3876723047773454e-05, -4.382567914108882e-05, 0.00011443451617624293]]} - #*EXTRAS*# Step: 2 Bead: 8 -{"friction": [[0.00011561365087447448, -4.4437517560348225e-05, -4.416959012099159e-05], [-4.4437517560348225e-05, 0.00011522036883705721, -4.408764020899972e-05], [-4.416959012099159e-05, -4.408764020899972e-05, 0.0001156356292036104]]} - #*EXTRAS*# Step: 3 Bead: 8 -{"friction": [[0.0001158429220620997, -4.448838680624022e-05, -4.4210312868082447e-05], [-4.448838680624022e-05, 0.00011543719029533046, -4.412203162566874e-05], [-4.4210312868082447e-05, -4.412203162566874e-05, 0.00011586272539859846]]} - #*EXTRAS*# Step: 4 Bead: 8 -{"friction": [[0.00011600522173201786, -4.4519939115628516e-05, -4.423641116309736e-05], [-4.4519939115628516e-05, 0.00011559247235171704, -4.4143595305645986e-05], [-4.423641116309736e-05, -4.4143595305645986e-05, 0.00011602350880121933]]} - #*EXTRAS*# Step: 5 Bead: 8 -{"friction": [[0.00011613565918578713, -4.4542567861116895e-05, -4.42557619975353e-05], [-4.4542567861116895e-05, 0.00011571841657673697, -4.4159277670253444e-05], [-4.42557619975353e-05, -4.4159277670253444e-05, 0.0001161527414463372]]} - #*EXTRAS*# Step: 6 Bead: 8 -{"friction": [[0.00011622752125911485, -4.455702551339066e-05, -4.426852781173778e-05], [-4.455702551339066e-05, 0.00011580775344866896, -4.416944996074423e-05], [-4.426852781173778e-05, -4.416944996074423e-05, 0.00011624376228949846]]} - #*EXTRAS*# Step: 7 Bead: 8 -{"friction": [[0.00011629939032091089, -4.4567476162497495e-05, -4.427802116232141e-05], [-4.4567476162497495e-05, 0.00011587802639901048, -4.4176909766542346e-05], [-4.427802116232141e-05, -4.4176909766542346e-05, 0.00011631497735151933]]} - #*EXTRAS*# Step: 8 Bead: 8 -{"friction": [[0.00011635553958831559, -4.457511170038498e-05, -4.428513748744425e-05], [-4.457511170038498e-05, 0.00011593316550007308, -4.418243517112752e-05], [-4.428513748744425e-05, -4.418243517112752e-05, 0.00011637061817791127]]} - #*EXTRAS*# Step: 9 Bead: 8 -{"friction": [[0.00011640104584294787, -4.4580957499726665e-05, -4.4290712135749456e-05], [-4.4580957499726665e-05, 0.00011597800798573457, -4.418671934421949e-05], [-4.4290712135749456e-05, -4.418671934421949e-05, 0.00011641571397100911]]} - #*EXTRAS*# Step: 10 Bead: 8 -{"friction": [[0.00011643869137132552, -4.458556080421623e-05, -4.429519371480964e-05], [-4.458556080421623e-05, 0.00011601521058417094, -4.419013276534553e-05], [-4.429519371480964e-05, -4.419013276534553e-05, 0.00011645302102132379]]} - #*EXTRAS*# Step: 11 Bead: 8 -{"friction": [[0.00011647044226095271, -4.4589278957904075e-05, -4.4298882176155864e-05], [-4.4589278957904075e-05, 0.00011604666341394956, -4.419291999075e-05], [-4.4298882176155864e-05, -4.419291999075e-05, 0.0001164844871900325]]} - #*EXTRAS*# Step: 12 Bead: 8 -{"friction": [[0.00011649760057183907, -4.459233962852725e-05, -4.430197089623492e-05], [-4.459233962852725e-05, 0.00011607362207808758, -4.4195237645098335e-05], [-4.430197089623492e-05, -4.4195237645098335e-05, 0.00011651140251110558]]} - #*EXTRAS*# Step: 13 Bead: 8 -{"friction": [[0.00011652110399713297, -4.459489912123446e-05, -4.4304594733541665e-05], [-4.459489912123446e-05, 0.00011609699417891634, -4.41971940781963e-05], [-4.4304594733541665e-05, -4.41971940781963e-05, 0.00011653469605396405]]} - #*EXTRAS*# Step: 14 Bead: 8 -{"friction": [[0.00011654163499285293, -4.459706699323447e-05, -4.430684942628757e-05], [-4.459706699323447e-05, 0.00011611744212656427, -4.4198865713418594e-05], [-4.430684942628757e-05, -4.4198865713418594e-05, 0.0001165550440184781]]} - #*EXTRAS*# Step: 15 Bead: 8 -{"friction": [[0.00011655970808107098, -4.459892282047363e-05, -4.43088054331317e-05], [-4.459892282047363e-05, 0.0001161354666775947, -4.4200308434240344e-05], [-4.43088054331317e-05, -4.4200308434240344e-05, 0.00011657295622442934]]} - #*EXTRAS*# Step: 16 Bead: 8 -{"friction": [[0.00011657571868130707, -4.4600525725037505e-05, -4.4310515750297864e-05], [-4.4600525725037505e-05, 0.00011615145358469009, -4.420156402765112e-05], [-4.4310515750297864e-05, -4.420156402765112e-05, 0.00011658882448716252]]} - #*EXTRAS*# Step: 17 Bead: 8 -{"friction": [[0.00011658997727537349, -4.460192064756414e-05, -4.4312021154897514e-05], [-4.460192064756414e-05, 0.00011616570640859802, -4.420266446432044e-05], [-4.4312021154897514e-05, -4.420266446432044e-05, 0.0001166029564654644]]} - #*EXTRAS*# Step: 18 Bead: 8 -{"friction": [[0.00011660273182153701, -4.4603142389315595e-05, -4.431335360119967e-05], [-4.4603142389315595e-05, 0.0001161784680751581, -4.420363466229619e-05], [-4.431335360119967e-05, -4.420363466229619e-05, 0.00011661559786814936]]} - #*EXTRAS*# Step: 19 Bead: 8 -{"friction": [[0.00011661418350222212, -4.4604218358757286e-05, -4.4314538553061436e-05], [-4.4604218358757286e-05, 0.00011618993606180516, -4.420449437449366e-05], [-4.4314538553061436e-05, -4.420449437449366e-05, 0.0001166269480563745]]} - #*EXTRAS*# Step: 20 Bead: 8 -{"friction": [[0.0001166244978089904, -4.4605170462104105e-05, -4.43155966008996e-05], [-4.4605170462104105e-05, 0.00011620027310611618, -4.420525949219757e-05], [-4.43155966008996e-05, -4.420525949219757e-05, 0.00011663717102648823]]} - #*EXTRAS*# Step: 21 Bead: 8 -{"friction": [[0.00011663381257164465, -4.460601644019453e-05, -4.4316544614206814e-05], [-4.460601644019453e-05, 0.00011620961497655201, -4.420594297034978e-05], [-4.4316544614206814e-05, -4.420594297034978e-05, 0.0001166464033653154]]} - #*EXTRAS*# Step: 22 Bead: 8 -{"friction": [[0.00011664224385316955, -4.460677083015247e-05, -4.4317396576287755e-05], [-4.460677083015247e-05, 0.00011621807618644159, -4.420655549534652e-05], [-4.4317396576287755e-05, -4.420655549534652e-05, 0.00011665476009099646]]} - #*EXTRAS*# Step: 23 Bead: 8 -{"friction": [[0.00011664989035485446, -4.4607445670059886e-05, -4.4318164200031045e-05], [-4.4607445670059886e-05, 0.00011622575427004272, -4.420710597599047e-05], [-4.4318164200031045e-05, -4.420710597599047e-05, 0.00011666233901774869]]} - #*EXTRAS*# Step: 24 Bead: 8 -{"friction": [[0.00011665683675385242, -4.460805102333174e-05, -4.4318857388996035e-05], [-4.460805102333174e-05, 0.00011623273302653051, -4.4207601909959875e-05], [-4.4318857388996035e-05, -4.4207601909959875e-05, 0.00011666922406289098]]} - #*EXTRAS*# Step: 25 Bead: 8 -{"friction": [[0.00011666315626687374, -4.460859537466756e-05, -4.431948458768202e-05], [-4.460859537466756e-05, 0.00011623908501485188, -4.420804966136658e-05], [-4.431948458768202e-05, -4.420804966136658e-05, 0.00011667548778711555]]} - #*EXTRAS*# Step: 26 Bead: 8 -{"friction": [[0.00011666891264392731, -4.4609085932984916e-05, -4.43200530510818e-05], [-4.4609085932984916e-05, 0.00011624487349615581, -4.4208454673741115e-05], [-4.43200530510818e-05, -4.4208454673741115e-05, 0.00011668119337003838]]} - #*EXTRAS*# Step: 27 Bead: 8 -{"friction": [[0.00011667416173841158, -4.460952886613504e-05, -4.432056905477376e-05], [-4.460952886613504e-05, 0.00011625015396519832, -4.420882163556085e-05], [-4.432056905477376e-05, -4.420882163556085e-05, 0.000116686396165983]]} - #*EXTRAS*# Step: 28 Bead: 8 -{"friction": [[0.00011667895275401717, -4.4609929484540624e-05, -4.4321038060200666e-05], [-4.4609929484540624e-05, 0.00011625497536776117, -4.420915461012703e-05], [-4.4321038060200666e-05, -4.420915461012703e-05, 0.0001166911449395338]]} - #*EXTRAS*# Step: 29 Bead: 8 -{"friction": [[0.00011668332924602711, -4.461029238643615e-05, -4.432146484613645e-05], [-4.461029238643615e-05, 0.0001162593810792788, -4.420945713859487e-05], [-4.432146484613645e-05, -4.420945713859487e-05, 0.00011669548285773304]]} - #*EXTRAS*# Step: 30 Bead: 8 -{"friction": [[0.00011668732993809322, -4.461062157424355e-05, -4.432185361475086e-05], [-4.461062157424355e-05, 0.00011626340970407677, -4.42097323228364e-05], [-4.432185361475086e-05, -4.42097323228364e-05, 0.00011669944829944141]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_09 b/drivers/py/pes/friction/frictionH/120K/inst.raw_09 deleted file mode 100644 index dc18d7be5..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_09 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 9 -{"friction": [[0.00011023000206976872, -4.1719099977050135e-05, -4.179519325177442e-05], [-4.1719099977050135e-05, 0.00011025478793267088, -4.1768623177242506e-05], [-4.179519325177442e-05, -4.1768623177242506e-05, 0.00011030747133180427]]} - #*EXTRAS*# Step: 1 Bead: 9 -{"friction": [[0.0001120073975097586, -4.2852245848480316e-05, -4.289328022843257e-05], [-4.2852245848480316e-05, 0.00011196977894012911, -4.2874611323661373e-05], [-4.289328022843257e-05, -4.2874611323661373e-05, 0.0001120694699104753]]} - #*EXTRAS*# Step: 2 Bead: 9 -{"friction": [[0.00011383403760730907, -4.3815018267426756e-05, -4.369393643517858e-05], [-4.3815018267426756e-05, 0.00011360872331669778, -4.3654920490220314e-05], [-4.369393643517858e-05, -4.3654920490220314e-05, 0.0001138743232405381]]} - #*EXTRAS*# Step: 3 Bead: 9 -{"friction": [[0.00011446456981832135, -4.407844389125281e-05, -4.3895566097042505e-05], [-4.407844389125281e-05, 0.00011416939046917575, -4.3843039969113373e-05], [-4.3895566097042505e-05, -4.3843039969113373e-05, 0.00011449806588679258]]} - #*EXTRAS*# Step: 4 Bead: 9 -{"friction": [[0.00011488519249740362, -4.422912706448435e-05, -4.4009628341838655e-05], [-4.422912706448435e-05, 0.00011454834212274395, -4.394690312347593e-05], [-4.4009628341838655e-05, -4.394690312347593e-05, 0.00011491434898528704]]} - #*EXTRAS*# Step: 5 Bead: 9 -{"friction": [[0.00011519528225452894, -4.432628466105797e-05, -4.4083471767382156e-05], [-4.432628466105797e-05, 0.00011483158915350017, -4.401276357632711e-05], [-4.4083471767382156e-05, -4.401276357632711e-05, 0.00011522133221385813]]} - #*EXTRAS*# Step: 6 Bead: 9 -{"friction": [[0.00011541993154577386, -4.4388917357314456e-05, -4.413162537140607e-05], [-4.4388917357314456e-05, 0.00011503931432179354, -4.405493826495506e-05], [-4.413162537140607e-05, -4.405493826495506e-05, 0.00011544377842369428]]} - #*EXTRAS*# Step: 7 Bead: 9 -{"friction": [[0.00011559424220464159, -4.443287799769209e-05, -4.41659339538479e-05], [-4.443287799769209e-05, 0.00011520214349742901, -4.4084515237877984e-05], [-4.41659339538479e-05, -4.4084515237877984e-05, 0.00011561640645895223]]} - #*EXTRAS*# Step: 8 Bead: 9 -{"friction": [[0.0001157325142430018, -4.446480133204771e-05, -4.41912688126215e-05], [-4.446480133204771e-05, 0.00011533241944828726, -4.4106048754205006e-05], [-4.41912688126215e-05, -4.4106048754205006e-05, 0.00011575336008890156]]} - #*EXTRAS*# Step: 9 Bead: 9 -{"friction": [[0.00011584575516743248, -4.4488969546810477e-05, -4.421078775817225e-05], [-4.4488969546810477e-05, 0.00011543988777458822, -4.4122427693728e-05], [-4.421078775817225e-05, -4.4122427693728e-05, 0.00011586553187104084]]} - #*EXTRAS*# Step: 10 Bead: 9 -{"friction": [[0.0001159405096017899, -4.450780688553114e-05, -4.422627480243371e-05], [-4.450780688553114e-05, 0.00011553037276569203, -4.413527143188702e-05], [-4.422627480243371e-05, -4.413527143188702e-05, 0.00011595939894010257]]} - #*EXTRAS*# Step: 11 Bead: 9 -{"friction": [[0.00011602123734048728, -4.4522849357801144e-05, -4.423886480844434e-05], [-4.4522849357801144e-05, 0.00011560788014043383, -4.414559955548052e-05], [-4.423886480844434e-05, -4.414559955548052e-05, 0.00011603937582126426]]} - #*EXTRAS*# Step: 12 Bead: 9 -{"friction": [[0.00011609096484203325, -4.453509040273595e-05, -4.4249293666561855e-05], [-4.453509040273595e-05, 0.00011567514358786254, -4.415406840074309e-05], [-4.4249293666561855e-05, -4.415406840074309e-05, 0.00011610845855855039]]} - #*EXTRAS*# Step: 13 Bead: 9 -{"friction": [[0.00011615186312587815, -4.454520732434268e-05, -4.4258065434256845e-05], [-4.454520732434268e-05, 0.00011573413612688788, -4.416112415652501e-05], [-4.4258065434256845e-05, -4.416112415652501e-05, 0.00011616879656419277]]} - #*EXTRAS*# Step: 14 Bead: 9 -{"friction": [[0.00011620552397863365, -4.45536755210519e-05, -4.426553555633415e-05], [-4.45536755210519e-05, 0.00011578631174915651, -4.4167079387366444e-05], [-4.426553555633415e-05, -4.4167079387366444e-05, 0.00011622196590681415]]} - #*EXTRAS*# Step: 15 Bead: 9 -{"friction": [[0.00011625315011976243, -4.4560839244442916e-05, -4.427196283651981e-05], [-4.4560839244442916e-05, 0.00011583277446479393, -4.417216021445205e-05], [-4.427196283651981e-05, -4.417216021445205e-05, 0.00011626915751512446]]} - #*EXTRAS*# Step: 16 Bead: 9 -{"friction": [[0.00011629567001525927, -4.4566953816928685e-05, -4.4277540351813475e-05], [-4.4566953816928685e-05, 0.00011587438041054757, -4.417653430451256e-05], [-4.4277540351813475e-05, -4.417653430451256e-05, 0.00011631129081145187]]} - #*EXTRAS*# Step: 17 Bead: 9 -{"friction": [[0.00011633381556057052, -4.457221277349927e-05, -4.42824154040179e-05], [-4.457221277349927e-05, 0.00011591180741430548, -4.418032880877613e-05], [-4.42824154040179e-05, -4.418032880877613e-05, 0.00011634909060471281]]} - #*EXTRAS*# Step: 18 Bead: 9 -{"friction": [[0.00011636817402154336, -4.4576765545811356e-05, -4.428670252779166e-05], [-4.4576765545811356e-05, 0.00011594560164594516, -4.418364201146586e-05], [-4.428670252779166e-05, -4.418364201146586e-05, 0.00011638313850616208]]} - #*EXTRAS*# Step: 19 Bead: 9 -{"friction": [[0.00011639922428803086, -4.458072940840643e-05, -4.42904922999065e-05], [-4.458072940840643e-05, 0.00011597621031109923, -4.418655118070438e-05], [-4.42904922999065e-05, -4.418655118070438e-05, 0.00011641390881881277]]} - #*EXTRAS*# Step: 20 Bead: 9 -{"friction": [[0.00011642736250627663, -4.458419771783323e-05, -4.42938574245781e-05], [-4.458419771783323e-05, 0.0001160040048337319, -4.418911797098415e-05], [-4.42938574245781e-05, -4.418911797098415e-05, 0.00011644179391360331]]} - #*EXTRAS*# Step: 21 Bead: 9 -{"friction": [[0.00011645292062233236, -4.458724573066234e-05, -4.429685703873108e-05], [-4.458724573066234e-05, 0.00011602929767471124, -4.4191392231022114e-05], [-4.429685703873108e-05, -4.4191392231022114e-05, 0.00011646712258831828]]} - #*EXTRAS*# Step: 22 Bead: 9 -{"friction": [[0.00011647618000517811, -4.4589934790329666e-05, -4.429953981497139e-05], [-4.4589934790329666e-05, 0.00011605235471649696, -4.4193414739152955e-05], [-4.429953981497139e-05, -4.4193414739152955e-05, 0.00011649017355569753]]} - #*EXTRAS*# Step: 23 Bead: 9 -{"friction": [[0.00011649738161897188, -4.4592315395081555e-05, -4.4301946238573e-05], [-4.4592315395081555e-05, 0.00011607340452986138, -4.4195219204415585e-05], [-4.4301946238573e-05, -4.4195219204415585e-05, 0.00011651118551522964]]} - #*EXTRAS*# Step: 24 Bead: 9 -{"friction": [[0.000116516733724583, -4.4594429482251846e-05, -4.4304110304889e-05], [-4.4594429482251846e-05, 0.0001160926454023666, -4.4196833754107314e-05], [-4.4304110304889e-05, -4.4196833754107314e-05, 0.00011653036477886384]]} - #*EXTRAS*# Step: 25 Bead: 9 -{"friction": [[0.00011653441778836367, -4.459631215429695e-05, -4.430606080332941e-05], [-4.459631215429695e-05, 0.00011611025073933215, -4.4198282056079054e-05], [-4.430606080332941e-05, -4.4198282056079054e-05, 0.00011654789112177313]]} - #*EXTRAS*# Step: 26 Bead: 9 -{"friction": [[0.00011655059307127204, -4.459799300059555e-05, -4.430782230160922e-05], [-4.459799300059555e-05, 0.00011612637326461201, -4.4199584176928776e-05], [-4.430782230160922e-05, -4.4199584176928776e-05, 0.00011656392232653962]]} - #*EXTRAS*# Step: 27 Bead: 9 -{"friction": [[0.00011656540023642417, -4.459949712235913e-05, -4.430941590974105e-05], [-4.459949712235913e-05, 0.00011614114832750222, -4.4200757246549344e-05], [-4.430941590974105e-05, -4.4200757246549344e-05, 0.00011657859775546678]]} - #*EXTRAS*# Step: 28 Bead: 9 -{"friction": [[0.00011657896421307934, -4.460084593595999e-05, -4.431085987945202e-05], [-4.460084593595999e-05, 0.00011615469653142538, -4.420181597833952e-05], [-4.431085987945202e-05, -4.420181597833952e-05, 0.00011659204118665177]]} - #*EXTRAS*# Step: 29 Bead: 9 -{"friction": [[0.00011659139649489952, -4.460205780915855e-05, -4.431217007949892e-05], [-4.460205780915855e-05, 0.00011616712584621018, -4.420277308076444e-05], [-4.431217007949892e-05, -4.420277308076444e-05, 0.00011660436308989604]]} - #*EXTRAS*# Step: 30 Bead: 9 -{"friction": [[0.0001166027970087331, -4.4603148570308243e-05, -4.4313360376864236e-05], [-4.4603148570308243e-05, 0.0001161785333286023, -4.4203639586559004e-05], [-4.4313360376864236e-05, -4.4203639586559004e-05, 0.00011661566247736258]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_10 b/drivers/py/pes/friction/frictionH/120K/inst.raw_10 deleted file mode 100644 index 58abe1164..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_10 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 10 -{"friction": [[0.00010769201875396802, -3.972555413098312e-05, -3.9719950576865164e-05], [-3.972555413098312e-05, 0.00010769006591528216, -3.9728539753675745e-05], [-3.9719950576865164e-05, -3.9728539753675745e-05, 0.00010769920684122335]]} - #*EXTRAS*# Step: 1 Bead: 10 -{"friction": [[0.00010994070331190677, -4.1515923212077605e-05, -4.158738609491027e-05], [-4.1515923212077605e-05, 0.00010996587746853609, -4.1559657141601646e-05], [-4.158738609491027e-05, -4.1559657141601646e-05, 0.00011001762387994532]]} - #*EXTRAS*# Step: 2 Bead: 10 -{"friction": [[0.0001122416337676336, -4.2988313952896364e-05, -4.30144746611767e-05], [-4.2988313952896364e-05, 0.00011218576231652864, -4.299522399437862e-05], [-4.30144746611767e-05, -4.299522399437862e-05, 0.0001123007274820805]]} - #*EXTRAS*# Step: 3 Bead: 10 -{"friction": [[0.00011321787911832415, -4.351915599685663e-05, -4.346046109431979e-05], [-4.351915599685663e-05, 0.00011306330514334234, -4.343194355760015e-05], [-4.346046109431979e-05, -4.343194355760015e-05, 0.00011326514838475347]]} - #*EXTRAS*# Step: 4 Bead: 10 -{"friction": [[0.00011386662136821714, -4.3829659077936924e-05, -4.370527136779423e-05], [-4.3829659077936924e-05, 0.00011363757120179098, -4.366561927527114e-05], [-4.370527136779423e-05, -4.366561927527114e-05, 0.00011390654748464366]]} - #*EXTRAS*# Step: 5 Bead: 10 -{"friction": [[0.0001143360240024973, -4.402826312081935e-05, -4.385746991642737e-05], [-4.402826312081935e-05, 0.0001140545285929471, -4.380788834149783e-05], [-4.385746991642737e-05, -4.380788834149783e-05, 0.00011437087604157181]]} - #*EXTRAS*# Step: 6 Bead: 10 -{"friction": [[0.00011467915984424482, -4.415795911661266e-05, -4.395577392716699e-05], [-4.415795911661266e-05, 0.0001143620604311086, -4.389814537663849e-05], [-4.395577392716699e-05, -4.389814537663849e-05, 0.00011471042356415885]]} - #*EXTRAS*# Step: 7 Bead: 10 -{"friction": [[0.00011494538832515696, -4.424893635428884e-05, -4.4024637736642186e-05], [-4.424893635428884e-05, 0.00011460303963966819, -4.396039039939615e-05], [-4.4024637736642186e-05, -4.396039039939615e-05, 0.00011497393571329889]]} - #*EXTRAS*# Step: 8 Bead: 10 -{"friction": [[0.00011515772977844747, -4.431517105089904e-05, -4.4074986498576565e-05], [-4.431517105089904e-05, 0.00011479708303707918, -4.400526286861805e-05], [-4.4074986498576565e-05, -4.400526286861805e-05, 0.00011518415186040586]]} - #*EXTRAS*# Step: 9 Bead: 10 -{"friction": [[0.00011533234131953108, -4.436528838858742e-05, -4.4113380218554005e-05], [-4.436528838858742e-05, 0.00011495804973649112, -4.4039041533526255e-05], [-4.4113380218554005e-05, -4.4039041533526255e-05, 0.0001153570425035311]]} - #*EXTRAS*# Step: 10 Bead: 10 -{"friction": [[0.00011547904088130318, -4.440428425480747e-05, -4.414355714646095e-05], [-4.440428425480747e-05, 0.00011509436141309667, -4.406527379082173e-05], [-4.414355714646095e-05, -4.406527379082173e-05, 0.00011550231457867276]]} - #*EXTRAS*# Step: 11 Bead: 10 -{"friction": [[0.00011560446714637382, -4.443532865130998e-05, -4.4167864188932856e-05], [-4.443532865130998e-05, 0.0001152117425952739, -4.4086165728219205e-05], [-4.4167864188932856e-05, -4.4086165728219205e-05, 0.00011562653341554738]]} - #*EXTRAS*# Step: 12 Bead: 10 -{"friction": [[0.00011571315962829314, -4.4460491737441325e-05, -4.4187822173071014e-05], [-4.4460491737441325e-05, 0.00011531412245632432, -4.410313649357994e-05], [-4.4187822173071014e-05, -4.410313649357994e-05, 0.00011573418915775181]]} - #*EXTRAS*# Step: 13 Bead: 10 -{"friction": [[0.00011580837551996515, -4.4481190232852206e-05, -4.420446669831853e-05], [-4.4481190232852206e-05, 0.00011540433421013385, -4.4117145549554835e-05], [-4.420446669831853e-05, -4.4117145549554835e-05, 0.00011582850408947181]]} - #*EXTRAS*# Step: 14 Bead: 10 -{"friction": [[0.00011589251010532, -4.44984231956536e-05, -4.421852555969295e-05], [-4.44984231956536e-05, 0.00011548447093774284, -4.4128862874726845e-05], [-4.421852555969295e-05, -4.4128862874726845e-05, 0.00011591184813424328]]} - #*EXTRAS*# Step: 15 Bead: 10 -{"friction": [[0.0001159673760482947, -4.4512916307967616e-05, -4.423052640100533e-05], [-4.4512916307967616e-05, 0.0001155561242680459, -4.413877121057319e-05], [-4.423052640100533e-05, -4.413877121057319e-05, 0.0001159860149752213]]} - #*EXTRAS*# Step: 16 Bead: 10 -{"friction": [[0.00011603437558828352, -4.4525209293654095e-05, -4.424086136597787e-05], [-4.4525209293654095e-05, 0.0001156205313718501, -4.414722722543254e-05], [-4.424086136597787e-05, -4.414722722543254e-05, 0.00011605239231392712]]} - #*EXTRAS*# Step: 17 Bead: 10 -{"friction": [[0.00011609461618347797, -4.453571211631032e-05, -4.4249828435484305e-05], [-4.453571211631032e-05, 0.00011567867414237503, -4.4154500385270814e-05], [-4.4249828435484305e-05, -4.4154500385270814e-05, 0.00011611207623231274]]} - #*EXTRAS*# Step: 18 Bead: 10 -{"friction": [[0.00011614898827703445, -4.45447418210519e-05, -4.425765838209436e-05], [-4.45447418210519e-05, 0.00011573134600888, -4.41607981927127e-05], [-4.425765838209436e-05, -4.41607981927127e-05, 0.00011616594810528464]]} - #*EXTRAS*# Step: 19 Bead: 10 -{"friction": [[0.00011619821952687713, -4.455254748270171e-05, -4.426453295093187e-05], [-4.455254748270171e-05, 0.00011577919866604918, -4.4166283134799443e-05], [-4.426453295093187e-05, -4.4166283134799443e-05, 0.0001162147282409548]]} - #*EXTRAS*# Step: 20 Bead: 10 -{"friction": [[0.00011624291321593945, -4.4559327474411505e-05, -4.427059739720875e-05], [-4.4559327474411505e-05, 0.00011582277523915037, -4.41710843260536e-05], [-4.427059739720875e-05, -4.41710843260536e-05, 0.00011625901387648784]]} - #*EXTRAS*# Step: 21 Bead: 10 -{"friction": [[0.0001162835760462778, -4.456524169540128e-05, -4.427596933536378e-05], [-4.456524169540128e-05, 0.00011586253433113894, -4.417530569690603e-05], [-4.427596933536378e-05, -4.417530569690603e-05, 0.00011629930667443367]]} - #*EXTRAS*# Step: 22 Bead: 10 -{"friction": [[0.00011632063857106015, -4.457042039654621e-05, -4.428074510630205e-05], [-4.457042039654621e-05, 0.00011589886772760401, -4.4179031866684034e-05], [-4.428074510630205e-05, -4.4179031866684034e-05, 0.00011633603293710135]]} - #*EXTRAS*# Step: 23 Bead: 10 -{"friction": [[0.00011635447045375835, -4.457497066556595e-05, -4.428500444231657e-05], [-4.457497066556595e-05, 0.00011593211363640091, -4.418233243373006e-05], [-4.428500444231657e-05, -4.418233243373006e-05, 0.00011636955870407648]]} - #*EXTRAS*# Step: 24 Bead: 10 -{"friction": [[0.00011638539202259604, -4.457898126956909e-05, -4.4288813940233484e-05], [-4.457898126956909e-05, 0.0001159625667226676, -4.418526516088908e-05], [-4.4288813940233484e-05, -4.418526516088908e-05, 0.00011640020118480342]]} - #*EXTRAS*# Step: 25 Bead: 10 -{"friction": [[0.00011641368313495058, -4.458252632473814e-05, -4.4292229685779804e-05], [-4.458252632473814e-05, 0.00011599048581338536, -4.418787837649857e-05], [-4.4292229685779804e-05, -4.418787837649857e-05, 0.00011642823752987342]]} - #*EXTRAS*# Step: 26 Bead: 10 -{"friction": [[0.0001164395900611906, -4.4585668114817086e-05, -4.429529926352362e-05], [-4.4585668114817086e-05, 0.00011601609988412703, -4.419021280893684e-05], [-4.429529926352362e-05, -4.419021280893684e-05, 0.00011645391164281808]]} - #*EXTRAS*# Step: 27 Bead: 10 -{"friction": [[0.00011646333089469213, -4.4588459282820604e-05, -4.4298063315672626e-05], [-4.4588459282820604e-05, 0.00011603961276687251, -4.419230300616769e-05], [-4.4298063315672626e-05, -4.419230300616769e-05, 0.00011647743953370307]]} - #*EXTRAS*# Step: 28 Bead: 10 -{"friction": [[0.0001164850998472225, -4.4590944554100244e-05, -4.4300556764417406e-05], [-4.4590944554100244e-05, 0.00011606120688987146, -4.419417844647579e-05], [-4.4300556764417406e-05, -4.419417844647579e-05, 0.00011649901356985895]]} - #*EXTRAS*# Step: 29 Bead: 10 -{"friction": [[0.00011650507069591507, -4.459316210491671e-05, -4.430280978058162e-05], [-4.459316210491671e-05, 0.00011608104628090328, -4.419586441676021e-05], [-4.430280978058162e-05, -4.419586441676021e-05, 0.00011651880588713797]]} - #*EXTRAS*# Step: 30 Bead: 10 -{"friction": [[0.0001165233995843945, -4.4595144660284005e-05, -4.430484855940996e-05], [-4.4595144660284005e-05, 0.00011609927901095163, -4.4197382714271126e-05], [-4.430484855940996e-05, -4.4197382714271126e-05, 0.00011653697116211853]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_11 b/drivers/py/pes/friction/frictionH/120K/inst.raw_11 deleted file mode 100644 index ea4f84ce2..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_11 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 11 -{"friction": [[0.00010562036954718544, -3.769046910141249e-05, -3.763042875179934e-05], [-3.769046910141249e-05, 0.00010561870141779494, -3.7770470863789636e-05], [-3.763042875179934e-05, -3.7770470863789636e-05, 0.0001054411173289977]]} - #*EXTRAS*# Step: 1 Bead: 11 -{"friction": [[0.00010821236836118526, -4.017525929535722e-05, -4.01892366340863e-05], [-4.017525929535722e-05, 0.0001082163039907463, -4.01788382840068e-05], [-4.01892366340863e-05, -4.01788382840068e-05, 0.00010824877993734805]]} - #*EXTRAS*# Step: 2 Bead: 11 -{"friction": [[0.00011087321121944126, -4.2151091695803704e-05, -4.2228522571900055e-05], [-4.2151091695803704e-05, 0.00011088889095304024, -4.220578815264125e-05], [-4.2228522571900055e-05, -4.220578815264125e-05, 0.00011094788651397632]]} - #*EXTRAS*# Step: 3 Bead: 11 -{"friction": [[0.00011213417529862159, -4.292623993049148e-05, -4.295956406562726e-05], [-4.292623993049148e-05, 0.00011208701598576566, -4.29406649174682e-05], [-4.295956406562726e-05, -4.29406649174682e-05, 0.00011219463053401914]]} - #*EXTRAS*# Step: 4 Bead: 11 -{"friction": [[0.00011297783363293415, -4.339494572357907e-05, -4.335954244420975e-05], [-4.339494572357907e-05, 0.00011284990220887222, -4.3334227938776024e-05], [-4.335954244420975e-05, -4.3334227938776024e-05, 0.00011302792165266635]]} - #*EXTRAS*# Step: 5 Bead: 11 -{"friction": [[0.00011358349355306288, -4.369895560824174e-05, -4.360340221378703e-05], [-4.369895560824174e-05, 0.00011338705590697053, -4.3569019915907095e-05], [-4.360340221378703e-05, -4.3569019915907095e-05, 0.00011362657605572488]]} - #*EXTRAS*# Step: 6 Bead: 11 -{"friction": [[0.00011402829830315826, -4.390070302550329e-05, -4.376002852900331e-05], [-4.390070302550329e-05, 0.00011378084754233082, -4.37171130581761e-05], [-4.376002852900331e-05, -4.37171130581761e-05, 0.0001140664546972499]]} - #*EXTRAS*# Step: 7 Bead: 11 -{"friction": [[0.00011437371302471472, -4.404316993724665e-05, -4.386879790222642e-05], [-4.404316993724665e-05, 0.00011408816728461423, -4.3818362187299696e-05], [-4.386879790222642e-05, -4.3818362187299696e-05, 0.00011440816603031544]]} - #*EXTRAS*# Step: 8 Bead: 11 -{"friction": [[0.00011465014086711433, -4.414752353410407e-05, -4.394787858877758e-05], [-4.414752353410407e-05, 0.00011433593069042934, -4.3890952908600004e-05], [-4.394787858877758e-05, -4.3890952908600004e-05, 0.00011468170420575605]]} - #*EXTRAS*# Step: 9 Bead: 11 -{"friction": [[0.00011487806272146681, -4.4226751012235514e-05, -4.400782893916518e-05], [-4.4226751012235514e-05, 0.00011454187213681023, -4.394528305835716e-05], [-4.400782893916518e-05, -4.394528305835716e-05, 0.00011490729154815703]]} - #*EXTRAS*# Step: 10 Bead: 11 -{"friction": [[0.00011507004143281612, -4.428851335394793e-05, -4.405468348940537e-05], [-4.428851335394793e-05, 0.00011471673560688194, -4.3987240669324866e-05], [-4.405468348940537e-05, -4.3987240669324866e-05, 0.00011509733680744573]]} - #*EXTRAS*# Step: 11 Bead: 11 -{"friction": [[0.00011523454798143413, -4.433770974457707e-05, -4.4092210192543e-05], [-4.433770974457707e-05, 0.00011486773394562937, -4.4020467728222156e-05], [-4.4092210192543e-05, -4.4020467728222156e-05, 0.00011526021002952367]]} - #*EXTRAS*# Step: 12 Bead: 11 -{"friction": [[0.00011537739839639266, -4.4377570674422355e-05, -4.412284996939199e-05], [-4.4377570674422355e-05, 0.000114999807939624, -4.404730584767392e-05], [-4.412284996939199e-05, -4.404730584767392e-05, 0.0001154016593782393]]} - #*EXTRAS*# Step: 13 Bead: 11 -{"friction": [[0.00011550276899845874, -4.441032076947214e-05, -4.4148260840333685e-05], [-4.441032076947214e-05, 0.00011511650690458263, -4.40693342501867e-05], [-4.4148260840333685e-05, -4.40693342501867e-05, 0.00011552581335752506]]} - #*EXTRAS*# Step: 14 Bead: 11 -{"friction": [[0.00011561373689600929, -4.443753800868773e-05, -4.416960625269821e-05], [-4.443753800868773e-05, 0.0001152204496575237, -4.408765398457129e-05], [-4.416960625269821e-05, -4.408765398457129e-05, 0.00011563571440173471]]} - #*EXTRAS*# Step: 15 Bead: 11 -{"friction": [[0.0001157126336821658, -4.446037390257119e-05, -4.418772806188175e-05], [-4.446037390257119e-05, 0.00011531362553462515, -4.41030568938101e-05], [-4.418772806188175e-05, -4.41030568938101e-05, 0.00011573366820697028]]} - #*EXTRAS*# Step: 16 Bead: 11 -{"friction": [[0.00011580126567183418, -4.4479688373543245e-05, -4.4203250807266947e-05], [-4.4479688373543245e-05, 0.00011539758062629221, -4.411612700399723e-05], [-4.4203250807266947e-05, -4.411612700399723e-05, 0.00011582146128496173]]} - #*EXTRAS*# Step: 17 Bead: 11 -{"friction": [[0.00011588106140119909, -4.449613683692962e-05, -4.42166481411486e-05], [-4.449613683692962e-05, 0.000115473542386068, -4.412730473444839e-05], [-4.42166481411486e-05, -4.412730473444839e-05, 0.00011590050669878025]]} - #*EXTRAS*# Step: 18 Bead: 11 -{"friction": [[0.00011595317111282038, -4.451022763468408e-05, -4.422828614534523e-05], [-4.451022763468408e-05, 0.00011554250350248416, -4.413692858179606e-05], [-4.422828614534523e-05, -4.413692858179606e-05, 0.00011597194237301501]]} - #*EXTRAS*# Step: 19 Bead: 11 -{"friction": [[0.00011601853613128384, -4.452236108962481e-05, -4.423845250186793e-05], [-4.452236108962481e-05, 0.00011560528035920046, -4.414526306626239e-05], [-4.423845250186793e-05, -4.414526306626239e-05, 0.00011603669966018084]]} - #*EXTRAS*# Step: 20 Bead: 11 -{"friction": [[0.00011607793805666355, -4.453285665344483e-05, -4.4247376595304723e-05], [-4.453285665344483e-05, 0.00011566255445718895, -4.415251791607359e-05], [-4.4247376595304723e-05, -4.415251791607359e-05, 0.00011609555196604801]]} - #*EXTRAS*# Step: 21 Bead: 11 -{"friction": [[0.00011613203437581162, -4.4541972200792865e-05, -4.4255243688486256e-05], [-4.4541972200792865e-05, 0.00011571490238636489, -4.4158861546996105e-05], [-4.4255243688486256e-05, -4.4158861546996105e-05, 0.00011614914995333076]]} - #*EXTRAS*# Step: 22 Bead: 11 -{"friction": [[0.00011618138465452555, -4.4549918004864376e-05, -4.426220511615592e-05], [-4.4549918004864376e-05, 0.00011576281785484028, -4.4164430723894424e-05], [-4.426220511615592e-05, -4.4164430723894424e-05, 0.00011619804743634081]]} - #*EXTRAS*# Step: 23 Bead: 11 -{"friction": [[0.00011622647010410126, -4.455686704151943e-05, -4.426838574932557e-05], [-4.455686704151943e-05, 0.00011580672813257594, -4.4169337614234824e-05], [-4.426838574932557e-05, -4.4169337614234824e-05, 0.00011624272072676866]]} - #*EXTRAS*# Step: 24 Bead: 11 -{"friction": [[0.00011626770840058649, -4.45629627087815e-05, -4.427388955062027e-05], [-4.45629627087815e-05, 0.00011584700649291977, -4.4173675023210626e-05], [-4.427388955062027e-05, -4.4173675023210626e-05, 0.00011628358328669974]]} - #*EXTRAS*# Step: 25 Bead: 11 -{"friction": [[0.00011630546505509871, -4.45683246954817e-05, -4.4278803770893984e-05], [-4.45683246954817e-05, 0.0001158839817475781, -4.417752033834332e-05], [-4.4278803770893984e-05, -4.417752033834332e-05, 0.00011632099697204031]]} - #*EXTRAS*# Step: 26 Bead: 11 -{"friction": [[0.00011634006224412026, -4.457305350289396e-05, -4.4283202162798454e-05], [-4.457305350289396e-05, 0.00011591794564235315, -4.418093854281077e-05], [-4.4283202162798454e-05, -4.418093854281077e-05, 0.00011635528076472381]]} - #*EXTRAS*# Step: 27 Bead: 11 -{"friction": [[0.00011637178574903721, -4.4577233971660795e-05, -4.4287147472712066e-05], [-4.4577233971660795e-05, 0.00011594915866253105, -4.4183984546682e-05], [-4.4287147472712066e-05, -4.4183984546682e-05, 0.00011638671763550077]]} - #*EXTRAS*# Step: 28 Bead: 11 -{"friction": [[0.00011640089046666198, -4.458093806307912e-05, -4.429069339479454e-05], [-4.458093806307912e-05, 0.00011597785463761974, -4.4186705010896505e-05], [-4.429069339479454e-05, -4.4186705010896505e-05, 0.0001164155599937648]]} - #*EXTRAS*# Step: 29 Bead: 11 -{"friction": [[0.00011642760483178894, -4.458422707467639e-05, -4.429388611940742e-05], [-4.458422707467639e-05, 0.00011600424443387224, -4.4189139789407405e-05], [-4.429388611940742e-05, -4.4189139789407405e-05, 0.00011644203406159262]]} - #*EXTRAS*# Step: 30 Bead: 11 -{"friction": [[0.00011645213441051987, -4.458715342220104e-05, -4.429676557278342e-05], [-4.458715342220104e-05, 0.00011602851895441478, -4.419132308101357e-05], [-4.429676557278342e-05, -4.419132308101357e-05, 0.00011646634342782935]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_12 b/drivers/py/pes/friction/frictionH/120K/inst.raw_12 deleted file mode 100644 index f4b4d0d88..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_12 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 12 -{"friction": [[0.00010410059478635681, -3.587758594138993e-05, -3.5810247906280144e-05], [-3.587758594138993e-05, 0.00010409721165943899, -3.604130532787345e-05], [-3.5810247906280144e-05, -3.604130532787345e-05, 0.00010376542350754372]]} - #*EXTRAS*# Step: 1 Bead: 12 -{"friction": [[0.0001068327151359019, -3.893184247074491e-05, -3.889866598949092e-05], [-3.893184247074491e-05, 0.00010682771546644247, -3.89544635257768e-05], [-3.889866598949092e-05, -3.89544635257768e-05, 0.00010677313268688233]]} - #*EXTRAS*# Step: 2 Bead: 12 -{"friction": [[0.00010975520545054818, -4.1382615441172184e-05, -4.145001846751924e-05], [-4.1382615441172184e-05, 0.00010977966461402201, -4.142190567266487e-05], [-4.145001846751924e-05, -4.142190567266487e-05, 0.00010983104042364265]]} - #*EXTRAS*# Step: 3 Bead: 12 -{"friction": [[0.00011123838468290335, -4.238488746171244e-05, -4.24565520519884e-05], [-4.238488746171244e-05, 0.00011124270384435449, -4.243595453504287e-05], [-4.24565520519884e-05, -4.243595453504287e-05, 0.00011130968920532037]]} - #*EXTRAS*# Step: 4 Bead: 12 -{"friction": [[0.000112241118158019, -4.298801753934856e-05, -4.301421397383399e-05], [-4.298801753934856e-05, 0.00011218528985869091, -4.299496534312935e-05], [-4.301421397383399e-05, -4.299496534312935e-05, 0.00011230021837633124]]} - #*EXTRAS*# Step: 5 Bead: 12 -{"friction": [[0.00011295812906910908, -4.3384548065145496e-05, -4.335100737757962e-05], [-4.3384548065145496e-05, 0.00011283233725818939, -4.33259311902522e-05], [-4.335100737757962e-05, -4.33259311902522e-05, 0.00011300845098280771]]} - #*EXTRAS*# Step: 6 Bead: 12 -{"friction": [[0.00011348606564890072, -4.3652212445027466e-05, -4.3566573533822705e-05], [-4.3652212445027466e-05, 0.00011330086329487549, -4.353386303118347e-05], [-4.3566573533822705e-05, -4.353386303118347e-05, 0.00011353025146975719]]} - #*EXTRAS*# Step: 7 Bead: 12 -{"friction": [[0.00011389636660104093, -4.384293089401598e-05, -4.3715530997318114e-05], [-4.384293089401598e-05, 0.00011366391285594257, -4.3675291739595756e-05], [-4.3715530997318114e-05, -4.3675291739595756e-05, 0.00011393596535945519]]} - #*EXTRAS*# Step: 8 Bead: 12 -{"friction": [[0.0001142254810941062, -4.398362711642463e-05, -4.3823483921327296e-05], [-4.398362711642463e-05, 0.000113956030633264, -4.377636169502792e-05], [-4.3823483921327296e-05, -4.377636169502792e-05, 0.00011426151059840706]]} - #*EXTRAS*# Step: 9 Bead: 12 -{"friction": [[0.00011449737357560288, -4.40909472237156e-05, -4.390504360787269e-05], [-4.40909472237156e-05, 0.00011419876430255276, -4.385175216648622e-05], [-4.390504360787269e-05, -4.385175216648622e-05, 0.0001145305258737652]]} - #*EXTRAS*# Step: 10 Bead: 12 -{"friction": [[0.00011472680733037341, -4.417487517031147e-05, -4.3968571086911244e-05], [-4.417487517031147e-05, 0.00011440501900121447, -4.3909780178080244e-05], [-4.3968571086911244e-05, -4.3909780178080244e-05, 0.00011475758061362871]]} - #*EXTRAS*# Step: 11 Bead: 12 -{"friction": [[0.00011492372411565602, -4.424185899278311e-05, -4.4019273533566274e-05], [-4.424185899278311e-05, 0.00011458333921575277, -4.3955575629645575e-05], [-4.4019273533566274e-05, -4.3955575629645575e-05, 0.00011495249037718288]]} - #*EXTRAS*# Step: 12 Bead: 12 -{"friction": [[0.00011509496688030585, -4.429619095664406e-05, -4.40605244292057e-05], [-4.429619095664406e-05, 0.00011473954262543702, -4.39924359520136e-05], [-4.40605244292057e-05, -4.39924359520136e-05, 0.0001151220133987645]]} - #*EXTRAS*# Step: 13 Bead: 12 -{"friction": [[0.00011524545300301727, -4.434084714220448e-05, -4.409461279801186e-05], [-4.434084714220448e-05, 0.00011487778407972865, -4.402258224244548e-05], [-4.409461279801186e-05, -4.402258224244548e-05, 0.00011527100753390562]]} - #*EXTRAS*# Step: 14 Bead: 12 -{"friction": [[0.00011537881051006066, -4.437795125486582e-05, -4.412314386780297e-05], [-4.437795125486582e-05, 0.0001150011181925357, -4.404756187657773e-05], [-4.412314386780297e-05, -4.404756187657773e-05, 0.00011540305772112605]]} - #*EXTRAS*# Step: 15 Bead: 12 -{"friction": [[0.00011549779116329254, -4.4409060688524696e-05, -4.414727814993491e-05], [-4.4409060688524696e-05, 0.0001151118587730749, -4.4068486615272564e-05], [-4.414727814993491e-05, -4.4068486615272564e-05, 0.00011552088359878881]]} - #*EXTRAS*# Step: 16 Bead: 12 -{"friction": [[0.00011560452911225125, -4.443534345933797e-05, -4.416787585896807e-05], [-4.443534345933797e-05, 0.00011521180078489779, -4.408617570223349e-05], [-4.416787585896807e-05, -4.408617570223349e-05, 0.00011562659478784912]]} - #*EXTRAS*# Step: 17 Bead: 12 -{"friction": [[0.00011570071390717125, -4.445769307823169e-05, -4.4185588763936975e-05], [-4.445769307823169e-05, 0.00011530236757253213, -4.410124633298001e-05], [-4.4185588763936975e-05, -4.410124633298001e-05, 0.00011572186169923649]]} - #*EXTRAS*# Step: 18 Bead: 12 -{"friction": [[0.00011578770740543426, -4.447680476269851e-05, -4.42009200917125e-05], [-4.447680476269851e-05, 0.00011538470960130434, -4.411417238115771e-05], [-4.42009200917125e-05, -4.411417238115771e-05, 0.0001158080309721356]]} - #*EXTRAS*# Step: 19 Bead: 12 -{"friction": [[0.00011586662531246567, -4.4493227497859536e-05, -4.421426484172417e-05], [-4.4493227497859536e-05, 0.00011545977296558404, -4.412532374055468e-05], [-4.421426484172417e-05, -4.412532374055468e-05, 0.0001158862060056764]]} - #*EXTRAS*# Step: 20 Bead: 12 -{"friction": [[0.00011593839504655627, -4.4507400383041e-05, -4.422593756242792e-05], [-4.4507400383041e-05, 0.0001155283477757352, -4.413499332295562e-05], [-4.422593756242792e-05, -4.413499332295562e-05, 0.00011595730411603433]]} - #*EXTRAS*# Step: 21 Bead: 12 -{"friction": [[0.00011600379764257343, -4.451967856208787e-05, -4.4236191932462926e-05], [-4.451967856208787e-05, 0.00011559110305868992, -4.414341601952192e-05], [-4.4236191932462926e-05, -4.414341601952192e-05, 0.0001160220979330397]]} - #*EXTRAS*# Step: 22 Bead: 12 -{"friction": [[0.00011606349858452001, -4.45303520734083e-05, -4.4245234839166275e-05], [-4.45303520734083e-05, 0.00011564861233963841, -4.41507822876659e-05], [-4.4245234839166275e-05, -4.41507822876659e-05, 0.00011608124586296825]]} - #*EXTRAS*# Step: 23 Bead: 12 -{"friction": [[0.00011611807084429713, -4.4539659794748494e-05, -4.425323668645334e-05], [-4.4539659794748494e-05, 0.00011570137268677369, -4.415724806795969e-05], [-4.425323668645334e-05, -4.415724806795969e-05, 0.00011613531485317723]]} - #*EXTRAS*# Step: 24 Bead: 12 -{"friction": [[0.00011616801233402253, -4.454779992380627e-05, -4.426033906628171e-05], [-4.454779992380627e-05, 0.00011574981908445137, -4.4162942143420715e-05], [-4.426033906628171e-05, -4.4162942143420715e-05, 0.00011618479763818467]]} - #*EXTRAS*# Step: 25 Bead: 12 -{"friction": [[0.00011621375929808845, -4.4554937970685396e-05, -4.426666055405615e-05], [-4.4554937970685396e-05, 0.00011579433542124454, -4.416797168418527e-05], [-4.426666055405615e-05, -4.416797168418527e-05, 0.00011623012597442388]]} - #*EXTRAS*# Step: 26 Bead: 12 -{"friction": [[0.00011625569671425065, -4.456121293438177e-05, -4.427230114690497e-05], [-4.456121293438177e-05, 0.00011583526299218641, -4.417242648304509e-05], [-4.427230114690497e-05, -4.417242648304509e-05, 0.00011627168091982291]]} - #*EXTRAS*# Step: 27 Bead: 12 -{"friction": [[0.0001162941664677594, -4.456674213450042e-05, -4.427734570568556e-05], [-4.456674213450042e-05, 0.00011587290715701099, -4.4176382232223756e-05], [-4.427734570568556e-05, -4.4176382232223756e-05, 0.000116309800912928]]} - #*EXTRAS*# Step: 28 Bead: 12 -{"friction": [[0.00011632947384293495, -4.45716250323032e-05, -4.428186665452228e-05], [-4.45716250323032e-05, 0.0001159075426100518, -4.417990308730539e-05], [-4.428186665452228e-05, -4.417990308730539e-05, 0.00011634478818938673]]} - #*EXTRAS*# Step: 29 Bead: 12 -{"friction": [[0.00011636189273357148, -4.4575946282837156e-05, -4.428592612027846e-05], [-4.4575946282837156e-05, 0.00011593941759766081, -4.418304369450968e-05], [-4.428592612027846e-05, -4.418304369450968e-05, 0.00011637691393236536]]} - #*EXTRAS*# Step: 30 Bead: 12 -{"friction": [[0.00011639166987622474, -4.457977819593182e-05, -4.428957764538481e-05], [-4.457977819593182e-05, 0.00011596875733822666, -4.418585080971323e-05], [-4.428957764538481e-05, -4.418585080971323e-05, 0.00011640642245735647]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_13 b/drivers/py/pes/friction/frictionH/120K/inst.raw_13 deleted file mode 100644 index 2fc11cdf2..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_13 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 13 -{"friction": [[0.00010310461147450481, -3.446489117457354e-05, -3.44165270104119e-05], [-3.446489117457354e-05, 0.00010307920642357731, -3.4657347226921115e-05], [-3.44165270104119e-05, -3.4657347226921115e-05, 0.00010269639584043074]]} - #*EXTRAS*# Step: 1 Bead: 13 -{"friction": [[0.00010582671403554583, -3.7912901255851164e-05, -3.7856307578776025e-05], [-3.7912901255851164e-05, 0.0001058242814256422, -3.798157672066333e-05], [-3.7856307578776025e-05, -3.798157672066333e-05, 0.00010566907242795302]]} - #*EXTRAS*# Step: 2 Bead: 13 -{"friction": [[0.00010890484522279301, -4.0739678150744975e-05, -4.078040507024623e-05], [-4.0739678150744975e-05, 0.00010891949857258055, -4.0756279501326e-05], [-4.078040507024623e-05, -4.0756279501326e-05, 0.00010896660145634423]]} - #*EXTRAS*# Step: 3 Bead: 13 -{"friction": [[0.00011054972099373442, -4.193714718026962e-05, -4.201558912948856e-05], [-4.193714718026962e-05, 0.0001105715549370078, -4.199081787307331e-05], [-4.201558912948856e-05, -4.199081787307331e-05, 0.00011062640262796619]]} - #*EXTRAS*# Step: 4 Bead: 13 -{"friction": [[0.00011167373558125277, -4.26534658442672e-05, -4.271108016930257e-05], [-4.26534658442672e-05, 0.0001116575473293728, -4.2692179113977573e-05], [-4.271108016930257e-05, -4.2692179113977573e-05, 0.00011174001845452613]]} - #*EXTRAS*# Step: 5 Bead: 13 -{"friction": [[0.00011247568658637595, -4.3121336579496224e-05, -4.313004578132801e-05], [-4.3121336579496224e-05, 0.00011239900052642074, -4.310953434255642e-05], [-4.313004578132801e-05, -4.310953434255642e-05, 0.00011253185682476278]]} - #*EXTRAS*# Step: 6 Bead: 13 -{"friction": [[0.0001130670218367398, -4.344163292317609e-05, -4.33976973064958e-05], [-4.344163292317609e-05, 0.00011292930775780671, -4.337125657025158e-05], [-4.33976973064958e-05, -4.337125657025158e-05, 0.00011311605597761532]]} - #*EXTRAS*# Step: 7 Bead: 13 -{"friction": [[0.00011352682554249325, -4.367187449585796e-05, -4.358209223127699e-05], [-4.367187449585796e-05, 0.00011333692604758067, -4.3548691559485286e-05], [-4.358209223127699e-05, -4.3548691559485286e-05, 0.00011357054869820459]]} - #*EXTRAS*# Step: 8 Bead: 13 -{"friction": [[0.00011389622348109768, -4.384286725123632e-05, -4.371548183344317e-05], [-4.384286725123632e-05, 0.00011366378609545335, -4.367524541545088e-05], [-4.371548183344317e-05, -4.367524541545088e-05, 0.00011393582381268883]]} - #*EXTRAS*# Step: 9 Bead: 13 -{"friction": [[0.00011420181934117877, -4.397389772462523e-05, -4.381606138306165e-05], [-4.397389772462523e-05, 0.00011393497660502943, -4.3769456425915896e-05], [-4.381606138306165e-05, -4.3769456425915896e-05, 0.0001142381022644138]]} - #*EXTRAS*# Step: 10 Bead: 13 -{"friction": [[0.00011446002767836162, -4.407670286225753e-05, -4.38942459890099e-05], [-4.407670286225753e-05, 0.00011416532533488921, -4.384182539436e-05], [-4.38942459890099e-05, -4.384182539436e-05, 0.00011449357141881446]]} - #*EXTRAS*# Step: 11 Bead: 13 -{"friction": [[0.00011468189405087364, -4.415893718984814e-05, -4.395651387558936e-05], [-4.415893718984814e-05, 0.0001143645237014826, -4.38988189009581e-05], [-4.395651387558936e-05, -4.38988189009581e-05, 0.00011471312957649538]]} - #*EXTRAS*# Step: 12 Bead: 13 -{"friction": [[0.00011487503308454692, -4.422573946021489e-05, -4.4007062934188094e-05], [-4.422573946021489e-05, 0.00011453912340221844, -4.394459319713776e-05], [-4.4007062934188094e-05, -4.394459319713776e-05, 0.00011490429266252298]]} - #*EXTRAS*# Step: 13 Bead: 13 -{"friction": [[0.00011504491984739898, -4.428069530147123e-05, -4.4048740380350584e-05], [-4.428069530147123e-05, 0.00011469377408783648, -4.3981946095619455e-05], [-4.4048740380350584e-05, -4.3981946095619455e-05, 0.00011507246653865287]]} - #*EXTRAS*# Step: 14 Bead: 13 -{"friction": [[0.00011519559759727089, -4.432637721358142e-05, -4.408354249076434e-05], [-4.432637721358142e-05, 0.00011483187916794359, -4.401282601279096e-05], [-4.408354249076434e-05, -4.401282601279096e-05, 0.00011522164443645417]]} - #*EXTRAS*# Step: 15 Bead: 13 -{"friction": [[0.00011533013526401523, -4.4364680129311266e-05, -4.411291197265244e-05], [-4.4364680129311266e-05, 0.00011495600760655756, -4.403863216160053e-05], [-4.411291197265244e-05, -4.403863216160053e-05, 0.00011535485804133444]]} - #*EXTRAS*# Step: 16 Bead: 13 -{"friction": [[0.00011545091484349607, -4.439703068600205e-05, -4.413791782680746e-05], [-4.439703068600205e-05, 0.00011506814717146045, -4.4060395122933384e-05], [-4.413791782680746e-05, -4.4060395122933384e-05, 0.00011547446094367727]]} - #*EXTRAS*# Step: 17 Bead: 13 -{"friction": [[0.00011555982351716945, -4.4424523851076944e-05, -4.415936965502208e-05], [-4.4424523851076944e-05, 0.00011516987108592353, -4.407889090359397e-05], [-4.415936965502208e-05, -4.407889090359397e-05, 0.00011558231818457514]]} - #*EXTRAS*# Step: 18 Bead: 13 -{"friction": [[0.00011565838361758527, -4.444801404528341e-05, -4.41778922252533e-05], [-4.444801404528341e-05, 0.0001152624493084045, -4.409471497490848e-05], [-4.41778922252533e-05, -4.409471497490848e-05, 0.00011567993450939103]]} - #*EXTRAS*# Step: 19 Bead: 13 -{"friction": [[0.00011574784329626794, -4.4468177655739154e-05, -4.419397564232528e-05], [-4.4468177655739154e-05, 0.00011534692537950514, -4.4108331854304194e-05], [-4.419397564232528e-05, -4.4108331854304194e-05, 0.00011576854386057148]]} - #*EXTRAS*# Step: 20 Bead: 13 -{"friction": [[0.00011582924089926089, -4.448555684975521e-05, -4.420800991531217e-05], [-4.448555684975521e-05, 0.00011542417050392197, -4.412010912483631e-05], [-4.420800991531217e-05, -4.412010912483631e-05, 0.00011584917292990527]]} - #*EXTRAS*# Step: 21 Bead: 13 -{"friction": [[0.00011590345159842897, -4.4500590940188836e-05, -4.422030932464491e-05], [-4.4500590940188836e-05, 0.00011549492242682979, -4.4130341323568685e-05], [-4.422030932464491e-05, -4.4130341323568685e-05, 0.00011592268720048554]]} - #*EXTRAS*# Step: 22 Bead: 13 -{"friction": [[0.00011597122171221414, -4.451363925922771e-05, -4.4231129942102445e-05], [-4.451363925922771e-05, 0.00011555981384470958, -4.4139267057065886e-05], [-4.4231129942102445e-05, -4.4139267057065886e-05, 0.00011598982483806489]]} - #*EXTRAS*# Step: 23 Bead: 13 -{"friction": [[0.00011603319435547614, -4.452499812996451e-05, -4.424068245910179e-05], [-4.452499812996451e-05, 0.00011561939349653067, -4.4147081492826656e-05], [-4.424068245910179e-05, -4.4147081492826656e-05, 0.00011605122202279234]]} - #*EXTRAS*# Step: 24 Bead: 13 -{"friction": [[0.00011608992887239284, -4.4534913657689345e-05, -4.4249141734914816e-05], [-4.4534913657689345e-05, 0.00011567414203879047, -4.415394562886166e-05], [-4.4249141734914816e-05, -4.415394562886166e-05, 0.00011610743214294139]]} - #*EXTRAS*# Step: 25 Bead: 13 -{"friction": [[0.00011614191574952336, -4.4543591510566036e-05, -4.425665401086803e-05], [-4.4543591510566036e-05, 0.000115724484150297, -4.4159993277701105e-05], [-4.425665401086803e-05, -4.4159993277701105e-05, 0.00011615894052565837]]} - #*EXTRAS*# Step: 26 Bead: 13 -{"friction": [[0.00011618958819876309, -4.455120449747471e-05, -4.4263342436119065e-05], [-4.455120449747471e-05, 0.00011577079787497754, -4.4165336401661865e-05], [-4.4263342436119065e-05, -4.4165336401661865e-05, 0.00011620617587916405]]} - #*EXTRAS*# Step: 27 Bead: 13 -{"friction": [[0.00011623333126044384, -4.455789851061065e-05, -4.4269311353823196e-05], [-4.455789851061065e-05, 0.00011581342192051826, -4.417006924065452e-05], [-4.4269311353823196e-05, -4.417006924065452e-05, 0.00011624951928585755]]} - #*EXTRAS*# Step: 28 Bead: 13 -{"friction": [[0.0001162734890331635, -4.456379723627706e-05, -4.427464966345945e-05], [-4.456379723627706e-05, 0.00011585266142198939, -4.4174271542296306e-05], [-4.427464966345945e-05, -4.4174271542296306e-05, 0.00011628931134524612]]} - #*EXTRAS*# Step: 29 Bead: 13 -{"friction": [[0.00011631037047712337, -4.4569005926295173e-05, -4.427943348610479e-05], [-4.4569005926295173e-05, 0.00011588879254445702, -4.4178011116136335e-05], [-4.427943348610479e-05, -4.4178011116136335e-05, 0.00011632585790789502]]} - #*EXTRAS*# Step: 30 Bead: 13 -{"friction": [[0.00011634425412913697, -4.45736144454399e-05, -4.4283728298414045e-05], [-4.45736144454399e-05, 0.0001159220662077576, -4.41813458735139e-05], [-4.4283728298414045e-05, -4.41813458735139e-05, 0.00011635943473439066]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_14 b/drivers/py/pes/friction/frictionH/120K/inst.raw_14 deleted file mode 100644 index 9d10e6d9a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_14 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 14 -{"friction": [[0.0001025334360101724, -3.35409127376559e-05, -3.351447758652769e-05], [-3.35409127376559e-05, 0.00010248196407672836, -3.372632209749448e-05], [-3.351447758652769e-05, -3.372632209749448e-05, 0.00010210975134216749]]} - #*EXTRAS*# Step: 1 Bead: 14 -{"friction": [[0.00010519168232281083, -3.7211976697797746e-05, -3.714645580679814e-05], [-3.7211976697797746e-05, 0.00010519130228864114, -3.7316436674238246e-05], [-3.714645580679814e-05, -3.7316436674238246e-05, 0.00010496699170022938]]} - #*EXTRAS*# Step: 2 Bead: 14 -{"friction": [[0.00010833362238078242, -4.027685149614361e-05, -4.0295575796002505e-05], [-4.027685149614361e-05, 0.000108339326029239, -4.028190415799287e-05], [-4.0295575796002505e-05, -4.028190415799287e-05, 0.00010837552412981438]]} - #*EXTRAS*# Step: 3 Bead: 14 -{"friction": [[0.00011008265454679817, -4.161632741533034e-05, -4.169033744061508e-05], [-4.161632741533034e-05, 0.00011010788472364582, -4.1663104162240184e-05], [-4.169033744061508e-05, -4.1663104162240184e-05, 0.00011016000841955724]]} - #*EXTRAS*# Step: 4 Bead: 14 -{"friction": [[0.0001112883467890681, -4.241625972818069e-05, -4.2486723402319566e-05], [-4.241625972818069e-05, 0.00011129071388823947, -4.24663800515419e-05], [-4.2486723402319566e-05, -4.24663800515419e-05, 0.00011135911985226815]]} - #*EXTRAS*# Step: 5 Bead: 14 -{"friction": [[0.00011214772838297943, -4.293410147886103e-05, -4.296655395403621e-05], [-4.293410147886103e-05, 0.00011209950196090243, -4.2947618564056564e-05], [-4.296655395403621e-05, -4.2947618564056564e-05, 0.00011220801125498411]]} - #*EXTRAS*# Step: 6 Bead: 14 -{"friction": [[0.00011278183154961537, -4.329023337108696e-05, -4.327293990660613e-05], [-4.329023337108696e-05, 0.00011267477709142058, -4.324982107078609e-05], [-4.327293990660613e-05, -4.324982107078609e-05, 0.00011283426331533821]]} - #*EXTRAS*# Step: 7 Bead: 14 -{"friction": [[0.00011327502683945429, -4.354803158052156e-05, -4.348365746667777e-05], [-4.354803158052156e-05, 0.00011311398293648072, -4.345429880390739e-05], [-4.348365746667777e-05, -4.345429880390739e-05, 0.00011332163329382059]]} - #*EXTRAS*# Step: 8 Bead: 14 -{"friction": [[0.00011367162651694423, -4.374047405346169e-05, -4.363593254015711e-05], [-4.374047405346169e-05, 0.00011346501477663194, -4.359997377988664e-05], [-4.363593254015711e-05, -4.359997377988664e-05, 0.00011371371858201674]]} - #*EXTRAS*# Step: 9 Bead: 14 -{"friction": [[0.00011400002041220176, -4.388847216906664e-05, -4.375062927157147e-05], [-4.388847216906664e-05, 0.0001137557685304746, -4.370829709395565e-05], [-4.375062927157147e-05, -4.370829709395565e-05, 0.00011403848464612836]]} - #*EXTRAS*# Step: 10 Bead: 14 -{"friction": [[0.0001142777243456353, -4.4004891132398966e-05, -4.383968752253089e-05], [-4.4004891132398966e-05, 0.00011400255200345484, -4.37914116610628e-05], [-4.383968752253089e-05, -4.37914116610628e-05, 0.00011431319605058983]]} - #*EXTRAS*# Step: 11 Bead: 14 -{"friction": [[0.00011451651952939906, -4.409818733423324e-05, -4.391052939444478e-05], [-4.409818733423324e-05, 0.00011421592085069752, -4.385678875238935e-05], [-4.391052939444478e-05, -4.385678875238935e-05, 0.0001145494716078967]]} - #*EXTRAS*# Step: 12 Bead: 14 -{"friction": [[0.00011472453519537842, -4.417407470068416e-05, -4.396796553123765e-05], [-4.417407470068416e-05, 0.00011440296887710529, -4.3909230281361765e-05], [-4.396796553123765e-05, -4.3909230281361765e-05, 0.00011475533182298323]]} - #*EXTRAS*# Step: 13 Bead: 14 -{"friction": [[0.00011490761863731029, -4.423655970779449e-05, -4.401525831223124e-05], [-4.423655970779449e-05, 0.00011456870465346151, -4.3951967683383266e-05], [-4.401525831223124e-05, -4.3951967683383266e-05, 0.00011493654785915102]]} - #*EXTRAS*# Step: 14 Bead: 14 -{"friction": [[0.00011507009052491487, -4.428852855326548e-05, -4.4054695048043976e-05], [-4.428852855326548e-05, 0.00011471678050223818, -4.398725095843072e-05], [-4.4054695048043976e-05, -4.398725095843072e-05, 0.0001150973854089206]]} - #*EXTRAS*# Step: 15 Bead: 14 -{"friction": [[0.00011521523189894976, -4.4332114427759526e-05, -4.408792857579159e-05], [-4.4332114427759526e-05, 0.0001148499448369494, -4.401669550695885e-05], [-4.408792857579159e-05, -4.401669550695885e-05, 0.00011524108462159225]]} - #*EXTRAS*# Step: 16 Bead: 14 -{"friction": [[0.00011534559067896935, -4.4368927999911615e-05, -4.411618343112335e-05], [-4.4368927999911615e-05, 0.00011497031927949368, -4.404149086546815e-05], [-4.411618343112335e-05, -4.404149086546815e-05, 0.00011537016225503557]]} - #*EXTRAS*# Step: 17 Bead: 14 -{"friction": [[0.00011546318649434041, -4.440020856432753e-05, -4.414038683301374e-05], [-4.440020856432753e-05, 0.0001150795799358324, -4.406253249351644e-05], [-4.414038683301374e-05, -4.406253249351644e-05, 0.00011548661366817549]]} - #*EXTRAS*# Step: 18 Bead: 14 -{"friction": [[0.00011556964934227437, -4.4426925257663114e-05, -4.416125414460787e-05], [-4.4426925257663114e-05, 0.00011517907799780986, -4.4080507323137e-05], [-4.416125414460787e-05, -4.4080507323137e-05, 0.00011559204959216378]]} - #*EXTRAS*# Step: 19 Bead: 14 -{"friction": [[0.00011566631633386957, -4.444984672508419e-05, -4.417934637200958e-05], [-4.444984672508419e-05, 0.00011526992271742914, -4.4095951038870774e-05], [-4.417934637200958e-05, -4.4095951038870774e-05, 0.00011568779158251992]]} - #*EXTRAS*# Step: 20 Bead: 14 -{"friction": [[0.00011575430040742481, -4.446959009239209e-05, -4.419510978345115e-05], [-4.446959009239209e-05, 0.00011535303962791814, -4.4109287377334705e-05], [-4.419510978345115e-05, -4.4109287377334705e-05, 0.00011577493982647148]]} - #*EXTRAS*# Step: 21 Bead: 14 -{"friction": [[0.00011583454011065565, -4.4486656115805784e-05, -4.420890383843134e-05], [-4.4486656115805784e-05, 0.00011542921228004529, -4.412085572113952e-05], [-4.420890383843134e-05, -4.412085572113952e-05, 0.00011585442227705705]]} - #*EXTRAS*# Step: 22 Bead: 14 -{"friction": [[0.00011590783624697304, -4.4501454877078116e-05, -4.422102127034339e-05], [-4.4501454877078116e-05, 0.00011549911266803255, -4.413093086869774e-05], [-4.422102127034339e-05, -4.413093086869774e-05, 0.00011592703082743166]]} - #*EXTRAS*# Step: 23 Bead: 14 -{"friction": [[0.00011597487926643055, -4.451432489063061e-05, -4.4231702792463545e-05], [-4.451432489063061e-05, 0.00011556332376443181, -4.4139737462657e-05], [-4.4231702792463545e-05, -4.4139737462657e-05, 0.0001159934483523425]]} - #*EXTRAS*# Step: 24 Bead: 14 -{"friction": [[0.00011603627001945651, -4.452554753438608e-05, -4.4241148045036806e-05], [-4.452554753438608e-05, 0.00011562235644471546, -4.414746069702863e-05], [-4.4241148045036806e-05, -4.414746069702863e-05, 0.00011605426919921828]]} - #*EXTRAS*# Step: 25 Bead: 14 -{"friction": [[0.00011609253568430965, -4.4535358105882756e-05, -4.4249523867531355e-05], [-4.4535358105882756e-05, 0.00011567666236509574, -4.4154254384577616e-05], [-4.4249523867531355e-05, -4.4154254384577616e-05, 0.000116110014915498]]} - #*EXTRAS*# Step: 26 Bead: 14 -{"friction": [[0.00011614414213824473, -4.454395440444776e-05, -4.425697063582144e-05], [-4.454395440444776e-05, 0.00011572664388163542, -4.4160247120047005e-05], [-4.425697063582144e-05, -4.4160247120047005e-05, 0.00011616114646534827]]} - #*EXTRAS*# Step: 27 Bead: 14 -{"friction": [[0.00011619150368014531, -4.455150347352646e-05, -4.4263607178518685e-05], [-4.455150347352646e-05, 0.00011577266178366082, -4.4165547048834103e-05], [-4.4263607178518685e-05, -4.4165547048834103e-05, 0.00011620807383163987]]} - #*EXTRAS*# Step: 28 Bead: 14 -{"friction": [[0.00011623499075269259, -4.455814695469795e-05, -4.4269534634316696e-05], [-4.455814695469795e-05, 0.00011581504138924509, -4.417024559889495e-05], [-4.4269534634316696e-05, -4.417024559889495e-05, 0.00011625116364282444]]} - #*EXTRAS*# Step: 29 Bead: 14 -{"friction": [[0.00011627493614113685, -4.456400538111324e-05, -4.427483951016366e-05], [-4.456400538111324e-05, 0.00011585407740411557, -4.417442043197761e-05], [-4.427483951016366e-05, -4.417442043197761e-05, 0.00011629074529564047]]} - #*EXTRAS*# Step: 30 Bead: 14 -{"friction": [[0.00011631164000959571, -4.456918165209777e-05, -4.4279596130081314e-05], [-4.456918165209777e-05, 0.00011589003784716062, -4.4178137800607205e-05], [-4.4279596130081314e-05, -4.4178137800607205e-05, 0.00011632711592999599]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst.raw_15 b/drivers/py/pes/friction/frictionH/120K/inst.raw_15 deleted file mode 100644 index 3ebf65bdb..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst.raw_15 +++ /dev/null @@ -1,62 +0,0 @@ - #*EXTRAS*# Step: 0 Bead: 15 -{"friction": [[0.00010230241023370649, -3.314250126533514e-05, -3.3126410324985165e-05], [-3.314250126533514e-05, 0.00010223847872837513, -3.331935139787916e-05], [-3.3126410324985165e-05, -3.331935139787916e-05, 0.00010188032678501224]]} - #*EXTRAS*# Step: 1 Bead: 15 -{"friction": [[0.00010490646196707843, -3.688040445238592e-05, -3.681260326094125e-05], [-3.688040445238592e-05, 0.00010490644633441923, -3.700130613295973e-05], [-3.681260326094125e-05, -3.700130613295973e-05, 0.00010465164772604607]]} - #*EXTRAS*# Step: 2 Bead: 15 -{"friction": [[0.00010804894795674986, -4.003644136708558e-05, -4.0044088080650715e-05], [-4.003644136708558e-05, 0.00010805069246089233, -4.0038763003397624e-05], [-4.0044088080650715e-05, -4.0038763003397624e-05, 0.00010807719179759272]]} - #*EXTRAS*# Step: 3 Bead: 15 -{"friction": [[0.000109846791122782, -4.144873373250682e-05, -4.1518239960726356e-05], [-4.144873373250682e-05, 0.00010987168889267842, -4.1490275622346016e-05], [-4.1518239960726356e-05, -4.1490275622346016e-05, 0.00010992323866299621]]} - #*EXTRAS*# Step: 4 Bead: 15 -{"friction": [[0.0001110934841185232, -4.229307267970011e-05, -4.236764724312105e-05], [-4.229307267970011e-05, 0.00011110290985240808, -4.234625069845896e-05], [-4.236764724312105e-05, -4.234625069845896e-05, 0.00011116624268365842]]} - #*EXTRAS*# Step: 5 Bead: 15 -{"friction": [[0.00011198186004245606, -4.283724029820972e-05, -4.287973185865863e-05], [-4.283724029820972e-05, 0.00011194606798587027, -4.286108643611016e-05], [-4.287973185865863e-05, -4.286108643611016e-05, 0.00011204425848994699]]} - #*EXTRAS*# Step: 6 Bead: 15 -{"friction": [[0.00011263749862161975, -4.321137648770671e-05, -4.320673529490046e-05], [-4.321137648770671e-05, 0.00011254514892545843, -4.318497538875252e-05], [-4.320673529490046e-05, -4.318497538875252e-05, 0.00011269168097625769]]} - #*EXTRAS*# Step: 7 Bead: 15 -{"friction": [[0.00011314750693072298, -4.348322371012179e-05, -4.34314596515937e-05], [-4.348322371012179e-05, 0.00011300084137030593, -4.34039372313655e-05], [-4.34314596515937e-05, -4.34039372313655e-05, 0.00011319559672456412]]} - #*EXTRAS*# Step: 8 Bead: 15 -{"friction": [[0.000113557807659321, -4.368671754246975e-05, -4.3593781271739395e-05], [-4.368671754246975e-05, 0.00011336433438059563, -4.355984706866713e-05], [-4.3593781271739395e-05, -4.355984706866713e-05, 0.00011360118017890116]]} - #*EXTRAS*# Step: 9 Bead: 15 -{"friction": [[0.00011389769609939838, -4.384352199767221e-05, -4.371598760754804e-05], [-4.384352199767221e-05, 0.0001136650903929266, -4.367572196373652e-05], [-4.371598760754804e-05, -4.367572196373652e-05, 0.00011393728024482742]]} - #*EXTRAS*# Step: 10 Bead: 15 -{"friction": [[0.00011418523901234777, -4.396704372646741e-05, -4.381082910801568e-05], [-4.396704372646741e-05, 0.00011392022929805612, -4.376458463996789e-05], [-4.381082910801568e-05, -4.376458463996789e-05, 0.0001142216998038932]]} - #*EXTRAS*# Step: 11 Bead: 15 -{"friction": [[0.0001144325852997188, -4.406613370435628e-05, -4.3886229780003875e-05], [-4.406613370435628e-05, 0.00011414077542752546, -4.383444451041036e-05], [-4.3886229780003875e-05, -4.383444451041036e-05, 0.00011446641743561044]]} - #*EXTRAS*# Step: 12 Bead: 15 -{"friction": [[0.0001146481214505214, -4.414679359375208e-05, -4.3947326294855004e-05], [-4.414679359375208e-05, 0.00011433411325762788, -4.3890449382639175e-05], [-4.3947326294855004e-05, -4.3890449382639175e-05, 0.00011467970566563867]]} - #*EXTRAS*# Step: 13 Bead: 15 -{"friction": [[0.00011483788091673104, -4.4213242853602196e-05, -4.399760203492852e-05], [-4.4213242853602196e-05, 0.00011450544178743952, -4.393606301890881e-05], [-4.399760203492852e-05, -4.393606301890881e-05, 0.00011486751820456193]]} - #*EXTRAS*# Step: 14 Bead: 15 -{"friction": [[0.0001150063231797754, -4.426852782517029e-05, -4.403949930587289e-05], [-4.426852782517029e-05, 0.00011465854409739665, -4.397369702421923e-05], [-4.403949930587289e-05, -4.397369702421923e-05, 0.00011503425697800367]]} - #*EXTRAS*# Step: 15 Bead: 15 -{"friction": [[0.00011515683547669439, -4.431490416238581e-05, -4.4074782895117636e-05], [-4.431490416238581e-05, 0.0001147962620072534, -4.400508265642352e-05], [-4.4074782895117636e-05, -4.400508265642352e-05, 0.00011518326643423707]]} - #*EXTRAS*# Step: 16 Bead: 15 -{"friction": [[0.00011529204884873972, -4.4354077649540466e-05, -4.410476022893306e-05], [-4.4354077649540466e-05, 0.00011492078622842417, -4.4031494645731336e-05], [-4.410476022893306e-05, -4.4031494645731336e-05, 0.00011531714502044951]]} - #*EXTRAS*# Step: 17 Bead: 15 -{"friction": [[0.00011541404931829606, -4.438736251917914e-05, -4.4130421225672194e-05], [-4.438736251917914e-05, 0.00011503384556929901, -4.405389247735868e-05], [-4.4130421225672194e-05, -4.405389247735868e-05, 0.00011543795338267569]]} - #*EXTRAS*# Step: 18 Bead: 15 -{"friction": [[0.00011552452088742819, -4.4415787702466094e-05, -4.4152529553054e-05], [-4.4415787702466094e-05, 0.00011513683255631027, -4.407301210706523e-05], [-4.4152529553054e-05, -4.407301210706523e-05, 0.00011554735538607565]]} - #*EXTRAS*# Step: 19 Bead: 15 -{"friction": [[0.00011562484531966278, -4.4440170092856075e-05, -4.4171684026850306e-05], [-4.4440170092856075e-05, 0.00011523088968546649, -4.408942736555049e-05], [-4.4171684026850306e-05, -4.408942736555049e-05, 0.00011564671654077228]]} - #*EXTRAS*# Step: 20 Bead: 15 -{"friction": [[0.00011571617302025789, -4.4461166129520405e-05, -4.4188360919499634e-05], [-4.4461166129520405e-05, 0.0001153169698431867, -4.4103592087117034e-05], [-4.4188360919499634e-05, -4.4103592087117034e-05, 0.00011573717393301113]]} - #*EXTRAS*# Step: 21 Bead: 15 -{"friction": [[0.00011579947439274807, -4.447930887375212e-05, -4.4202943786216355e-05], [-4.447930887375212e-05, 0.00011539587955328829, -4.4115869689297385e-05], [-4.4202943786216355e-05, -4.4115869689297385e-05, 0.00011581968690295247]]} - #*EXTRAS*# Step: 22 Bead: 15 -{"friction": [[0.00011587557764730116, -4.449503514742408e-05, -4.421574491281106e-05], [-4.449503514742408e-05, 0.00011546831046100785, -4.412655436523581e-05], [-4.421574491281106e-05, -4.412655436523581e-05, 0.00011589507435887457]]} - #*EXTRAS*# Step: 23 Bead: 15 -{"friction": [[0.00011594519706177471, -4.450870573735675e-05, -4.422702102231156e-05], [-4.450870573735675e-05, 0.0001155348626215392, -4.4135886550394264e-05], [-4.422702102231156e-05, -4.4135886550394264e-05, 0.0001159640426724252]]} - #*EXTRAS*# Step: 24 Bead: 15 -{"friction": [[0.00011600895439554875, -4.4520620671803464e-05, -4.423698496775611e-05], [-4.4520620671803464e-05, 0.00011559606196934362, -4.41440644003494e-05], [-4.423698496775611e-05, -4.41440644003494e-05, 0.00011602720681759612]]} - #*EXTRAS*# Step: 25 Bead: 15 -{"friction": [[0.00011606739532393004, -4.4531030936743826e-05, -4.4245814568660354e-05], [-4.4531030936743826e-05, 0.00011565237359480983, -4.415125243906922e-05], [-4.4245814568660354e-05, -4.415125243906922e-05, 0.00011608510659573453]]} - #*EXTRAS*# Step: 26 Bead: 15 -{"friction": [[0.00011612100220321597, -4.454014757959801e-05, -4.425365938102953e-05], [-4.454014757959801e-05, 0.00011570421195889767, -4.415758816613875e-05], [-4.425365938102953e-05, -4.415758816613875e-05, 0.00011613821923903676]]} - #*EXTRAS*# Step: 27 Bead: 15 -{"friction": [[0.00011617020410291505, -4.454814886809761e-05, -4.426064594994927e-05], [-4.454814886809761e-05, 0.0001157519488481037, -4.4163187169163425e-05], [-4.426064594994927e-05, -4.4163187169163425e-05, 0.00011618696931657183]]} - #*EXTRAS*# Step: 28 Bead: 15 -{"friction": [[0.00011621538477393464, -4.455518598025975e-05, -4.42668819311607e-05], [-4.455518598025975e-05, 0.00011579591963794912, -4.4168147124848764e-05], [-4.42668819311607e-05, -4.4168147124848764e-05, 0.00011623173660281609]]} - #*EXTRAS*# Step: 29 Bead: 15 -{"friction": [[0.0001162568890449437, -4.4561387571187995e-05, -4.427245935901929e-05], [-4.4561387571187995e-05, 0.00011583642828076177, -4.417255096323238e-05], [-4.427245935901929e-05, -4.417255096323238e-05, 0.00011627286239448222]]} - #*EXTRAS*# Step: 30 Bead: 15 -{"friction": [[0.00011629502801921822, -4.456686347189924e-05, -4.427745726346961e-05], [-4.456686347189924e-05, 0.00011587375133142305, -4.417646939483376e-05], [-4.427745726346961e-05, -4.417646939483376e-05, 0.00011631065464316028]]} diff --git a/drivers/py/pes/friction/frictionH/120K/inst1D.dat b/drivers/py/pes/friction/frictionH/120K/inst1D.dat deleted file mode 100644 index 1f3d8435a..000000000 --- a/drivers/py/pes/friction/frictionH/120K/inst1D.dat +++ /dev/null @@ -1,16 +0,0 @@ -2.540461685335739 0.14619035118482168 -2.540889201874614 0.14619070699962955 -2.541727677502115 0.14619091286669983 -2.5429446512904574 0.1461900516834462 -2.544493039798159 0.14618696880233711 -2.5463129920858996 0.14618049740360584 -2.5483342419943114 0.14616970302480536 -2.550478859856288 0.14615412201583527 -2.5526642868502076 0.1461339066076566 -2.554806530261252 0.14610987493352684 -2.5568233936762144 0.14608346566825425 -2.5586376170955685 0.14605659799922505 -2.5601798087781122 0.1460314573249148 -2.5613910616601223 0.1460102372726762 -2.562225161548596 0.14599487391951996 -2.562650311001014 0.14598680823928564 diff --git a/drivers/py/pes/friction/frictionH/120K/z_friction.dat b/drivers/py/pes/friction/frictionH/120K/z_friction.dat deleted file mode 100644 index 88b85ef6d..000000000 --- a/drivers/py/pes/friction/frictionH/120K/z_friction.dat +++ /dev/null @@ -1,1003 +0,0 @@ -#eta 1 -# bath_type Ohmic -# w_c 500 - # freq (cm^-1) Laplace transform -1 0.9915470158218098 -2 0.9848551497951816 -3 0.9788255643617454 -4 0.9732247078293326 -5 0.9679416696883935 -6 0.962911133018018 -7 0.9580899447435153 -8 0.9534474391977994 -9 0.9489606918318892 -10 0.9446119121776004 -11 0.9403868910489187 -12 0.9362740173481964 -13 0.9322636249598021 -14 0.928347541807527 -15 0.9245187684107862 -16 0.9207712425362906 -17 0.9170996629124359 -18 0.9134993545627568 -19 0.9099661641551429 -20 0.9064963774421086 -21 0.9030866532531712 -22 0.8997339700879358 -23 0.8964355824392188 -24 0.8931889847263488 -25 0.8899918812500051 -26 0.8868421609620551 -27 0.8837378761228457 -28 0.8806772241248969 -29 0.8776585319167312 -30 0.874680242577914 -31 0.8717409036863014 -32 0.8688391571880675 -33 0.8659737305354348 -34 0.8631434288998111 -35 0.8603471283020212 -36 0.857583769528487 -37 0.8548523527240882 -38 0.8521519325701771 -39 0.8494816139706848 -40 0.8468405481811211 -41 0.8442279293250585 -42 0.8416429912508109 -43 0.8390850046877706 -44 0.8365532746675381 -45 0.8340471381797273 -46 0.831565962036351 -47 0.8291091409221039 -48 0.8266760956107441 -49 0.824266271330268 -50 0.8218791362616757 -51 0.8195141801579645 -52 0.8171709130715548 -53 0.8148488641797111 -54 0.8125475806987108 -55 0.8102666268785352 -56 0.8080055830707606 -57 0.8057640448631033 -58 0.8035416222747761 -59 0.8013379390074006 -60 0.7991526317467734 -61 0.796985349511237 -62 0.7948357530428389 -63 0.7927035142377412 -64 0.7905883156132424 -65 0.7884898498073732 -66 0.7864078191101018 -67 0.7843419350226136 -68 0.7822919178430147 -69 0.7802574962764451 -70 0.7782384070678282 -71 0.7762343946556395 -72 0.7742452108452136 -73 0.7722706145002324 -74 0.770310371251143 -75 0.76836425321937 -76 0.7664320387562564 -77 0.7645135121957763 -78 0.7626084636201109 -79 0.7607166886372758 -80 0.7588379881700227 -81 0.7569721682553251 -82 0.7551190398537776 -83 0.7532784186683185 -84 0.7514501249717047 -85 0.7496339834422199 -86 0.7478298230071312 -87 0.7460374766934447 -88 0.744256781485537 -89 0.742487578189273 -90 0.740729711302249 -91 0.738983028889811 -92 0.7372473824665428 -93 0.7355226268829143 -94 0.7338086202168218 -95 0.7321052236697538 -96 0.7304123014673415 -97 0.7287297207640642 -98 0.7270573515518944 -99 0.7253950665726847 -100 0.7237427412341026 -101 0.7221002535289383 -102 0.7204674839576208 -103 0.7188443154537764 -104 0.7172306333126927 -105 0.7156263251225384 -106 0.7140312806982176 -107 0.712445392017719 -108 0.7108685531608633 -109 0.7093006602503189 -110 0.7077416113947941 -111 0.7061913066343006 -112 0.7046496478873963 -113 0.7031165389003207 -114 0.701591885197936 -115 0.7000755940363974 -116 0.6985675743574739 -117 0.6970677367444532 -118 0.6955759933795586 -119 0.694092258002813 -120 0.6926164458722978 -121 0.6911484737257331 -122 0.6896882597433415 -123 0.6882357235119293 -124 0.6867907859901439 -125 0.6853533694748546 -126 0.6839233975686164 -127 0.6825007951481693 -128 0.6810854883339358 -129 0.6796774044604751 -130 0.6782764720478581 -131 0.6768826207739282 -132 0.675495781447412 -133 0.6741158859818493 -134 0.6727428673703116 -135 0.6713766596608783 -136 0.6700171979328448 -137 0.6686644182736309 -138 0.6673182577563711 -139 0.665978654418155 -140 0.6646455472388978 -141 0.6633188761208197 -142 0.6619985818685072 -143 0.6606846061695424 -144 0.6593768915756765 -145 0.6580753814845278 -146 0.6567800201217898 -147 0.6554907525239279 -148 0.6542075245213498 -149 0.6529302827220361 -150 0.6516589744956094 -151 0.6503935479578326 -152 0.6491339519555221 -153 0.6478801360518566 -154 0.6466320505120773 -155 0.6453896462895573 -156 0.6441528750122365 -157 0.642921688969405 -158 0.6416960410988252 -159 0.640475884974183 -160 0.6392611747928573 -161 0.6380518653639957 -162 0.6368479120968908 -163 0.635649270989643 -164 0.6344558986181063 -165 0.6332677521251036 -166 0.6320847892099062 -167 0.6309069681179693 -168 0.6297342476309137 -169 0.6285665870567494 -170 0.6274039462203316 -171 0.626246285454043 -172 0.6250935655886968 -173 0.623945747944651 -174 0.6228027943231316 -175 0.6216646669977567 -176 0.6205313287062546 -177 0.6194027426423736 -178 0.6182788724479744 -179 0.6171596822053032 -180 0.6160451364294374 -181 0.6149352000609029 -182 0.6138298384584534 -183 0.6127290173920114 -184 0.6116327030357649 -185 0.610540861961415 -186 0.6094534611315701 -187 0.6083704678932862 -188 0.6072918499717428 -189 0.6062175754640584 -190 0.6051476128332351 -191 0.6040819309022343 -192 0.6030204988481755 -193 0.6019632861966588 -194 0.6009102628162061 -195 0.5998613989128165 -196 0.5988166650246367 -197 0.5977760320167395 -198 0.5967394710760106 -199 0.5957069537061387 -200 0.5946784517227086 -201 0.5936539372483923 -202 0.5926333827082372 -203 0.5916167608250495 -204 0.5906040446148677 -205 0.5895952073825281 -206 0.5885902227173152 -207 0.5875890644887002 -208 0.5865917068421604 -209 0.5855981241950815 -210 0.5846082912327386 -211 0.5836221829043546 -212 0.5826397744192342 -213 0.581661041242972 -214 0.5806859590937321 -215 0.5797145039385988 -216 0.5787466519899951 -217 0.5777823797021695 -218 0.5768216637677468 -219 0.5758644811143447 -220 0.5749108089012515 -221 0.5739606245161651 -222 0.5730139055719944 -223 0.5720706299037137 -224 0.5711307755652795 -225 0.5701943208266014 -226 0.5692612441705648 -227 0.5683315242901118 -228 0.5674051400853706 -229 0.5664820706608363 -230 0.565562295322604 -231 0.5646457935756481 -232 0.5637325451211503 -233 0.5628225298538745 -234 0.5619157278595864 -235 0.5610121194125203 -236 0.5601116849728858 -237 0.5592144051844212 -238 0.5583202608719857 -239 0.5574292330391953 -240 0.5565413028660963 -241 0.5556564517068797 -242 0.5547746610876346 -243 0.5538959127041372 -244 0.5530201884196781 -245 0.5521474702629271 -246 0.5512777404258298 -247 0.5504109812615423 -248 0.549547175282398 -249 0.548686305157909 -250 0.5478283537127981 -251 0.5469733039250656 -252 0.5461211389240842 -253 0.5452718419887275 -254 0.5444253965455269 -255 0.5435817861668577 -256 0.5427409945691563 -257 0.5419030056111626 -258 0.5410678032921926 -259 0.5402353717504378 -260 0.5394056952612899 -261 0.5385787582356935 -262 0.5377545452185236 -263 0.5369330408869883 -264 0.5361142300490556 -265 0.5352980976419066 -266 0.5344846287304097 -267 0.5336738085056196 -268 0.5328656222832998 -269 0.5320600555024659 -270 0.5312570937239519 -271 0.5304567226289982 -272 0.5296589280178607 -273 0.5288636958084402 -274 0.528071012034933 -275 0.527280862846501 -276 0.526493234505962 -277 0.5257081133884988 -278 0.5249254859803876 -279 0.5241453388777454 -280 0.5233676587852939 -281 0.5225924325151446 -282 0.5218196469855986 -283 0.5210492892199644 -284 0.5202813463453946 -285 0.5195158055917365 -286 0.5187526542904008 -287 0.5179918798732471 -288 0.5172334698714828 -289 0.5164774119145797 -290 0.5157236937292059 -291 0.5149723031381711 -292 0.5142232280593879 -293 0.5134764565048479 -294 0.5127319765796108 -295 0.5119897764808087 -296 0.5112498444966641 -297 0.5105121690055203 -298 0.5097767384748864 -299 0.5090435414604948 -300 0.5083125666053719 -301 0.507583802638921 -302 0.5068572383760178 -303 0.5061328627161186 -304 0.5054106646423798 -305 0.5046906332207897 -306 0.5039727575993115 -307 0.5032570270070392 -308 0.5025434307533622 -309 0.5018319582271428 -310 0.5011225988959046 -311 0.5004153423050312 -312 0.49971017807697427 -313 0.49900709591047493 -314 0.49830608557979217 -315 0.497607136933943 -316 0.4969102398959523 -317 0.4962153844621122 -318 0.4955225607012511 -319 0.4948317587540115 -320 0.4941429688321387 -321 0.4934561812177765 -322 0.49277138626277345 -323 0.4920885743879972 -324 0.4914077360826579 -325 0.49072886190364023 -326 0.4900519424748425 -327 0.48937696848652695 -328 0.4887039306946743 -329 0.4880328199203507 -330 0.48736362704907843 -331 0.48669634303021736 -332 0.4860309588763527 -333 0.48536746566269084 -334 0.48470585452646225 -335 0.4840461166663318 -336 0.48338824334181657 -337 0.4827322258727103 -338 0.48207805563851625 -339 0.4814257240778837 -340 0.4807752226880555 -341 0.4801265430243186 -342 0.4794796766994642 -343 0.4788346153832517 -344 0.478191350801881 -345 0.4775498747374702 -346 0.47691017902753985 -347 0.4762722555645029 -348 0.47563609629516157 -349 0.4750016932202088 -350 0.474369038393737 -351 0.4737381239227518 -352 0.4731089419666909 -353 0.4724814847369504 -354 0.4718557444964145 -355 0.471231713558992 -356 0.4706093842891585 -357 0.46998874910150146 -358 0.46936980046027404 -359 0.46875253087895113 -360 0.4681369329197923 -361 0.4675229991934086 -362 0.4669107223583348 -363 0.46630009512060633 -364 0.4656911102333418 -365 0.46508376049632844 -366 0.4644780387556143 -367 0.4638739379031033 -368 0.46327145087615657 -369 0.4626705706571957 -370 0.4620712902733141 -371 0.46147360279588856 -372 0.46087750134019834 -373 0.4602829790650468 -374 0.4596900291723878 -375 0.4590986449069562 -376 0.45850881955590195 -377 0.45792054644842906 -378 0.4573338189554377 -379 0.45674863048917047 -380 0.45616497450286275 -381 0.4555828444903966 -382 0.4550022339859583 -383 0.45442313656369987 -384 0.4538455458374046 -385 0.45326945546015474 -386 0.4526948591240039 -387 0.45212175055965415 -388 0.45155012353613266 -389 0.4509799718604769 -390 0.4504112893774181 -391 0.44984406996907317 -392 0.44927830755463477 -393 0.44871399609006835 -394 0.4481511295678115 -395 0.44758970201647463 -396 0.4470297075005478 -397 0.44647114012010813 -398 0.4459139940105313 -399 0.445358263342206 -400 0.4448039423202515 -401 0.4442510251842373 -402 0.4436995062079068 -403 0.4431493796989029 -404 0.44260063999849697 -405 0.4420532814813202 -406 0.4415072985550987 -407 0.44096268566038893 -408 0.4404194372703193 -409 0.4398775478903305 -410 0.4393370120579223 -411 0.4387978243423998 -412 0.43825997934462363 -413 0.4377234716967632 -414 0.43718829606205123 -415 0.43665444713454066 -416 0.4361219196388661 -417 0.4355907083300043 -418 0.4350608079930402 -419 0.43453221344293347 -420 0.4340049195242877 -421 0.43347892111112174 -422 0.43295421310664406 -423 0.43243079044302857 -424 0.43190864808119267 -425 0.43138778101057784 -426 0.43086818424893225 -427 0.43034985284209504 -428 0.4298327818637838 -429 0.42931696641538275 -430 0.4288024016257333 -431 0.4282890826509284 -432 0.4277770046741056 -433 0.4272661629052452 -434 0.4267565525809683 -435 0.426248168964338 -436 0.4257410073446616 -437 0.4252350630372958 -438 0.42473033138345195 -439 0.42422680775000515 -440 0.42372448752930386 -441 0.4232233661389823 -442 0.4227234390217727 -443 0.42222470164532216 -444 0.4217271495020085 -445 0.42123077810876014 -446 0.4207355830068754 -447 0.42024155976184563 -448 0.419748703963178 -449 0.4192570112242222 -450 0.4187664771819965 -451 0.41827709749701647 -452 0.4177888678531257 -453 0.41730178395732725 -454 0.4168158415396169 -455 0.4163310363528185 -456 0.4158473641724194 -457 0.41536482079640946 -458 0.4148834020451197 -459 0.41440310376106304 -460 0.41392392180877696 -461 0.4134458520746668 -462 0.41296889046685104 -463 0.4124930329150079 -464 0.4120182753702229 -465 0.41154461380483826 -466 0.41107204421230364 -467 0.4106005626070276 -468 0.41013016502423144 -469 0.4096608475198032 -470 0.4091926061701538 -471 0.4087254370720742 -472 0.40825933634259365 -473 0.40779430011883927 -474 0.407330324557897 -475 0.40686740583667413 -476 0.40640554015176156 -477 0.40594472371929935 -478 0.4054849527748419 -479 0.40502622357322515 -480 0.40456853238843427 -481 0.40411187551347244 -482 0.4036562492602327 -483 0.4032016499593676 -484 0.40274807396016254 -485 0.40229551763040994 -486 0.401843977356283 -487 0.4013934495422118 -488 0.40094393061076083 -489 0.40049541700250596 -490 0.4000479051759142 -491 0.39960139160722313 -492 0.3991558727903225 -493 0.39871134523663565 -494 0.39826780547500285 -495 0.3978252500515656 -496 0.3973836755296513 -497 0.3969430784896594 -498 0.39650345552894783 -499 0.39606480326172205 -500 0.39562711831892267 -501 0.3951903973481156 -502 0.39475463701338354 -503 0.3943198339952161 -504 0.39388598499040356 -505 0.39345308671192963 -506 0.39302113588886617 -507 0.3925901292662675 -508 0.39216006360506744 -509 0.39173093568197576 -510 0.39130274228937556 -511 0.39087548023522245 -512 0.3904491463429436 -513 0.3900237374513377 -514 0.38959925041447707 -515 0.389175682101608 -516 0.38875302939705453 -517 0.38833128920012144 -518 0.38791045842499833 -519 0.3874905340006655 -520 0.3870715128707984 -521 0.3866533919936748 -522 0.3862361683420825 -523 0.38581983890322674 -524 0.385404400678639 -525 0.38498985068408675 -526 0.3845761859494836 -527 0.38416340351880035 -528 0.38375150044997597 -529 0.38334047381483105 -530 0.3829303206989799 -531 0.3825210382017448 -532 0.38211262343607033 -533 0.38170507352843797 -534 0.38129838561878276 -535 0.3808925568604089 -536 0.38048758441990777 -537 0.38008346547707406 -538 0.3796801972248261 -539 0.37927777686912334 -540 0.3788762016288872 -541 0.37847546873592014 -542 0.3780755754348275 -543 0.37767651898293847 -544 0.3772782966502284 -545 0.3768809057192419 -546 0.3764843434850152 -547 0.37608860725500115 -548 0.37569369434899286 -549 0.3752996020990492 -550 0.3749063278494206 -551 0.37451386895647465 -552 0.37412222278862356 -553 0.373731386726251 -554 0.3733413581616405 -555 0.3729521344989033 -556 0.3725637131539079 -557 0.3721760915542089 -558 0.37178926713897814 -559 0.3714032373589341 -560 0.37101799967627386 -561 0.37063355156460415 -562 0.37024989050887425 -563 0.3698670140053074 -564 0.36948491956133556 -565 0.36910360469553166 -566 0.36872306693754475 -567 0.3683433038280338 -568 0.36796431291860365 -569 0.3675860917717399 -570 0.36720863796074577 -571 0.366831949069678 -572 0.36645602269328403 -573 0.3660808564369399 -574 0.36570644791658763 -575 0.36533279475867425 -576 0.36495989460009 -577 0.3645877450881084 -578 0.36421634388032514 -579 0.3638456886445993 -580 0.36347577705899325 -581 0.36310660681171375 -582 0.36273817560105387 -583 0.3623704811353349 -584 0.36200352113284795 -585 0.3616372933217977 -586 0.361271795440245 -587 0.3609070252360509 -588 0.36054298046682 -589 0.36017965889984516 -590 0.3598170583120531 -591 0.35945517648994796 -592 0.3590940112295585 -593 0.3587335603363829 -594 0.35837382162533604 -595 0.3580147929206956 -596 0.35765647205604956 -597 0.3572988568742431 -598 0.35694194522732786 -599 0.3565857349765085 -600 0.3562302239920924 -601 0.35587541015343827 -602 0.3555212913489055 -603 0.3551678654758042 -604 0.3548151304403445 -605 0.35446308415758787 -606 0.3541117245513971 -607 0.3537610495543878 -608 0.3534110571078797 -609 0.35306174516184863 -610 0.3527131116748783 -611 0.3523651546141128 -612 0.3520178719552097 -613 0.35167126168229296 -614 0.3513253217879061 -615 0.3509800502729663 -616 0.3506354451467184 -617 0.35029150442668927 -618 0.3499482261386421 -619 0.34960560831653265 -620 0.3492636490024624 -621 0.3489223462466368 -622 0.3485816981073192 -623 0.34824170265078774 -624 0.34790235795129204 -625 0.3475636620910101 -626 0.3472256131600049 -627 0.3468882092561822 -628 0.3465514484852485 -629 0.3462153289606681 -630 0.3458798488036226 -631 0.34554500614296846 -632 0.3452107991151962 -633 0.3448772258643897 -634 0.34454428454218505 -635 0.34421197330773123 -636 0.34388029032764894 -637 0.3435492337759909 -638 0.3432188018342032 -639 0.3428889926910855 -640 0.3425598045427515 -641 0.342231235592591 -642 0.34190328405123144 -643 0.3415759481364984 -644 0.3412492260733795 -645 0.3409231160939852 -646 0.3405976164375119 -647 0.3402727253502047 -648 0.33994844108532046 -649 0.3396247619030907 -650 0.3393016860706855 -651 0.33897921186217694 -652 0.33865733755850347 -653 0.33833606144743356 -654 0.3380153818235307 -655 0.3376952969881176 -656 0.33737580524924166 -657 0.3370569049216394 -658 0.33673859432670233 -659 0.3364208717924425 -660 0.3361037356534581 -661 0.33578718425089965 -662 0.33547121593243634 -663 0.3351558290522219 -664 0.33484102197086224 -665 0.33452679305538185 -666 0.3342131406791904 -667 0.3339000632220512 -668 0.33358755907004783 -669 0.3332756266155521 -670 0.3329642642571924 -671 0.33265347039982107 -672 0.33234324345448363 -673 0.3320335818383867 -674 0.3317244839748669 -675 0.3314159482933603 -676 0.3311079732293706 -677 0.3308005572244392 -678 0.33049369872611495 -679 0.33018739618792325 -680 0.32988164806933584 -681 0.32957645283574216 -682 0.329271808958418 -683 0.32896771491449733 -684 0.32866416918694225 -685 0.3283611702645137 -686 0.3280587166417438 -687 0.32775680681890496 -688 0.32745543930198334 -689 0.32715461260264894 -690 0.32685432523822827 -691 0.32655457573167584 -692 0.3262553626115465 -693 0.32595668441196735 -694 0.3256585396726107 -695 0.32536092693866625 -696 0.3250638447608144 -697 0.32476729169519847 -698 0.3244712663033984 -699 0.3241757671524041 -700 0.3238807928145882 -701 0.32358634186768065 -702 0.32329241289474187 -703 0.32299900448413643 -704 0.32270611522950815 -705 0.3224137437297533 -706 0.3221218885889956 -707 0.3218305484165607 -708 0.32153972182695095 -709 0.3212494074398199 -710 0.320959603879948 -711 0.32067030977721706 -712 0.32038152376658613 -713 0.3200932444880666 -714 0.3198054705866983 -715 0.31951820071252474 -716 0.3192314335205693 -717 0.3189451676708114 -718 0.3186594018281623 -719 0.31837413466244235 -720 0.3180893648483562 -721 0.3178050910654704 -722 0.3175213119981899 -723 0.31723802633573495 -724 0.316955232772118 -725 0.31667293000612123 -726 0.31639111674127374 -727 0.3161097916858287 -728 0.3158289535527413 -729 0.3155486010596463 -730 0.31526873292883634 -731 0.31498934788723887 -732 0.3147104446663956 -733 0.3144320220024395 -734 0.31415407863607436 -735 0.3138766133125523 -736 0.3135996247816527 -737 0.31332311179766137 -738 0.3130470731193488 -739 0.3127715075099498 -740 0.312496413737142 -741 0.3122217905730254 -742 0.31194763679410176 -743 0.3116739511812541 -744 0.3114007325197262 -745 0.3111279795991024 -746 0.3108556912132874 -747 0.310583866160486 -748 0.3103125032431839 -749 0.31004160126812674 -750 0.3097711590463018 -751 0.3095011753929171 -752 0.30923164912738277 -753 0.30896257907329133 -754 0.3086939640583986 -755 0.30842580291460436 -756 0.30815809447793374 -757 0.30789083758851776 -758 0.30762403109057496 -759 0.30735767383239243 -760 0.3070917646663073 -761 0.30682630244868847 -762 0.3065612860399177 -763 0.306296714304372 -764 0.3060325861104046 -765 0.305768900330328 -766 0.30550565584039485 -767 0.30524285152078096 -768 0.304980486255567 -769 0.30471855893272104 -770 0.30445706844408094 -771 0.30419601368533694 -772 0.30393539355601423 -773 0.30367520695945566 -774 0.30341545280280474 -775 0.30315612999698804 -776 0.3028972374566991 -777 0.30263877410038054 -778 0.30238073885020794 -779 0.30212313063207297 -780 0.30186594837556674 -781 0.3016091910139632 -782 0.30135285748420293 -783 0.30109694672687665 -784 0.30084145768620885 -785 0.30058638931004206 -786 0.3003317405498202 -787 0.30007751036057334 -788 0.29982369770090106 -789 0.2995703015329571 -790 0.2993173208224336 -791 0.29906475453854525 -792 0.2988126016540142 -793 0.29856086114505387 -794 0.29830953199135457 -795 0.29805861317606724 -796 0.29780810368578886 -797 0.2975580025105472 -798 0.2973083086437855 -799 0.297059021082348 -800 0.2968101388264648 -801 0.2965616608797368 -802 0.29631358624912163 -803 0.29606591394491844 -804 0.2958186429807536 -805 0.2955717723735663 -806 0.29532530114359384 -807 0.29507922831435773 -808 0.29483355291264907 -809 0.29458827396851467 -810 0.29434339051524283 -811 0.2940989015893491 -812 0.293854806230563 -813 0.2936111034818134 -814 0.2933677923892153 -815 0.2931248720020557 -816 0.2928823413727803 -817 0.2926401995569797 -818 0.292398445613376 -819 0.2921570786038094 -820 0.2919160975932247 -821 0.2916755016496583 -822 0.2914352898442247 -823 0.29119546125110335 -824 0.29095601494752615 -825 0.29071695001376363 -826 0.29047826553311235 -827 0.29023996059188234 -828 0.29000203427938387 -829 0.28976448568791496 -830 0.28952731391274866 -831 0.2892905180521204 -832 0.28905409720721553 -833 0.28881805048215686 -834 0.28858237698399214 -835 0.28834707582268215 -836 0.28811214611108754 -837 0.28787758696495763 -838 0.28764339750291784 -839 0.28740957684645724 -840 0.2871761241199174 -841 0.2869430384504794 -842 0.286710318968153 -843 0.28647796480576393 -844 0.2862459750989426 -845 0.2860143489861123 -846 0.2857830856084774 -847 0.2855521841100122 -848 0.2853216436374487 -849 0.2850914633402659 -850 0.28486164237067796 -851 0.28463217988362266 -852 0.2844030750367507 -853 0.2841743269904139 -854 0.28394593490765446 -855 0.2837178979541936 -856 0.28349021529842056 -857 0.28326288611138145 -858 0.2830359095667686 -859 0.2828092848409096 -860 0.28258301111275624 -861 0.2823570875638738 -862 0.28213151337843057 -863 0.28190628774318693 -864 0.28168140984748485 -865 0.28145687888323717 -866 0.2812326940449174 -867 0.28100885452954893 -868 0.28078535953669487 -869 0.28056220826844747 -870 0.2803393999294182 -871 0.2801169337267269 -872 0.27989480886999235 -873 0.27967302457132137 -874 0.27945158004529935 -875 0.2792304745089797 -876 0.27900970718187434 -877 0.2787892772859434 -878 0.27856918404558545 -879 0.27834942668762763 -880 0.27813000444131597 -881 0.2779109165383055 -882 0.27769216221265064 -883 0.2774737407007956 -884 0.27725565124156454 -885 0.2770378930761524 -886 0.27682046544811495 -887 0.27660336760335985 -888 0.2763865987901368 -889 0.2761701582590283 -890 0.27595404526294054 -891 0.27573825905709387 -892 0.2755227988990136 -893 0.2753076640485212 -894 0.2750928537677243 -895 0.2748783673210088 -896 0.2746642039750288 -897 0.27445036299869796 -898 0.27423684366318085 -899 0.2740236452418835 -900 0.27381076701044504 -901 0.27359820824672837 -902 0.27338596823081174 -903 0.2731740462449801 -904 0.2729624415737158 -905 0.27275115350369084 -906 0.2725401813237574 -907 0.2723295243249398 -908 0.27211918180042577 -909 0.2719091530455581 -910 0.271699437357826 -911 0.2714900340368568 -912 0.27128094238440764 -913 0.27107216170435705 -914 0.2708636913026968 -915 0.27065553048752344 -916 0.2704476785690303 -917 0.27024013485949927 -918 0.27003289867329255 -919 0.2698259693268448 -920 0.26961934613865485 -921 0.269413028429278 -922 0.2692070155213177 -923 0.26900130673941763 -924 0.26879590141025433 -925 0.2685907988625287 -926 0.26838599842695854 -927 0.2681814994362706 -928 0.2679773012251932 -929 0.2677734031304478 -930 0.267569804490742 -931 0.2673665046467618 -932 0.2671635029411637 -933 0.26696079871856737 -934 0.2667583913255481 -935 0.26655628011062926 -936 0.2663544644242748 -937 0.26615294361888214 -938 0.26595171704877413 -939 0.26575078407019265 -940 0.2655501440412903 -941 0.26534979632212374 -942 0.2651497402746465 -943 0.26494997526270114 -944 0.26475050065201294 -945 0.26455131581018193 -946 0.2643524201066763 -947 0.2641538129128253 -948 0.2639554936018118 -949 0.26375746154866575 -950 0.26355971613025697 -951 0.2633622567252881 -952 0.2631650827142882 -953 0.26296819347960493 -954 0.26277158840539866 -955 0.26257526687763516 -956 0.2623792282840789 -957 0.2621834720142861 -958 0.26198799745959866 -959 0.2617928040131365 -960 0.2615978910697918 -961 0.2614032580262219 -962 0.26120890428084254 -963 0.2610148292338218 -964 0.26082103228707326 -965 0.26062751284424945 -966 0.2604342703107354 -967 0.2602413040936423 -968 0.2600486136018011 -969 0.259856198245756 -970 0.25966405743775794 -971 0.25947219059175874 -972 0.2592805971234043 -973 0.25908927645002855 -974 0.2588982279906473 -975 0.2587074511659519 -976 0.25851694539830294 -977 0.2583267101117244 -978 0.2581367447318972 -979 0.2579470486861532 -980 0.25775762140346925 -981 0.25756846231446096 -982 0.25737957085137686 -983 0.2571909464480922 -984 0.2570025885401032 -985 0.2568144965645208 -986 0.2566266699600653 -987 0.25643910816705967 -988 0.2562518106274244 -989 0.25606477678467143 -990 0.25587800608389827 -991 0.2556914979717821 -992 0.25550525189657447 -993 0.255319267308095 -994 0.2551335436577262 -995 0.2549480803984073 -996 0.25476287698462907 -997 0.2545779328724277 -998 0.2543932475193798 -999 0.25420882038459613 diff --git a/drivers/py/pes/friction/onheH/060K/RESTART b/drivers/py/pes/friction/onheH/060K/RESTART deleted file mode 100644 index 3817a4203..000000000 --- a/drivers/py/pes/friction/onheH/060K/RESTART +++ /dev/null @@ -1,309 +0,0 @@ - - - [ step, potential{electronvolt} ] - - 13 - 30 - - - - - - - - - 1.90008912e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 1.52256720e-03, 1.52268542e-03, 1.52293023e-03, 1.52331896e-03, 1.52387900e-03, - 1.52464951e-03, 1.52568398e-03, 1.52705357e-03, 1.52885149e-03, 1.53119871e-03, - 1.53425120e-03, 1.53820897e-03, 1.54332745e-03, 1.54993143e-03, 1.55843219e-03, - 1.56934802e-03, 1.58332877e-03, 1.60118429e-03, 1.62391688e-03, 1.65275689e-03, - 1.68919994e-03, 1.73504302e-03, 1.79241455e-03, 1.86379141e-03, 1.95199218e-03, - 2.06013228e-03, 2.19152155e-03, 2.34948106e-03, 2.53705233e-03, 2.75657290e-03, - 3.00909908e-03, 3.29367501e-03, 3.60625489e-03, 3.93773549e-03, 4.27354625e-03, - 4.59357104e-03, 4.87414452e-03, 5.10037162e-03, 5.26315169e-03, 5.35451351e-03, - 5.36798774e-03, 5.30515468e-03, 5.18087393e-03, 5.01208619e-03, 4.80667438e-03, - 4.56612240e-03, 4.29436737e-03, 4.00433381e-03, 3.71080420e-03, 3.42522528e-03, - 3.15579863e-03, 2.90710471e-03, 2.68132833e-03, 2.47940514e-03, 2.30133650e-03, - 2.14645873e-03, 2.01366321e-03, 1.90144267e-03, 1.80821862e-03, 1.73262306e-03, - 1.67351407e-03, 1.62997883e-03, 1.60133407e-03, 1.58712517e-03 ] - - - [ -2.13437291e-04, -1.70577631e-19, 6.06271585e-19, -2.16987992e-04, 7.87229546e-20, - 2.89359302e-19, -2.24142320e-04, -3.66086552e-20, 5.98871333e-20, -2.35006485e-04, - -8.96834346e-20, -1.84211791e-20, -2.49740673e-04, -2.29736508e-19, -3.05350296e-19, - -2.68560001e-04, -4.91468908e-19, -4.86174340e-19, -2.91735639e-04, -3.11592161e-19, - -3.30100319e-19, -3.19595949e-04, -1.97233829e-19, -1.65439430e-19, -3.52527429e-04, - -9.83494451e-20, -1.64554222e-19, -3.90975181e-04, -6.61421875e-20, -3.37654475e-20, - -4.35442511e-04, -6.64537826e-20, 6.47995202e-20, -4.86489151e-04, 1.60811506e-20, - 2.51332780e-19, -5.44727431e-04, -5.77516252e-20, 1.48759351e-19, -6.10815507e-04, - 6.42678112e-21, 9.57592509e-21, -6.85446509e-04, -1.31459848e-19, -3.51287341e-19, - -7.69332124e-04, -1.87478298e-19, -2.66980784e-19, -8.63178768e-04, -1.31292977e-19, - -2.93731553e-19, -9.67653978e-04, 1.15299762e-20, -1.72570698e-19, -1.08334012e-03, - -1.97864347e-21, 3.07200274e-20, -1.21067187e-03, -1.32216466e-19, 5.60802786e-20, - -1.34985321e-03, -2.38390128e-19, -2.99436676e-20, -1.50074904e-03, -1.22081864e-19, - -1.71458943e-21, -1.66274584e-03, -7.09982051e-20, -5.79473987e-21, -1.83457564e-03, - -5.02637871e-20, 1.91694974e-21, -2.01409773e-03, -2.71744661e-20, -9.60643548e-22, - -2.19803373e-03, -1.42422932e-21, 1.04678372e-20, -2.38165474e-03, 1.21815240e-21, - 5.45670496e-21, -2.55842459e-03, 1.99736338e-20, 1.12835564e-20, -2.71961216e-03, - -2.45022652e-21, 3.93950869e-21, -2.85390023e-03, 1.14998741e-20, 1.58389026e-21, - -2.94703878e-03, -4.45746460e-21, -5.25383913e-21, -2.98161892e-03, -4.09091164e-21, - -2.92321870e-21, -2.93907123e-03, -5.27510312e-23, 3.04498267e-21, -2.80972632e-03, - -1.98899146e-20, -2.61236673e-21, -2.59148181e-03, 3.34679419e-21, 4.12826901e-21, - -2.28923378e-03, -1.69605097e-20, 1.18238279e-21, -1.91457146e-03, 4.09268719e-21, - 5.50249023e-21, -1.47689125e-03, -5.49945712e-21, 2.55152535e-21, -9.86477095e-04, - -2.96308545e-21, -8.19942104e-21, -4.62601649e-04, 2.13529661e-20, -3.70546584e-21, - 6.64580154e-05, -6.69150933e-21, -9.44013190e-21, 5.76051562e-04, 2.45152488e-20, - 7.03827879e-21, 1.05315514e-03, -1.63317756e-20, -2.91631869e-21, 1.48750084e-03, - 7.89054108e-21, 5.25953928e-21, 1.86581711e-03, -1.01974911e-20, 2.04403444e-21, - 2.17454475e-03, -8.73724795e-21, -1.24264401e-21, 2.40638442e-03, 1.00863013e-20, - 1.06661591e-20, 2.56828152e-03, -2.29080297e-20, -1.43979877e-20, 2.67280351e-03, - 3.22884062e-20, 1.02627370e-20, 2.73153608e-03, -2.97893807e-20, -1.98107526e-20, - 2.75472265e-03, 3.58826849e-20, 2.12385986e-20, 2.75084135e-03, -3.27701674e-20, - -1.74397334e-20, 2.72695497e-03, 2.82355269e-20, 2.04973663e-20, 2.68909369e-03, - -2.88220081e-20, -1.76532065e-20, 2.64233152e-03, 2.09702896e-20, 1.46048521e-20, - 2.59087975e-03, -1.50386257e-20, -1.19729461e-20, 2.53819672e-03, 1.20417583e-20, - 9.72401358e-21, 2.48718989e-03, -8.02469731e-21, -9.70236653e-21, 2.44019193e-03, - 5.56859120e-21, 4.94244574e-21, 2.39893512e-03, -3.13122347e-21, -2.30305139e-21, - 2.36467732e-03, 1.08433355e-21, 4.64181643e-21, 2.33830678e-03, -3.18702951e-21, - -1.25426281e-21, 2.32042267e-03, -6.06611391e-22, -3.65539553e-22, 2.31139318e-03, - 2.33856944e-21, -8.26903829e-22 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] - - - [ 1.80810675e-02, 0.00000000e+00, 0.00000000e+00, 1.80707858e-02, 0.00000000e+00, - 0.00000000e+00, 1.80500435e-02, 0.00000000e+00, 0.00000000e+00, 1.80184794e-02, - 0.00000000e+00, 0.00000000e+00, 1.79755436e-02, 0.00000000e+00, 0.00000000e+00, - 1.79204879e-02, 0.00000000e+00, 0.00000000e+00, 1.78523516e-02, 0.00000000e+00, - 0.00000000e+00, 1.77699453e-02, 0.00000000e+00, 0.00000000e+00, 1.76718282e-02, - 0.00000000e+00, 0.00000000e+00, 1.75562830e-02, 0.00000000e+00, 0.00000000e+00, - 1.74212844e-02, 0.00000000e+00, 0.00000000e+00, 1.72644625e-02, 0.00000000e+00, - 0.00000000e+00, 1.70830596e-02, 0.00000000e+00, 0.00000000e+00, 1.68738805e-02, - 0.00000000e+00, 0.00000000e+00, 1.66332348e-02, 0.00000000e+00, 0.00000000e+00, - 1.63568704e-02, 0.00000000e+00, 0.00000000e+00, 1.60398981e-02, 0.00000000e+00, - 0.00000000e+00, 1.56767056e-02, 0.00000000e+00, 0.00000000e+00, 1.52608612e-02, - 0.00000000e+00, 0.00000000e+00, 1.47850068e-02, 0.00000000e+00, 0.00000000e+00, - 1.42407405e-02, 0.00000000e+00, 0.00000000e+00, 1.36184913e-02, 0.00000000e+00, - 0.00000000e+00, 1.29073882e-02, 0.00000000e+00, 0.00000000e+00, 1.20951310e-02, - 0.00000000e+00, 0.00000000e+00, 1.11678717e-02, 0.00000000e+00, 0.00000000e+00, - 1.01101212e-02, 0.00000000e+00, 0.00000000e+00, 8.90470512e-03, 0.00000000e+00, - 0.00000000e+00, 7.53279817e-03, 0.00000000e+00, 0.00000000e+00, 5.97408355e-03, - 0.00000000e+00, 0.00000000e+00, 4.20709454e-03, 0.00000000e+00, 0.00000000e+00, - 2.20981495e-03, 0.00000000e+00, 0.00000000e+00, -3.93694185e-05, 0.00000000e+00, - 0.00000000e+00, -2.37611224e-03, 0.00000000e+00, 0.00000000e+00, -4.52252479e-03, - 0.00000000e+00, 0.00000000e+00, -6.38799128e-03, 0.00000000e+00, 0.00000000e+00, - -7.87971916e-03, 0.00000000e+00, 0.00000000e+00, -9.02101367e-03, 0.00000000e+00, - 0.00000000e+00, -9.97227014e-03, 0.00000000e+00, 0.00000000e+00, -1.06817925e-02, - 0.00000000e+00, 0.00000000e+00, -1.09437948e-02, 0.00000000e+00, 0.00000000e+00, - -1.07106928e-02, 0.00000000e+00, 0.00000000e+00, -1.02216120e-02, 0.00000000e+00, - 0.00000000e+00, -9.59048387e-03, 0.00000000e+00, 0.00000000e+00, -8.79186846e-03, - 0.00000000e+00, 0.00000000e+00, -7.68096592e-03, 0.00000000e+00, 0.00000000e+00, - -6.28048728e-03, 0.00000000e+00, 0.00000000e+00, -4.75182024e-03, 0.00000000e+00, - 0.00000000e+00, -3.39119240e-03, 0.00000000e+00, 0.00000000e+00, -2.20045228e-03, - 0.00000000e+00, 0.00000000e+00, -1.16598512e-03, 0.00000000e+00, 0.00000000e+00, - -2.68370833e-04, 0.00000000e+00, 0.00000000e+00, 5.21465381e-04, 0.00000000e+00, - 0.00000000e+00, 1.21401114e-03, 0.00000000e+00, 0.00000000e+00, 1.81788565e-03, - 0.00000000e+00, 0.00000000e+00, 2.34117920e-03, 0.00000000e+00, 0.00000000e+00, - 2.79132140e-03, 0.00000000e+00, 0.00000000e+00, 3.17264015e-03, 0.00000000e+00, - 0.00000000e+00, 3.48148896e-03, 0.00000000e+00, 0.00000000e+00, 3.72684914e-03, - 0.00000000e+00, 0.00000000e+00, 3.91787688e-03, 0.00000000e+00, 0.00000000e+00, - 4.06202700e-03, 0.00000000e+00, 0.00000000e+00, 4.16514097e-03, 0.00000000e+00, - 0.00000000e+00, 4.23152531e-03, 0.00000000e+00, 0.00000000e+00, 4.26401446e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, - 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -4.81482486e-32, 5.51152161e-01, 0.00000000e+00, 2.40741243e-32, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.80555932e-32, - 5.51152161e-01, 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, - -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -7.52316385e-33, 5.51152161e-01, - 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -6.39468927e-33, - 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, - -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, -8.27548023e-33, 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 3.00926554e-33, - 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, - -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, 5.51152161e-01, - 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, - 5.51152161e-01, 0.00000000e+00, -6.77084746e-33, 5.51152161e-01, 0.00000000e+00, - -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, 5.51152161e-01, - 0.00000000e+00, -3.31783281e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, - 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, 5.51152161e-01, 0.00000000e+00, - -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, - 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, - 5.51152161e-01, 0.00000000e+00, -1.50463277e-33, 5.51152161e-01, 0.00000000e+00, - -6.77084746e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, - 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, - 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, - -5.26621469e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, - 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, - 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, - -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, - 0.00000000e+00, -9.02779661e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, - -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, - 0.00000000e+00, -3.76158192e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, - 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, 5.51152161e-01, 0.00000000e+00, - -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, 5.51152161e-01, - 0.00000000e+00, -3.33840396e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, - 5.51152161e-01 ] - - True - - - - - [ 1.87833334e+00, 3.09492810e-19, -1.10000763e-18, 1.87852977e+00, -1.42833432e-19, - -5.25008014e-19, 1.87892591e+00, 6.64220477e-20, -1.08658076e-19, 1.87952833e+00, - 1.62719918e-19, 3.34230370e-20, 1.88034703e+00, 4.16829551e-19, 5.54021771e-19, - 1.88139557e+00, 8.91711840e-19, 8.82105478e-19, 1.88269128e+00, 5.65346892e-19, - 5.98927742e-19, 1.88425549e+00, 3.57857309e-19, 3.00170156e-19, 1.88611383e+00, - 1.78443363e-19, 2.98564051e-19, 1.88829661e+00, 1.20007127e-19, 6.12633858e-20, - 1.89083922e+00, 1.20572479e-19, -1.17571017e-19, 1.89378259e+00, -2.91773338e-20, - -4.56013416e-19, 1.89717369e+00, 1.04783451e-19, -2.69906138e-19, 1.90106614e+00, - -1.16606295e-20, -1.73743764e-20, 1.90552074e+00, 2.38518247e-19, 6.37369071e-19, - 1.91060619e+00, 3.40157059e-19, 4.84404857e-19, 1.91639970e+00, 2.38215480e-19, - 5.32940944e-19, 1.92298764e+00, -2.09197696e-20, 3.13108993e-19, 1.93046617e+00, - 3.59001308e-21, -5.57378336e-20, 1.93894176e+00, 2.39891042e-19, -1.01750991e-19, - 1.94853161e+00, 4.32530515e-19, 5.43292211e-20, 1.95936382e+00, 2.21503012e-19, - 3.11091845e-21, 1.97157728e+00, 1.28817793e-19, 1.05138658e-20, 1.98532110e+00, - 9.11976595e-20, -3.47807716e-21, 2.00075343e+00, 4.93048344e-20, 1.74297339e-21, - 2.01803953e+00, 2.58409460e-21, -1.89926448e-20, 2.03734870e+00, -2.21019255e-21, - -9.90054170e-21, 2.05884997e+00, -3.62397814e-20, -2.04726702e-20, 2.08270609e+00, - 4.44564440e-21, -7.14776966e-21, 2.10906544e+00, -2.08651528e-20, -2.87378037e-21, - 2.13805170e+00, 8.08753900e-21, 9.53246582e-21, 2.16975066e+00, 7.42247228e-21, - 5.30383242e-21, 2.20419426e+00, 9.57104679e-23, -5.52475866e-21, 2.24134346e+00, - 3.60878829e-20, 4.73982851e-21, 2.28107934e+00, -6.07235974e-21, -7.49025279e-21, - 2.32320120e+00, 3.07728263e-20, -2.14529284e-21, 2.36743104e+00, -7.42569381e-21, - -9.98361363e-21, 2.41342420e+00, 9.97811042e-21, -4.62943908e-21, 2.46077805e+00, - 5.37616590e-21, 1.48768736e-20, 2.50904140e+00, -3.87424155e-20, 6.72312676e-21, - 2.55773228e+00, 1.21409473e-20, 1.71279958e-20, 2.60636390e+00, -4.44800013e-20, - -1.27701192e-20, 2.65446740e+00, 2.96320631e-20, 5.29131317e-21, 2.70160379e+00, - -1.43164477e-20, -9.54280805e-21, 2.74737339e+00, 1.85021340e-20, -3.70865722e-21, - 2.79142808e+00, 1.58526965e-20, 2.25462966e-21, 2.83348374e+00, -1.83003932e-20, - -1.93524762e-20, 2.87332701e+00, 4.15638934e-20, 2.61234351e-20, 2.91080887e+00, - -5.85834702e-20, -1.86205149e-20, 2.94583309e+00, 5.40492859e-20, 3.59442527e-20, - 2.97834557e+00, -6.51048611e-20, -3.85349094e-20, 3.00832493e+00, 5.94575685e-20, - 3.16423207e-20, 3.03577466e+00, -5.12300030e-20, -3.71900317e-20, 3.06071670e+00, - 5.22941034e-20, 3.20296422e-20, 3.08318583e+00, -3.80480947e-20, -2.64987659e-20, - 3.10322501e+00, 2.72857966e-20, 2.17234856e-20, 3.12088156e+00, -2.18483372e-20, - -1.76430653e-20, 3.13620389e+00, 1.45598582e-20, 1.76037893e-20, 3.14923890e+00, - -1.01035460e-20, -8.96747956e-21, 3.16002982e+00, 5.68123231e-21, 4.17861264e-21, - 3.16861456e+00, -1.96739418e-21, -8.42202345e-21, 3.17502463e+00, 5.78248573e-21, - 2.27571058e-21, 3.17928429e+00, 1.10062417e-21, 6.63228014e-22, 3.18140996e+00, - -4.24305591e-21, 1.50031858e-21 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/onheH/060K/clean.sh b/drivers/py/pes/friction/onheH/060K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/onheH/060K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/onheH/060K/control.in b/drivers/py/pes/friction/onheH/060K/control.in deleted file mode 100644 index 687e6ee90..000000000 --- a/drivers/py/pes/friction/onheH/060K/control.in +++ /dev/null @@ -1,181 +0,0 @@ -# Physical settings -xc pbe -spin none -relativistic atomic_zora scalar -charge 0.0 -#vdw_correction_hirshfeld - -# k-grid settings (to be adjusted) -k_grid 12 12 12 - -# accuracy requirements -sc_iter_limit 200 -sc_init_iter 200 - -#Mixing settings - mixer pulay - n_max_pulay 10 - charge_mix_param 0.05 - - -# occupation gaussian broadening -occupation_type gaussian 0.1 - -final_forces_cleaned .true. -compute_forces .true. - - -# IPI - output_level MD_light -# use_pimd_wrapper localhost 41000 - use_pimd_wrapper drag092 41111 - -#=============================================================================== - -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for Pd atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species Pd -# global species definitions - nucleus 46 - mass 106.42 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 62 5.0 - radial_multiplier 2 - angular_grids specified - division 0.5211 50 - division 0.9161 110 - division 1.2296 194 - division 1.5678 302 -# division 1.9785 434 -# division 2.0474 590 -# division 2.1195 770 -# division 2.1568 974 -# division 2.7392 1202 -# outer_grid 974 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 5 s 1. - valence 4 p 6. - valence 4 d 9. -# ion occupancy - ion_occ 5 s 0. - ion_occ 4 p 6. - ion_occ 4 d 8. -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A -# -################################################################################ -# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV - ionic 5 p auto - hydro 4 f 8 -# hydro 5 g 10 - hydro 3 s 2.6 - hydro 3 d 2.5 -# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV -# hydro 5 f 17.2 -# hydro 6 h 14 -# hydro 4 d 4 -# hydro 5 f 7.6 -# hydro 3 p 3.3 -# hydro 4 s 9.4 -# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV -# hydro 4 f 20 -# hydro 5 g 12.8 -# hydro 5 d 9.8 -# hydro 6 h 15.2 -# hydro 5 s 10 -# hydro 6 p 9.8 -# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV -# hydro 5 f 9.2 -# hydro 2 s 5.6 -# hydro 5 f 43.2 -# hydro 5 d 13.2 -# hydro 5 g 14 -# hydro 4 p 4.7 -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for H atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species H -# global species definitions - nucleus 1 - mass 1.00794 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 24 5.0 - radial_multiplier 2 - angular_grids specified - division 0.2421 50 - division 0.3822 110 - division 0.4799 194 - division 0.5341 302 -# division 0.5626 434 -# division 0.5922 590 -# division 0.6542 770 -# division 0.6868 1202 -# outer_grid 770 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 1 s 1. -# ion occupancy - ion_occ 1 s 0.5 -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A -# -################################################################################ -# "First tier" - improvements: -1014.90 meV to -62.69 meV - hydro 2 s 2.1 - hydro 2 p 3.5 -# "Second tier" - improvements: -12.89 meV to -1.83 meV -# hydro 1 s 0.85 -# hydro 2 p 3.7 -# hydro 2 s 1.2 -# hydro 3 d 7 -# "Third tier" - improvements: -0.25 meV to -0.12 meV -# hydro 4 f 11.2 -# hydro 3 p 4.8 -# hydro 4 d 9 -# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/060K/geometry.in b/drivers/py/pes/friction/onheH/060K/geometry.in deleted file mode 100644 index cd6ad1f1f..000000000 --- a/drivers/py/pes/friction/onheH/060K/geometry.in +++ /dev/null @@ -1,11 +0,0 @@ -#=======================================# -# iterations/iteration0105/aims-chain-node-0.56500/geometry.in -#=======================================# -lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 -lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 -lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 -atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd -atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd -atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd -atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd -atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/060K/get1D.sh b/drivers/py/pes/friction/onheH/060K/get1D.sh deleted file mode 100755 index 152292560..000000000 --- a/drivers/py/pes/friction/onheH/060K/get1D.sh +++ /dev/null @@ -1,5 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 diff --git a/drivers/py/pes/friction/onheH/060K/hessian.dat b/drivers/py/pes/friction/onheH/060K/hessian.dat deleted file mode 100644 index b7c4a075c..000000000 --- a/drivers/py/pes/friction/onheH/060K/hessian.dat +++ /dev/null @@ -1 +0,0 @@ -1.378510022033408410e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.374149649158943470e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.365386164323188767e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.352133750286003099e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.334262841121765589e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.311599136371373493e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.283922326557654890e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.250964570367895864e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.212408781770814986e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.167886809118204652e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.116977619527808295e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.059205642513455330e-02 0.000000000000000000e+00 0.000000000000000000e+00 9.940394789238792342e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.208912470912980139e-03 0.000000000000000000e+00 0.000000000000000000e+00 8.391169197007053437e-03 0.000000000000000000e+00 0.000000000000000000e+00 7.480181041022698069e-03 0.000000000000000000e+00 0.000000000000000000e+00 6.468458364070799396e-03 0.000000000000000000e+00 0.000000000000000000e+00 5.348070950090709139e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.110748886856484957e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.748029305969009600e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.251460587409648079e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.856572806540479320e-04 0.000000000000000000e+00 0.000000000000000000e+00 -2.045253061764250313e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.624265238991826107e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.087272944572949693e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.397147251201249635e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.516221353232781580e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.419755849999087730e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.205605456844467155e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.891765945738735868e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.046411621116077016e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.083438326205651663e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094271005320850837e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.078186079621248905e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.045852056796305746e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.005739908480898434e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.582470944891540929e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.027644602088387427e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.311261768819506665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.429950574283877666e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.402668266896000340e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.280878871200076624e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.235299504634637557e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.285322439935869226e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.425974145285831121e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.651787645496867810e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.570280415647277467e-04 0.000000000000000000e+00 0.000000000000000000e+00 -3.319806470703911411e-04 0.000000000000000000e+00 0.000000000000000000e+00 2.354599461292655738e-04 0.000000000000000000e+00 0.000000000000000000e+00 7.490319701981655587e-04 0.000000000000000000e+00 0.000000000000000000e+00 1.212168733365171988e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.628156766571992042e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.000098758112630465e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.330887030369986276e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.623185465408864325e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.879418048553359158e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.100817716734189863e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.286142250638482767e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.438452727564343669e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.560803084098245266e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.655709148902988939e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.725163518119613271e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.770648486958304985e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.793146312772643566e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -3.761581922631320025e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.394689268473244043e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/init.xyz b/drivers/py/pes/friction/onheH/060K/init.xyz deleted file mode 100644 index 68ce56e03..000000000 --- a/drivers/py/pes/friction/onheH/060K/init.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9564769528235888 -4.081266917441785e-20 2.7908590995563204e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9572334263205735 5.793139237674196e-19 2.4185003162589166e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.958751763695091 -1.1359567387731722e-19 3.155591492681714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9610427325580506 4.263983379745125e-19 5.047032241637723e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.964122449291171 -3.0677902327976046e-19 -4.650172702221773e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9680123308996569 -7.45538526892937e-20 -6.970257247008592e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9727390204616129 -3.808551907426885e-19 -1.0826990762924036e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9783342769467933 -3.0348861952035195e-19 -1.2358742897106272e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9848348174402097 -4.584095695768042e-19 -9.271971209596813e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.992282096803991 -1.5086226825266906e-19 -6.183559315633063e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0007220065116598 -6.156031683827155e-19 -4.634132022778111e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.010204470788343 -1.0480581203642447e-18 4.266881407114594e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0207829143103897 -1.3140177167600518e-18 7.245521823821627e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.032513571624667 -5.258368060764154e-19 9.405987362224346e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0454546042753683 -5.640551456381032e-19 1.6491301631013408e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.059664987584168 4.983155605782578e-19 -3.4250313702765564e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0752031254526586 4.67436026454736e-19 -2.845095461161012e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0921251489161405 9.110050220091565e-19 -6.180607952836432e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.110482853138887 6.3557012491399515e-19 -5.077314010018871e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1303212289824893 3.306162067628708e-19 -8.972585851203428e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1516755503443252 3.06529810397258e-19 1.0230296390897176e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.174567988550856 3.1634112764565127e-20 3.211158236815306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.1990037421619237 7.938725892671158e-20 4.764275669257918e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2249673020424345 -6.359958136967343e-20 -1.3487347900221808e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.2524204022209573 4.0368983843111056e-20 4.247511852849374e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.2813009397482813 -8.223640698136658e-20 -2.385478682073356e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3115228265771175 7.151344222945072e-20 2.265934918916512e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.342976946334549 -2.2465718725286376e-20 -6.026096826208427e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.3755333115441912 1.365798958746426e-19 -1.0922892997824771e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4090432941993125 1.5421807062298458e-20 -7.603164867851816e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4433411330757084 1.2263465489498636e-19 -1.4644186229431397e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4782459771560252 -1.3111974826278987e-20 -5.459195156603685e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5135650638013027 8.593769432463794e-20 1.8351203506167365e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.5490989536591657 -1.376732419270732e-20 -1.17665121469279e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.5846474722769193 6.89376852033929e-20 4.485389457303741e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6200151047052884 -2.974868320905954e-20 -7.041753229592538e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.6550139581737247 1.7207084550365028e-20 8.204738077442038e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.689466031649674 -5.0994329962374406e-20 -1.3743625254957537e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7232052107021776 -1.915821745618279e-20 9.992582484315834e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7560798156790374 -3.508406739959154e-20 -1.232616938052844e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.7879556560926417 -2.6694536815958284e-21 -1.3907961273724353e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8187183738450803 1.0055554470722832e-21 -1.6001873827387636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.848274886621655 1.2119052308771354e-20 1.1243050791743687e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8765524574110763 1.2822923481728442e-20 3.1870319452721283e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9034960916674586 -1.1583124770536357e-20 2.3594503082335707e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9290659974092295 -7.968957792852064e-21 1.5564002084628535e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9532352140127287 -3.729091858099146e-21 -1.6708185489246323e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9759874394174197 -1.5155235662274669e-21 -2.0160886778735562e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.997315082213753 1.2243512419222811e-20 -7.785392353887547e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0172176036086396 3.3528726826537933e-21 3.079652244187743e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0357000656683986 8.646308670597711e-21 9.952897799961877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.052771838413057 -9.995445386668589e-21 -7.35603676816985e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0684454585289456 8.897607318654096e-21 -2.2618389133440714e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0827356301736373 -1.7577403791920215e-20 -2.6072419043289368e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0956583569753633 9.135256775001372e-21 1.7420561007689692e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.107230193751229 -7.915614285908413e-21 8.11223834059773e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1174676064867515 1.0705356297191669e-20 5.7106549073573374e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1263864287271423 -4.738709226491207e-21 -1.3325369170643531e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1340013932700996 8.819486705005479e-21 -5.913187693657786e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1403257436809935 -5.116068399802934e-21 -6.03541893106877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1453709279398856 4.66690879611828e-21 1.4256347447713127e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.149146361861662 -4.713953894693887e-21 -5.082605521005283e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1516592519153455 -2.4143343021733654e-21 4.162980272149272e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.15291446930372 1.702097554911546e-22 4.571800149560974e-21 diff --git a/drivers/py/pes/friction/onheH/060K/input.xml b/drivers/py/pes/friction/onheH/060K/input.xml deleted file mode 100644 index dbb51f72f..000000000 --- a/drivers/py/pes/friction/onheH/060K/input.xml +++ /dev/null @@ -1,37 +0,0 @@ - - - [ step, potential{electronvolt}] - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - - - 60 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - true - 0.1 - - - -
diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 deleted file mode 100644 index 5c2737e3d..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -1.506227006934168430e-02 -3.425936022842994169e-32 1.370374409137197668e-31 1.502767670138223030e-02 3.401686353053557653e-32 -1.823960511020674335e-34 1.495810121059897545e-02 0.000000000000000000e+00 -3.354228097608541053e-32 1.485276099866961533e-02 -1.715690642156499444e-34 -1.647063016470239398e-32 1.471046941194160268e-02 -2.575080792162824633e-31 3.214760963532369835e-32 1.452962034275445680e-02 3.088365813366071594e-34 -1.930228633353794746e-35 1.430816756398415462e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.404359872097630559e-02 -2.913997943048781120e-32 -1.339769169217830286e-34 1.373290394037445829e-02 0.000000000000000000e+00 -1.391806197733385137e-32 1.337253909596743638e-02 -1.130995630957285661e-34 -2.657839732749621187e-32 1.295838391687817448e-02 -2.063558310876674737e-34 -5.117624610974152937e-32 1.248569535866733173e-02 -4.861124450080682964e-32 9.384410135290893443e-35 1.194905701734108421e-02 -4.260512473609739461e-35 -4.652479621181835266e-32 1.134232589454333556e-02 -7.734167019506621626e-35 3.093666807802648650e-34 1.065857857656206907e-02 -1.405329041396741492e-34 -4.230040414604191704e-32 9.890059942571405999e-03 -2.002733963911398812e-32 1.599627766702395199e-35 9.028138956149914240e-03 -2.339181047300820208e-34 -3.836256917573345004e-32 8.063278020693778400e-03 0.000000000000000000e+00 -2.309995188448496655e-33 6.985024904269959527e-03 0.000000000000000000e+00 8.892026910113234684e-33 5.782039468999978712e-03 -3.445799978918764312e-32 -3.705161267654585562e-34 4.442171450410847475e-03 3.488990675909715679e-34 0.000000000000000000e+00 2.952624329058926422e-03 0.000000000000000000e+00 1.612490047844318588e-32 1.312344508970641251e-03 -3.180915037563134205e-32 8.032613731220035353e-35 -4.381717768554087809e-04 7.890519662171125457e-35 0.000000000000000000e+00 -2.230703661009506358e-03 3.948123075355810602e-33 9.870307688389526025e-36 -3.966035024629116154e-03 -1.008583304500015817e-35 3.104545484164111282e-35 -5.550567176402747618e-03 -8.143758935879853827e-33 -2.041214189239315418e-33 -6.928750979738668679e-03 1.055855394199086599e-33 0.000000000000000000e+00 -8.073784189370946524e-03 -2.501959195243057480e-35 2.220488785778213453e-33 -9.014653348233103020e-03 -4.744697981254628996e-33 3.570126396730345581e-36 -9.810373894349215182e-03 0.000000000000000000e+00 -1.295118217920219888e-33 -1.044993019304902432e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.084155897170733726e-02 -1.646147591016451566e-33 -1.074228394033184229e-37 -1.090039892658436864e-02 -1.562052545041772714e-32 -3.905735498025626725e-33 -1.064447307719057143e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.023251204423378247e-02 -3.357307061109203154e-36 1.627034934490047644e-33 -9.720712298700280932e-03 1.988467846443171235e-32 9.785766960842378581e-37 -9.109679760563109754e-03 4.374272417570274520e-36 -6.568243427007865426e-34 -8.300584906976833655e-03 0.000000000000000000e+00 -1.694127082748360209e-33 -7.269569097051605498e-03 -1.298026380528296206e-35 2.262622234558386403e-33 -6.043448758650506875e-03 0.000000000000000000e+00 3.683864272723515900e-36 -4.766978636912596289e-03 -2.674039966316875204e-32 3.342549957896094005e-33 -3.610983712974477101e-03 -1.713106407937711159e-35 -2.676728762402673686e-37 -2.574576607046632007e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.650144039495938294e-03 -2.197541465015040773e-36 -2.329393952915943086e-34 -8.277487326243680764e-04 6.618517316167119220e-33 1.656369212668532299e-33 -9.145350364914422037e-05 1.206076294130375192e-32 4.711235523946778094e-35 5.710604402621225189e-04 -1.967607902828418533e-35 2.459509878535523166e-36 1.166518357509653894e-03 0.000000000000000000e+00 1.306090230549346235e-33 1.700025733985569129e-03 3.097276987432112332e-35 1.235039198738554800e-33 2.176432038955953760e-03 1.888036838019580200e-32 0.000000000000000000e+00 2.598490483436719650e-03 1.813613839154938619e-32 5.675721520443395122e-34 2.966872718701811344e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.284070774204726414e-03 -2.323035862692772347e-35 0.000000000000000000e+00 3.553850267842143321e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.780570836528641520e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.968768429152299757e-03 -5.174324058341501658e-36 -3.233952536463438536e-37 4.123080034052132962e-03 -5.041147939460656966e-36 -1.246108756285431235e-34 4.247772627206324557e-03 1.976666357603309228e-33 -7.711713317740750984e-38 4.346420792367636926e-03 0.000000000000000000e+00 -4.889410545885136790e-34 4.421938339607826493e-03 -1.197612235187371759e-36 1.214079403421198123e-34 4.476613052322547283e-03 4.834405809294092505e-34 4.840337595563164884e-34 4.512135239064637461e-03 7.369203729012634514e-38 0.000000000000000000e+00 4.529619522664536137e-03 0.000000000000000000e+00 9.615543789726310105e-34 -3.425936022842994169e-32 5.511521610893899137e-01 7.034880654628458492e-34 3.401686353053557653e-32 5.511521610893899137e-01 6.022463092658234147e-34 0.000000000000000000e+00 5.511521610893899137e-01 5.272711987855515804e-34 -1.715690642156499444e-34 5.511521610893899137e-01 -1.553724899105315985e-34 -2.575080792162824633e-31 5.511521610893899137e-01 8.684328578386033194e-34 3.088365813366071594e-34 5.511521610893899137e-01 1.592196964609921784e-34 0.000000000000000000e+00 5.511521610893899137e-01 1.363280259728783207e-33 -2.913997943048781120e-32 5.511521610893899137e-01 -2.580929346232268245e-34 0.000000000000000000e+00 5.511521610893899137e-01 -5.595253927394622821e-36 -1.130995630957285661e-34 5.511521610893899137e-01 1.898820418319370078e-34 -2.063558310876674737e-34 5.511521610893899137e-01 -4.966807357747377228e-34 -4.861124450080682964e-32 5.511521610893899137e-01 2.885063682391402880e-34 -4.260512473609739461e-35 5.511521610893899137e-01 -1.728168662566742781e-34 -7.734167019506621626e-35 5.511521610893899137e-01 4.158769826582580269e-34 -1.405329041396741492e-34 5.511521610893899137e-01 -5.093362408750378646e-34 -2.002733963911398812e-32 5.511521610893899137e-01 -1.694644554233883970e-35 -2.339181047300820208e-34 5.511521610893899137e-01 5.760081881009954932e-34 0.000000000000000000e+00 5.511521610893899137e-01 8.343692044762322778e-35 0.000000000000000000e+00 5.511521610893899137e-01 -2.928085215119096584e-35 -3.445799978918764312e-32 5.511521610893899137e-01 -7.412021787651107749e-34 3.488990675909715679e-34 5.511521610893899137e-01 9.409280717399915955e-34 0.000000000000000000e+00 5.511521610893899137e-01 5.173677025347640048e-34 -3.180915037563134205e-32 5.511521610893899137e-01 1.558102331723709920e-34 7.890519662171125457e-35 5.511521610893899137e-01 2.903126592608412800e-35 3.948123075355810602e-33 5.511521610893899137e-01 5.248973699356195156e-36 -1.008583304500015817e-35 5.511521610893899137e-01 -1.748397566974016790e-38 -8.143758935879853827e-33 5.511521610893899137e-01 -2.763384442020469118e-36 1.055855394199086599e-33 5.511521610893899137e-01 -7.304638524574063352e-37 -2.501959195243057480e-35 5.511521610893899137e-01 -3.581690987099461043e-36 -4.744697981254628996e-33 5.511521610893899137e-01 -7.324051961639652751e-37 0.000000000000000000e+00 5.511521610893899137e-01 -8.974131286115321801e-37 0.000000000000000000e+00 5.511521610893899137e-01 -3.081907946609472917e-37 -1.646147591016451566e-33 5.511521610893899137e-01 1.813017515127337424e-38 -1.562052545041772714e-32 5.511521610893899137e-01 -4.280018714947023860e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.639044046427557461e-37 -3.357307061109203154e-36 5.511521610893899137e-01 -4.370620437321199212e-37 1.988467846443171235e-32 5.511521610893899137e-01 -7.992799118463532479e-37 4.374272417570274520e-36 5.511521610893899137e-01 1.545765674080682600e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.947678798218874966e-37 -1.298026380528296206e-35 5.511521610893899137e-01 2.670429232782507366e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.116237809925155111e-35 -2.674039966316875204e-32 5.511521610893899137e-01 3.920738665697954181e-36 -1.713106407937711159e-35 5.511521610893899137e-01 -2.783967620646281251e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.125424220083700766e-36 -2.197541465015040773e-36 5.511521610893899137e-01 6.308962015599689956e-38 6.618517316167119220e-33 5.511521610893899137e-01 7.086274291962006260e-37 1.206076294130375192e-32 5.511521610893899137e-01 5.635743381882329130e-38 -1.967607902828418533e-35 5.511521610893899137e-01 2.359624974774508700e-36 0.000000000000000000e+00 5.511521610893899137e-01 3.788139762956023868e-36 3.097276987432112332e-35 5.511521610893899137e-01 3.480337289587597326e-36 1.888036838019580200e-32 5.511521610893899137e-01 3.492997718346034772e-36 1.813613839154938619e-32 5.511521610893899137e-01 1.519472190048699872e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.583351468789963563e-36 -2.323035862692772347e-35 5.511521610893899137e-01 1.878795810963495899e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.092505530570360165e-36 0.000000000000000000e+00 5.511521610893899137e-01 -8.284462195105786532e-38 -5.174324058341501658e-36 5.511521610893899137e-01 1.244997923489414768e-37 -5.041147939460656966e-36 5.511521610893899137e-01 4.388095839287971764e-38 1.976666357603309228e-33 5.511521610893899137e-01 1.333451384229864514e-38 0.000000000000000000e+00 5.511521610893899137e-01 7.221152015534320527e-38 -1.197612235187371759e-36 5.511521610893899137e-01 -7.029920874323088627e-39 4.834405809294092505e-34 5.511521610893899137e-01 -2.182287488826882183e-38 7.369203729012634514e-38 5.511521610893899137e-01 2.057188518507853134e-39 0.000000000000000000e+00 5.511521610893899137e-01 -1.244729013371577066e-38 1.370374409137197668e-31 -5.315043010747265935e-33 5.511521610893899137e-01 -1.823960511020674335e-34 -4.754600230041507171e-32 5.511521610893899137e-01 -3.354228097608541053e-32 -5.491259877424560204e-33 5.511521610893899137e-01 -1.647063016470239398e-32 -1.553724899105315985e-34 5.511521610893899137e-01 3.214760963532369835e-32 8.684328578386033194e-34 5.511521610893899137e-01 -1.930228633353794746e-35 -5.859311379749120162e-33 5.511521610893899137e-01 0.000000000000000000e+00 1.363280259728783207e-33 5.511521610893899137e-01 -1.339769169217830286e-34 -2.580929346232268245e-34 5.511521610893899137e-01 -1.391806197733385137e-32 -5.595253927394622821e-36 5.511521610893899137e-01 -2.657839732749621187e-32 1.898820418319370078e-34 5.511521610893899137e-01 -5.117624610974152937e-32 -2.457080504061518537e-32 5.511521610893899137e-01 9.384410135290893443e-35 2.885063682391402880e-34 5.511521610893899137e-01 -4.652479621181835266e-32 -1.728168662566742781e-34 5.511521610893899137e-01 3.093666807802648650e-34 4.158769826582580269e-34 5.511521610893899137e-01 -4.230040414604191704e-32 -2.458346054571548671e-32 5.511521610893899137e-01 1.599627766702395199e-35 -4.816519505522323298e-32 5.511521610893899137e-01 -3.836256917573345004e-32 -4.757224042157990331e-32 5.511521610893899137e-01 -2.309995188448496655e-33 8.343692044762322778e-35 5.511521610893899137e-01 8.892026910113234684e-33 2.404484345268925835e-32 5.511521610893899137e-01 -3.705161267654585562e-34 1.129585997365511331e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.297799022416021636e-32 5.511521610893899137e-01 1.612490047844318588e-32 -9.872650665177640909e-34 5.511521610893899137e-01 8.032613731220035353e-35 -2.853455304932685007e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.989499810284027779e-33 5.511521610893899137e-01 9.870307688389526025e-36 -4.508649333458227785e-33 5.511521610893899137e-01 3.104545484164111282e-35 -3.009283022080725843e-33 5.511521610893899137e-01 -2.041214189239315418e-33 -3.012028922547076381e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.505363232904985390e-33 5.511521610893899137e-01 2.220488785778213453e-33 -1.204064384340732409e-32 5.511521610893899137e-01 3.570126396730345581e-36 -3.762314327827483788e-33 5.511521610893899137e-01 -1.295118217920219888e-33 -1.203795956554883561e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.514206497952244782e-33 5.511521610893899137e-01 -1.074228394033184229e-37 -6.018512946034960550e-33 5.511521610893899137e-01 -3.905735498025626725e-33 -5.266642693555342602e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009101633700413357e-33 5.511521610893899137e-01 1.627034934490047644e-33 -1.505069831096260175e-33 5.511521610893899137e-01 9.785766960842378581e-37 -5.267013971595694290e-33 5.511521610893899137e-01 -6.568243427007865426e-34 -3.009110961537647872e-33 5.511521610893899137e-01 -1.694127082748360209e-33 -5.266019923804026256e-33 5.511521610893899137e-01 2.262622234558386403e-33 -4.511227877924801483e-33 5.511521610893899137e-01 3.683864272723515900e-36 -3.280221804203153303e-33 5.511521610893899137e-01 3.342549957896094005e-33 -3.287463443636707164e-33 5.511521610893899137e-01 -2.676728762402673686e-37 -6.394967665235309304e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.265089267463764460e-33 5.511521610893899137e-01 -2.329393952915943086e-34 -4.889993409800559745e-33 5.511521610893899137e-01 1.656369212668532299e-33 -3.384715102938991710e-33 5.511521610893899137e-01 4.711235523946778094e-35 -3.197288276802803183e-33 5.511521610893899137e-01 2.459509878535523166e-36 -3.289024557327630401e-33 5.511521610893899137e-01 1.306090230549346235e-33 -6.767059320973420383e-33 5.511521610893899137e-01 1.235039198738554800e-33 -3.193864296947034472e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.886563501702369887e-33 5.511521610893899137e-01 5.675721520443395122e-34 -4.888537027230667298e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.888473147951925948e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.007386742294092587e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.888963993890145432e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890139344042667412e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.385299230575839311e-33 5.511521610893899137e-01 -1.246108756285431235e-34 -6.770803579777983743e-33 5.511521610893899137e-01 -7.711713317740750984e-38 -4.890043164906873414e-33 5.511521610893899137e-01 -4.889410545885136790e-34 -3.197272422716466807e-33 5.511521610893899137e-01 1.214079403421198123e-34 -3.385430760289062257e-33 5.511521610893899137e-01 4.840337595563164884e-34 -6.582790187479697990e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291382125113886581e-33 5.511521610893899137e-01 9.615543789726310105e-34 -3.314906516608984654e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 deleted file mode 100644 index 1cd035ee4..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -1.728120619390645374e-02 -3.542738869274355092e-32 -2.063629275944806903e-31 1.726190828369338071e-02 3.401686353053557653e-32 -1.823960511020674335e-34 1.722299240960656341e-02 -3.375035431197975981e-31 5.083360480386398351e-32 1.716381173905208099e-02 -1.243199416152717293e-31 -1.647063016470239398e-32 1.708337905923526523e-02 2.270655704591035201e-31 3.214760963532369835e-32 1.698034599777839548e-02 -3.914555591392588862e-32 -9.934848170807599477e-34 1.685297461084935347e-02 7.584282830077568691e-32 3.020068245380212957e-31 1.669910073242517751e-02 -1.015540585470740966e-31 -7.254805603350806548e-32 1.651608832957153841e-02 0.000000000000000000e+00 2.108009668548692463e-32 1.630077396930475556e-02 -1.342045419382843246e-31 3.993801553493286858e-32 1.604940038411482167e-02 3.181384509744293486e-32 1.222375172874906666e-32 1.575753804399471908e-02 1.155374385689681745e-32 -7.462936287325012831e-33 1.541999363254347062e-02 1.427948362909960750e-32 1.256006704479162178e-31 1.503070442905433089e-02 1.565211922236584275e-34 1.088217348430684805e-31 1.458261788575629381e-02 2.789384104313185699e-34 3.164452352567590235e-32 1.406755626047747829e-02 4.415570276478289644e-33 6.173729352556617726e-33 1.347606716419970721e-02 -4.644592117609538137e-32 5.372412307596528467e-32 1.279726251341044285e-02 6.061104415617773346e-34 4.132995660399947178e-32 1.201865091559647589e-02 0.000000000000000000e+00 -3.314871614980337452e-32 1.112597232812429990e-02 -1.134415308057596725e-31 -2.345104402179759659e-33 1.010304937573192584e-02 3.488990675909715679e-34 8.970013099046606808e-34 8.931677532289853533e-03 0.000000000000000000e+00 1.612490047844318588e-32 7.591591555858014095e-03 2.929500813919224937e-33 8.032613731220035353e-35 6.060952442666531562e-03 -9.659518447048637078e-35 0.000000000000000000e+00 4.317062163020816447e-03 1.203381764684610519e-32 -8.075824263801903757e-33 2.338509408897714199e-03 -1.008583304500015817e-35 3.104545484164111282e-35 1.546067783415620497e-04 7.328078595823150219e-33 -1.358154784384526569e-34 -2.114438086211452641e-03 -2.780958166884859142e-33 3.874429380310258942e-33 -4.283305343024701797e-03 -6.292370407290400383e-35 2.684270115738322081e-34 -6.181183632586233212e-03 -7.995050266326074964e-34 3.929232422827554127e-33 -7.724840751389351959e-03 0.000000000000000000e+00 9.656319980370172886e-34 -8.935143516086353765e-03 -2.097290439145297018e-33 2.623707546707065725e-33 -9.903979045288509309e-03 -1.658600071468264730e-33 2.817171747158474427e-37 -1.060849997745690228e-02 3.393254932848490570e-33 8.468145789440409533e-34 -1.089402305441272180e-02 4.260663671260588839e-36 -1.065165917815147210e-36 -1.070037223650031032e-02 -3.357307061109203154e-36 1.849795887944143741e-34 -1.021385585321613575e-02 -3.046708926272669735e-33 3.276891061082424354e-33 -9.574406308410530336e-03 7.645184831520068991e-33 -4.477229622252036282e-33 -8.747242064948817716e-03 0.000000000000000000e+00 3.269586879210648575e-35 -7.595928811011507138e-03 -1.298026380528296206e-35 5.160718709323466272e-33 -6.129162338357456268e-03 0.000000000000000000e+00 -1.554413684609571447e-32 -4.550480677541271328e-03 -1.197339955402505454e-31 3.342549957896094005e-33 -3.142324311591399542e-03 -8.810722339412769790e-32 -1.946778018444609176e-35 -1.904651036943976567e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.245578081357268080e-04 1.727255188071653879e-32 -2.804627774709108475e-34 1.264071584710107663e-04 6.700546260675067372e-33 -1.446231838314319496e-32 9.724840589708151238e-04 1.206076294130375192e-32 2.162076698056672865e-32 1.722589814379883255e-03 6.656060198206126988e-32 -4.100020164959082116e-35 2.385452976668203922e-03 1.186440986346068982e-34 1.246768181232042828e-33 2.968247540530983934e-03 -1.462804315209311135e-34 1.279352499087367786e-33 3.463483364020931293e-03 1.873954462970553758e-32 3.520593762256636289e-35 3.869420800861308844e-03 9.500179401581342541e-32 5.383234246378463570e-34 4.198701782568560296e-03 0.000000000000000000e+00 -1.779611191907839282e-32 4.463598035149346152e-03 -1.119522922310912564e-34 0.000000000000000000e+00 4.674828526784226279e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.841667455245108123e-03 3.667870844758556595e-35 -9.169677111896391488e-36 4.972061408482619967e-03 -5.174324058341501658e-36 -3.233952536463438536e-37 5.072649649892250513e-03 -2.113138846585561356e-35 3.439377400967939512e-33 5.148730287624611428e-03 -1.511491206001795706e-33 3.756023046608422268e-36 5.204891056665827097e-03 0.000000000000000000e+00 -4.889410545885136790e-34 5.245050063922449164e-03 5.961872011150859766e-36 -2.996592268956474661e-34 5.272378926540109700e-03 4.843162144919647471e-34 -7.628684335226933339e-34 5.289268068113470340e-03 5.053045552096236127e-37 -1.726450071677988945e-36 5.297313545334941809e-03 0.000000000000000000e+00 -6.841801237134676918e-34 -3.542738869274355092e-32 5.511521610893899137e-01 2.845974148209923387e-32 3.401686353053557653e-32 5.511521610893899137e-01 1.183807063212349168e-32 -3.375035431197975981e-31 5.511521610893899137e-01 9.808970414423777389e-33 -1.243199416152717293e-31 5.511521610893899137e-01 5.086845686046830215e-34 2.270655704591035201e-31 5.511521610893899137e-01 6.406765915486485673e-33 -3.914555591392588862e-32 5.511521610893899137e-01 -2.310055997093402660e-33 7.584282830077568691e-32 5.511521610893899137e-01 2.711043080274167995e-33 -1.015540585470740966e-31 5.511521610893899137e-01 -1.555839978484002212e-33 0.000000000000000000e+00 5.511521610893899137e-01 -3.310983082790151904e-34 -1.342045419382843246e-31 5.511521610893899137e-01 -1.481596832967081230e-33 3.181384509744293486e-32 5.511521610893899137e-01 9.805988219435624130e-34 1.155374385689681745e-32 5.511521610893899137e-01 2.001781829487448464e-34 1.427948362909960750e-32 5.511521610893899137e-01 -6.580166507506179208e-34 1.565211922236584275e-34 5.511521610893899137e-01 2.696988908566534161e-33 2.789384104313185699e-34 5.511521610893899137e-01 -4.064959508186727256e-34 4.415570276478289644e-33 5.511521610893899137e-01 -7.249958804972652658e-35 -4.644592117609538137e-32 5.511521610893899137e-01 3.576679181544805411e-34 6.061104415617773346e-34 5.511521610893899137e-01 -2.437915145419918380e-33 0.000000000000000000e+00 5.511521610893899137e-01 3.031155048292435097e-33 -1.134415308057596725e-31 5.511521610893899137e-01 5.911842207738938141e-33 3.488990675909715679e-34 5.511521610893899137e-01 1.258439885868115363e-32 0.000000000000000000e+00 5.511521610893899137e-01 4.404268178175266599e-33 2.929500813919224937e-33 5.511521610893899137e-01 1.393843602264355920e-33 -9.659518447048637078e-35 5.511521610893899137e-01 3.053499287626638697e-34 1.203381764684610519e-32 5.511521610893899137e-01 6.539085139435131510e-35 -1.008583304500015817e-35 5.511521610893899137e-01 -3.691597531308812644e-36 7.328078595823150219e-33 5.511521610893899137e-01 -2.097641747006767341e-35 -2.780958166884859142e-33 5.511521610893899137e-01 1.126561099554825961e-35 -6.292370407290400383e-35 5.511521610893899137e-01 -1.031718664242702187e-35 -7.995050266326074964e-34 5.511521610893899137e-01 4.635630054135295272e-36 0.000000000000000000e+00 5.511521610893899137e-01 -8.929239576824547324e-37 -2.097290439145297018e-33 5.511521610893899137e-01 -4.796431318285689994e-37 -1.658600071468264730e-33 5.511521610893899137e-01 2.011818038456673966e-37 3.393254932848490570e-33 5.511521610893899137e-01 -5.213400928487227977e-38 4.260663671260588839e-36 5.511521610893899137e-01 -8.667351589518109023e-37 -3.357307061109203154e-36 5.511521610893899137e-01 -1.522176210570282207e-36 -3.046708926272669735e-33 5.511521610893899137e-01 -1.637885368649847761e-36 7.645184831520068991e-33 5.511521610893899137e-01 1.282352124838609119e-36 0.000000000000000000e+00 5.511521610893899137e-01 4.761811945169089374e-37 -1.298026380528296206e-35 5.511521610893899137e-01 -2.477074469114290914e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.074528240036378698e-36 -1.197339955402505454e-31 5.511521610893899137e-01 1.530342359834450166e-35 -8.810722339412769790e-32 5.511521610893899137e-01 1.395017083016023053e-34 0.000000000000000000e+00 5.511521610893899137e-01 8.656802974935791080e-33 1.727255188071653879e-32 5.511521610893899137e-01 -3.490939748843842644e-35 6.700546260675067372e-33 5.511521610893899137e-01 6.083862849624305299e-35 1.206076294130375192e-32 5.511521610893899137e-01 1.563043018266323453e-34 6.656060198206126988e-32 5.511521610893899137e-01 2.246345322342294802e-34 1.186440986346068982e-34 5.511521610893899137e-01 2.418713794591359511e-34 -1.462804315209311135e-34 5.511521610893899137e-01 2.604463121916524957e-34 1.873954462970553758e-32 5.511521610893899137e-01 2.091269583398447926e-34 9.500179401581342541e-32 5.511521610893899137e-01 1.503751390040286969e-34 0.000000000000000000e+00 5.511521610893899137e-01 1.150909755925890029e-34 -1.119522922310912564e-34 5.511521610893899137e-01 7.606216786905653783e-35 0.000000000000000000e+00 5.511521610893899137e-01 3.868287627436741770e-35 3.667870844758556595e-35 5.511521610893899137e-01 1.854525477146529574e-35 -5.174324058341501658e-36 5.511521610893899137e-01 1.399529440311034911e-35 -2.113138846585561356e-35 5.511521610893899137e-01 3.477894856789226509e-36 -1.511491206001795706e-33 5.511521610893899137e-01 8.457691109422172818e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.735818218614457499e-36 5.961872011150859766e-36 5.511521610893899137e-01 8.612245989066594577e-38 4.843162144919647471e-34 5.511521610893899137e-01 1.227138284483865207e-39 5.053045552096236127e-37 5.511521610893899137e-01 4.114837214437934287e-38 0.000000000000000000e+00 5.511521610893899137e-01 6.527259308142098534e-38 -2.063629275944806903e-31 2.244121040588912456e-32 5.511521610893899137e-01 -1.823960511020674335e-34 -3.631017797755740464e-32 5.511521610893899137e-01 5.083360480386398351e-32 3.790439338213665348e-33 5.511521610893899137e-01 -1.647063016470239398e-32 5.086845686046830215e-34 5.511521610893899137e-01 3.214760963532369835e-32 6.406765915486485673e-33 5.511521610893899137e-01 -9.934848170807599477e-34 -8.328587073303515043e-33 5.511521610893899137e-01 3.020068245380212957e-31 2.711043080274167995e-33 5.511521610893899137e-01 -7.254805603350806548e-32 -1.555839978484002212e-33 5.511521610893899137e-01 2.108009668548692463e-32 -3.310983082790151904e-34 5.511521610893899137e-01 3.993801553493286858e-32 -1.481596832967081230e-33 5.511521610893899137e-01 1.222375172874906666e-32 -2.309352548289688507e-32 5.511521610893899137e-01 -7.462936287325012831e-33 2.001781829487448464e-34 5.511521610893899137e-01 1.256006704479162178e-31 -6.580166507506179208e-34 5.511521610893899137e-01 1.088217348430684805e-31 2.696988908566534161e-33 5.511521610893899137e-01 3.164452352567590235e-32 -2.448062025565912063e-32 5.511521610893899137e-01 6.173729352556617726e-33 -4.822074819773062061e-32 5.511521610893899137e-01 5.372412307596528467e-32 -4.779058069152641899e-32 5.511521610893899137e-01 4.132995660399947178e-32 -2.437915145419918380e-33 5.511521610893899137e-01 -3.314871614980337452e-32 2.710527935313288189e-32 5.511521610893899137e-01 -2.345104402179759659e-33 1.794890436015916359e-32 5.511521610893899137e-01 8.970013099046606808e-34 2.462146101110138045e-32 5.511521610893899137e-01 1.612490047844318588e-32 2.899635409122738589e-33 5.511521610893899137e-01 8.032613731220035353e-35 -1.615421935840700100e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.713181147447448043e-33 5.511521610893899137e-01 -8.075824263801903757e-33 -4.448507455763232854e-33 5.511521610893899137e-01 3.104545484164111282e-35 -3.012957135636364800e-33 5.511521610893899137e-01 -1.358154784384526569e-34 -3.030241955575123721e-33 5.511521610893899137e-01 3.874429380310258942e-33 -1.493367158056979788e-33 5.511521610893899137e-01 2.684270115738322081e-34 -1.204737933906265137e-32 5.511521610893899137e-01 3.929232422827554127e-33 -3.756946292577184782e-33 5.511521610893899137e-01 9.656319980370172886e-34 -1.203795507637790592e-32 5.511521610893899137e-01 2.623707546707065725e-33 -4.514377950289412616e-33 5.511521610893899137e-01 2.817171747158474427e-37 -6.018329894406266118e-33 5.511521610893899137e-01 8.468145789440409533e-34 -5.266266825693132590e-33 5.511521610893899137e-01 -1.065165917815147210e-36 -3.010132273264007946e-33 5.511521610893899137e-01 1.849795887944143741e-34 -1.506154945263098384e-33 5.511521610893899137e-01 3.276891061082424354e-33 -5.267852577052497827e-33 5.511521610893899137e-01 -4.477229622252036282e-33 -3.007983185980217336e-33 5.511521610893899137e-01 3.269586879210648575e-35 -5.265738510489331570e-33 5.511521610893899137e-01 5.160718709323466272e-33 -4.514146014604495384e-33 5.511521610893899137e-01 -1.554413684609571447e-32 -3.290309654062368275e-33 5.511521610893899137e-01 3.342549957896094005e-33 -3.276080758704060430e-33 5.511521610893899137e-01 -1.946778018444609176e-35 -6.255187560171642957e-33 5.511521610893899137e-01 0.000000000000000000e+00 3.390588283251943044e-33 5.511521610893899137e-01 -2.804627774709108475e-34 -4.924965896909154411e-33 5.511521610893899137e-01 -1.446231838314319496e-32 -3.324585101871944799e-33 5.511521610893899137e-01 2.162076698056672865e-32 -3.041040332409989548e-33 5.511521610893899137e-01 -4.100020164959082116e-35 -3.066749650068175457e-33 5.511521610893899137e-01 1.246768181232042828e-33 -6.528976081277240993e-33 5.511521610893899137e-01 1.279352499087367786e-33 -2.936898322044969611e-33 5.511521610893899137e-01 3.520593762256636289e-35 -4.680929541080871027e-33 5.511521610893899137e-01 5.383234246378463570e-34 -4.739681360416687379e-33 5.511521610893899137e-01 -1.779611191907839282e-32 -4.774965523828126902e-33 5.511521610893899137e-01 0.000000000000000000e+00 -2.933203370235999568e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.851373623146348423e-33 5.511521610893899137e-01 -9.169677111896391488e-36 -4.871511244649250922e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.371428435965078219e-33 5.511521610893899137e-01 3.439377400967939512e-33 -6.767369565879586943e-33 5.511521610893899137e-01 3.756023046608422268e-36 -4.889210730309773783e-33 5.511521610893899137e-01 -4.889410545885136790e-34 -3.195608816018007455e-33 5.511521610893899137e-01 -2.996592268956474661e-34 -3.385337607908297476e-33 5.511521610893899137e-01 -7.628684335226933339e-34 -6.582767137466525564e-33 5.511521610893899137e-01 -1.726450071677988945e-36 -3.291343033930260993e-33 5.511521610893899137e-01 -6.841801237134676918e-34 -3.314828796725769578e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 deleted file mode 100644 index e9cc9e8ad..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_10 +++ /dev/null @@ -1 +0,0 @@ -1.807662116346134967e-02 3.164087156628939504e-31 -1.633434488660336739e-30 1.806625868490087383e-02 -1.085177402730688066e-30 -3.226443523490898253e-30 1.804535322851988713e-02 3.543751496778853165e-31 1.872996459437099683e-31 1.801354055310852922e-02 -2.688696798746614423e-30 3.927707757456414859e-30 1.797026613278851145e-02 -7.008030484572618691e-32 1.115107960831865645e-31 1.791477518303168787e-02 5.503944078191396923e-31 4.120484283053314901e-31 1.784609906784695443e-02 -8.514420401935630375e-31 -1.476804827316818698e-30 1.776303783039119913e-02 1.794332681167508319e-31 2.247206098713937892e-31 1.766413851358830320e-02 -5.681895945623271615e-32 7.849521353568395954e-33 1.754766886655685643e-02 2.386405059475222744e-31 1.325538945151555855e-32 1.741158595133916395e-02 -1.287141234869270892e-31 -8.066475638589354568e-32 1.725349908068764954e-02 -1.721020222363038698e-31 2.349298806889960130e-31 1.707062644091276310e-02 -1.593607132994180941e-30 7.020652028459235777e-31 1.685974467252692940e-02 -6.128475234436036736e-32 -4.200343067810369111e-31 1.661713062326950624e-02 -9.265647227757254475e-31 9.240359461569142922e-31 1.633849445088169164e-02 -2.962330518146786986e-32 4.663521481165233462e-31 1.601890326888725721e-02 -2.025209179592617023e-32 -1.681391503196031743e-31 1.565269462199747955e-02 1.192254554813799353e-30 -8.769109520231000651e-33 1.523337930290643953e-02 -2.196649816182515576e-31 -1.797211333297436084e-31 1.475353344194707365e-02 7.182646886513290429e-33 6.213757404568850101e-31 1.420468051919606539e-02 5.760457034663925865e-31 -2.471986719052780083e-32 1.357716509835260772e-02 8.886840178566166225e-32 2.796153290459943396e-31 1.286002185300457595e-02 4.250487804384383034e-32 -1.789690272568214350e-32 1.204084609213827185e-02 2.389923208440380923e-33 1.643402474908239138e-32 1.110567581212736250e-02 -1.343346034488042710e-33 -9.716741310014274257e-35 1.003890068287666658e-02 3.580908177937360760e-33 -3.070865982252067423e-33 8.823220746538041129e-03 -4.231153308533512797e-33 -7.368300405582650670e-34 7.439687378049326602e-03 -2.615634003300615308e-32 1.804036459908213617e-34 5.867871510747562497e-03 -1.145697898623915686e-32 -1.429969374971154658e-32 4.086219201034677062e-03 -2.586770821341835067e-33 -5.793325363106860298e-33 2.072671522343479990e-03 -2.714472459481445071e-33 -5.983234717341650964e-35 -1.943301428610652538e-04 4.364828264905785795e-33 -6.379949195047204859e-33 -2.522900199108353298e-03 5.058170564180594619e-33 1.523114619859653715e-34 -4.654628855234116229e-03 -7.563361636010057075e-34 -1.738589300108749537e-33 -6.499151941018628358e-03 2.027358810256903635e-33 5.535739266042202676e-34 -7.963541136812359381e-03 -4.453577401150869010e-34 -4.183270911100182673e-34 -9.091014769496964104e-03 3.625286767107592387e-33 2.119924900926689598e-33 -1.002912314298475688e-02 8.117848115817957424e-33 -2.717898365592131047e-33 -1.071535521933834369e-02 -1.489711957138894375e-33 1.527523580936962022e-33 -1.094340768136065414e-02 -2.260998548010460752e-33 -2.000405003634025794e-33 -1.068139216269998158e-02 2.202525955196679834e-33 -5.259197251956479527e-34 -1.018162866523230140e-02 2.717541467462236649e-33 -2.459378625932372757e-33 -9.540234830633593024e-03 -1.609377956175339294e-33 -1.300110261878807407e-33 -8.722009664728382766e-03 -1.134677965359366717e-32 1.029429459866732799e-33 -7.586964263465604229e-03 1.622107356915102752e-33 4.858616868190341274e-34 -6.164876687500073921e-03 2.227444846913826618e-34 4.326676239137077823e-34 -4.641006316885080279e-03 -6.974255266373161154e-34 -3.640728615636350653e-33 -3.291456588225678565e-03 1.220862751365442332e-33 5.208516986718054924e-33 -2.111041386981096172e-03 -3.070621989745760526e-33 -5.660787037112491821e-34 -1.086039395631184946e-03 -3.990061490866478591e-33 4.559203738450610561e-33 -1.956182906113430376e-04 7.236292230237556541e-34 -7.458223354219071687e-33 5.882818317652856220e-04 -4.548845259825297636e-33 3.829379978604814926e-33 1.275495760500583052e-03 8.840782518357675480e-33 7.844439867260642662e-34 1.874629561658635235e-03 2.592600399940473664e-33 -1.735572245668321533e-32 2.393750128099486358e-03 -1.317025969628458420e-32 7.642477992654330315e-33 2.840257706827205384e-03 -8.951878579547795097e-34 2.366366155393414663e-34 3.217232157070671131e-03 1.024008328502186040e-33 4.733625503408135770e-34 3.521710645887283705e-03 2.814435943849740853e-35 1.307272369824395214e-33 3.763489673766458061e-03 -5.830181313208050816e-33 1.089590271795947122e-33 3.951650395040713810e-03 1.533383441508987127e-36 -6.457978647149066464e-34 4.093584046955925197e-03 1.419060325234624282e-33 -2.503974908514965981e-34 4.195080777651336024e-03 -4.986826270073553557e-33 1.271011556946934550e-34 4.260408451665708557e-03 1.424401468998474442e-34 1.328261862783616291e-34 4.292375711879439261e-03 -2.846866755351295910e-33 2.406196339113465262e-33 3.164087156628939504e-31 5.511521610893899137e-01 4.109099409034863354e-29 -1.085177402730688066e-30 5.511521610893899137e-01 2.884516053272865121e-29 3.543751496778853165e-31 5.511521610893899137e-01 -3.470970858216986142e-28 -2.688696798746614423e-30 5.511521610893899137e-01 -2.481093667383957773e-29 -7.008030484572618691e-32 5.511521610893899137e-01 -4.762632913372167944e-29 5.503944078191396923e-31 5.511521610893899137e-01 -1.223719799011351399e-30 -8.514420401935630375e-31 5.511521610893899137e-01 -2.349250725256108953e-31 1.794332681167508319e-31 5.511521610893899137e-01 -2.632295029854413973e-31 -5.681895945623271615e-32 5.511521610893899137e-01 -6.853875300571520784e-32 2.386405059475222744e-31 5.511521610893899137e-01 5.042636366005646363e-32 -1.287141234869270892e-31 5.511521610893899137e-01 6.659160334961256299e-33 -1.721020222363038698e-31 5.511521610893899137e-01 -4.952225321441334376e-32 -1.593607132994180941e-30 5.511521610893899137e-01 -2.274496159051381277e-31 -6.128475234436036736e-32 5.511521610893899137e-01 -2.934756400891602520e-32 -9.265647227757254475e-31 5.511521610893899137e-01 -4.597268208559428753e-32 -2.962330518146786986e-32 5.511521610893899137e-01 -3.059256171910973785e-32 -2.025209179592617023e-32 5.511521610893899137e-01 8.182649255080780921e-32 1.192254554813799353e-30 5.511521610893899137e-01 -4.423114634736851793e-34 -2.196649816182515576e-31 5.511521610893899137e-01 6.276196472814834536e-32 7.182646886513290429e-33 5.511521610893899137e-01 2.297253242164015091e-31 5.760457034663925865e-31 5.511521610893899137e-01 3.951560921186745574e-31 8.886840178566166225e-32 5.511521610893899137e-01 1.700032004436945594e-31 4.250487804384383034e-32 5.511521610893899137e-01 1.108494471384979388e-30 2.389923208440380923e-33 5.511521610893899137e-01 4.836273720504902666e-32 -1.343346034488042710e-33 5.511521610893899137e-01 7.626666602919988734e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.338390184150765363e-33 -4.231153308533512797e-33 5.511521610893899137e-01 -7.610496118856242256e-34 -2.615634003300615308e-32 5.511521610893899137e-01 3.799637646121936530e-34 -1.145697898623915686e-32 5.511521610893899137e-01 -6.894616178699667280e-35 -2.586770821341835067e-33 5.511521610893899137e-01 1.979372363168888232e-34 -2.714472459481445071e-33 5.511521610893899137e-01 -3.213086025265911031e-37 4.364828264905785795e-33 5.511521610893899137e-01 -3.836623248938668840e-36 5.058170564180594619e-33 5.511521610893899137e-01 1.024661732475899459e-36 -7.563361636010057075e-34 5.511521610893899137e-01 -6.807464439994498325e-36 2.027358810256903635e-33 5.511521610893899137e-01 4.627783997385413790e-36 -4.453577401150869010e-34 5.511521610893899137e-01 -2.103444186160364319e-36 3.625286767107592387e-33 5.511521610893899137e-01 -1.942304565660424427e-36 8.117848115817957424e-33 5.511521610893899137e-01 7.781665070946366210e-37 -1.489711957138894375e-33 5.511521610893899137e-01 -1.052205865854580907e-36 -2.260998548010460752e-33 5.511521610893899137e-01 -1.004959322465592115e-36 2.202525955196679834e-33 5.511521610893899137e-01 -1.873117496633209190e-35 2.717541467462236649e-33 5.511521610893899137e-01 -5.530421987235179704e-36 -1.609377956175339294e-33 5.511521610893899137e-01 1.273250780154655654e-34 -1.134677965359366717e-32 5.511521610893899137e-01 8.634172227514183218e-33 1.622107356915102752e-33 5.511521610893899137e-01 -3.510223057793875360e-35 2.227444846913826618e-34 5.511521610893899137e-01 6.116654138661856436e-35 -6.974255266373161154e-34 5.511521610893899137e-01 1.491778143599704412e-34 1.220862751365442332e-33 5.511521610893899137e-01 1.813544644578465992e-34 -3.070621989745760526e-33 5.511521610893899137e-01 2.014139643065488961e-34 -3.990061490866478591e-33 5.511521610893899137e-01 1.891346900461419465e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.103436512901035678e-34 -4.548845259825297636e-33 5.511521610893899137e-01 6.840215552815010651e-35 8.840782518357675480e-33 5.511521610893899137e-01 3.994529136422151354e-35 2.592600399940473664e-33 5.511521610893899137e-01 1.217128198741814571e-35 -1.317025969628458420e-32 5.511521610893899137e-01 -5.014994547500942282e-36 -8.951878579547795097e-34 5.511521610893899137e-01 -6.269868642228042143e-36 1.024008328502186040e-33 5.511521610893899137e-01 -3.577806068910826536e-36 2.814435943849740853e-35 5.511521610893899137e-01 -5.447816640424803865e-36 -5.830181313208050816e-33 5.511521610893899137e-01 -2.839984405307110264e-36 1.533383441508987127e-36 5.511521610893899137e-01 1.090474688602002585e-37 1.419060325234624282e-33 5.511521610893899137e-01 -9.755592473335495052e-37 -4.986826270073553557e-33 5.511521610893899137e-01 1.350119804441656505e-37 1.424401468998474442e-34 5.511521610893899137e-01 -1.279882245548657912e-37 -2.846866755351295910e-33 5.511521610893899137e-01 1.806043725779841565e-37 -1.633434488660336739e-30 4.108497555927242343e-29 5.511521610893899137e-01 -3.226443523490898253e-30 2.879701228411897031e-29 5.511521610893899137e-01 1.872996459437099683e-31 -3.471031043527748243e-28 5.511521610893899137e-01 3.927707757456414859e-30 -2.481093667383957773e-29 5.511521610893899137e-01 1.115107960831865645e-31 -4.762632913372167944e-29 5.511521610893899137e-01 4.120484283053314901e-31 -1.229738330087561511e-30 5.511521610893899137e-01 -1.476804827316818698e-30 -2.349250725256108953e-31 5.511521610893899137e-01 2.247206098713937892e-31 -2.632295029854413973e-31 5.511521610893899137e-01 7.849521353568395954e-33 -6.853875300571520784e-32 5.511521610893899137e-01 1.325538945151555855e-32 5.042636366005646363e-32 5.511521610893899137e-01 -8.066475638589354568e-32 -1.741496396987918913e-32 5.511521610893899137e-01 2.349298806889960130e-31 -4.952225321441334376e-32 5.511521610893899137e-01 7.020652028459235777e-31 -2.274496159051381277e-31 5.511521610893899137e-01 -4.200343067810369111e-31 -2.934756400891602520e-32 5.511521610893899137e-01 9.240359461569142922e-31 -7.004680639043472474e-32 5.511521610893899137e-01 4.663521481165233462e-31 -7.874081032879063418e-32 5.511521610893899137e-01 -1.681391503196031743e-31 3.367824394112691835e-32 5.511521610893899137e-01 -8.769109520231000651e-33 -4.423114634736851793e-34 5.511521610893899137e-01 -1.797211333297436084e-31 8.683608903298879352e-32 5.511521610893899137e-01 6.213757404568850101e-31 2.417623863688217332e-31 5.511521610893899137e-01 -2.471986719052780083e-32 4.071931542710947815e-31 5.511521610893899137e-01 2.796153290459943396e-31 1.684985676746420314e-31 5.511521610893899137e-01 -1.789690272568214350e-32 1.105485205846874332e-30 5.511521610893899137e-01 1.643402474908239138e-32 4.234420612883892009e-32 5.511521610893899137e-01 -9.716741310014274257e-35 -3.751231646865585072e-33 5.511521610893899137e-01 -3.070865982252067423e-33 -4.347655722255821212e-33 5.511521610893899137e-01 -7.368300405582650670e-34 -3.770315149990679562e-33 5.511521610893899137e-01 1.804036459908213617e-34 -1.124669004440334571e-33 5.511521610893899137e-01 -1.429969374971154658e-32 -1.210600831420722146e-32 5.511521610893899137e-01 -5.793325363106860298e-33 -3.563644686314430433e-33 5.511521610893899137e-01 -5.983234717341650964e-35 -1.203738346102274991e-32 5.511521610893899137e-01 -6.379949195047204859e-33 -4.517734930406522923e-33 5.511521610893899137e-01 1.523114619859653715e-34 -6.017506414477635352e-33 5.511521610893899137e-01 -1.738589300108749537e-33 -5.273022156123841947e-33 5.511521610893899137e-01 5.535739266042202676e-34 -3.004637754107670971e-33 5.511521610893899137e-01 -4.183270911100182673e-34 -1.506736213238688689e-33 5.511521610893899137e-01 2.119924900926689598e-33 -5.268156996249509145e-33 5.511521610893899137e-01 -2.717898365592131047e-33 -3.008487371597961645e-33 5.511521610893899137e-01 1.527523580936962022e-33 -5.267266897549702856e-33 5.511521610893899137e-01 -2.000405003634025794e-33 -4.514903266480049337e-33 5.511521610893899137e-01 -5.259197251956479527e-34 -3.310115357268737133e-33 5.511521610893899137e-01 -2.459378625932372757e-33 -3.296914604289640174e-33 5.511521610893899137e-01 -1.300110261878807407e-33 -6.267364190457779761e-33 5.511521610893899137e-01 1.029429459866732799e-33 3.367957535830335866e-33 5.511521610893899137e-01 4.858616868190341274e-34 -4.925158729998654530e-33 5.511521610893899137e-01 4.326676239137077823e-34 -3.324257188981569779e-33 5.511521610893899137e-01 -3.640728615636350653e-33 -3.048166819876651089e-33 5.511521610893899137e-01 5.208516986718054924e-33 -3.110029717844558316e-33 5.511521610893899137e-01 -5.660787037112491821e-34 -6.569433496429826637e-33 5.511521610893899137e-01 4.559203738450610561e-33 -3.008209944190480268e-33 5.511521610893899137e-01 -7.458223354219071687e-33 -4.779712848130612850e-33 5.511521610893899137e-01 3.829379978604814926e-33 -4.821654343892565552e-33 5.511521610893899137e-01 7.844439867260642662e-34 -4.850111208056493643e-33 5.511521610893899137e-01 -1.735572245668321533e-32 -2.997094256117638043e-33 5.511521610893899137e-01 7.642477992654330315e-33 -4.895071493968217538e-33 5.511521610893899137e-01 2.366366155393414663e-34 -4.896326368062944781e-33 5.511521610893899137e-01 4.733625503408135770e-34 -3.389001536437099113e-33 5.511521610893899137e-01 1.307272369824395214e-33 -6.776295277376799899e-33 5.511521610893899137e-01 1.089590271795947122e-33 -4.892896483826023436e-33 5.511521610893899137e-01 -6.457978647149066464e-34 -3.197235586767761803e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386399289615522745e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582633352624366177e-33 5.511521610893899137e-01 1.328261862783616291e-34 -3.291512170526960564e-33 5.511521610893899137e-01 2.406196339113465262e-33 -3.314713464946271998e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 deleted file mode 100644 index 0ea30ab3b..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_11 +++ /dev/null @@ -1 +0,0 @@ -1.807898350714676888e-02 3.164087156628939504e-31 -1.633416496230578585e-30 1.806866389922883245e-02 -1.085177402730688066e-30 7.494088202208559875e-30 1.804784499167345208e-02 2.943044193935160955e-30 1.872996459437099683e-31 1.801616417618827001e-02 -2.278206731471931115e-31 -3.454891334876421243e-30 1.797306941594462026e-02 -7.008030484572618691e-32 1.115099924708597682e-31 1.791780932057515999e-02 5.503833975358133052e-31 4.120484283053314901e-31 1.784941962268379173e-02 3.695619536574259089e-31 4.768020242409573290e-31 1.776670579353104712e-02 1.794294696845283279e-31 2.247187106552825263e-31 1.766822147182208619e-02 -2.101806029569568146e-33 2.074234920256048739e-31 1.755224230196259991e-02 -1.187850347705862894e-31 1.325044731024847447e-32 1.741673469743295136e-02 -1.287101969013600634e-31 -8.066475638589354568e-32 1.725931896381768457e-02 -1.721020222363038698e-31 -4.804142943019735722e-32 1.707722613804758816e-02 4.116877284934018868e-31 -3.005530599726098366e-31 1.686724782032753694e-02 8.251569118972100076e-31 2.447893419825505980e-31 1.662567821338048132e-02 7.609687442100940499e-31 1.414146485298581983e-31 1.634824755155716430e-02 1.005944810315200055e-30 -9.143991931157246912e-31 1.603004610967478927e-02 -2.025567551320680311e-32 -7.768693676076753072e-31 1.566543807725627457e-02 2.530543625126067272e-31 -8.769109520231000651e-33 1.524796480067974573e-02 -2.196476517008808955e-31 -2.245449536730418452e-33 1.477023730992070051e-02 -2.015985131611327998e-31 -4.964367134765074798e-33 1.422381875179584004e-02 2.300798361201171004e-32 -2.470934956624849824e-32 1.359909848579154978e-02 8.888483632181468455e-32 -4.627330560025812967e-32 1.288516134240549546e-02 4.250165951709050658e-32 -1.789851198905880538e-32 1.206965814923045659e-02 6.631065550615756620e-32 1.643402474908239138e-32 1.113868739941329539e-02 -1.343346034488042710e-33 -9.616964867105549433e-35 1.007670325726365765e-02 3.580908177937360760e-33 -3.070865982252067423e-33 8.866472384362347747e-03 -4.229893178473325927e-33 -7.361999755281718030e-34 7.489111744779660372e-03 1.619718331321312422e-33 1.805299369667113984e-34 5.924251894328687665e-03 6.696194665165440143e-33 -6.844055379998046559e-34 4.150385225814744866e-03 -2.586770821341835067e-33 2.398552610057406280e-33 2.145475490328964049e-03 5.357086373903222994e-34 -9.884652779971463384e-34 -1.120783082218002215e-04 4.368465893632683552e-33 2.089587240147885982e-33 -2.445235779882755194e-03 5.058170564180594619e-33 -1.402848117749616632e-33 -4.584788167742536238e-03 6.825148071867091987e-34 -1.738753346508337810e-33 -6.440457486830632357e-03 1.276574816793747093e-32 5.535739266042202676e-34 -7.919385956839759474e-03 -4.453577401150869010e-34 3.372078172375365935e-33 -9.054011913773633846e-03 -1.174948634616024770e-33 2.120153114076909274e-33 -9.999107882856590052e-03 -1.029060331883910940e-32 -7.044674351065770787e-34 -1.069785569919829045e-02 -1.489711957138894375e-33 -4.039535033038970226e-33 -1.094393474885496653e-02 2.089652448082430309e-33 7.187547979216128924e-34 -1.069703533453243531e-02 2.202525955196679834e-33 -5.258286148275195376e-34 -1.020294051514731085e-02 2.716820413326428725e-33 2.873582828387489556e-33 -9.566992572270992604e-03 -1.608652823422668247e-33 -1.299928978690639645e-33 -8.759327159946159527e-03 5.946702174264974085e-33 -3.294218693997060108e-33 -7.637082461672707774e-03 -2.778551053935280230e-33 -6.412473127051169994e-35 -6.226448781884301106e-03 7.861099026261541842e-34 4.322652918887588653e-34 -4.699717127279229648e-03 -9.976743568455591432e-33 1.000210075867870935e-33 -3.344295178355856726e-03 1.220862751365442332e-33 -7.986782734950020645e-33 -2.158407565926498579e-03 -3.070621989745760526e-33 1.922579448072465519e-33 -1.128389263014817215e-03 -2.468750614516272360e-32 4.559203738450610561e-33 -2.341799836408455827e-04 7.236292230237556541e-34 1.678038997592667629e-32 5.528662103220083465e-04 -4.546350488607981187e-33 -1.781984181944427226e-33 1.242905872204948551e-03 8.838074892674237372e-33 7.841055335156345027e-34 1.844552064814121038e-03 2.591133048841808798e-33 1.307493830297766321e-32 2.365884115890789108e-03 3.745365848506935549e-32 -5.013699835248945461e-33 2.814317849649910098e-03 -8.943337308632567126e-34 1.008685729852643024e-32 3.193632196235244268e-03 1.024008328502186040e-33 4.733625503408135770e-34 3.500425995620083490e-03 2.765695988467439920e-35 1.307028670047483771e-33 3.744102214241160857e-03 -5.830181313208050816e-33 3.795026811194313807e-33 3.933781778921634567e-03 1.398170179618489839e-36 -6.458654713458518731e-34 4.076889628583571686e-03 1.419200972308698315e-33 1.633921684055722715e-33 4.179243107111789077e-03 -1.161109502551565378e-33 -3.511043810920364783e-34 4.245130555095284579e-03 1.424401468998474442e-34 -2.294988601259996621e-34 4.277374284242677592e-03 1.037791607864249507e-33 -2.935218250943761834e-33 3.164087156628939504e-31 5.511521610893899137e-01 4.109657743165264764e-29 -1.085177402730688066e-30 5.511521610893899137e-01 2.885145373872302969e-29 2.943044193935160955e-30 5.511521610893899137e-01 -3.470945509031821367e-28 -2.278206731471931115e-31 5.511521610893899137e-01 -2.480857242293348698e-29 -7.008030484572618691e-32 5.511521610893899137e-01 -4.762611114854708221e-29 5.503833975358133052e-31 5.511521610893899137e-01 -1.223087042232672510e-30 3.695619536574259089e-31 5.511521610893899137e-01 -2.349192607244107049e-31 1.794294696845283279e-31 5.511521610893899137e-01 -2.633386978933868415e-31 -2.101806029569568146e-33 5.511521610893899137e-01 -6.853875663589955556e-32 -1.187850347705862894e-31 5.511521610893899137e-01 5.020390860180797741e-32 -1.287101969013600634e-31 5.511521610893899137e-01 6.705522407871147028e-33 -1.721020222363038698e-31 5.511521610893899137e-01 -4.946977979766468472e-32 4.116877284934018868e-31 5.511521610893899137e-01 -2.285123633122857078e-31 8.251569118972100076e-31 5.511521610893899137e-01 -2.932005168519828988e-32 7.609687442100940499e-31 5.511521610893899137e-01 -4.595746991405747641e-32 1.005944810315200055e-30 5.511521610893899137e-01 -3.103556214498266342e-32 -2.025567551320680311e-32 5.511521610893899137e-01 8.200659092102597744e-32 2.530543625126067272e-31 5.511521610893899137e-01 -5.648955651447502683e-34 -2.196476517008808955e-31 5.511521610893899137e-01 6.277576031198777625e-32 -2.015985131611327998e-31 5.511521610893899137e-01 2.297416258213689087e-31 2.300798361201171004e-32 5.511521610893899137e-01 3.950100225522453649e-31 8.888483632181468455e-32 5.511521610893899137e-01 1.699388288588661400e-31 4.250165951709050658e-32 5.511521610893899137e-01 1.108483037972520292e-30 6.631065550615756620e-32 5.511521610893899137e-01 4.835133363197374688e-32 -1.343346034488042710e-33 5.511521610893899137e-01 7.614278649692538268e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.340520585744010067e-33 -4.229893178473325927e-33 5.511521610893899137e-01 -7.620634576702095600e-34 1.619718331321312422e-33 5.511521610893899137e-01 3.799501454021552274e-34 6.696194665165440143e-33 5.511521610893899137e-01 -6.844469744338379922e-35 -2.586770821341835067e-33 5.511521610893899137e-01 1.972319209519752623e-34 5.357086373903222994e-34 5.511521610893899137e-01 -3.187551514779025548e-37 4.368465893632683552e-33 5.511521610893899137e-01 -3.559780924178211243e-36 5.058170564180594619e-33 5.511521610893899137e-01 1.185501001400141567e-36 6.825148071867091987e-34 5.511521610893899137e-01 -6.782731506363316528e-36 1.276574816793747093e-32 5.511521610893899137e-01 4.057262763278559551e-36 -4.453577401150869010e-34 5.511521610893899137e-01 -2.066384445995679206e-36 -1.174948634616024770e-33 5.511521610893899137e-01 -2.016992308839736954e-36 -1.029060331883910940e-32 5.511521610893899137e-01 7.897034933096438817e-37 -1.489711957138894375e-33 5.511521610893899137e-01 -1.043001572900672219e-36 2.089652448082430309e-33 5.511521610893899137e-01 -1.005124041821692210e-36 2.202525955196679834e-33 5.511521610893899137e-01 -1.864850531132053407e-35 2.716820413326428725e-33 5.511521610893899137e-01 -5.558882078715272679e-36 -1.608652823422668247e-33 5.511521610893899137e-01 1.275054062324360197e-34 5.946702174264974085e-33 5.511521610893899137e-01 8.634235909547083279e-33 -2.778551053935280230e-33 5.511521610893899137e-01 -3.513139224067612572e-35 7.861099026261541842e-34 5.511521610893899137e-01 6.116757199542155306e-35 -9.976743568455591432e-33 5.511521610893899137e-01 1.493682528374880229e-34 1.220862751365442332e-33 5.511521610893899137e-01 1.814495738953533586e-34 -3.070621989745760526e-33 5.511521610893899137e-01 2.019104036917194080e-34 -2.468750614516272360e-32 5.511521610893899137e-01 1.900263619891314077e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.108566490758971427e-34 -4.546350488607981187e-33 5.511521610893899137e-01 6.929884466890864023e-35 8.838074892674237372e-33 5.511521610893899137e-01 4.071152385272870367e-35 2.591133048841808798e-33 5.511521610893899137e-01 1.280970066895145672e-35 3.745365848506935549e-32 5.511521610893899137e-01 -4.466079480629635055e-36 -8.943337308632567126e-34 5.511521610893899137e-01 -5.987062872395923697e-36 1.024008328502186040e-33 5.511521610893899137e-01 -3.487730966093527857e-36 2.765695988467439920e-35 5.511521610893899137e-01 -5.314315827064846505e-36 -5.830181313208050816e-33 5.511521610893899137e-01 -2.815436833467863152e-36 1.398170179618489839e-36 5.511521610893899137e-01 1.226775310931167321e-37 1.419200972308698315e-33 5.511521610893899137e-01 -9.607600860769337638e-37 -1.161109502551565378e-33 5.511521610893899137e-01 1.318364315615816114e-37 1.424401468998474442e-34 5.511521610893899137e-01 -1.281081110800922931e-37 1.037791607864249507e-33 5.511521610893899137e-01 1.803045135776986878e-37 -1.633416496230578585e-30 4.109055890057643752e-29 5.511521610893899137e-01 7.494088202208559875e-30 2.880330549011334879e-29 5.511521610893899137e-01 1.872996459437099683e-31 -3.471005694342583469e-28 5.511521610893899137e-01 -3.454891334876421243e-30 -2.480857242293348698e-29 5.511521610893899137e-01 1.115099924708597682e-31 -4.762611114854708221e-29 5.511521610893899137e-01 4.120484283053314901e-31 -1.229105573308882622e-30 5.511521610893899137e-01 4.768020242409573290e-31 -2.349192607244107049e-31 5.511521610893899137e-01 2.247187106552825263e-31 -2.633386978933868415e-31 5.511521610893899137e-01 2.074234920256048739e-31 -6.853875663589955556e-32 5.511521610893899137e-01 1.325044731024847447e-32 5.020390860180797741e-32 5.511521610893899137e-01 -8.066475638589354568e-32 -1.736860189696929840e-32 5.511521610893899137e-01 -4.804142943019735722e-32 -4.946977979766468472e-32 5.511521610893899137e-01 -3.005530599726098366e-31 -2.285123633122857078e-31 5.511521610893899137e-01 2.447893419825505980e-31 -2.932005168519828988e-32 5.511521610893899137e-01 1.414146485298581983e-31 -7.003159421889791910e-32 5.511521610893899137e-01 -9.143991931157246912e-31 -7.918381075466355974e-32 5.511521610893899137e-01 -7.768693676076753072e-31 3.385834231134508659e-32 5.511521610893899137e-01 -8.769109520231000651e-33 -5.648955651447502683e-34 5.511521610893899137e-01 -2.245449536730418452e-33 8.684988461682822442e-32 5.511521610893899137e-01 -4.964367134765074798e-33 2.417786879737891327e-31 5.511521610893899137e-01 -2.470934956624849824e-32 4.070470847046655890e-31 5.511521610893899137e-01 -4.627330560025812967e-32 1.684341960898136120e-31 5.511521610893899137e-01 -1.789851198905880538e-32 1.105473772434415236e-30 5.511521610893899137e-01 1.643402474908239138e-32 4.233280255576364031e-32 5.511521610893899137e-01 -9.616964867105549433e-35 -3.752470442188330289e-33 5.511521610893899137e-01 -3.070865982252067423e-33 -4.349786123849065575e-33 5.511521610893899137e-01 -7.361999755281718030e-34 -3.771328995775264554e-33 5.511521610893899137e-01 1.805299369667113984e-34 -1.124682623650372954e-33 5.511521610893899137e-01 -6.844055379998046559e-34 -1.210550684986360809e-32 5.511521610893899137e-01 2.398552610057406280e-33 -3.564350001679344122e-33 5.511521610893899137e-01 -9.884652779971463384e-34 -1.203738090757170156e-32 5.511521610893899137e-01 2.089587240147885982e-33 -4.517458088081762399e-33 5.511521610893899137e-01 -1.402848117749616632e-33 -6.017345575208711032e-33 5.511521610893899137e-01 -1.738753346508337810e-33 -5.272997423190210744e-33 5.511521610893899137e-01 5.535739266042202676e-34 -3.005208275341777679e-33 5.511521610893899137e-01 3.372078172375365935e-33 -1.506699153498524000e-33 5.511521610893899137e-01 2.120153114076909274e-33 -5.268231683992688379e-33 5.511521610893899137e-01 -7.044674351065770787e-34 -3.008475834611746704e-33 5.511521610893899137e-01 -4.039535033038970226e-33 -5.267257693256748681e-33 5.511521610893899137e-01 7.187547979216128924e-34 -4.514903431199405683e-33 5.511521610893899137e-01 -5.258286148275195376e-34 -3.310032687613725556e-33 5.511521610893899137e-01 2.873582828387489556e-33 -3.296943064381120443e-33 5.511521610893899137e-01 -1.299928978690639645e-33 -6.267183862240808815e-33 5.511521610893899137e-01 -3.294218693997060108e-33 3.368021217863236612e-33 5.511521610893899137e-01 -6.412473127051169994e-35 -4.925187891661391929e-33 5.511521610893899137e-01 4.322652918887588653e-34 -3.324256158372766801e-33 5.511521610893899137e-01 1.000210075867870935e-33 -3.047976381399133336e-33 5.511521610893899137e-01 -7.986782734950020645e-33 -3.109934608407051386e-33 5.511521610893899137e-01 1.922579448072465519e-33 -6.568937057044656296e-33 5.511521610893899137e-01 4.559203738450610561e-33 -3.007318272247490892e-33 5.511521610893899137e-01 1.678038997592667629e-32 -4.779199850344819575e-33 5.511521610893899137e-01 -1.781984181944427226e-33 -4.820757654751807318e-33 5.511521610893899137e-01 7.841055335156345027e-34 -4.849344975567986720e-33 5.511521610893899137e-01 1.307493830297766321e-32 -2.996455837436104780e-33 5.511521610893899137e-01 -5.013699835248945461e-33 -4.894522578901346243e-33 5.511521610893899137e-01 1.008685729852643024e-32 -4.896043562293112846e-33 5.511521610893899137e-01 4.733625503408135770e-34 -3.388911461334281973e-33 5.511521610893899137e-01 1.307028670047483771e-33 -6.776161776563440342e-33 5.511521610893899137e-01 3.795026811194313807e-33 -4.892871936254183886e-33 5.511521610893899137e-01 -6.458654713458518731e-34 -3.197221956705529112e-33 5.511521610893899137e-01 1.633921684055722715e-33 -3.386384490454265902e-33 5.511521610893899137e-01 -3.511043810920364783e-34 -6.582636528173249226e-33 5.511521610893899137e-01 -2.294988601259996621e-34 -3.291512290413485851e-33 5.511521610893899137e-01 -2.935218250943761834e-33 -3.314713764805272361e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 deleted file mode 100644 index 8353ca88d..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_12 +++ /dev/null @@ -1 +0,0 @@ -1.808049300835544090e-02 -8.599641799148956268e-31 -2.171187442256295323e-30 1.807020072673284211e-02 -5.568486383432259574e-31 -9.591720279908338638e-31 1.804943698591649978e-02 1.366267224799299344e-31 -8.332161415958349168e-31 1.801784021813360864e-02 -2.278206731471931115e-31 -5.979171609110400104e-32 1.797485996999861196e-02 -1.887837580472879059e-30 1.115020033298263228e-31 1.791974701224428868e-02 5.503833975358133052e-31 4.120484283053314901e-31 1.785153985879996130e-02 -5.925964068023183471e-31 4.767905640314831142e-31 1.776904743545236823e-02 1.794306486146191807e-31 -1.171837159237190224e-30 1.767082757938890497e-02 -2.103718332580223764e-33 2.074234920256048739e-31 1.755516096108914598e-02 9.234921404436402118e-32 -5.497726832929538147e-31 1.742001994464114148e-02 3.730663299175025575e-31 4.211142054966477855e-31 1.726303183194934782e-02 -1.721020222363038698e-31 -4.803374769736571476e-32 1.708143583723383332e-02 -1.167001346883324908e-30 -3.005651120462601188e-31 1.687203307842673194e-02 -1.965929531133735490e-30 2.447893419825505980e-31 1.663112880039913435e-02 7.609540655960419366e-31 -1.398540769601704723e-30 1.635446600905215292e-02 1.005944810315200055e-30 7.155411897022206758e-31 1.603714971144631907e-02 -1.400065657134950680e-31 4.206461915989356279e-31 1.567356104324097929e-02 -1.692244500116344924e-31 -4.310341256901685359e-31 1.525726078036251585e-02 -3.348129764458791701e-32 -4.878770846635657439e-32 1.478088214333261527e-02 -2.016152101684308155e-31 7.715673257175165246e-32 1.423601349773071650e-02 2.300798361201171004e-32 -2.470934956624849824e-32 1.361307267816807588e-02 -1.674523423958381644e-31 1.780717635338882441e-32 1.290117639479585951e-02 -7.092867443543458901e-32 1.045807607701798291e-32 1.208801075793203283e-02 6.630752679570818016e-32 -2.418020063675367683e-33 1.115971270291740182e-02 -1.250665132973134301e-32 1.106651865075644844e-32 1.010077737207093658e-02 3.580908177937360760e-33 -3.071843828424299543e-33 8.894013751669977222e-03 -2.196826422691738474e-32 1.480999027557153089e-33 7.520580473713100664e-03 1.620030586559512797e-33 1.805299369667113984e-34 5.960145971441407377e-03 3.128081550439510515e-33 -6.839012466967552953e-34 4.191232078798090045e-03 -2.586360155762359490e-33 -1.626366365362976753e-35 2.191816967794502601e-03 5.358774965240956296e-34 -9.884652779971463384e-34 -5.970989411820957278e-05 -9.573720071873773816e-34 2.089587240147885982e-33 -2.395531108363500687e-03 1.685903287053252669e-34 8.377259487386970603e-33 -4.540029186260710094e-03 -1.579085590581463009e-33 -1.738753346508337810e-33 -6.402758975146515333e-03 1.068778850751994032e-34 5.532212823642319418e-34 -7.890909337164631054e-03 1.540155012718818776e-33 -4.570441350474050560e-33 -9.030288366418117232e-03 -4.946695938107116112e-33 -5.423341492905273067e-33 -9.979822077998657184e-03 2.815828623373947060e-33 -7.047263589159705411e-34 -1.068636538433350575e-02 2.595763068918823541e-34 2.957739242581670439e-33 -1.094391114107849845e-02 3.809592675781491216e-34 -1.355917358566239833e-34 -1.070689125123828501e-02 2.202525955196679834e-33 1.158718970346610369e-33 -1.021640625938967546e-02 -4.243473683035807763e-34 2.873360467457380368e-33 -9.583927954247995623e-03 5.110750436635113920e-33 3.799497835324140372e-34 -8.782814920058321095e-03 -4.237947510922356087e-33 -3.294218693997060108e-33 -7.668733745893299876e-03 6.762875586055641711e-34 3.390418358490274939e-33 -6.265408296724456726e-03 4.324234081320919057e-33 -6.644478983109389781e-33 -4.737204971693676978e-03 9.512731866155993410e-34 1.910878138790470166e-33 -3.378035675202108786e-03 -2.545461970618675541e-33 -7.986220848522751409e-33 -2.188655240270969641e-03 -6.976508122184772554e-33 1.922579448072465519e-33 -1.155434781506194932e-03 3.215537096979999750e-32 -1.168077866204217208e-32 -2.587810852476532032e-04 7.236292230237556541e-34 -1.261164683041430576e-34 5.302733598160939629e-04 4.259037289682987288e-33 -1.781984181944427226e-33 1.222116873000205850e-03 8.838074892674237372e-33 7.836889095571482092e-34 1.825366943555350096e-03 1.213947785353023409e-32 -6.022654265858707436e-33 2.348110809334531292e-03 -2.254589050892284361e-33 1.484060692398300465e-32 2.797774220140504618e-03 -6.044554382815318951e-33 -2.138467114223242564e-34 3.178543277687884659e-03 -9.637833410583793140e-33 4.730810941559429197e-34 3.486815834211615898e-03 -2.723023173744822966e-33 1.307028670047483771e-33 3.731703777774010404e-03 -1.731176813553256759e-34 -1.862195290702442877e-33 3.922353425706458750e-03 1.439733535640175535e-36 -1.931807769454129713e-34 4.066211236036011180e-03 -5.813563553716515512e-35 1.633921684055722715e-33 4.169111920063873697e-03 7.134942201190782385e-34 -1.850738357405418545e-33 4.235356895868877362e-03 1.424401468998474442e-34 -2.295215902285943341e-34 4.267777205671297210e-03 -4.849344729846970522e-34 3.155731999946545439e-33 -8.599641799148956268e-31 5.511521610893899137e-01 4.109657377430108723e-29 -5.568486383432259574e-31 5.511521610893899137e-01 2.885100398704818831e-29 1.366267224799299344e-31 5.511521610893899137e-01 -3.470945271411379413e-28 -2.278206731471931115e-31 5.511521610893899137e-01 -2.480876765937088468e-29 -1.887837580472879059e-30 5.511521610893899137e-01 -4.762672524644159012e-29 5.503833975358133052e-31 5.511521610893899137e-01 -1.225489263839405105e-30 -5.925964068023183471e-31 5.511521610893899137e-01 -2.351251394254347108e-31 1.794306486146191807e-31 5.511521610893899137e-01 -2.634432424339563338e-31 -2.103718332580223764e-33 5.511521610893899137e-01 -6.863125289067424982e-32 9.234921404436402118e-32 5.511521610893899137e-01 5.019022658768176772e-32 3.730663299175025575e-31 5.511521610893899137e-01 6.757962030077996172e-33 -1.721020222363038698e-31 5.511521610893899137e-01 -4.981690596607500101e-32 -1.167001346883324908e-30 5.511521610893899137e-01 -2.280319271643018501e-31 -1.965929531133735490e-30 5.511521610893899137e-01 -2.857908166246436197e-32 7.609540655960419366e-31 5.511521610893899137e-01 -4.552035108546792752e-32 1.005944810315200055e-30 5.511521610893899137e-01 -3.046164362969508274e-32 -1.400065657134950680e-31 5.511521610893899137e-01 8.198338919343348862e-32 -1.692244500116344924e-31 5.511521610893899137e-01 -8.062741753608699670e-34 -3.348129764458791701e-32 5.511521610893899137e-01 6.279054914775583248e-32 -2.016152101684308155e-31 5.511521610893899137e-01 2.298040587565372493e-31 2.300798361201171004e-32 5.511521610893899137e-01 3.949305773339509325e-31 -1.674523423958381644e-31 5.511521610893899137e-01 1.698935637602325669e-31 -7.092867443543458901e-32 5.511521610893899137e-01 1.108475974110627382e-30 6.630752679570818016e-32 5.511521610893899137e-01 4.835219933365242761e-32 -1.250665132973134301e-32 5.511521610893899137e-01 7.617299082421310695e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.341055609562289724e-33 -2.196826422691738474e-32 5.511521610893899137e-01 -7.621895919763526682e-34 1.620030586559512797e-33 5.511521610893899137e-01 3.798530281652419897e-34 3.128081550439510515e-33 5.511521610893899137e-01 -6.823140351494685930e-35 -2.586360155762359490e-33 5.511521610893899137e-01 1.972015208087545774e-34 5.358774965240956296e-34 5.511521610893899137e-01 -3.456816830640966395e-37 -9.573720071873773816e-34 5.511521610893899137e-01 -3.401145554541274151e-36 1.685903287053252669e-34 5.511521610893899137e-01 1.343103788274969003e-36 -1.579085590581463009e-33 5.511521610893899137e-01 -6.746788727172931583e-36 1.068778850751994032e-34 5.511521610893899137e-01 4.201856183642599110e-36 1.540155012718818776e-33 5.511521610893899137e-01 -2.079391535760816513e-36 -4.946695938107116112e-33 5.511521610893899137e-01 -2.058949375060042808e-36 2.815828623373947060e-33 5.511521610893899137e-01 8.004613669090264608e-37 2.595763068918823541e-34 5.511521610893899137e-01 -1.025774173730979307e-36 3.809592675781491216e-34 5.511521610893899137e-01 -1.005127651228756316e-36 2.202525955196679834e-33 5.511521610893899137e-01 -1.865784038041425504e-35 -4.243473683035807763e-34 5.511521610893899137e-01 -5.554513729021185886e-36 5.110750436635113920e-33 5.511521610893899137e-01 1.275131824024549165e-34 -4.237947510922356087e-33 5.511521610893899137e-01 8.634193228327318161e-33 6.762875586055641711e-34 5.511521610893899137e-01 -3.511568506160065083e-35 4.324234081320919057e-33 5.511521610893899137e-01 6.130209384222094880e-35 9.512731866155993410e-34 5.511521610893899137e-01 1.493488194050706158e-34 -2.545461970618675541e-33 5.511521610893899137e-01 1.812659198859070774e-34 -6.976508122184772554e-33 5.511521610893899137e-01 2.018043766276871302e-34 3.215537096979999750e-32 5.511521610893899137e-01 1.897659006442553832e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.103884412602426144e-34 4.259037289682987288e-33 5.511521610893899137e-01 6.896391779800071623e-35 8.838074892674237372e-33 5.511521610893899137e-01 4.041030714485907757e-35 1.213947785353023409e-32 5.511521610893899137e-01 1.246584563798026085e-35 -2.254589050892284361e-33 5.511521610893899137e-01 -4.589478324265958347e-36 -6.044554382815318951e-33 5.511521610893899137e-01 -6.155605437541054197e-36 -9.637833410583793140e-33 5.511521610893899137e-01 -3.586280290213180093e-36 -2.723023173744822966e-33 5.511521610893899137e-01 -5.334956423506742484e-36 -1.731176813553256759e-34 5.511521610893899137e-01 -2.847473582909621120e-36 1.439733535640175535e-36 5.511521610893899137e-01 1.224824418993808297e-37 -5.813563553716515512e-35 5.511521610893899137e-01 -9.669854168175094939e-37 7.134942201190782385e-34 5.511521610893899137e-01 1.330156366588775914e-37 1.424401468998474442e-34 5.511521610893899137e-01 -1.265837804008855066e-37 -4.849344729846970522e-34 5.511521610893899137e-01 1.752197238202174692e-37 -2.171187442256295323e-30 4.109055524322487712e-29 5.511521610893899137e-01 -9.591720279908338638e-31 2.880285573843850741e-29 5.511521610893899137e-01 -8.332161415958349168e-31 -3.471005456722141514e-28 5.511521610893899137e-01 -5.979171609110400104e-32 -2.480876765937088468e-29 5.511521610893899137e-01 1.115020033298263228e-31 -4.762672524644159012e-29 5.511521610893899137e-01 4.120484283053314901e-31 -1.231507794915615217e-30 5.511521610893899137e-01 4.767905640314831142e-31 -2.351251394254347108e-31 5.511521610893899137e-01 -1.171837159237190224e-30 -2.634432424339563338e-31 5.511521610893899137e-01 2.074234920256048739e-31 -6.863125289067424982e-32 5.511521610893899137e-01 -5.497726832929538147e-31 5.019022658768176772e-32 5.511521610893899137e-01 4.211142054966477855e-31 -1.731616227476244925e-32 5.511521610893899137e-01 -4.803374769736571476e-32 -4.981690596607500101e-32 5.511521610893899137e-01 -3.005651120462601188e-31 -2.280319271643018501e-31 5.511521610893899137e-01 2.447893419825505980e-31 -2.857908166246436197e-32 5.511521610893899137e-01 -1.398540769601704723e-30 -6.959447539030837021e-32 5.511521610893899137e-01 7.155411897022206758e-31 -7.860989223937597359e-32 5.511521610893899137e-01 4.206461915989356279e-31 3.383514058375259230e-32 5.511521610893899137e-01 -4.310341256901685359e-31 -8.062741753608699670e-34 5.511521610893899137e-01 -4.878770846635657439e-32 8.686467345259628065e-32 5.511521610893899137e-01 7.715673257175165246e-32 2.418411209089574734e-31 5.511521610893899137e-01 -2.470934956624849824e-32 4.069676394863711565e-31 5.511521610893899137e-01 1.780717635338882441e-32 1.683889309911800389e-31 5.511521610893899137e-01 1.045807607701798291e-32 1.105466708572522326e-30 5.511521610893899137e-01 -2.418020063675367683e-33 4.233366825744232104e-32 5.511521610893899137e-01 1.106651865075644844e-32 -3.752168398915452961e-33 5.511521610893899137e-01 -3.071843828424299543e-33 -4.350321147667345402e-33 5.511521610893899137e-01 1.480999027557153089e-33 -3.771455130081407833e-33 5.511521610893899137e-01 1.805299369667113984e-34 -1.124779740887286192e-33 5.511521610893899137e-01 -6.839012466967552953e-34 -1.210529355593517070e-32 5.511521610893899137e-01 -1.626366365362976753e-35 -3.564380401822564721e-33 5.511521610893899137e-01 -9.884652779971463384e-34 -1.203740783410328717e-32 5.511521610893899137e-01 2.089587240147885982e-33 -4.517299452712125446e-33 5.511521610893899137e-01 8.377259487386970603e-33 -6.017187972421836528e-33 5.511521610893899137e-01 -1.738753346508337810e-33 -5.272961480411020339e-33 5.511521610893899137e-01 5.532212823642319418e-34 -3.005063681921413516e-33 5.511521610893899137e-01 -4.570441350474050560e-33 -1.506712160588289200e-33 5.511521610893899137e-01 -5.423341492905273067e-33 -5.268273641058908974e-33 5.511521610893899137e-01 -7.047263589159705411e-34 -3.008465076738147456e-33 5.511521610893899137e-01 2.957739242581670439e-33 -5.267240465857579302e-33 5.511521610893899137e-01 -1.355917358566239833e-34 -4.514903434808812519e-33 5.511521610893899137e-01 1.158718970346610369e-33 -3.310042022682819229e-33 5.511521610893899137e-01 2.873360467457380368e-33 -3.296938696031426590e-33 5.511521610893899137e-01 3.799497835324140372e-34 -6.267176086070790453e-33 5.511521610893899137e-01 -3.294218693997060108e-33 3.367978536643471494e-33 5.511521610893899137e-01 3.390418358490274939e-33 -4.925172184482316219e-33 5.511521610893899137e-01 -6.644478983109389781e-33 -3.324121636525967470e-33 5.511521610893899137e-01 1.910878138790470166e-33 -3.047995814831550743e-33 5.511521610893899137e-01 -7.986220848522751409e-33 -3.110118262416497581e-33 5.511521610893899137e-01 1.922579448072465519e-33 -6.569043084108688189e-33 5.511521610893899137e-01 -1.168077866204217208e-32 -3.007578733592366767e-33 5.511521610893899137e-01 -1.261164683041430576e-34 -4.779668058160473953e-33 5.511521610893899137e-01 -1.781984181944427226e-33 -4.821092581622715210e-33 5.511521610893899137e-01 7.836889095571482092e-34 -4.849646192275856426e-33 5.511521610893899137e-01 -6.022654265858707436e-33 -2.996799692467076064e-33 5.511521610893899137e-01 1.484060692398300465e-32 -4.894645977744982411e-33 5.511521610893899137e-01 -2.138467114223242564e-34 -4.896212104858258278e-33 5.511521610893899137e-01 4.730810941559429197e-34 -3.389010010658401813e-33 5.511521610893899137e-01 1.307028670047483771e-33 -6.776182417159882705e-33 5.511521610893899137e-01 -1.862195290702442877e-33 -4.892903973003625720e-33 5.511521610893899137e-01 -1.931807769454129713e-34 -3.197222151794722800e-33 5.511521610893899137e-01 1.633921684055722715e-33 -3.386390715785006288e-33 5.511521610893899137e-01 -1.850738357405418545e-33 -6.582635348968152236e-33 5.511521610893899137e-01 -2.295215902285943341e-34 -3.291510766082806982e-33 5.511521610893899137e-01 3.155731999946545439e-33 -3.314718849595029814e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 deleted file mode 100644 index 57f24b9c9..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.798183811423135353e-02 6.122348544044080192e-31 -2.063629275944806903e-31 1.796797785409042988e-02 -6.101898276721323203e-31 -1.612340688517690275e-31 1.793998761800792013e-02 -3.385170637274411837e-31 5.070691472790853531e-32 1.789732230596942711e-02 -1.223327315013582227e-31 -6.493970514461556998e-31 1.783914996705431716e-02 1.489584030680479503e-31 3.263199516953179408e-32 1.776433427249787117e-02 8.847229865814432269e-31 4.611758674846738442e-31 1.767141052974850746e-02 9.860191375349637258e-31 9.078813092456368596e-31 1.755855469600759930e-02 -3.993663668192157022e-31 -3.707996154977914111e-31 1.742354469980607334e-02 -4.241218514648545116e-34 2.108009668548692463e-32 1.726371322276509107e-02 -1.333839942311332102e-31 3.993801553493286858e-32 1.707589093379265066e-02 -7.454605185168855880e-32 1.062959870656067884e-32 1.685633901119188219e-02 1.116391988804065522e-32 -6.006480808485334302e-32 1.660066964731259781e-02 4.923740116643441041e-32 1.256006704479162178e-31 1.630375312757224859e-02 1.399321707781484506e-31 -4.518253458164972514e-31 1.595961004695052587e-02 2.789384104313185699e-34 5.967450787270980854e-31 1.556128733010373605e-02 5.815928248263278141e-31 6.173729352556617726e-33 1.510071704414081561e-02 -4.284405479207655328e-32 3.544799661415376388e-31 1.456855766894174162e-02 6.061104415617773346e-34 3.644749446659820287e-31 1.395401871329038021e-02 0.000000000000000000e+00 -2.126442401779329327e-31 1.324467161496615045e-02 -1.134415308057596725e-31 -2.345104402179759659e-33 1.242625312571369461e-02 3.488990675909715679e-34 1.082847778143033712e-30 1.148247237661566798e-02 7.332611161745850011e-33 1.612490047844318588e-32 1.039484053574663003e-02 2.929500813919224937e-33 8.234413684688681770e-31 9.142607594014176900e-03 -6.631357895429931702e-31 0.000000000000000000e+00 7.702913748454134207e-03 1.082115334335678803e-32 -8.000032744833821776e-33 6.051207372212138134e-03 3.918769778285902730e-34 3.104545484164111282e-35 4.162060342863257295e-03 7.328078595823150219e-33 -2.416545279417239897e-32 2.010272330948578018e-03 -2.878824290464192714e-33 -3.135737510824985075e-32 -4.168044749976156788e-04 -3.341285563626358694e-35 3.864704053203938971e-34 -2.866776619648636788e-03 2.123622996929380622e-32 2.612014865111965016e-32 -5.073764788738598444e-03 -4.642320850000695198e-33 3.273138538184421415e-33 -6.928542448036343476e-03 5.914329158110691341e-33 6.208026473930686349e-34 -8.351255126143436111e-03 -1.626846619618110428e-33 -1.702873565918794262e-36 -9.470803741030937861e-03 9.982341035939150454e-34 7.216310297474077933e-33 -1.035472846679208470e-02 1.173308150297919173e-32 -1.065165917815147210e-36 -1.084926458569601682e-02 5.479425983855504195e-33 1.849795887944143741e-34 -1.081013237403952859e-02 1.501138946694587754e-33 -6.208055981355432556e-34 -1.037323237556274369e-02 -1.231280023802430984e-32 -7.338738634976246674e-34 -9.743963813557748530e-03 -9.693570785691527172e-33 3.455715350518089336e-35 -8.918588907511007177e-03 -1.298026380528296206e-35 -1.971908283206304609e-33 -7.777493995230210649e-03 -9.387860452234622834e-33 3.259607522410052804e-33 -6.301489311212999343e-03 1.995824295780086024e-33 -6.025559036107633817e-33 -4.697553134891576353e-03 9.927091983699431391e-34 -1.946778018444609176e-35 -3.220713035295743806e-03 0.000000000000000000e+00 -4.737407014413756140e-33 -1.929302204997196011e-03 -5.738844034805634475e-34 -2.804627774709108475e-34 -8.053299490783354803e-04 -1.723178377449637606e-33 -1.221626287900307221e-33 1.791819796332395909e-04 2.311903151836662979e-33 2.100410730294778288e-33 1.048160720869014025e-03 7.156865239912921430e-33 -4.100020164959082116e-35 1.814359597779304986e-03 1.186440986346068982e-34 1.246768181232042828e-33 2.487087492642727198e-03 -1.628371341703527747e-34 1.149483803378053866e-32 3.067872393967137692e-03 -2.281006205946655939e-32 4.375523941046185762e-35 3.555551866091283871e-03 -3.163210759461825720e-32 1.108452960098921929e-32 3.953748886483041472e-03 0.000000000000000000e+00 3.638178048489731707e-33 4.273574150943893271e-03 -1.166391929881695717e-34 0.000000000000000000e+00 4.528128328414583910e-03 0.000000000000000000e+00 -2.409378201690617302e-36 4.728779898374679998e-03 1.120582123131089114e-32 -6.697534012546389907e-36 4.885261569205448517e-03 -3.908947354900799352e-36 -3.233952536463438536e-37 5.005736890203004406e-03 -2.113138846585561356e-35 -2.272528782731722383e-33 5.096806488930366412e-03 -7.054039988462939767e-35 -2.877816604985414113e-33 5.164061913162622947e-03 0.000000000000000000e+00 -4.889410545885136790e-34 5.212196062226516144e-03 -2.916353354825908871e-33 -2.996592268956474661e-34 5.244981725402745806e-03 4.843162144919647471e-34 7.050516753101862712e-34 5.265257889180871044e-03 4.838256186334363906e-37 -1.726450071677988945e-36 5.274921237608814692e-03 -7.375181793003856945e-34 5.333266878240635817e-35 6.122348544044080192e-31 5.511521610893899137e-01 7.290301753470531539e-32 -6.101898276721323203e-31 5.511521610893899137e-01 2.052075703451992891e-32 -3.385170637274411837e-31 5.511521610893899137e-01 -7.936379925821067502e-35 -1.223327315013582227e-31 5.511521610893899137e-01 -3.257828496583015078e-32 1.489584030680479503e-31 5.511521610893899137e-01 3.350929661161666969e-33 8.847229865814432269e-31 5.511521610893899137e-01 -5.405481763327431915e-33 9.860191375349637258e-31 5.511521610893899137e-01 -2.427143490458209002e-32 -3.993663668192157022e-31 5.511521610893899137e-01 -1.005214785246823979e-32 -4.241218514648545116e-34 5.511521610893899137e-01 -5.565508141517109443e-33 -1.333839942311332102e-31 5.511521610893899137e-01 -2.281701216058222731e-32 -7.454605185168855880e-32 5.511521610893899137e-01 3.404451926431939346e-33 1.116391988804065522e-32 5.511521610893899137e-01 6.054374322309786519e-34 4.923740116643441041e-32 5.511521610893899137e-01 1.846752820246126828e-33 1.399321707781484506e-31 5.511521610893899137e-01 -1.185676347230074322e-32 2.789384104313185699e-34 5.511521610893899137e-01 -1.880252533982346097e-32 5.815928248263278141e-31 5.511521610893899137e-01 -4.949444060748510347e-32 -4.284405479207655328e-32 5.511521610893899137e-01 6.825816436612319595e-32 6.061104415617773346e-34 5.511521610893899137e-01 6.844193557718299278e-32 0.000000000000000000e+00 5.511521610893899137e-01 6.946519394136355429e-32 -1.134415308057596725e-31 5.511521610893899137e-01 2.540984558187787890e-31 3.488990675909715679e-34 5.511521610893899137e-01 4.002915002779924867e-31 7.332611161745850011e-33 5.511521610893899137e-01 1.721097688083060774e-31 2.929500813919224937e-33 5.511521610893899137e-01 1.108866946010025268e-30 -6.631357895429931702e-31 5.511521610893899137e-01 4.857711625976752462e-32 1.082115334335678803e-32 5.511521610893899137e-01 8.021691665423144045e-34 3.918769778285902730e-34 5.511521610893899137e-01 -1.319434053035366988e-33 7.328078595823150219e-33 5.511521610893899137e-01 -7.528807982620396284e-34 -2.878824290464192714e-33 5.511521610893899137e-01 3.929443716179735526e-34 -3.341285563626358694e-35 5.511521610893899137e-01 -5.336005019238102634e-35 2.123622996929380622e-32 5.511521610893899137e-01 2.029877435441140654e-34 -4.642320850000695198e-33 5.511521610893899137e-01 3.161835591885279779e-36 5.914329158110691341e-33 5.511521610893899137e-01 -3.711075044493321503e-36 -1.626846619618110428e-33 5.511521610893899137e-01 -2.088540278529872865e-36 9.982341035939150454e-34 5.511521610893899137e-01 -7.143048618917842010e-37 1.173308150297919173e-32 5.511521610893899137e-01 1.943163719901402791e-36 5.479425983855504195e-33 5.511521610893899137e-01 -2.186475693165983751e-36 1.501138946694587754e-33 5.511521610893899137e-01 -1.721787781994624412e-36 -1.231280023802430984e-32 5.511521610893899137e-01 1.402821250299783532e-36 -9.693570785691527172e-33 5.511521610893899137e-01 -5.853808892982871024e-37 -1.298026380528296206e-35 5.511521610893899137e-01 -9.626762060567784589e-37 -9.387860452234622834e-33 5.511521610893899137e-01 -1.275712957278488923e-35 1.995824295780086024e-33 5.511521610893899137e-01 5.147487893496827138e-36 9.927091983699431391e-34 5.511521610893899137e-01 1.344845322093598052e-34 0.000000000000000000e+00 5.511521610893899137e-01 8.647974044815551686e-33 -5.738844034805634475e-34 5.511521610893899137e-01 -3.482558806060697687e-35 -1.723178377449637606e-33 5.511521610893899137e-01 6.062497003572582331e-35 2.311903151836662979e-33 5.511521610893899137e-01 1.520020306126427064e-34 7.156865239912921430e-33 5.511521610893899137e-01 2.126297112416656041e-34 1.186440986346068982e-34 5.511521610893899137e-01 2.301683372987477540e-34 -1.628371341703527747e-34 5.511521610893899137e-01 2.419576327104729841e-34 -2.281006205946655939e-32 5.511521610893899137e-01 1.921641454400174397e-34 -3.163210759461825720e-32 5.511521610893899137e-01 1.376550661506089195e-34 0.000000000000000000e+00 5.511521610893899137e-01 1.053295417120417522e-34 -1.166391929881695717e-34 5.511521610893899137e-01 7.048877150877689228e-35 0.000000000000000000e+00 5.511521610893899137e-01 3.578289971096288554e-35 1.120582123131089114e-32 5.511521610893899137e-01 1.702721348131158905e-35 -3.908947354900799352e-36 5.511521610893899137e-01 1.304963687892904648e-35 -2.113138846585561356e-35 5.511521610893899137e-01 3.232764897814372328e-36 -7.054039988462939767e-35 5.511521610893899137e-01 7.974307030464134955e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.682783801913494586e-36 -2.916353354825908871e-33 5.511521610893899137e-01 7.499798216079838695e-38 4.843162144919647471e-34 5.511521610893899137e-01 5.010140534413867288e-39 4.838256186334363906e-37 5.511521610893899137e-01 4.010310238345746211e-38 -7.375181793003856945e-34 5.511521610893899137e-01 6.572598132721406097e-38 -2.063629275944806903e-31 6.688448645849520335e-32 5.511521610893899137e-01 -1.612340688517690275e-31 -2.762749157516096741e-32 5.511521610893899137e-01 5.070691472790853531e-32 -6.097894875468322716e-33 5.511521610893899137e-01 -6.493970514461556998e-31 -3.257828496583015078e-32 5.511521610893899137e-01 3.263199516953179408e-32 3.350929661161666969e-33 5.511521610893899137e-01 4.611758674846738442e-31 -1.142401283953754532e-32 5.511521610893899137e-01 9.078813092456368596e-31 -2.427143490458209002e-32 5.511521610893899137e-01 -3.707996154977914111e-31 -1.005214785246823979e-32 5.511521610893899137e-01 2.108009668548692463e-32 -5.565508141517109443e-33 5.511521610893899137e-01 3.993801553493286858e-32 -2.281701216058222731e-32 5.511521610893899137e-01 1.062959870656067884e-32 -2.066967237840850745e-32 5.511521610893899137e-01 -6.006480808485334302e-32 6.054374322309786519e-34 5.511521610893899137e-01 1.256006704479162178e-31 1.846752820246126828e-33 5.511521610893899137e-01 -4.518253458164972514e-31 -1.185676347230074322e-32 5.511521610893899137e-01 5.967450787270980854e-31 -4.287664964466390639e-32 5.511521610893899137e-01 6.173729352556617726e-33 -9.764268921716599979e-32 5.511521610893899137e-01 3.544799661415376388e-31 2.010991575644229962e-32 5.511521610893899137e-01 3.644749446659820287e-31 6.844193557718299278e-32 5.511521610893899137e-01 -2.126442401779329327e-31 9.353931824620400246e-32 5.511521610893899137e-01 -2.345104402179759659e-33 2.661355179711990131e-31 5.511521610893899137e-01 1.082847778143033712e-30 4.123285624304127108e-31 5.511521610893899137e-01 1.612490047844318588e-32 1.706051360392535493e-31 5.511521610893899137e-01 8.234413684688681770e-31 1.105857680471920212e-30 5.511521610893899137e-01 0.000000000000000000e+00 4.255858518355741805e-32 5.511521610893899137e-01 -8.000032744833821776e-33 -3.711729140615269797e-33 5.511521610893899137e-01 3.104545484164111282e-35 -4.328699591140422837e-33 5.511521610893899137e-01 -2.416545279417239897e-32 -3.762146336367095563e-33 5.511521610893899137e-01 -3.135737510824985075e-32 -1.111688397434554543e-33 5.511521610893899137e-01 3.864704053203938971e-34 -1.209042220261260509e-32 5.511521610893899137e-01 2.612014865111965016e-32 -3.558594179087206046e-33 5.511521610893899137e-01 3.273138538184421415e-33 -1.203390031682833843e-32 5.511521610893899137e-01 6.208026473930686349e-34 -4.517609382202077460e-33 5.511521610893899137e-01 -1.702873565918794262e-36 -6.020619616488641948e-33 5.511521610893899137e-01 7.216310297474077933e-33 -5.266928996545739637e-33 5.511521610893899137e-01 -1.065165917815147210e-36 -3.007322374385154897e-33 5.511521610893899137e-01 1.849795887944143741e-34 -1.506819244745694127e-33 5.511521610893899137e-01 -6.208055981355432556e-34 -5.267936479465842327e-33 5.511521610893899137e-01 -7.338738634976246674e-34 -3.007862716854756044e-33 5.511521610893899137e-01 3.455715350518089336e-35 -5.266800072573146551e-33 5.511521610893899137e-01 -1.971908283206304609e-33 -4.514860983363640478e-33 5.511521610893899137e-01 3.259607522410052804e-33 -3.304141311875189503e-33 5.511521610893899137e-01 -6.025559036107633817e-33 -3.286236694408907931e-33 5.511521610893899137e-01 -1.946778018444609176e-35 -6.260204736263885542e-33 5.511521610893899137e-01 -4.737407014413756140e-33 3.381759353131704334e-33 5.511521610893899137e-01 -2.804627774709108475e-34 -4.924882087481323256e-33 5.511521610893899137e-01 -1.221626287900307221e-33 -3.324798760332462349e-33 5.511521610893899137e-01 2.100410730294778288e-33 -3.045342603623979208e-33 5.511521610893899137e-01 -4.100020164959082116e-35 -3.078754471060739333e-33 5.511521610893899137e-01 1.246768181232042828e-33 -6.540679123437629233e-33 5.511521610893899137e-01 1.149483803378053866e-32 -2.955387001526149038e-33 5.511521610893899137e-01 4.375523941046185762e-35 -4.697892353980698080e-33 5.511521610893899137e-01 1.108452960098921929e-32 -4.752401433270106900e-33 5.511521610893899137e-01 3.638178048489731707e-33 -4.784726957708674046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -2.938776766596279353e-33 5.511521610893899137e-01 -2.409378201690617302e-36 -4.854273599709752977e-33 5.511521610893899137e-01 -6.697534012546389907e-36 -4.873029285939404931e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.372374093489259343e-33 5.511521610893899137e-01 -2.272528782731722383e-33 -6.767614695838561382e-33 5.511521610893899137e-01 -2.877816604985414113e-33 -4.889259068717669802e-33 5.511521610893899137e-01 -4.889410545885136790e-34 -3.195661850434708181e-33 5.511521610893899137e-01 -2.996592268956474661e-34 -3.385348732386027581e-33 5.511521610893899137e-01 7.050516753101862712e-34 -6.582763354464275839e-33 5.511521610893899137e-01 -1.726450071677988945e-36 -3.291344079200021888e-33 5.511521610893899137e-01 5.333266878240635817e-35 -3.314828343337523493e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 deleted file mode 100644 index d7b0ec677..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ -1.786499140402910898e-02 1.219025168772197872e-30 -2.061350679195397059e-31 1.785146619118939751e-02 -9.088030628340098222e-33 1.393727461163637243e-31 1.782418098358570444e-02 8.416680943954785125e-31 5.070691472790853531e-32 1.778266193180831276e-02 3.083834705487193332e-31 1.647756026154257990e-30 1.772618746159203632e-02 1.490534683593706111e-31 3.263199516953179408e-32 1.765377507078429165e-02 1.415282428565477326e-30 1.522120426024128610e-30 1.756416331614273768e-02 -1.491509779375724108e-31 -1.010975222135009452e-31 1.745578863112032600e-02 7.711288369379520972e-32 5.821588855282304127e-31 1.732675651657127058e-02 -5.635030251248151319e-32 2.108009668548692463e-32 1.717480654251533206e-02 -6.153526910182389613e-32 2.489377390136957169e-31 1.699727049186759709e-02 -7.452266308646484897e-32 2.050136264808488947e-31 1.679102286916022910e-02 1.116391988804065522e-32 -6.006480808485334302e-32 1.655242289492476690e-02 2.155072474711587442e-31 1.254637453596010338e-31 1.627724701948258038e-02 4.461835589921824044e-31 1.606774306115706125e-31 1.596061093524065236e-02 2.781727869749155645e-34 3.402485386963482174e-32 1.559688007076428726e-02 5.815928248263278141e-31 6.173729352556617726e-33 1.517956765325232001e-02 -4.284405479207655328e-32 8.253958216199754513e-35 1.470121968994313189e-02 5.482810314984024248e-34 -2.515302655945666252e-34 1.415328673319700761e-02 9.663928469904542086e-35 9.626114629871546684e-33 1.352598318952005427e-02 -1.134415308057596725e-31 8.793799817194899781e-32 1.280813639516813034e-02 -1.646495290354010478e-31 9.332863360537578569e-32 1.198702997070378098e-02 7.332611161745850011e-33 1.618113804892623203e-32 1.104824943796820468e-02 2.929500813919224937e-33 -3.296298748378319555e-33 9.975543208627353151e-03 -1.177916986927023080e-33 3.935774258612676784e-35 8.750719768572296636e-03 1.078812607213867500e-32 6.432884777481389612e-33 7.353613318991375145e-03 4.196749418562749869e-34 5.884341886932585872e-35 5.762166180091505933e-03 -1.690908208614039301e-32 -1.195292996992720207e-32 3.952722249407784015e-03 2.723644687208776301e-33 3.603175351998728114e-32 1.900704636829885722e-03 -3.341285563626358694e-35 3.864704053203938971e-34 -3.998958664629946071e-04 2.000347947764716070e-33 6.869593950703046195e-33 -2.738027981654521208e-03 -1.299310535341134450e-34 -5.687726185110405598e-33 -4.874968260864200389e-03 6.394453540747697885e-34 6.264480079860168169e-34 -6.706028089909856632e-03 3.792234435617083444e-34 -1.069644379309003009e-36 -8.142377943033657361e-03 4.014659126157913485e-34 -8.060955391565888706e-33 -9.268420375211786424e-03 -2.979666767466250584e-33 9.070959407796831379e-39 -1.018552970198861353e-02 9.995100124784569229e-34 1.931211898328097440e-34 -1.078749224543992281e-02 1.501261960996105635e-33 -1.802760076126178113e-34 -1.089270899258410787e-02 5.197957972586126182e-33 1.016813347749601594e-33 -1.054244458732895608e-02 4.372873701430834135e-33 -8.460633277420454411e-34 -9.981439339801162838e-03 4.265742886675583257e-35 5.153735354357563358e-33 -9.266053553068535203e-03 5.184284687530419145e-33 -4.026465047472468186e-33 -8.295845506956858045e-03 2.013771030157760808e-33 9.031751106761569233e-33 -6.989605370277018545e-03 4.907765156984922479e-33 -1.946778018444609176e-35 -5.427426853013662261e-03 2.146243631063305260e-35 3.461243656248069857e-33 -3.918674894688610119e-03 1.606190421071709619e-33 -4.152201498676860125e-34 -2.592638169155561060e-03 8.898962355468307551e-36 5.087612203537692155e-34 -1.436760624707282248e-03 2.311903151836662979e-33 -3.636894581700903678e-34 -4.322979969844952843e-04 -3.453768035410177292e-33 -1.061626469938827926e-32 4.523791085092895934e-04 1.186440986346068982e-34 1.246768181232042828e-33 1.233321845374947892e-03 2.425364612286880779e-32 -7.134035947390421354e-34 1.919998166912073156e-03 3.005264002094712790e-32 2.647510627961730437e-32 2.521447097608605671e-03 -3.025072287832607301e-33 -1.749010815731762617e-32 3.044677145599743607e-03 0.000000000000000000e+00 1.910801707555194848e-32 3.483606480501018517e-03 -1.166391929881695717e-34 -1.667092276747645340e-32 3.840774522548483574e-03 0.000000000000000000e+00 1.806916393655533957e-32 4.128935819625061641e-03 -8.224779587819093516e-33 1.942390328511743824e-32 4.359355053051283506e-03 -3.908947354900799352e-36 -3.233952536463438536e-37 4.541643474033266355e-03 -3.100640009528949161e-35 -2.272528782731722383e-33 4.683885605064238775e-03 -6.003933837716056402e-33 -2.877816604985414113e-33 4.792761780226757751e-03 0.000000000000000000e+00 -6.739733327963650152e-33 4.873659654621166105e-03 3.471184117644577121e-34 -2.996592268956474661e-34 4.930770528039748329e-03 2.174815863601836037e-33 4.088771734767767148e-33 4.967168041485876470e-03 1.733030324772810164e-33 3.463366548236675634e-33 4.984867893779819717e-03 -7.989583522313930872e-35 -3.451388966455412406e-33 1.219025168772197872e-30 5.511521610893899137e-01 8.188535716359637875e-32 -9.088030628340098222e-33 5.511521610893899137e-01 2.423194187666158305e-32 8.416680943954785125e-31 5.511521610893899137e-01 7.410096935743693115e-33 3.083834705487193332e-31 5.511521610893899137e-01 -2.787803481625604565e-32 1.490534683593706111e-31 5.511521610893899137e-01 1.521391938874292871e-32 1.415282428565477326e-30 5.511521610893899137e-01 4.761986729142090379e-33 -1.491509779375724108e-31 5.511521610893899137e-01 -2.486097670950934026e-32 7.711288369379520972e-32 5.511521610893899137e-01 -9.120973661842751120e-33 -5.635030251248151319e-32 5.511521610893899137e-01 -5.455745693634111084e-33 -6.153526910182389613e-32 5.511521610893899137e-01 -2.283138488157920833e-32 -7.452266308646484897e-32 5.511521610893899137e-01 3.634249058361741254e-33 1.116391988804065522e-32 5.511521610893899137e-01 1.522137282030466403e-33 2.155072474711587442e-31 5.511521610893899137e-01 2.576421217373871953e-33 4.461835589921824044e-31 5.511521610893899137e-01 -1.118411058063982529e-32 2.781727869749155645e-34 5.511521610893899137e-01 -1.882240901357352221e-32 5.815928248263278141e-31 5.511521610893899137e-01 -5.069724044132510212e-32 -4.284405479207655328e-32 5.511521610893899137e-01 6.745253903130761803e-32 5.482810314984024248e-34 5.511521610893899137e-01 6.838490331625611715e-32 9.663928469904542086e-35 5.511521610893899137e-01 6.932088389392429618e-32 -1.134415308057596725e-31 5.511521610893899137e-01 2.527717721699126820e-31 -1.646495290354010478e-31 5.511521610893899137e-01 3.990966925283136989e-31 7.332611161745850011e-33 5.511521610893899137e-01 1.714949971642328725e-31 2.929500813919224937e-33 5.511521610893899137e-01 1.108663111022782843e-30 -1.177916986927023080e-33 5.511521610893899137e-01 4.850415190095525195e-32 1.078812607213867500e-32 5.511521610893899137e-01 7.681097194163084624e-34 4.196749418562749869e-34 5.511521610893899137e-01 -1.364218020698895923e-33 -1.690908208614039301e-32 5.511521610893899137e-01 -8.147223787513243048e-34 2.723644687208776301e-33 5.511521610893899137e-01 3.661934818988863426e-34 -3.341285563626358694e-35 5.511521610893899137e-01 -8.167033872537366791e-35 2.000347947764716070e-33 5.511521610893899137e-01 2.121886347837056675e-34 -1.299310535341134450e-34 5.511521610893899137e-01 -3.958774408165175441e-37 6.394453540747697885e-34 5.511521610893899137e-01 -3.772643918754414573e-36 3.792234435617083444e-34 5.511521610893899137e-01 -2.198538092860321267e-36 4.014659126157913485e-34 5.511521610893899137e-01 -6.514312051763950670e-37 -2.979666767466250584e-33 5.511521610893899137e-01 1.344718119704852008e-36 9.995100124784569229e-34 5.511521610893899137e-01 -1.596539800662342077e-36 1.501261960996105635e-33 5.511521610893899137e-01 -1.718834146137470594e-36 5.197957972586126182e-33 5.511521610893899137e-01 1.058737060380784340e-36 4.372873701430834135e-33 5.511521610893899137e-01 -1.065567503230144586e-36 4.265742886675583257e-35 5.511521610893899137e-01 -9.820818159637571184e-37 5.184284687530419145e-33 5.511521610893899137e-01 -1.821320916532643268e-35 2.013771030157760808e-33 5.511521610893899137e-01 -5.034252844245116114e-36 4.907765156984922479e-33 5.511521610893899137e-01 1.286690998515404549e-34 2.146243631063305260e-35 5.511521610893899137e-01 8.636015325953288225e-33 1.606190421071709619e-33 5.511521610893899137e-01 -3.489970250415837310e-35 8.898962355468307551e-36 5.511521610893899137e-01 6.065937263706933481e-35 2.311903151836662979e-33 5.511521610893899137e-01 1.495322351462086941e-34 -3.453768035410177292e-33 5.511521610893899137e-01 1.868525391950803367e-34 1.186440986346068982e-34 5.511521610893899137e-01 2.049783731702362665e-34 2.425364612286880779e-32 5.511521610893899137e-01 1.913762142357593685e-34 3.005264002094712790e-32 5.511521610893899137e-01 1.174864251130577670e-34 -3.025072287832607301e-33 5.511521610893899137e-01 7.994468142967189702e-35 0.000000000000000000e+00 5.511521610893899137e-01 4.468226415995556820e-35 -1.166391929881695717e-34 5.511521610893899137e-01 1.393706649057642718e-35 0.000000000000000000e+00 5.511521610893899137e-01 -1.155815865560166942e-36 -8.224779587819093516e-33 5.511521610893899137e-01 -4.006881125302465257e-36 -3.908947354900799352e-36 5.511521610893899137e-01 -3.196156189547332784e-36 -3.100640009528949161e-35 5.511521610893899137e-01 -4.967446765927542058e-36 -6.003933837716056402e-33 5.511521610893899137e-01 -2.424150876061110738e-36 0.000000000000000000e+00 5.511521610893899137e-01 -9.430321678422058656e-38 3.471184117644577121e-34 5.511521610893899137e-01 -9.876554103350274757e-37 2.174815863601836037e-33 5.511521610893899137e-01 1.482217323769206854e-37 1.733030324772810164e-33 5.511521610893899137e-01 -1.025654498532010812e-37 -7.989583522313930872e-35 5.511521610893899137e-01 1.142733614113401684e-37 -2.061350679195397059e-31 7.586682608738626671e-32 5.511521610893899137e-01 1.393727461163637243e-31 -2.391630673301931328e-32 5.511521610893899137e-01 5.070691472790853531e-32 1.391565859533581074e-33 5.511521610893899137e-01 1.647756026154257990e-30 -2.787803481625604565e-32 5.511521610893899137e-01 3.263199516953179408e-32 1.521391938874292871e-32 5.511521610893899137e-01 1.522120426024128610e-30 -1.256544347068023030e-33 5.511521610893899137e-01 -1.010975222135009452e-31 -2.486097670950934026e-32 5.511521610893899137e-01 5.821588855282304127e-31 -9.120973661842751120e-33 5.511521610893899137e-01 2.108009668548692463e-32 -5.455745693634111084e-33 5.511521610893899137e-01 2.489377390136957169e-31 -2.283138488157920833e-32 5.511521610893899137e-01 2.050136264808488947e-31 -2.043987524647870486e-32 5.511521610893899137e-01 -6.006480808485334302e-32 1.522137282030466403e-33 5.511521610893899137e-01 1.254637453596010338e-31 2.576421217373871953e-33 5.511521610893899137e-01 1.606774306115706125e-31 -1.118411058063982529e-32 5.511521610893899137e-01 3.402485386963482174e-32 -4.289653331841396490e-32 5.511521610893899137e-01 6.173729352556617726e-33 -9.884548905100599844e-32 5.511521610893899137e-01 8.253958216199754513e-35 1.930429042162672444e-32 5.511521610893899137e-01 -2.515302655945666252e-34 6.838490331625611715e-32 5.511521610893899137e-01 9.626114629871546684e-33 9.339500819876474435e-32 5.511521610893899137e-01 8.793799817194899781e-32 2.648088343223329061e-31 5.511521610893899137e-01 9.332863360537578569e-32 4.111337546807339230e-31 5.511521610893899137e-01 1.618113804892623203e-32 1.699903643951803445e-31 5.511521610893899137e-01 -3.296298748378319555e-33 1.105653845484677787e-30 5.511521610893899137e-01 3.935774258612676784e-35 4.248562082474514538e-32 5.511521610893899137e-01 6.432884777481389612e-33 -3.745788587741275739e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.373483558803951944e-33 5.511521610893899137e-01 -1.195292996992720207e-32 -3.823987916856379983e-33 5.511521610893899137e-01 3.603175351998728114e-32 -1.138439287153641839e-33 5.511521610893899137e-01 3.864704053203938971e-34 -1.211873249114559839e-32 5.511521610893899137e-01 6.869593950703046195e-33 -3.549393287847614230e-33 5.511521610893899137e-01 -5.687726185110405598e-33 -1.203745802986104080e-32 5.511521610893899137e-01 6.264480079860168169e-34 -4.517670951076338410e-33 5.511521610893899137e-01 -1.069644379309003009e-36 -6.020729614302972554e-33 5.511521610893899137e-01 -8.060955391565888706e-33 -5.266866122889023921e-33 5.511521610893899137e-01 9.070959407796831379e-39 -3.007920819985351288e-33 5.511521610893899137e-01 1.931211898328097440e-34 -1.506229308853190546e-33 5.511521610893899137e-01 -1.802760076126178113e-34 -5.267933525829985385e-33 5.511521610893899137e-01 1.016813347749601594e-33 -3.008206801044675184e-33 5.511521610893899137e-01 -8.460633277420454411e-34 -5.267280259187078551e-33 5.511521610893899137e-01 5.153735354357563358e-33 -4.514880388973547146e-33 5.511521610893899137e-01 -4.026465047472468186e-33 -3.309597391467730915e-33 5.511521610893899137e-01 9.031751106761569233e-33 -3.296418435146650144e-33 5.511521610893899137e-01 -1.946778018444609176e-35 -6.266020168621704829e-33 5.511521610893899137e-01 3.461243656248069857e-33 3.369800634269440874e-33 5.511521610893899137e-01 -4.152201498676860125e-34 -4.924956201924874492e-33 5.511521610893899137e-01 5.087612203537692155e-34 -3.324764357731118827e-33 5.511521610893899137e-01 -3.636894581700903678e-34 -3.047812399090413050e-33 5.511521610893899137e-01 -1.061626469938827926e-32 -3.104531643107324429e-33 5.511521610893899137e-01 1.246768181232042828e-33 -6.565869087566140549e-33 5.511521610893899137e-01 -7.134035947390421354e-34 -3.005968420000862632e-33 5.511521610893899137e-01 2.647510627961730437e-32 -4.772570074307657881e-33 5.511521610893899137e-01 -1.749010815731762617e-32 -4.810111817991044072e-33 5.511521610893899137e-01 1.910801707555194848e-32 -4.845374235260760454e-33 5.511521610893899137e-01 -1.667092276747645340e-32 -2.995328471614479668e-33 5.511521610893899137e-01 1.806916393655533957e-32 -4.891212315286276050e-33 5.511521610893899137e-01 1.942390328511743824e-32 -4.894063380546019290e-33 5.511521610893899137e-01 -3.233952536463438536e-37 -3.388619886557735543e-33 5.511521610893899137e-01 -2.272528782731722383e-33 -6.775814907502302766e-33 5.511521610893899137e-01 -2.877816604985414113e-33 -4.892480650296777516e-33 5.511521610893899137e-01 -6.739733327963650152e-33 -3.197438937453405757e-33 5.511521610893899137e-01 -2.996592268956474661e-34 -3.386411385778523483e-33 5.511521610893899137e-01 4.088771734767767148e-33 -6.582620142872433735e-33 5.511521610893899137e-01 3.463366548236675634e-33 -3.291486747752258884e-33 5.511521610893899137e-01 -3.451388966455412406e-33 -3.314779795957439418e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 deleted file mode 100644 index 4a5c25ee6..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ -1.799778436423971409e-02 1.219025168772197872e-30 -2.149629174367300742e-31 1.798581963798388805e-02 -2.547749298567240989e-29 1.393727461163637243e-31 1.796167813123256476e-02 9.248305222816737997e-31 6.562428130299290628e-29 1.792493185355002738e-02 4.085533839483115743e-29 -3.889919889812817590e-29 1.787492902271115708e-02 1.354041690245903251e-31 1.898269583475151629e-32 1.781078210778701265e-02 1.415282428565477326e-30 -1.926387805552289444e-29 1.773135150706650967e-02 -1.470728288658100625e-31 -1.016522188324816620e-30 1.763522455702333513e-02 7.607428998900385867e-32 5.811202918234390726e-31 1.752068945830497979e-02 -5.691745879160194111e-32 -1.893639501625071104e-30 1.738570361799311043e-02 -6.120544238769751067e-32 -2.672007641289552916e-30 1.722785580849505241e-02 6.794270284953473327e-32 -2.074432228495144465e-30 1.704432144738322538e-02 -4.414965795742949096e-31 1.751593262715021738e-30 1.683181020539359016e-02 2.168285515390814547e-31 1.254637453596010338e-31 1.658650506770730990e-02 -1.495196759340117625e-31 7.570401156133287865e-31 1.630399191357161451e-02 2.781727869749155645e-34 3.402485386963482174e-32 1.597917866688803798e-02 5.815928248263278141e-31 8.214561457864649796e-31 1.560620313584362533e-02 -4.226938242677714770e-32 -6.112850916285418976e-35 1.517832885349972537e-02 5.482810314984024248e-34 -2.515302655945666252e-34 1.468782862579815982e-02 -2.422063877957254614e-31 9.480849026106304245e-33 1.412585619303672116e-02 2.982973084057903701e-31 8.793799817194899781e-32 1.348230756387135305e-02 -1.643443539183447700e-31 -8.214705870198037319e-32 1.274567539186835172e-02 1.577995049480980166e-31 1.623711531595984600e-32 1.190290250895358060e-02 3.012268158423843884e-33 1.292610077452696246e-32 1.093924476792008937e-02 -1.177916986927023080e-33 3.935774258612676784e-35 9.838159163957388431e-03 -1.290539357634013215e-33 3.993313283509172683e-34 8.581241374760576607e-03 -4.819831381353186080e-33 5.884341886932585872e-35 7.148247939311277131e-03 -3.164811428019896678e-33 6.443656674984563977e-33 5.517252857428797501e-03 2.703255481406595149e-33 -4.073814292903174464e-33 3.665006504697506176e-03 -1.416005646938911502e-32 3.549377186825527043e-34 1.567599311221681054e-03 2.000347947764716070e-33 -1.802926846517315153e-32 -7.811222221411782615e-04 -5.623684681962583616e-33 -1.454411642046522691e-34 -3.103007922958699559e-03 -1.838460586560540422e-33 -1.228097582379752015e-33 -5.199426999447688720e-03 3.665786754285398957e-34 -1.069644379309003009e-36 -6.973119444680726114e-03 -1.060500932882088620e-34 1.093184245933168355e-33 -8.336978678820262251e-03 -2.979666767466250584e-33 2.229590324476974472e-36 -9.425339071166433449e-03 1.312557608857429119e-34 -1.546265504241876010e-33 -1.030753342517499484e-02 1.501261960996105635e-33 2.278907910954674984e-34 -1.085143921970906783e-02 5.390389136525588787e-34 1.016813347749601594e-33 -1.088421244523845276e-02 -5.648927656619281196e-35 -1.003865248524299504e-34 -1.048488384838473612e-02 1.491106517551685953e-33 -2.785306349843858574e-34 -9.908089277260737071e-03 -4.970829372705128249e-34 -4.746510235930920077e-34 -9.180631676533910351e-03 6.070948481785306704e-34 5.916940148861884058e-34 -8.181516242304015182e-03 -3.535007175409306647e-33 -2.009372712486677764e-35 -6.851724683032456992e-03 3.163343212336492066e-35 -7.876898445206682528e-34 -5.281288580302534626e-03 1.611428068024115904e-33 -4.178389733438892408e-34 -3.803212291732335597e-03 6.171668904368829264e-36 -2.235170712664407360e-34 -2.506361257386052928e-03 -6.125133017672881067e-34 -3.636894581700903678e-34 -1.377082102084136242e-03 1.183726395400383997e-33 -5.688649430207863190e-34 -3.966108345036283489e-04 6.490322450524500754e-33 -3.445423970556099455e-34 4.666799725983937584e-04 -2.059832891718379434e-33 3.146810422034122736e-34 1.227292532381542983e-03 9.654117347840357155e-33 1.291507840463730036e-34 1.894536139817574018e-03 -1.005187012212588500e-32 9.562142754408546077e-34 2.477266634252319171e-03 8.354045048976923314e-36 -8.602391027651434444e-34 2.982891756475050671e-03 -1.077364779223984655e-34 1.952709246269234806e-34 3.407931392727246017e-03 -7.729145568591987267e-33 -3.180073628014644746e-33 3.753475245200006607e-03 -2.725462520813445041e-34 -4.516723506150108411e-34 4.031464857816904543e-03 4.078291795837875167e-33 -5.099387918464743503e-34 4.252736165035643154e-03 -4.208581604253366338e-33 -1.227443330168335911e-33 4.426443954647979982e-03 -1.738516360303765341e-33 -7.429448756720615104e-34 4.560178974122994743e-03 1.493849476002967948e-36 -2.397859825961023666e-33 4.660079425228842720e-03 3.471184117644577121e-34 -1.401187875912048392e-33 4.730930133365732898e-03 2.263513525322121667e-34 -3.641880348981279427e-34 4.776245171839331970e-03 5.066575763068170477e-35 -1.022274601875958317e-33 4.798331390832154264e-03 -8.009661784401173479e-35 1.049354263020949057e-33 1.219025168772197872e-30 5.511521610893899137e-01 4.114335215482925721e-29 -2.547749298567240989e-29 5.511521610893899137e-01 2.882047122032719151e-29 9.248305222816737997e-31 5.511521610893899137e-01 -3.471060282920869642e-28 4.085533839483115743e-29 5.511521610893899137e-01 -2.478328409548690705e-29 1.354041690245903251e-31 5.511521610893899137e-01 -4.760071514253114014e-29 1.415282428565477326e-30 5.511521610893899137e-01 -1.192390400657338190e-30 -1.470728288658100625e-31 5.511521610893899137e-01 -2.222392764189609121e-31 7.607428998900385867e-32 5.511521610893899137e-01 -2.581446728278788609e-31 -5.691745879160194111e-32 5.511521610893899137e-01 -7.536942668129204208e-32 -6.120544238769751067e-32 5.511521610893899137e-01 4.266280235830796144e-32 6.794270284953473327e-32 5.511521610893899137e-01 6.563289423335584247e-33 -4.414965795742949096e-31 5.511521610893899137e-01 -2.283605390315669631e-32 2.168285515390814547e-31 5.511521610893899137e-01 -2.059205168580225327e-31 -1.495196759340117625e-31 5.511521610893899137e-01 -2.098161439290507655e-32 2.781727869749155645e-34 5.511521610893899137e-01 -2.823718845965968353e-32 5.815928248263278141e-31 5.511521610893899137e-01 -3.157587119733249815e-32 -4.226938242677714770e-32 5.511521610893899137e-01 7.379425188619455696e-32 5.482810314984024248e-34 5.511521610893899137e-01 9.517445073193804196e-33 -2.422063877957254614e-31 5.511521610893899137e-01 6.621822711954710688e-32 2.982973084057903701e-31 5.511521610893899137e-01 2.384253162230904344e-31 -1.643443539183447700e-31 5.511521610893899137e-01 3.970739694744006864e-31 1.577995049480980166e-31 5.511521610893899137e-01 1.708044936054189412e-31 3.012268158423843884e-33 5.511521610893899137e-01 1.108558251649963851e-30 -1.177916986927023080e-33 5.511521610893899137e-01 4.844870933633260426e-32 -1.290539357634013215e-33 5.511521610893899137e-01 7.706230958198821154e-34 -4.819831381353186080e-33 5.511521610893899137e-01 -1.356668462051774935e-33 -3.164811428019896678e-33 5.511521610893899137e-01 -7.953852581409622786e-34 2.703255481406595149e-33 5.511521610893899137e-01 3.766355122431778432e-34 -1.416005646938911502e-32 5.511521610893899137e-01 -9.799885310739010467e-35 2.000347947764716070e-33 5.511521610893899137e-01 2.005233745589640025e-34 -5.623684681962583616e-33 5.511521610893899137e-01 -6.110425351671128988e-36 -1.838460586560540422e-33 5.511521610893899137e-01 -3.529957010917058842e-36 3.665786754285398957e-34 5.511521610893899137e-01 -3.314139050591534997e-36 -1.060500932882088620e-34 5.511521610893899137e-01 -6.549974620718971693e-37 -2.979666767466250584e-33 5.511521610893899137e-01 2.094272811063005541e-36 1.312557608857429119e-34 5.511521610893899137e-01 -1.653402918031087435e-36 1.501261960996105635e-33 5.511521610893899137e-01 -1.860207581066935175e-36 5.390389136525588787e-34 5.511521610893899137e-01 1.084488942099937802e-36 -5.648927656619281196e-35 5.511521610893899137e-01 -1.065283704277287659e-36 1.491106517551685953e-33 5.511521610893899137e-01 -9.773823804167548562e-37 -4.970829372705128249e-34 5.511521610893899137e-01 -1.799481661881643528e-35 6.070948481785306704e-34 5.511521610893899137e-01 -5.229508455448575678e-36 -3.535007175409306647e-33 5.511521610893899137e-01 1.288355501329216972e-34 3.163343212336492066e-35 5.511521610893899137e-01 8.635822048817139493e-33 1.611428068024115904e-33 5.511521610893899137e-01 -3.555155743341351473e-35 6.171668904368829264e-36 5.511521610893899137e-01 6.059881837107416445e-35 -6.125133017672881067e-34 5.511521610893899137e-01 1.495326014813041659e-34 1.183726395400383997e-33 5.511521610893899137e-01 1.870264363190951477e-34 6.490322450524500754e-33 5.511521610893899137e-01 2.054970988482785465e-34 -2.059832891718379434e-33 5.511521610893899137e-01 1.913261091978488926e-34 9.654117347840357155e-33 5.511521610893899137e-01 1.180459809288329567e-34 -1.005187012212588500e-32 5.511521610893899137e-01 7.957749167336128566e-35 8.354045048976923314e-36 5.511521610893899137e-01 4.378548838516980763e-35 -1.077364779223984655e-34 5.511521610893899137e-01 1.503455206200842488e-35 -7.729145568591987267e-33 5.511521610893899137e-01 -5.928056248641673425e-37 -2.725462520813445041e-34 5.511521610893899137e-01 -4.842584065038806837e-36 4.078291795837875167e-33 5.511521610893899137e-01 -3.066262945676626989e-36 -4.208581604253366338e-33 5.511521610893899137e-01 -4.835570408178955663e-36 -1.738516360303765341e-33 5.511521610893899137e-01 -2.663482672229399405e-36 1.493849476002967948e-36 5.511521610893899137e-01 1.312984183720976117e-37 3.471184117644577121e-34 5.511521610893899137e-01 -9.158691372125902189e-37 2.263513525322121667e-34 5.511521610893899137e-01 1.164346048741381478e-37 5.066575763068170477e-35 5.511521610893899137e-01 -8.702592989173307279e-38 -8.009661784401173479e-35 5.511521610893899137e-01 1.784896947985151813e-37 -2.149629174367300742e-31 4.113733362375304710e-29 5.511521610893899137e-01 1.393727461163637243e-31 2.877232297171751061e-29 5.511521610893899137e-01 6.562428130299290628e-29 -3.471120468231631743e-28 5.511521610893899137e-01 -3.889919889812817590e-29 -2.478328409548690705e-29 5.511521610893899137e-01 1.898269583475151629e-32 -4.760071514253114014e-29 5.511521610893899137e-01 -1.926387805552289444e-29 -1.198408931733548302e-30 5.511521610893899137e-01 -1.016522188324816620e-30 -2.222392764189609121e-31 5.511521610893899137e-01 5.811202918234390726e-31 -2.581446728278788609e-31 5.511521610893899137e-01 -1.893639501625071104e-30 -7.536942668129204208e-32 5.511521610893899137e-01 -2.672007641289552916e-30 4.266280235830796144e-32 5.511521610893899137e-01 -2.074432228495144465e-30 -1.751083488150486255e-32 5.511521610893899137e-01 1.751593262715021738e-30 -2.283605390315669631e-32 5.511521610893899137e-01 1.254637453596010338e-31 -2.059205168580225327e-31 5.511521610893899137e-01 7.570401156133287865e-31 -2.098161439290507655e-32 5.511521610893899137e-01 3.402485386963482174e-32 -5.231131276450012074e-32 5.511521610893899137e-01 8.214561457864649796e-31 -7.972411980701338900e-32 5.511521610893899137e-01 -6.112850916285418976e-35 2.564600327651366611e-32 5.511521610893899137e-01 -2.515302655945666252e-34 9.517445073193804196e-33 5.511521610893899137e-01 9.480849026106304245e-33 9.029235142438755505e-32 5.511521610893899137e-01 8.793799817194899781e-32 2.504623783755106585e-31 5.511521610893899137e-01 -8.214705870198037319e-32 4.091110316268209105e-31 5.511521610893899137e-01 1.623711531595984600e-32 1.692998608363664132e-31 5.511521610893899137e-01 1.292610077452696246e-32 1.105548986111858795e-30 5.511521610893899137e-01 3.935774258612676784e-35 4.243017826012249769e-32 5.511521610893899137e-01 3.993313283509172683e-34 -3.743275211337701915e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.365934000156830956e-33 5.511521610893899137e-01 6.443656674984563977e-33 -3.804650796246018128e-33 5.511521610893899137e-01 -4.073814292903174464e-33 -1.127997256809350338e-33 5.511521610893899137e-01 3.549377186825527043e-34 -1.213506100552761468e-32 5.511521610893899137e-01 -1.802926846517315153e-32 -3.561058548072355895e-33 5.511521610893899137e-01 -1.454411642046522691e-34 -1.204317257777189548e-32 5.511521610893899137e-01 -1.228097582379752015e-33 -4.517428264168501102e-33 5.511521610893899137e-01 -1.069644379309003009e-36 -6.021845215260703704e-33 5.511521610893899137e-01 1.093184245933168355e-33 -5.266869689145919479e-33 5.511521610893899137e-01 2.229590324476974472e-36 -3.007171265293993135e-33 5.511521610893899137e-01 -1.546265504241876010e-33 -1.506286171970559353e-33 5.511521610893899137e-01 2.278907910954674984e-34 -5.268074899264915187e-33 5.511521610893899137e-01 1.016813347749601594e-33 -3.008181049162955958e-33 5.511521610893899137e-01 -1.003865248524299504e-34 -5.267279975388125881e-33 5.511521610893899137e-01 -2.785306349843858574e-34 -4.514875689538000469e-33 5.511521610893899137e-01 -4.746510235930920077e-34 -3.309378998921221073e-33 5.511521610893899137e-01 5.916940148861884058e-34 -3.296613690757853670e-33 5.511521610893899137e-01 -2.009372712486677764e-35 -6.265853718340324185e-33 5.511521610893899137e-01 -7.876898445206682528e-34 3.369607357133291457e-33 5.511521610893899137e-01 -4.178389733438892408e-34 -4.925608056854129901e-33 5.511521610893899137e-01 -2.235170712664407360e-34 -3.324824911997113784e-33 5.511521610893899137e-01 -3.636894581700903678e-34 -3.047812032755317471e-33 5.511521610893899137e-01 -5.688649430207863190e-34 -3.104357745983309468e-33 5.511521610893899137e-01 -3.445423970556099455e-34 -6.565350361888098526e-33 5.511521610893899137e-01 3.146810422034122736e-34 -3.006018525038772979e-33 5.511521610893899137e-01 1.291507840463730036e-34 -4.772010518491883012e-33 5.511521610893899137e-01 9.562142754408546077e-34 -4.810479007747354619e-33 5.511521610893899137e-01 -8.602391027651434444e-34 -4.846271011035546161e-33 5.511521610893899137e-01 1.952709246269234806e-34 -2.994230986043047606e-33 5.511521610893899137e-01 -3.180073628014644746e-33 -4.890649305045580235e-33 5.511521610893899137e-01 -4.516723506150108411e-34 -4.894899083485755691e-33 5.511521610893899137e-01 -5.099387918464743503e-34 -3.388489993313865014e-33 5.511521610893899137e-01 -1.227443330168335911e-33 -6.775683031144554724e-33 5.511521610893899137e-01 -7.429448756720615104e-34 -4.892719982092945600e-33 5.511521610893899137e-01 -2.397859825961023666e-33 -3.197213335818249773e-33 5.511521610893899137e-01 -1.401187875912048392e-33 -3.386339599505401269e-33 5.511521610893899137e-01 -3.641880348981279427e-34 -6.582651929999936953e-33 5.511521610893899137e-01 -1.022274601875958317e-33 -3.291471208232297431e-33 5.511521610893899137e-01 1.049354263020949057e-33 -3.314715579624052068e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 deleted file mode 100644 index ace5d2731..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ -1.801709400689215437e-02 1.870252469389928983e-32 3.772306472703611470e-32 1.800569290347733137e-02 2.425418466977416466e-30 1.393727461163637243e-31 1.798269078284147823e-02 7.698580410971097993e-32 7.035688929068638410e-31 1.794768418838936161e-02 8.706156194655386424e-31 -1.704042599242793723e-30 1.790005879194533911e-02 -1.627837359585986376e-30 1.898269583475151629e-32 1.783897822318526727e-02 -2.381729722385684803e-31 2.230090373758786688e-30 1.776336884076336678e-02 2.367622077266560260e-31 -1.016476588676869837e-30 1.767190015172353731e-02 -1.006517010801585865e-31 5.811589563732545292e-31 1.756296050514583734e-02 -5.694977228746045541e-32 6.913755400644628304e-31 1.743462760058129418e-02 5.260990018161603804e-31 -2.959117991882015539e-32 1.728463326462507596e-02 3.333486456369566368e-31 -4.818221347395336360e-31 1.711032185942713141e-02 1.470273958940915261e-30 1.752158823011152689e-30 1.690860160107952523e-02 2.167716327131818013e-31 1.841224833278552701e-30 1.667588798975544809e-02 -1.494740924604525302e-31 7.570401156133287865e-31 1.640803849950950993e-02 3.430290262260976874e-31 3.373401733722996796e-32 1.610027766217173376e-02 -2.962373658227604648e-32 2.105430754470588841e-31 1.574711173574207604e-02 -4.226938242677714770e-32 -5.446762673239320482e-31 1.534223231613530795e-02 5.482810314984024248e-34 -2.515302655945666252e-34 1.487840859496854760e-02 -2.664774326951202723e-32 9.365823068514941263e-33 1.434736857659678518e-02 -4.687056074656060086e-31 8.802904790080362200e-32 1.373967057257909422e-02 6.311702027893481846e-33 4.586301157546150024e-32 1.304456786816447431e-02 -1.461910636686037064e-31 1.629429939583507205e-32 1.224987183973277882e-02 3.023625359501312721e-33 -5.476281764718770536e-32 1.134182230273371103e-02 -1.177916986927023080e-33 3.031276590526414797e-35 1.030497886729738431e-02 -1.292345973754802025e-33 2.932207129696775430e-33 9.122154018600395903e-03 -4.843016817324846145e-33 5.884341886932585872e-35 7.774417984314650233e-03 -3.146125316699416021e-33 -4.431660113535341005e-33 6.241217590880353619e-03 2.703255481406595149e-33 -4.066241194489102664e-33 4.500666380616709546e-03 3.465744316476486500e-33 3.672980277890503045e-34 2.530080852587576583e-03 -6.011766506432110770e-33 2.997448148125118837e-33 3.068657059938871817e-04 -5.657456831321278243e-33 -1.412196455348154622e-34 -2.055235181163645591e-03 -1.682035059826884539e-34 2.112416578775951922e-33 -4.247755544518323420e-03 -5.807058352221019404e-33 3.091789610177026299e-33 -6.168755053402635337e-03 -1.060500932882088620e-34 1.093184245933168355e-33 -7.722865136024759797e-03 7.806236547608311400e-33 -2.371904263865415729e-36 -8.903892717692190456e-03 5.233580396036429465e-33 1.004896813333467181e-33 -9.884908864795578440e-03 1.505027898584846831e-33 4.564949712870212008e-34 -1.063058615375953204e-02 5.390389136525588787e-34 -1.334832119755790363e-33 -1.093736171125525396e-02 1.088683606055592579e-33 -1.003345707247363814e-34 -1.073704333206193344e-02 -3.015622567870276489e-33 -2.783295135507272625e-34 -1.025087691175463264e-02 -4.939098852159043306e-34 -4.746510235930920077e-34 -9.617669559340992491e-03 6.070948481785306704e-34 2.832121834794291524e-33 -8.812934136663759868e-03 -3.535007175409306647e-33 2.242904326193411519e-33 -7.688833974023862386e-03 3.163343212336492066e-35 -7.843152159624582796e-34 -6.261815907053394636e-03 -3.111295634302739543e-33 -1.220019417269349346e-34 -4.706741915362419940e-03 1.230426359528592904e-33 3.886102740456713059e-34 -3.320281673716350516e-03 -6.125133017672881067e-34 -3.636894581700903678e-34 -2.106877402484847589e-03 1.165916744376332503e-33 -5.862783709920098955e-33 -1.052621100582597051e-03 6.490322450524500754e-33 -5.893875062911622686e-33 -1.348607103235023759e-04 -2.081255929814878366e-33 -2.596174259158380855e-33 6.746727993788862940e-04 -1.479279502398157968e-32 -5.976672257611569619e-33 1.386143335776003193e-03 -1.005187012212588500e-32 9.562142754408546077e-34 2.008458733674122181e-03 8.354045048976923314e-36 -8.602391027651434444e-34 2.550007832326943447e-03 -1.077364779223984655e-34 3.736016790926291752e-33 3.018100641738330567e-03 -7.711688638639462383e-33 4.239121601808301150e-33 3.408665945440942074e-03 -2.725462520813445041e-34 3.429935640686640084e-33 3.724658918106924302e-03 -1.212324125627397849e-32 -5.112386581054691704e-34 3.977564169111118611e-03 -4.214200311327525950e-33 8.781671458729282482e-34 4.177177812447414700e-03 -1.735505821677683526e-33 -7.421922410155410565e-34 4.331647492378620616e-03 1.493849476002967948e-36 -1.525221877680855878e-34 4.447577556637734471e-03 4.950083638508133179e-33 -2.506563288518469099e-34 4.530125591774786589e-03 2.263513525322121667e-34 8.084353685595123472e-34 4.583084496499048761e-03 5.066575763068170477e-35 1.651816689170527790e-34 4.608946429057193470e-03 -8.009661784401173479e-35 6.758914310815100052e-34 1.870252469389928983e-32 5.511521610893899137e-01 4.114331810894601471e-29 2.425418466977416466e-30 5.511521610893899137e-01 2.882626282648707266e-29 7.698580410971097993e-32 5.511521610893899137e-01 -3.471057781682156163e-28 8.706156194655386424e-31 5.511521610893899137e-01 -2.479093284826504802e-29 -1.627837359585986376e-30 5.511521610893899137e-01 -4.764196667008044661e-29 -2.381729722385684803e-31 5.511521610893899137e-01 -1.202691575267287242e-30 2.367622077266560260e-31 5.511521610893899137e-01 -2.208516825998628134e-31 -1.006517010801585865e-31 5.511521610893899137e-01 -2.585512927356208926e-31 -5.694977228746045541e-32 5.511521610893899137e-01 -7.578476584024165265e-32 5.260990018161603804e-31 5.511521610893899137e-01 4.364564411634871470e-32 3.333486456369566368e-31 5.511521610893899137e-01 8.174652137514213234e-33 1.470273958940915261e-30 5.511521610893899137e-01 -3.173678765100465252e-32 2.167716327131818013e-31 5.511521610893899137e-01 -1.984835970850571401e-31 -1.494740924604525302e-31 5.511521610893899137e-01 -1.003349279266970671e-32 3.430290262260976874e-31 5.511521610893899137e-01 -3.496505108114665667e-32 -2.962373658227604648e-32 5.511521610893899137e-01 -3.072549736412839561e-32 -4.226938242677714770e-32 5.511521610893899137e-01 7.568719884743484077e-32 5.482810314984024248e-34 5.511521610893899137e-01 9.702001613305849040e-34 -2.664774326951202723e-32 5.511521610893899137e-01 6.540809380023967697e-32 -4.687056074656060086e-31 5.511521610893899137e-01 2.349297441899640856e-31 6.311702027893481846e-33 5.511521610893899137e-01 3.970254306736757534e-31 -1.461910636686037064e-31 5.511521610893899137e-01 1.702829082551505789e-31 3.023625359501312721e-33 5.511521610893899137e-01 1.108515649859955719e-30 -1.177916986927023080e-33 5.511521610893899137e-01 4.842162287042667999e-32 -1.292345973754802025e-33 5.511521610893899137e-01 7.706954215134349083e-34 -4.843016817324846145e-33 5.511521610893899137e-01 -1.341384945630975066e-33 -3.146125316699416021e-33 5.511521610893899137e-01 -7.743650155758533075e-34 2.703255481406595149e-33 5.511521610893899137e-01 3.842808249157783298e-34 3.465744316476486500e-33 5.511521610893899137e-01 -7.869646262167047071e-35 -6.011766506432110770e-33 5.511521610893899137e-01 2.018122582035714971e-34 -5.657456831321278243e-33 5.511521610893899137e-01 -1.007232929966661810e-36 -1.682035059826884539e-34 5.511521610893899137e-01 -3.707518286877727171e-36 -5.807058352221019404e-33 5.511521610893899137e-01 -5.199395389979625847e-37 -1.060500932882088620e-34 5.511521610893899137e-01 -1.105281172742548632e-36 7.806236547608311400e-33 5.511521610893899137e-01 5.053550691433800391e-36 5.233580396036429465e-33 5.511521610893899137e-01 -9.667163261075147847e-37 1.505027898584846831e-33 5.511521610893899137e-01 -1.889157129456798123e-36 5.390389136525588787e-34 5.511521610893899137e-01 1.174273785369945998e-36 1.088683606055592579e-33 5.511521610893899137e-01 -1.070182585832611062e-36 -3.015622567870276489e-33 5.511521610893899137e-01 -1.045108199912892681e-36 -4.939098852159043306e-34 5.511521610893899137e-01 -1.869374939087081262e-35 6.070948481785306704e-34 5.511521610893899137e-01 -6.155833774162642870e-36 -3.535007175409306647e-33 5.511521610893899137e-01 1.273214299150985563e-34 3.163343212336492066e-35 5.511521610893899137e-01 8.633835002662380735e-33 -3.111295634302739543e-33 5.511521610893899137e-01 -3.561952131634788319e-35 1.230426359528592904e-33 5.511521610893899137e-01 6.061302615627726133e-35 -6.125133017672881067e-34 5.511521610893899137e-01 1.491374983233796989e-34 1.165916744376332503e-33 5.511521610893899137e-01 1.824749277318427801e-34 6.490322450524500754e-33 5.511521610893899137e-01 1.999688415732405552e-34 -2.081255929814878366e-33 5.511521610893899137e-01 1.866991032115306720e-34 -1.479279502398157968e-32 5.511521610893899137e-01 1.067242963141412009e-34 -1.005187012212588500e-32 5.511521610893899137e-01 6.729644674724585598e-35 8.354045048976923314e-36 5.511521610893899137e-01 3.733776261172701441e-35 -1.077364779223984655e-34 5.511521610893899137e-01 8.599606597698550157e-36 -7.711688638639462383e-33 5.511521610893899137e-01 -5.971186761199111254e-36 -2.725462520813445041e-34 5.511521610893899137e-01 -7.678138488379691988e-36 -1.212324125627397849e-32 5.511521610893899137e-01 -4.397232944523604083e-36 -4.214200311327525950e-33 5.511521610893899137e-01 -5.623164516421098716e-36 -1.735505821677683526e-33 5.511521610893899137e-01 -3.240870642076605302e-36 1.493849476002967948e-36 5.511521610893899137e-01 8.956700534824534889e-38 4.950083638508133179e-33 5.511521610893899137e-01 -8.567856454910784429e-37 2.263513525322121667e-34 5.511521610893899137e-01 9.022108244246431799e-38 5.066575763068170477e-35 5.511521610893899137e-01 -1.158565097773380867e-37 -8.009661784401173479e-35 5.511521610893899137e-01 1.805788395031964209e-37 3.772306472703611470e-32 4.113729957786980459e-29 5.511521610893899137e-01 1.393727461163637243e-31 2.877811457787739176e-29 5.511521610893899137e-01 7.035688929068638410e-31 -3.471117966992918264e-28 5.511521610893899137e-01 -1.704042599242793723e-30 -2.479093284826504802e-29 5.511521610893899137e-01 1.898269583475151629e-32 -4.764196667008044661e-29 5.511521610893899137e-01 2.230090373758786688e-30 -1.208710106343497354e-30 5.511521610893899137e-01 -1.016476588676869837e-30 -2.208516825998628134e-31 5.511521610893899137e-01 5.811589563732545292e-31 -2.585512927356208926e-31 5.511521610893899137e-01 6.913755400644628304e-31 -7.578476584024165265e-32 5.511521610893899137e-01 -2.959117991882015539e-32 4.364564411634871470e-32 5.511521610893899137e-01 -4.818221347395336360e-31 -1.589947216732623219e-32 5.511521610893899137e-01 1.752158823011152689e-30 -3.173678765100465252e-32 5.511521610893899137e-01 1.841224833278552701e-30 -1.984835970850571401e-31 5.511521610893899137e-01 7.570401156133287865e-31 -1.003349279266970671e-32 5.511521610893899137e-01 3.373401733722996796e-32 -5.903917538598709389e-32 5.511521610893899137e-01 2.105430754470588841e-31 -7.887374597380928646e-32 5.511521610893899137e-01 -5.446762673239320482e-31 2.753895023775394444e-32 5.511521610893899137e-01 -2.515302655945666252e-34 9.702001613305849040e-34 5.511521610893899137e-01 9.365823068514941263e-33 8.948221810508012514e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.469668063423843097e-31 5.511521610893899137e-01 4.586301157546150024e-32 4.090624928260959775e-31 5.511521610893899137e-01 1.629429939583507205e-32 1.687782754860980509e-31 5.511521610893899137e-01 -5.476281764718770536e-32 1.105506384321850663e-30 5.511521610893899137e-01 3.031276590526414797e-35 4.240309179421657342e-32 5.511521610893899137e-01 2.932207129696775430e-33 -3.743202885644148780e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.350650483736030915e-33 5.511521610893899137e-01 -4.431660113535341005e-33 -3.783630553680909499e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.120351944136749894e-33 5.511521610893899137e-01 3.672980277890503045e-34 -1.211575861504189483e-32 5.511521610893899137e-01 2.997448148125118837e-33 -3.559769664427748315e-33 5.511521610893899137e-01 -1.412196455348154622e-34 -1.203806938535019083e-32 5.511521610893899137e-01 2.112416578775951922e-33 -4.517605825444461715e-33 5.511521610893899137e-01 3.091789610177026299e-33 -6.019051015749110279e-33 5.511521610893899137e-01 1.093184245933168355e-33 -5.267319972856590410e-33 5.511521610893899137e-01 -2.371904263865415729e-36 -3.004211987413622368e-33 5.511521610893899137e-01 1.004896813333467181e-33 -1.505599485378635766e-33 5.511521610893899137e-01 4.564949712870212008e-34 -5.268103848813305204e-33 5.511521610893899137e-01 -1.334832119755790363e-33 -3.008091264319686029e-33 5.511521610893899137e-01 -1.003345707247363814e-34 -5.267284874269681071e-33 5.511521610893899137e-01 -2.783295135507272625e-34 -4.514943415357496482e-33 5.511521610893899137e-01 -4.746510235930920077e-34 -3.310077931693275656e-33 5.511521610893899137e-01 2.832121834794291524e-33 -3.297540016076567957e-33 5.511521610893899137e-01 2.242904326193411519e-33 -6.267367838558147091e-33 5.511521610893899137e-01 -7.843152159624582796e-34 3.367620310978532699e-33 5.511521610893899137e-01 -1.220019417269349346e-34 -4.925676020737064307e-33 5.511521610893899137e-01 3.886102740456713059e-34 -3.324810704211910804e-33 5.511521610893899137e-01 -3.636894581700903678e-34 -3.048207135913241788e-33 5.511521610893899137e-01 -5.862783709920098955e-33 -3.108909254570561836e-33 5.511521610893899137e-01 -5.893875062911622686e-33 -6.570878619163136175e-33 5.511521610893899137e-01 -2.596174259158380855e-33 -3.010645531025091221e-33 5.511521610893899137e-01 -5.976672257611569619e-33 -4.783332203106574704e-33 5.511521610893899137e-01 9.562142754408546077e-34 -4.822760052673469995e-33 5.511521610893899137e-01 -8.602391027651434444e-34 -4.852718736808988746e-33 5.511521610893899137e-01 3.736016790926291752e-33 -3.000665931507357516e-33 5.511521610893899137e-01 4.239121601808301150e-33 -4.896027686181915068e-33 5.511521610893899137e-01 3.429935640686640084e-33 -4.897734637909096858e-33 5.511521610893899137e-01 -5.112386581054691704e-34 -3.389820963312711877e-33 5.511521610893899137e-01 8.781671458729282482e-34 -6.776470625252796823e-33 5.511521610893899137e-01 -7.421922410155410565e-34 -4.893297370062792903e-33 5.511521610893899137e-01 -1.525221877680855878e-34 -3.197255067231273288e-33 5.511521610893899137e-01 -2.506563288518469099e-34 -3.386280516013679905e-33 5.511521610893899137e-01 8.084353685595123472e-34 -6.582678143522368557e-33 5.511521610893899137e-01 1.651816689170527790e-34 -3.291500038812183029e-33 5.511521610893899137e-01 6.758914310815100052e-34 -3.314713490479347053e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 deleted file mode 100644 index 291a9271c..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ -1.804432112266367641e-02 1.409421330449194964e-30 3.802228882595608456e-32 1.803336190886439469e-02 1.062723533160975026e-30 1.393727461163637243e-31 1.801125163053411693e-02 1.386702104419931651e-30 4.869415230409048861e-32 1.797760311777902784e-02 8.707339244767703448e-31 7.688870505352508142e-31 1.793182687820524951e-02 6.704626009558033337e-31 1.898269583475151629e-32 1.787312042240506507e-02 1.869025083076677888e-30 1.231499536135263713e-31 1.780045371389215106e-02 -1.673474570203391222e-30 -1.016476588676869837e-30 1.771255046393132790e-02 -1.006517010801585865e-31 5.813868303882018801e-31 1.760786491533172446e-02 -5.685911436673960094e-32 6.913755400644628304e-31 1.748455367841220132e-02 5.260276543215873210e-31 -2.959117991882015539e-32 1.734044209792500596e-02 -2.665366460272018580e-31 1.743224163654003952e-31 1.717298454337667923e-02 -2.757076175302157245e-30 -3.615162441103835642e-31 1.697921793148403358e-02 2.167716327131818013e-31 -1.660759734682948260e-32 1.675570771334694564e-02 -4.755780731155188900e-32 2.387494942370911436e-30 1.649848550091981975e-02 -1.265818297496653836e-30 1.821350945817981609e-30 1.620297748555245623e-02 -2.962373658227604648e-32 -4.163234945023159059e-31 1.586392283893037214e-02 -1.796688997509781679e-31 -2.698772326755300077e-31 1.547528142438794538e-02 5.482810314984024248e-34 -2.562796258814976092e-31 1.503013043908538009e-02 -2.664774326951202723e-32 9.365823068514941263e-33 1.452055013832902891e-02 2.740650802503020783e-31 8.802904790080362200e-32 1.393749967633215771e-02 6.311702027893481846e-33 -3.576825382768648683e-32 1.327068549500118322e-02 -2.478366692657851076e-33 1.600581396803133040e-31 1.250842681840221536e-02 3.063386329129121957e-33 8.596287454726111535e-33 1.163752594950993521e-02 2.682283765568151242e-32 -1.609386896218923072e-33 1.064315557146978432e-02 1.108301311421255330e-32 -2.184282412892549210e-32 9.508781547471045065e-03 2.542539209632757569e-33 5.884341886932585872e-35 8.216148241559168008e-03 6.642178836896760616e-33 -4.461987934305584477e-33 6.745364548301843385e-03 2.697211393089774814e-33 -4.066241194489102664e-33 5.075142816101437665e-03 3.475453272704983204e-33 3.672980277890503045e-34 3.183259388343621064e-03 1.032070394264240496e-33 -4.058187474347944177e-33 1.047323364375913734e-03 3.897593698696004178e-33 -1.380013732107948148e-34 -1.307655263461107980e-03 -1.682035059826884539e-34 -7.809054911741957181e-34 -3.562634631395650894e-03 2.160106018361275099e-33 -2.221144025664548715e-33 -5.577236309898176737e-03 -1.060500932882088620e-34 5.996202611749455781e-33 -7.257810888474278480e-03 -1.869539276755243209e-34 -2.371904263865415729e-36 -8.534686747710663879e-03 -3.350772332347236815e-33 -6.741731574779184697e-35 -9.577783128391914591e-03 -2.565874468850511216e-33 -5.612306205718183536e-34 -1.041489662664574038e-02 -4.352800846794577006e-34 2.332430737732712415e-34 -1.089112521209250478e-02 -7.946244428741099679e-34 8.413194537401148923e-34 -1.086395641202846443e-02 -3.015622567870276489e-33 1.236751035189497686e-34 -1.044102027886548677e-02 -4.939098852159043306e-34 8.829179003792957368e-34 -9.861937689031216939e-03 -6.581729857226590560e-33 -6.158519895191060805e-33 -9.140188873589118190e-03 -3.530895042009466820e-33 -1.359581540403495286e-33 -8.144452627583584001e-03 3.163343212336492066e-35 1.260569097006284439e-34 -6.833050544570240699e-03 5.861937167396657446e-34 -5.833758326302929995e-34 -5.286062680982047887e-03 5.013218318636227726e-33 -5.570877157312373569e-34 -3.840752270771029091e-03 -8.393564298052711028e-33 1.718433903646358835e-33 -2.572074255418364559e-03 9.194525065555849818e-33 -9.042311532760118781e-34 -1.466847863185411893e-03 6.479355884011066783e-33 6.064480309580447475e-33 -5.088823375038156911e-04 -1.933193655585858080e-32 1.722399621043867116e-33 3.330489143654904549e-04 -1.479279502398157968e-32 2.989768900984245525e-33 1.073772957375441258e-03 8.597671604073580231e-33 8.244743404072263347e-35 1.722239076703683093e-03 1.579494188928886452e-35 8.829668807531083747e-33 2.286944466718735230e-03 -1.077364779223984655e-34 6.252731372642918868e-33 2.775775842928240953e-03 -7.711688638639462383e-33 -4.896698783054772646e-33 3.192849310600539853e-03 -2.725462520813445041e-34 -1.974081174953009497e-33 3.533128474645330815e-03 -9.547420366510072366e-34 2.280268829797199119e-33 3.806163237620873926e-03 1.532336354108531477e-33 -3.433371983605525850e-33 4.022191732447183248e-03 4.161925169087877536e-33 -7.423646401909025020e-34 4.189746935706888976e-03 1.493849476002967948e-36 4.130788254664797110e-34 4.315756726708988578e-03 3.419528593794266143e-34 -2.506563288518469099e-34 4.405638023762918631e-03 1.784331142119893580e-33 -1.163568616658025166e-34 4.463378049026053666e-03 8.369539444608574512e-34 1.651816689170527790e-34 4.491598266988698802e-03 -8.019546545807585765e-35 -9.036934416631003767e-34 1.409421330449194964e-30 5.511521610893899137e-01 4.111917865361087550e-29 1.062723533160975026e-30 5.511521610893899137e-01 2.884907303026033118e-29 1.386702104419931651e-30 5.511521610893899137e-01 -3.471034258093734797e-28 8.707339244767703448e-31 5.511521610893899137e-01 -2.482072749274465120e-29 6.704626009558033337e-31 5.511521610893899137e-01 -4.762279752724122361e-29 1.869025083076677888e-30 5.511521610893899137e-01 -1.218958895711070047e-30 -1.673474570203391222e-30 5.511521610893899137e-01 -2.349220698816356930e-31 -1.006517010801585865e-31 5.511521610893899137e-01 -2.614782336004479819e-31 -5.685911436673960094e-32 5.511521610893899137e-01 -6.698017490890739294e-32 5.260276543215873210e-31 5.511521610893899137e-01 5.082547480352268813e-32 -2.665366460272018580e-31 5.511521610893899137e-01 8.145685438317608205e-33 -2.757076175302157245e-30 5.511521610893899137e-01 -6.402472599173773716e-32 2.167716327131818013e-31 5.511521610893899137e-01 -1.842068139538466789e-31 -4.755780731155188900e-32 5.511521610893899137e-01 -7.521881906004319670e-33 -1.265818297496653836e-30 5.511521610893899137e-01 -3.576427225447460374e-32 -2.962373658227604648e-32 5.511521610893899137e-01 -3.152594597733007430e-32 -1.796688997509781679e-31 5.511521610893899137e-01 7.604035746541812995e-32 5.482810314984024248e-34 5.511521610893899137e-01 1.083844094875034222e-33 -2.664774326951202723e-32 5.511521610893899137e-01 6.412020190535773863e-32 2.740650802503020783e-31 5.511521610893899137e-01 2.336271532713347629e-31 6.311702027893481846e-33 5.511521610893899137e-01 3.978099258341334575e-31 -2.478366692657851076e-33 5.511521610893899137e-01 1.707057802780934355e-31 3.063386329129121957e-33 5.511521610893899137e-01 1.108640101060972195e-30 2.682283765568151242e-32 5.511521610893899137e-01 4.842147606466829586e-32 1.108301311421255330e-32 5.511521610893899137e-01 7.566335973054127237e-34 2.542539209632757569e-33 5.511521610893899137e-01 -1.341324053149783408e-33 6.642178836896760616e-33 5.511521610893899137e-01 -7.634482126704785268e-34 2.697211393089774814e-33 5.511521610893899137e-01 3.780580917812735910e-34 3.475453272704983204e-33 5.511521610893899137e-01 -6.886033285054593385e-35 1.032070394264240496e-33 5.511521610893899137e-01 1.987486337590316258e-34 3.897593698696004178e-33 5.511521610893899137e-01 -1.699224349079421196e-37 -1.682035059826884539e-34 5.511521610893899137e-01 -3.995394898050044367e-36 2.160106018361275099e-33 5.511521610893899137e-01 3.385440286988921100e-37 -1.060500932882088620e-34 5.511521610893899137e-01 -5.793029193575336347e-36 -1.869539276755243209e-34 5.511521610893899137e-01 5.419627633055729042e-36 -3.350772332347236815e-33 5.511521610893899137e-01 -1.433355851189197240e-36 -2.565874468850511216e-33 5.511521610893899137e-01 -1.998516990124010069e-36 -4.352800846794577006e-34 5.511521610893899137e-01 1.174171074729040136e-36 -7.946244428741099679e-34 5.511521610893899137e-01 -1.074202084097573588e-36 -3.015622567870276489e-33 5.511521610893899137e-01 -1.037241542460244644e-36 -4.939098852159043306e-34 5.511521610893899137e-01 -1.874161178853949314e-35 -6.581729857226590560e-33 5.511521610893899137e-01 -5.785223906159868245e-36 -3.530895042009466820e-33 5.511521610893899137e-01 1.271754028536620153e-34 3.163343212336492066e-35 5.511521610893899137e-01 8.634097139393541480e-33 5.861937167396657446e-34 5.511521610893899137e-01 -3.550708002483374411e-35 5.013218318636227726e-33 5.511521610893899137e-01 6.090157415235210673e-35 -8.393564298052711028e-33 5.511521610893899137e-01 1.491430635161527278e-34 9.194525065555849818e-33 5.511521610893899137e-01 1.824422890713884993e-34 6.479355884011066783e-33 5.511521610893899137e-01 2.004249528347693347e-34 -1.933193655585858080e-32 5.511521610893899137e-01 1.890813613059016630e-34 -1.479279502398157968e-32 5.511521610893899137e-01 1.088634952614288462e-34 8.597671604073580231e-33 5.511521610893899137e-01 6.762503370702183158e-35 1.579494188928886452e-35 5.511521610893899137e-01 3.972703379115322034e-35 -1.077364779223984655e-34 5.511521610893899137e-01 1.026686045672795007e-35 -7.711688638639462383e-33 5.511521610893899137e-01 -5.304625682845452319e-36 -2.725462520813445041e-34 5.511521610893899137e-01 -6.806957189859287814e-36 -9.547420366510072366e-34 5.511521610893899137e-01 -3.902989090438313080e-36 1.532336354108531477e-33 5.511521610893899137e-01 -5.406580765841531974e-36 4.161925169087877536e-33 5.511521610893899137e-01 -3.171986855925060054e-36 1.493849476002967948e-36 5.511521610893899137e-01 9.580544734040440899e-38 3.419528593794266143e-34 5.511521610893899137e-01 -8.947562486808009407e-37 1.784331142119893580e-33 5.511521610893899137e-01 8.947550998143539446e-38 8.369539444608574512e-34 5.511521610893899137e-01 -1.282577352568352558e-37 -8.019546545807585765e-35 5.511521610893899137e-01 1.752723524745863905e-37 3.802228882595608456e-32 4.111316012253466539e-29 5.511521610893899137e-01 1.393727461163637243e-31 2.880092478165065028e-29 5.511521610893899137e-01 4.869415230409048861e-32 -3.471094443404496898e-28 5.511521610893899137e-01 7.688870505352508142e-31 -2.482072749274465120e-29 5.511521610893899137e-01 1.898269583475151629e-32 -4.762279752724122361e-29 5.511521610893899137e-01 1.231499536135263713e-31 -1.224977426787280159e-30 5.511521610893899137e-01 -1.016476588676869837e-30 -2.349220698816356930e-31 5.511521610893899137e-01 5.813868303882018801e-31 -2.614782336004479819e-31 5.511521610893899137e-01 6.913755400644628304e-31 -6.698017490890739294e-32 5.511521610893899137e-01 -2.959117991882015539e-32 5.082547480352268813e-32 5.511521610893899137e-01 1.743224163654003952e-31 -1.592843886652283859e-32 5.511521610893899137e-01 -3.615162441103835642e-31 -6.402472599173773716e-32 5.511521610893899137e-01 -1.660759734682948260e-32 -1.842068139538466789e-31 5.511521610893899137e-01 2.387494942370911436e-30 -7.521881906004319670e-33 5.511521610893899137e-01 1.821350945817981609e-30 -5.983839655931504096e-32 5.511521610893899137e-01 -4.163234945023159059e-31 -7.967419458701096515e-32 5.511521610893899137e-01 -2.698772326755300077e-31 2.789210885573723362e-32 5.511521610893899137e-01 -2.562796258814976092e-31 1.083844094875034222e-33 5.511521610893899137e-01 9.365823068514941263e-33 8.819432621019818679e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.456642154237549870e-31 5.511521610893899137e-01 -3.576825382768648683e-32 4.098469879865536816e-31 5.511521610893899137e-01 1.600581396803133040e-31 1.692011475090409074e-31 5.511521610893899137e-01 8.596287454726111535e-33 1.105630835522867139e-30 5.511521610893899137e-01 -1.609386896218923072e-33 4.240294498845818930e-32 5.511521610893899137e-01 -2.184282412892549210e-32 -3.757264709852171136e-33 5.511521610893899137e-01 5.884341886932585872e-35 -4.350589591254839086e-33 5.511521610893899137e-01 -4.461987934305584477e-33 -3.772713750775534718e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.126574677271254676e-33 5.511521610893899137e-01 3.672980277890503045e-34 -1.210592248527077012e-32 5.511521610893899137e-01 -4.058187474347944177e-33 -3.562833288872288186e-33 5.511521610893899137e-01 -1.380013732107948148e-34 -1.203723207485513256e-32 5.511521610893899137e-01 -7.809054911741957181e-34 -4.517893702055634297e-33 5.511521610893899137e-01 -2.221144025664548715e-33 -6.018192532181413170e-33 5.511521610893899137e-01 5.996202611749455781e-33 -5.272007720877423321e-33 5.511521610893899137e-01 -2.371904263865415729e-36 -3.003845910472000465e-33 5.511521610893899137e-01 -6.741731574779184697e-35 -1.506066124903717487e-33 5.511521610893899137e-01 -5.612306205718183536e-34 -5.268213208673972136e-33 5.511521610893899137e-01 2.332430737732712415e-34 -3.008091367030327034e-33 5.511521610893899137e-01 8.413194537401148923e-34 -5.267288893767945697e-33 5.511521610893899137e-01 1.236751035189497686e-34 -4.514935548700044084e-33 5.511521610893899137e-01 8.829179003792957368e-34 -3.310125794090944090e-33 5.511521610893899137e-01 -6.158519895191060805e-33 -3.297169406208565213e-33 5.511521610893899137e-01 -1.359581540403495286e-33 -6.267513865619583546e-33 5.511521610893899137e-01 1.260569097006284439e-34 3.367882447709694129e-33 5.511521610893899137e-01 -5.833758326302929995e-34 -4.925563579445549836e-33 5.511521610893899137e-01 -5.570877157312373569e-34 -3.324522156215835916e-33 5.511521610893899137e-01 1.718433903646358835e-33 -3.048201570720468652e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.108941893231015967e-33 5.511521610893899137e-01 6.064480309580447475e-33 -6.570422507901606968e-33 5.511521610893899137e-01 1.722399621043867116e-33 -3.008263272930720230e-33 5.511521610893899137e-01 2.989768900984245525e-33 -4.781193004159287358e-33 5.511521610893899137e-01 8.244743404072263347e-35 -4.822431465713694137e-33 5.511521610893899137e-01 8.829668807531083747e-33 -4.850329465629562497e-33 5.511521610893899137e-01 6.252731372642918868e-33 -2.998998677648328276e-33 5.511521610893899137e-01 -4.896698783054772646e-33 -4.895361125103561357e-33 5.511521610893899137e-01 -1.974081174953009497e-33 -4.896863456610576203e-33 5.511521610893899137e-01 2.280268829797199119e-33 -3.389326719458626852e-33 5.511521610893899137e-01 -3.433371983605525850e-33 -6.776254041502216780e-33 5.511521610893899137e-01 -7.423646401909025020e-34 -4.893228486276641382e-33 5.511521610893899137e-01 4.130788254664797110e-34 -3.197248828789281084e-33 5.511521610893899137e-01 -2.506563288518469099e-34 -3.386318486616869476e-33 5.511521610893899137e-01 -1.163568616658025166e-34 -6.582678889094829215e-33 5.511521610893899137e-01 1.651816689170527790e-34 -3.291512440037662392e-33 5.511521610893899137e-01 -9.036934416631003767e-34 -3.314718796966375808e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 deleted file mode 100644 index 245d735ad..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ -1.805761600264701311e-02 1.409421330449194964e-30 3.791443320103482540e-32 1.804691184049187630e-02 1.062827799345986936e-30 1.393988126626167016e-31 1.802531658659698929e-02 -2.012542319488162019e-31 -1.539237796364254074e-30 1.799245301295517366e-02 -2.154544498282114946e-30 7.687985358095770542e-31 1.794774679027047112e-02 6.705407144447153410e-31 1.906080932366352633e-32 1.789041612119665614e-02 5.503853486405646783e-31 1.231499536135263713e-31 1.781945760947587290e-02 -1.673474570203391222e-30 4.969750700253189050e-31 1.773362809608793750e-02 -1.006399579877223115e-31 -2.450391713601550534e-31 1.763142211758921343e-02 -5.683994427484644451e-32 6.139480083342183026e-32 1.751104456315425578e-02 -3.679893743179468845e-31 1.939285398483593982e-31 1.737037802532987937e-02 1.330694110468978144e-31 -6.248896977827989497e-31 1.720694425521140242e-02 -8.797647488600853050e-32 -3.613594590129044464e-31 1.701785904989592743e-02 2.168952821877497262e-31 -1.685489629596535144e-32 1.679977982418905114e-02 1.072656372310652428e-30 1.469694771816673888e-31 1.654884505949806225e-02 7.168187815833642267e-31 1.821655066242736027e-30 1.626060479445498932e-02 -2.965344071836276016e-32 -4.163234945023159059e-31 1.592994135096987424e-02 -1.796225338613371251e-31 -2.699699644548120933e-31 1.555097960701775327e-02 5.482810314984024248e-34 4.274949384107784734e-31 1.511698639147877540e-02 2.752312077069242928e-31 9.478717216224903081e-33 1.462025905830787592e-02 7.203214565276606173e-33 8.802904790080362200e-32 1.405200410851620806e-02 6.380642315495872987e-33 -2.470616529648640127e-32 1.340220801717666513e-02 4.152160829799634761e-31 -4.882959606214692195e-32 1.265950439265974871e-02 3.063386329129121957e-33 5.488327734988232200e-32 1.181104451385940439e-02 -1.425956100956308518e-32 3.948972551949973258e-32 1.084238249425841308e-02 -1.174971233247231040e-32 1.467896205484483944e-32 9.737392212724934118e-03 -1.527679930058262571e-33 -1.622728334194530676e-32 8.478241168063224004e-03 -6.321951170828711093e-34 1.009095269639372584e-32 7.045456964980040607e-03 -3.823407570479320152e-33 -4.066241194489102664e-33 5.418135454767793006e-03 1.374188111140489639e-32 -2.563824720130054099e-33 3.574355444654529756e-03 -1.620590543036386185e-33 -8.364684178173658519e-35 1.491882338539318037e-03 2.879648838369351615e-34 -1.340981708040922803e-33 -8.354337967466054409e-04 -1.682035059826884539e-34 -7.805232285484782430e-34 -3.123589675081596927e-03 2.160106018361275099e-33 -2.024927040724557008e-34 -5.190393761742326945e-03 7.378179953081242236e-33 2.257412927744100416e-33 -6.943584490877732600e-03 -1.869539276755243209e-34 -2.613690742523013622e-36 -8.294556692145172577e-03 3.646519531589362870e-33 -6.741731574779184697e-35 -9.373856081621964251e-03 5.648551718150260103e-34 1.004911441479089579e-33 -1.025559093209626842e-02 -4.338473194193477704e-34 -5.184214008118828885e-34 -1.083065636595820225e-02 2.119832002711290432e-33 2.298379463647810836e-33 -1.091493526085888371e-02 -3.015622567870276489e-33 6.582914481665234623e-34 -1.055033899671229368e-02 3.025736258488239067e-33 -5.253802576869495765e-34 -1.000577501772464267e-02 4.638719740046352135e-33 7.867353815190463358e-33 -9.321498505030591242e-03 -3.530895042009466820e-33 2.602794223550400509e-33 -8.408339129547817703e-03 -3.251437603056696360e-34 1.262180556773353332e-34 -7.173166148704137463e-03 4.584986485963824885e-33 8.707306289057649163e-34 -5.666490983690903628e-03 -3.939659913135530780e-33 9.345294637592855281e-34 -4.184478824136440671e-03 -6.989032654287877954e-34 1.716932213358961582e-33 -2.881033083285400136e-03 1.222267445625011048e-33 -9.042311532760118781e-34 -1.743507277141761623e-03 1.508854035999832956e-33 -5.622755668895527717e-34 -7.576172253194132268e-04 6.710874656876233107e-33 1.722399621043867116e-33 1.047464364624914367e-04 2.299358678432296483e-32 -6.080545366322808843e-34 8.639989970993660088e-04 -4.548476114407360038e-33 3.838010613405255521e-33 1.529091178297889908e-03 8.836395442841935703e-33 -2.932755047303569183e-33 2.108568454861107881e-03 -8.284073467953947913e-33 -1.827627959745173091e-32 2.610395794717391450e-03 2.932761959762336215e-33 3.619148956511313883e-33 3.041523665627441156e-03 1.940440036357583108e-33 2.389051134859181145e-34 3.398003030600520516e-03 2.486608055228097660e-33 -1.377964295380245540e-32 3.684529859286169752e-03 1.532336354108531477e-33 1.308953829062360029e-33 3.911609371573238243e-03 -4.383683774031964527e-33 1.088904753600586791e-33 4.088009183123506897e-03 1.462803637524868075e-36 -2.128052782520143612e-34 4.220855284296411852e-03 2.898236950839277052e-33 -2.503974908514965981e-34 4.315724034851960676e-03 -8.124208054879120773e-34 1.271011556946934550e-34 4.376722471212647451e-03 -2.703415192906141797e-34 -1.629185103944478011e-34 4.406551935599332254e-03 -8.019546545807585765e-35 1.735230922648109921e-33 1.409421330449194964e-30 5.511521610893899137e-01 4.109678511081683674e-29 1.062827799345986936e-30 5.511521610893899137e-01 2.884150692069667555e-29 -2.012542319488162019e-31 5.511521610893899137e-01 -3.471069558968689050e-28 -2.154544498282114946e-30 5.511521610893899137e-01 -2.482649640250264392e-29 6.705407144447153410e-31 5.511521610893899137e-01 -4.763139161610846482e-29 5.503853486405646783e-31 5.511521610893899137e-01 -1.222861747139933484e-30 -1.673474570203391222e-30 5.511521610893899137e-01 -2.358638285914408749e-31 -1.006399579877223115e-31 5.511521610893899137e-01 -2.616591702060852752e-31 -5.683994427484644451e-32 5.511521610893899137e-01 -6.699012561171022208e-32 -3.679893743179468845e-31 5.511521610893899137e-01 5.107511310605744606e-32 1.330694110468978144e-31 5.511521610893899137e-01 7.548698108543963107e-33 -8.797647488600853050e-32 5.511521610893899137e-01 -6.238107590593755315e-32 2.168952821877497262e-31 5.511521610893899137e-01 -2.245044367091578993e-31 1.072656372310652428e-30 5.511521610893899137e-01 -1.729180389140164311e-33 7.168187815833642267e-31 5.511521610893899137e-01 -5.008965900054580210e-32 -2.965344071836276016e-32 5.511521610893899137e-01 -3.699969942877761107e-32 -1.796225338613371251e-31 5.511521610893899137e-01 7.827456163148242792e-32 5.482810314984024248e-34 5.511521610893899137e-01 2.300951961293530376e-33 2.752312077069242928e-31 5.511521610893899137e-01 6.590855024682098826e-32 7.203214565276606173e-33 5.511521610893899137e-01 2.333855258248745653e-31 6.380642315495872987e-33 5.511521610893899137e-01 3.978040409136271573e-31 4.152160829799634761e-31 5.511521610893899137e-01 1.704835696629792891e-31 3.063386329129121957e-33 5.511521610893899137e-01 1.108560532643517835e-30 -1.425956100956308518e-32 5.511521610893899137e-01 4.838644581117076359e-32 -1.174971233247231040e-32 5.511521610893899137e-01 7.533326027263965140e-34 -1.527679930058262571e-33 5.511521610893899137e-01 -1.341904373696786305e-33 -6.321951170828711093e-34 5.511521610893899137e-01 -7.613354049345748477e-34 -3.823407570479320152e-33 5.511521610893899137e-01 3.792230165415608834e-34 1.374188111140489639e-32 5.511521610893899137e-01 -6.867495010946281092e-35 -1.620590543036386185e-33 5.511521610893899137e-01 1.987198874525490931e-34 2.879648838369351615e-34 5.511521610893899137e-01 -1.982874188626154574e-37 -1.682035059826884539e-34 5.511521610893899137e-01 -3.815527954194791792e-36 2.160106018361275099e-33 5.511521610893899137e-01 8.465965153656699045e-37 7.378179953081242236e-33 5.511521610893899137e-01 -6.500364458767885375e-36 -1.869539276755243209e-34 5.511521610893899137e-01 5.343485907019659284e-36 3.646519531589362870e-33 5.511521610893899137e-01 -1.472667836074892705e-36 5.648551718150260103e-34 5.511521610893899137e-01 -1.880258932770736361e-36 -4.338473194193477704e-34 5.511521610893899137e-01 1.099637698887633153e-36 2.119832002711290432e-33 5.511521610893899137e-01 -1.059421299099188549e-36 -3.015622567870276489e-33 5.511521610893899137e-01 -1.033516908815799093e-36 3.025736258488239067e-33 5.511521610893899137e-01 -1.872768450327034567e-35 4.638719740046352135e-33 5.511521610893899137e-01 -5.932542027717243014e-36 -3.530895042009466820e-33 5.511521610893899137e-01 1.271707758396048074e-34 -3.251437603056696360e-34 5.511521610893899137e-01 8.634091697154241273e-33 4.584986485963824885e-33 5.511521610893899137e-01 -3.552362954111236193e-35 -3.939659913135530780e-33 5.511521610893899137e-01 6.096828260615472791e-35 -6.989032654287877954e-34 5.511521610893899137e-01 1.493258605624862016e-34 1.222267445625011048e-33 5.511521610893899137e-01 1.823697137081214433e-34 1.508854035999832956e-33 5.511521610893899137e-01 2.004950397571597836e-34 6.710874656876233107e-33 5.511521610893899137e-01 1.890765892900594591e-34 2.299358678432296483e-32 5.511521610893899137e-01 1.085552567163162661e-34 -4.548476114407360038e-33 5.511521610893899137e-01 6.771502876237034066e-35 8.836395442841935703e-33 5.511521610893899137e-01 3.958857412899519727e-35 -8.284073467953947913e-33 5.511521610893899137e-01 9.910181914135898215e-36 2.932761959762336215e-33 5.511521610893899137e-01 -5.478985241836660105e-36 1.940440036357583108e-33 5.511521610893899137e-01 -6.901809519328158182e-36 2.486608055228097660e-33 5.511521610893899137e-01 -3.958003497215862471e-36 1.532336354108531477e-33 5.511521610893899137e-01 -5.502918800263140589e-36 -4.383683774031964527e-33 5.511521610893899137e-01 -3.179453685899519367e-36 1.462803637524868075e-36 5.511521610893899137e-01 9.397075247079383502e-38 2.898236950839277052e-33 5.511521610893899137e-01 -9.561413535056866417e-37 -8.124208054879120773e-34 5.511521610893899137e-01 8.905228143544522530e-38 -2.703415192906141797e-34 5.511521610893899137e-01 -1.284584864072890547e-37 -8.019546545807585765e-35 5.511521610893899137e-01 1.669911490670958511e-37 3.791443320103482540e-32 4.109076657974062663e-29 5.511521610893899137e-01 1.393988126626167016e-31 2.879335867208699465e-29 5.511521610893899137e-01 -1.539237796364254074e-30 -3.471129744279451151e-28 5.511521610893899137e-01 7.687985358095770542e-31 -2.482649640250264392e-29 5.511521610893899137e-01 1.906080932366352633e-32 -4.763139161610846482e-29 5.511521610893899137e-01 1.231499536135263713e-31 -1.228880278216143596e-30 5.511521610893899137e-01 4.969750700253189050e-31 -2.358638285914408749e-31 5.511521610893899137e-01 -2.450391713601550534e-31 -2.616591702060852752e-31 5.511521610893899137e-01 6.139480083342183026e-32 -6.699012561171022208e-32 5.511521610893899137e-01 1.939285398483593982e-31 5.107511310605744606e-32 5.511521610893899137e-01 -6.248896977827989497e-31 -1.652542619629648506e-32 5.511521610893899137e-01 -3.613594590129044464e-31 -6.238107590593755315e-32 5.511521610893899137e-01 -1.685489629596535144e-32 -2.245044367091578993e-31 5.511521610893899137e-01 1.469694771816673888e-31 -1.729180389140164311e-33 5.511521610893899137e-01 1.821655066242736027e-30 -7.416378330538623932e-32 5.511521610893899137e-01 -4.163234945023159059e-31 -8.514794803845850192e-32 5.511521610893899137e-01 -2.699699644548120933e-31 3.012631302180153706e-32 5.511521610893899137e-01 4.274949384107784734e-31 2.300951961293530376e-33 5.511521610893899137e-01 9.478717216224903081e-33 8.998267455166143642e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.454225879772947893e-31 5.511521610893899137e-01 -2.470616529648640127e-32 4.098411030660473814e-31 5.511521610893899137e-01 -4.882959606214692195e-32 1.689789368939267611e-31 5.511521610893899137e-01 5.488327734988232200e-32 1.105551267105412779e-30 5.511521610893899137e-01 3.948972551949973258e-32 4.236791473496065703e-32 5.511521610893899137e-01 1.467896205484483944e-32 -3.760565704431187602e-33 5.511521610893899137e-01 -1.622728334194530676e-32 -4.351169911801842326e-33 5.511521610893899137e-01 1.009095269639372584e-32 -3.770600943039630783e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.125409752510967341e-33 5.511521610893899137e-01 -2.563824720130054099e-33 -1.210573710252968691e-32 5.511521610893899137e-01 -8.364684178173658519e-35 -3.562862035178770419e-33 5.511521610893899137e-01 -1.340981708040922803e-33 -1.203726043983908681e-32 5.511521610893899137e-01 -7.805232285484782430e-34 -4.517713835111779152e-33 5.511521610893899137e-01 -2.024927040724557008e-34 -6.017684479694746072e-33 5.511521610893899137e-01 2.257412927744100416e-33 -5.272715056142616008e-33 5.511521610893899137e-01 -2.613690742523013622e-36 -3.003922052198036592e-33 5.511521610893899137e-01 -6.741731574779184697e-35 -1.506105436888603236e-33 5.511521610893899137e-01 1.004911441479089579e-33 -5.268094950616619123e-33 5.511521610893899137e-01 -5.184214008118828885e-34 -3.008165900406168430e-33 5.511521610893899137e-01 2.298379463647810836e-33 -5.267274112982947432e-33 5.511521610893899137e-01 6.582914481665234623e-34 -4.514931824066399512e-33 5.511521610893899137e-01 -5.253802576869495765e-34 -3.310111866805675240e-33 5.511521610893899137e-01 7.867353815190463358e-33 -3.297316724330122850e-33 5.511521610893899137e-01 2.602794223550400509e-33 -6.267518492633640369e-33 5.511521610893899137e-01 1.262180556773353332e-34 3.367877005470394605e-33 5.511521610893899137e-01 8.707306289057649163e-34 -4.925580128961828294e-33 5.511521610893899137e-01 9.345294637592855281e-34 -3.324455447762033530e-33 5.511521610893899137e-01 1.716932213358961582e-33 -3.048018773674135264e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.109014468594283237e-33 5.511521610893899137e-01 -5.622755668895527717e-34 -6.570352420979215920e-33 5.511521610893899137e-01 1.722399621043867116e-33 -3.008268044946562605e-33 5.511521610893899137e-01 -6.080545366322808843e-34 -4.781501242704400259e-33 5.511521610893899137e-01 3.838010613405255521e-33 -4.822341470658345308e-33 5.511521610893899137e-01 -2.932755047303569183e-33 -4.850467925291720360e-33 5.511521610893899137e-01 -1.827627959745173091e-32 -2.999355356190920271e-33 5.511521610893899137e-01 3.619148956511313883e-33 -4.895535484662552603e-33 5.511521610893899137e-01 2.389051134859181145e-34 -4.896958308940044797e-33 5.511521610893899137e-01 -1.377964295380245540e-32 -3.389381733865404280e-33 5.511521610893899137e-01 1.308953829062360029e-33 -6.776350379536638100e-33 5.511521610893899137e-01 1.088904753600586791e-33 -4.893235953106615606e-33 5.511521610893899137e-01 -2.128052782520143612e-34 -3.197250663484150737e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386379871721694157e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582679312323374569e-33 5.511521610893899137e-01 -1.629185103944478011e-34 -3.291512640788812789e-33 5.511521610893899137e-01 1.735230922648109921e-33 -3.314727078169783218e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 deleted file mode 100644 index 2b5dc8767..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_8 +++ /dev/null @@ -1 +0,0 @@ -1.806711336598328804e-02 1.409421330449194964e-30 3.791443320103482540e-32 1.805657788473700315e-02 1.062827799345986936e-30 -1.292581316342299398e-30 1.803532315507581918e-02 1.180769493513372141e-30 1.224883545742278985e-30 1.800297833654828858e-02 4.702500847272684229e-31 7.687985358095770542e-31 1.795897884004885731e-02 6.705698914802670139e-31 1.903163228811187253e-32 1.790255615419862958e-02 5.503853486405646783e-31 -4.442596643541410612e-31 1.783272397975311369e-02 4.011006079294889920e-31 -5.403333301397521871e-31 1.774826040735070012e-02 -1.006399579877223115e-31 2.247527024521629837e-31 1.764768579987054456e-02 -5.683994427484644451e-32 9.063282885881363816e-31 1.752923596687258612e-02 9.739837602568446055e-33 -5.615519624455993469e-31 1.739083013318851526e-02 -5.393187370346192394e-31 4.748096114124831692e-32 1.723003312461110145e-02 -1.280628529538821202e-30 2.349940842800636697e-31 1.704401110992252028e-02 -3.106560090443000140e-31 -1.685489629596535144e-32 1.682948016254097803e-02 1.072656372310652428e-30 1.469694771816673888e-31 1.658264684441760131e-02 -9.263641715558220427e-31 1.785243406463995023e-31 1.629913998435786673e-02 -2.965344071836276016e-32 -4.162423886925431250e-31 1.597393284255928247e-02 -2.017755089059754883e-32 -2.699070359958201799e-31 1.560125496213432550e-02 5.238698115317381787e-34 1.550899281276668078e-30 1.517449324991218020e-02 -2.196649816182515576e-31 5.043749065414007522e-31 1.468608228250591410e-02 7.173760446969209747e-33 8.802904790080362200e-32 1.412738459674193862e-02 6.380642315495872987e-33 -2.470616529648640127e-32 1.348856294507621081e-02 -9.781909590741513190e-33 -3.888458781806910150e-31 1.275844836638341008e-02 -1.573038638744831542e-32 5.488327734988232200e-32 1.192441070305258824e-02 2.393222809928629309e-33 -2.712690164858815077e-32 1.097224220731497953e-02 -1.174971233247231040e-32 -9.977164535934985846e-35 9.886070519491550745e-03 -1.524253962930136058e-33 -3.074995537067733714e-33 8.648324997547005705e-03 -6.321951170828711093e-34 -4.575739739925714751e-33 7.239790543698054748e-03 -3.827776008141302375e-33 -4.066241194489102664e-33 5.639795965338170042e-03 -1.455504942207753933e-32 2.150567978989621741e-33 3.826599396527695200e-03 2.636026561498492949e-33 -8.594012710484557682e-33 1.778050499221967354e-03 2.885542115883947223e-34 -3.774308344045064080e-34 -5.232206783301683161e-04 -1.682035059826884539e-34 9.936966919309771973e-35 -2.831879899226090978e-03 2.160106018361275099e-33 1.411430311854760236e-33 -4.931257503353858249e-03 -8.602645705920587643e-35 -3.714517189026420107e-33 -6.729993609239199107e-03 -2.972566291740817352e-33 -2.788226054807816039e-33 -8.135174008484019267e-03 3.648695857140544478e-33 5.173174611498185701e-33 -9.237347591479757453e-03 5.651005434159133659e-34 1.004420698277314868e-33 -1.014698800645182086e-02 -5.206406984452160238e-33 -5.184214008118828885e-34 -1.077926951605447450e-02 2.119832002711290432e-33 2.298379463647810836e-33 -1.093428609128605650e-02 -3.015421174779958754e-33 2.913088487362088749e-33 -1.061618448698502595e-02 -4.754132794684438376e-33 -5.257717173353933981e-34 -1.009354934550890821e-02 -4.203984796617222785e-33 -9.753507214731115624e-34 -9.430222685311991440e-03 5.335039079714446464e-33 -6.263139898173513117e-33 -8.566057161918480545e-03 -3.259384816415664526e-34 4.605267504791728498e-33 -7.379627388203574036e-03 -4.531250053637266733e-33 8.707306289057649163e-34 -5.911702033722796706e-03 -1.608063158613080095e-33 -1.398793121077393480e-33 -4.406180628828078143e-03 -6.979888567629792538e-34 -6.843049430542406552e-34 -3.080199348376857355e-03 1.220313526918869399e-33 -9.042311532760118781e-34 -1.921731481273175265e-03 1.508854035999832956e-33 -5.664766445869374180e-34 -9.168351317392290766e-04 -3.990061490866478591e-33 -8.978536526698844924e-33 -4.109022705331527819e-05 7.236292230237556541e-34 -5.982309999929781922e-34 7.301963518011125604e-04 -4.548476114407360038e-33 3.832685179751328113e-33 1.406084070286037343e-03 8.836395442841935703e-33 -2.932755047303569183e-33 1.995149761950515150e-03 1.683777575254716931e-32 -1.827627959745173091e-32 2.505409581427200764e-03 2.932761959762336215e-33 3.619148956511313883e-33 2.944200587550648007e-03 -1.159682692093020224e-32 2.389051134859181145e-34 3.311049968435234719e-03 -4.516448044940250150e-33 7.230496779092677483e-33 3.606278702120196272e-03 -5.691170918874049770e-33 1.307920275296015364e-33 3.840479891835154279e-03 6.754265949370798883e-33 1.088904753600586791e-33 4.022574995710576605e-03 1.462803637524868075e-36 -2.125190800330826990e-34 4.159820032485237427e-03 -9.767636771861241842e-34 -2.503974908514965981e-34 4.257896095069992407e-03 -8.124208054879120773e-34 1.271011556946934550e-34 4.320988971261963650e-03 5.365807209145916773e-34 -1.627622228731936620e-34 4.351852527843493544e-03 -1.078387385112303824e-33 -2.609950498376899706e-34 1.409421330449194964e-30 5.511521610893899137e-01 4.109038320034489288e-29 1.062827799345986936e-30 5.511521610893899137e-01 2.884519767204063391e-29 1.180769493513372141e-30 5.511521610893899137e-01 -3.471029240878280159e-28 4.702500847272684229e-31 5.511521610893899137e-01 -2.482913206110615654e-29 6.705698914802670139e-31 5.511521610893899137e-01 -4.762745872744839086e-29 5.503853486405646783e-31 5.511521610893899137e-01 -1.220446525323430312e-30 4.011006079294889920e-31 5.511521610893899137e-01 -2.327114933879150980e-31 -1.006399579877223115e-31 5.511521610893899137e-01 -2.609694446083101317e-31 -5.683994427484644451e-32 5.511521610893899137e-01 -6.813645921479329469e-32 9.739837602568446055e-33 5.511521610893899137e-01 5.052296712245193520e-32 -5.393187370346192394e-31 5.511521610893899137e-01 6.742443697242529811e-33 -1.280628529538821202e-30 5.511521610893899137e-01 -5.979600512855226819e-32 -3.106560090443000140e-31 5.511521610893899137e-01 -2.254652443717403436e-31 1.072656372310652428e-30 5.511521610893899137e-01 -1.835088247219043480e-32 -9.263641715558220427e-31 5.511521610893899137e-01 -4.379169768228529425e-32 -2.965344071836276016e-32 5.511521610893899137e-01 -3.212800472530549036e-32 -2.017755089059754883e-32 5.511521610893899137e-01 7.894942837571399296e-32 5.238698115317381787e-34 5.511521610893899137e-01 4.354859286719888466e-34 -2.196649816182515576e-31 5.511521610893899137e-01 6.462118883197823475e-32 7.173760446969209747e-33 5.511521610893899137e-01 2.316516037742253615e-31 6.380642315495872987e-33 5.511521610893899137e-01 3.968667318365815120e-31 -9.781909590741513190e-33 5.511521610893899137e-01 1.704022483468703161e-31 -1.573038638744831542e-32 5.511521610893899137e-01 1.108583391856955513e-30 2.393222809928629309e-33 5.511521610893899137e-01 4.839510252324944016e-32 -1.174971233247231040e-32 5.511521610893899137e-01 7.641576859304135297e-34 -1.524253962930136058e-33 5.511521610893899137e-01 -1.339305856778594244e-33 -6.321951170828711093e-34 5.511521610893899137e-01 -7.607516662531926255e-34 -3.827776008141302375e-33 5.511521610893899137e-01 3.785970087242830488e-34 -1.455504942207753933e-32 5.511521610893899137e-01 -6.982170696299638299e-35 2.636026561498492949e-33 5.511521610893899137e-01 1.980329397432504876e-34 2.885542115883947223e-34 5.511521610893899137e-01 -2.654513132401053575e-37 -1.682035059826884539e-34 5.511521610893899137e-01 -3.875412129620557616e-36 2.160106018361275099e-33 5.511521610893899137e-01 5.191507755215942904e-37 -8.602645705920587643e-35 5.511521610893899137e-01 -6.767573582980993981e-36 -2.972566291740817352e-33 5.511521610893899137e-01 4.988214959649010859e-36 3.648695857140544478e-33 5.511521610893899137e-01 -2.447716552176715167e-36 5.651005434159133659e-34 5.511521610893899137e-01 -1.859314732544452388e-36 -5.206406984452160238e-33 5.511521610893899137e-01 6.643397477786722474e-37 2.119832002711290432e-33 5.511521610893899137e-01 -1.150330674446841035e-36 -3.015421174779958754e-33 5.511521610893899137e-01 -9.980648125227584068e-37 -4.754132794684438376e-33 5.511521610893899137e-01 -1.871769035231830432e-35 -4.203984796617222785e-33 5.511521610893899137e-01 -4.972637365541917370e-36 5.335039079714446464e-33 5.511521610893899137e-01 1.274208728763331596e-34 -3.259384816415664526e-34 5.511521610893899137e-01 8.634510955108184479e-33 -4.531250053637266733e-33 5.511521610893899137e-01 -3.515134532180869001e-35 -1.608063158613080095e-33 5.511521610893899137e-01 6.112047175480541048e-35 -6.979888567629792538e-34 5.511521610893899137e-01 1.495090750963376133e-34 1.220313526918869399e-33 5.511521610893899137e-01 1.843272595358051398e-34 1.508854035999832956e-33 5.511521610893899137e-01 2.035404475865304381e-34 -3.990061490866478591e-33 5.511521610893899137e-01 1.925120824253144312e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.150196590899929294e-34 -4.548476114407360038e-33 5.511521610893899137e-01 7.216299027763283840e-35 8.836395442841935703e-33 5.511521610893899137e-01 4.386276564750608690e-35 1.683777575254716931e-32 5.511521610893899137e-01 1.416806077627147752e-35 2.932761959762336215e-33 5.511521610893899137e-01 -3.286573472097530610e-36 -1.159682692093020224e-32 5.511521610893899137e-01 -4.782331738568268762e-36 -4.516448044940250150e-33 5.511521610893899137e-01 -3.069916833668002172e-36 -5.691170918874049770e-33 5.511521610893899137e-01 -5.130540096264236742e-36 6.754265949370798883e-33 5.511521610893899137e-01 -2.808957395281953115e-36 1.462803637524868075e-36 5.511521610893899137e-01 1.463931694700338780e-37 -9.767636771861241842e-34 5.511521610893899137e-01 -9.108146734402299417e-37 -8.124208054879120773e-34 5.511521610893899137e-01 9.821770445021751647e-38 5.365807209145916773e-34 5.511521610893899137e-01 -1.280861203138393574e-37 -1.078387385112303824e-33 5.511521610893899137e-01 1.756711259019237455e-37 3.791443320103482540e-32 4.108436466926868277e-29 5.511521610893899137e-01 -1.292581316342299398e-30 2.879704942343095302e-29 5.511521610893899137e-01 1.224883545742278985e-30 -3.471089426189042260e-28 5.511521610893899137e-01 7.687985358095770542e-31 -2.482913206110615654e-29 5.511521610893899137e-01 1.903163228811187253e-32 -4.762745872744839086e-29 5.511521610893899137e-01 -4.442596643541410612e-31 -1.226465056399640424e-30 5.511521610893899137e-01 -5.403333301397521871e-31 -2.327114933879150980e-31 5.511521610893899137e-01 2.247527024521629837e-31 -2.609694446083101317e-31 5.511521610893899137e-01 9.063282885881363816e-31 -6.813645921479329469e-32 5.511521610893899137e-01 -5.615519624455993469e-31 5.052296712245193520e-32 5.511521610893899137e-01 4.748096114124831692e-32 -1.733168060759791835e-32 5.511521610893899137e-01 2.349940842800636697e-31 -5.979600512855226819e-32 5.511521610893899137e-01 -1.685489629596535144e-32 -2.254652443717403436e-31 5.511521610893899137e-01 1.469694771816673888e-31 -1.835088247219043480e-32 5.511521610893899137e-01 1.785243406463995023e-31 -6.786582198712573694e-32 5.511521610893899137e-01 -4.162423886925431250e-31 -8.027625333498638668e-32 5.511521610893899137e-01 -2.699070359958201799e-31 3.080117976603310211e-32 5.511521610893899137e-01 1.550899281276668078e-30 4.354859286719888466e-34 5.511521610893899137e-01 5.043749065414007522e-31 8.869531313681868291e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.436886659266455856e-31 5.511521610893899137e-01 -2.470616529648640127e-32 4.089037939890017361e-31 5.511521610893899137e-01 -3.888458781806910150e-31 1.688976155778177881e-31 5.511521610893899137e-01 5.488327734988232200e-32 1.105574126318850457e-30 5.511521610893899137e-01 -2.712690164858815077e-32 4.237657144703933359e-32 5.511521610893899137e-01 -9.977164535934985846e-35 -3.749740621227170672e-33 5.511521610893899137e-01 -3.074995537067733714e-33 -4.348571394883650093e-33 5.511521610893899137e-01 -4.575739739925714751e-33 -3.770017204358248218e-33 5.511521610893899137e-01 -4.066241194489102664e-33 -1.126035760328245175e-33 5.511521610893899137e-01 2.150567978989621741e-33 -1.210688385938322066e-32 5.511521610893899137e-01 -8.594012710484557682e-33 -3.563548982888069281e-33 5.511521610893899137e-01 -3.774308344045064080e-34 -1.203732760373346415e-32 5.511521610893899137e-01 9.936966919309771973e-35 -4.517773719287204940e-33 5.511521610893899137e-01 1.411430311854760236e-33 -6.018011925434590048e-33 5.511521610893899137e-01 -3.714517189026420107e-33 -5.272982265266828970e-33 5.511521610893899137e-01 -2.788226054807816039e-33 -3.004277323145407374e-33 5.511521610893899137e-01 5.173174611498185701e-33 -1.507080485604705087e-33 5.511521610893899137e-01 1.004420698277314868e-33 -5.268074006416393044e-33 5.511521610893899137e-01 -5.184214008118828885e-34 -3.008601198357277368e-33 5.511521610893899137e-01 2.298379463647810836e-33 -5.267365022358294863e-33 5.511521610893899137e-01 2.913088487362088749e-33 -4.514896371970106534e-33 5.511521610893899137e-01 -5.257717173353933981e-34 -3.310101872654723295e-33 5.511521610893899137e-01 -9.753507214731115624e-34 -3.296356819667947391e-33 5.511521610893899137e-01 -6.263139898173513117e-33 -6.267268395596912081e-33 5.511521610893899137e-01 4.605267504791728498e-33 3.368296263424337811e-33 5.511521610893899137e-01 8.707306289057649163e-34 -4.925207844742524467e-33 5.511521610893899137e-01 -1.398793121077393480e-33 -3.324303258613382826e-33 5.511521610893899137e-01 -6.843049430542406552e-34 -3.047835559140283959e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.107056922766599540e-33 5.511521610893899137e-01 -5.664766445869374180e-34 -6.567307013149844966e-33 5.511521610893899137e-01 -8.978536526698844924e-33 -3.004832551811307783e-33 5.511521610893899137e-01 -5.982309999929781922e-34 -4.775036840330723745e-33 5.511521610893899137e-01 3.832685179751328113e-33 -4.817893509143082799e-33 5.511521610893899137e-01 -2.932755047303569183e-33 -4.846193733773209144e-33 5.511521610893899137e-01 -1.827627959745173091e-32 -2.995097477328784548e-33 5.511521610893899137e-01 3.619148956511313883e-33 -4.893343072892813665e-33 5.511521610893899137e-01 2.389051134859181145e-34 -4.894838831159284939e-33 5.511521610893899137e-01 7.230496779092677483e-33 -3.388493647201856377e-33 5.511521610893899137e-01 1.307920275296015364e-33 -6.775978000832638893e-33 5.511521610893899137e-01 1.088904753600586791e-33 -4.892865456815997765e-33 5.511521610893899137e-01 -2.125190800330826990e-34 -3.197198241067151656e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386334545041629000e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582670146900360426e-33 5.511521610893899137e-01 -1.627622228731936620e-34 -3.291512268422719519e-33 5.511521610893899137e-01 -2.609950498376899706e-34 -3.314718398192948455e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 b/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 deleted file mode 100644 index 3ca418b6e..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton.hess_9 +++ /dev/null @@ -1 +0,0 @@ -1.807287672320099028e-02 3.164087156628939504e-31 9.942975825973756746e-31 1.806244665201316504e-02 -1.085177402730688066e-30 1.694466978071154796e-30 1.804140473746466966e-02 -2.969524457806788919e-30 1.872996459437099683e-31 1.800938416947807721e-02 4.702500847272684229e-31 7.687608739825321013e-31 1.796582650400196587e-02 -3.029328851137965171e-30 1.903163228811187253e-32 1.790997161198396373e-02 5.503853486405646783e-31 4.120665466624815181e-31 1.784084398192265636e-02 4.011244058800179774e-31 1.028320477955721576e-30 1.775723511144627897e-02 -1.524641943227125187e-30 2.247330918814019639e-31 1.765768165947211726e-02 -5.682401887581259434e-32 -5.607940717539653123e-32 1.754043894553080490e-02 9.739837602568446055e-33 1.325538945151555855e-32 1.740344930861694242e-02 -2.673332581443883287e-32 -8.066475638589354568e-32 1.724430475397105075e-02 2.363182077915059793e-30 2.349298806889960130e-31 1.706020323396765029e-02 -3.107064287059630793e-31 -4.204768928243035181e-31 1.684789783376705596e-02 1.072577494976792241e-30 1.468905998478072015e-31 1.660363807154877080e-02 -9.264872277873667333e-31 -4.520619358755593171e-31 1.632310248805226779e-02 -2.965344071836276016e-32 -4.162423886925431250e-31 1.600132171929377622e-02 -2.025209179592617023e-32 2.208702846878285599e-31 1.563259134351488791e-02 -8.650930104970672751e-31 -1.802185303913225370e-31 1.521037402686594570e-02 -2.196649816182515576e-31 1.226021397410734054e-31 1.472719092416708946e-02 7.138628672296636600e-33 8.802904790080362200e-32 1.417450302697508338e-02 -3.655812497529102183e-31 -2.471986719052780083e-32 1.354258432862065833e-02 8.886840178566166225e-32 7.155258673008218071e-32 1.282039048543549657e-02 4.249438718672782935e-32 -1.789690272568214350e-32 1.199542934549937753e-02 2.389923208440380923e-33 1.643402474908239138e-32 1.105364361052948129e-02 5.449939623461131350e-33 -9.716741310014274257e-35 9.979321377856910022e-03 3.580908177937360760e-33 -3.070865982252067423e-33 8.755057805725286954e-03 -6.330180308084747197e-34 1.365673676454876113e-32 7.361801069419062794e-03 1.250035460668059189e-32 1.226056933539344084e-32 5.779028399042017601e-03 1.203637185508669357e-34 3.067647984389174742e-33 3.985113222356582129e-03 2.636026561498492949e-33 4.654431603932868533e-33 1.957961460083287690e-03 -2.714472459481445071e-33 1.124440004305540693e-33 -3.232430373775946938e-04 -1.035349427030647488e-33 1.005598138711710790e-34 -2.644175407615291691e-03 -2.874880064197850637e-33 1.529347374910233844e-34 -4.763428138426785766e-03 1.078265221712011597e-33 5.599816241143319680e-33 -6.590248810475938905e-03 -1.166680527405230685e-32 -1.158196583934431043e-33 -8.031607666879369070e-03 -4.445355006707590199e-34 -3.010634469532647036e-33 -9.148589770501652438e-03 5.651005434159133659e-34 -9.398904360574760081e-34 -1.007565331569645721e-02 2.251107472276590388e-33 -5.178706242641185794e-34 -1.074152350426420613e-02 -1.489711957138894375e-33 -1.311035468714979987e-33 -1.094118737353279476e-02 5.117256287909316903e-34 -6.140429152333295727e-34 -1.065639968735614118e-02 2.203117986637698052e-33 -5.257717173353933981e-34 -1.014773521899640062e-02 2.718127069683124700e-33 -7.896988047986915536e-33 -9.497801010947116637e-03 -1.608789120202838326e-33 4.152363634485582691e-33 -8.662336448804963326e-03 -3.259384816415664526e-34 -2.413982160259627036e-33 -7.507254141933886182e-03 -1.181267332960900537e-33 -9.158256581189675172e-34 -6.067263763080232505e-03 2.227444846913826618e-34 4.320145222270692769e-34 -4.549263176778189748e-03 -6.974255266373161154e-34 -6.843049430542406552e-34 -3.208920581501915285e-03 1.217902941105186126e-33 -9.042311532760118781e-34 -2.037080915246171960e-03 9.602999019172642638e-33 -5.664766445869374180e-34 -1.019935965791402173e-03 -3.990061490866478591e-33 7.853838189085814910e-33 -1.353488757122176173e-04 7.236292230237556541e-34 -5.982309999929781922e-34 6.436213374585932241e-04 -4.546823513834103787e-33 3.829379978604814926e-33 1.326408407110067286e-03 8.836395442841935703e-33 -2.936344435061161726e-33 1.921607069993320691e-03 -1.289885248227656694e-32 2.137320683870446837e-32 2.437264443250392303e-03 2.932761959762336215e-33 3.617043637372483973e-33 2.880756137315133164e-03 -8.951878579547795097e-34 2.366366155393414663e-34 3.253921765575504364e-03 1.023267826489446956e-33 -3.850151013787885202e-33 3.554785550054229571e-03 2.853858458901780832e-35 1.307272369824395214e-33 3.793603431702712199e-03 -1.242946472815877787e-33 1.089590271795947122e-33 3.979394086684456301e-03 1.642691454571552590e-36 5.814442342299030255e-33 4.119495836177664363e-03 -9.765765009792075833e-34 -2.503974908514965981e-34 4.219656142252208725e-03 2.308659076579265217e-33 1.271011556946934550e-34 4.284110738441826612e-03 1.424476173859684447e-34 1.328560682228456524e-34 4.315646821968673920e-03 2.091326642826814645e-33 -6.290035997558984419e-35 3.164087156628939504e-31 5.511521610893899137e-01 4.109018244191380040e-29 -1.085177402730688066e-30 5.511521610893899137e-01 2.884519259740471962e-29 -2.969524457806788919e-30 5.511521610893899137e-01 -3.471004292635915296e-28 4.702500847272684229e-31 5.511521610893899137e-01 -2.481915189565772335e-29 -3.029328851137965171e-30 5.511521610893899137e-01 -4.762648758124759363e-29 5.503853486405646783e-31 5.511521610893899137e-01 -1.222092255011954608e-30 4.011244058800179774e-31 5.511521610893899137e-01 -2.342972818317967151e-31 -1.524641943227125187e-30 5.511521610893899137e-01 -2.626521983575185370e-31 -5.682401887581259434e-32 5.511521610893899137e-01 -6.855912233401724089e-32 9.739837602568446055e-33 5.511521610893899137e-01 5.046074733967154048e-32 -2.673332581443883287e-32 5.511521610893899137e-01 6.759169400138994932e-33 2.363182077915059793e-30 5.511521610893899137e-01 -4.925693231242576936e-32 -3.107064287059630793e-31 5.511521610893899137e-01 -2.275350319505702927e-31 1.072577494976792241e-30 5.511521610893899137e-01 -2.842563117938824155e-32 -9.264872277873667333e-31 5.511521610893899137e-01 -4.639266084832117991e-32 -2.965344071836276016e-32 5.511521610893899137e-01 -3.134016789180174896e-32 -2.025209179592617023e-32 5.511521610893899137e-01 8.087905493957705687e-32 -8.650930104970672751e-31 5.511521610893899137e-01 -3.041282362580032157e-34 -2.196649816182515576e-31 5.511521610893899137e-01 6.379273141718118446e-32 7.138628672296636600e-33 5.511521610893899137e-01 2.308108875491821155e-31 -3.655812497529102183e-31 5.511521610893899137e-01 3.968214502418553227e-31 8.886840178566166225e-32 5.511521610893899137e-01 1.704228900262278559e-31 4.249438718672782935e-32 5.511521610893899137e-01 1.108584415097579557e-30 2.389923208440380923e-33 5.511521610893899137e-01 4.839556798109347675e-32 5.449939623461131350e-33 5.511521610893899137e-01 7.631139078059495742e-34 3.580908177937360760e-33 5.511521610893899137e-01 -1.339598673657634186e-33 -6.330180308084747197e-34 5.511521610893899137e-01 -7.614489537121553831e-34 1.250035460668059189e-32 5.511521610893899137e-01 3.799369442434800067e-34 1.203637185508669357e-34 5.511521610893899137e-01 -6.988073990787023096e-35 2.636026561498492949e-33 5.511521610893899137e-01 1.986600580704522294e-34 -2.714472459481445071e-33 5.511521610893899137e-01 -3.664465101049645506e-37 -1.035349427030647488e-33 5.511521610893899137e-01 -3.876298429759674771e-36 -2.874880064197850637e-33 5.511521610893899137e-01 6.414819634859823859e-37 1.078265221712011597e-33 5.511521610893899137e-01 -6.882227971923951538e-36 -1.166680527405230685e-32 5.511521610893899137e-01 4.942521982876558586e-36 -4.445355006707590199e-34 5.511521610893899137e-01 -2.102322576033843612e-36 5.651005434159133659e-34 5.511521610893899137e-01 -1.892710780859099885e-36 2.251107472276590388e-33 5.511521610893899137e-01 7.565288363685921993e-37 -1.489711957138894375e-33 5.511521610893899137e-01 -1.121573214330675443e-36 5.117256287909316903e-34 5.511521610893899137e-01 -1.003170074323236142e-36 2.203117986637698052e-33 5.511521610893899137e-01 -1.878090125021735637e-35 2.718127069683124700e-33 5.511521610893899137e-01 -5.325069368220264756e-36 -1.608789120202838326e-33 5.511521610893899137e-01 1.272756291696468634e-34 -3.259384816415664526e-34 5.511521610893899137e-01 8.634118525923798869e-33 -1.181267332960900537e-33 5.511521610893899137e-01 -3.515729058050027646e-35 2.227444846913826618e-34 5.511521610893899137e-01 6.119266067379315353e-35 -6.974255266373161154e-34 5.511521610893899137e-01 1.493218671503615264e-34 1.217902941105186126e-33 5.511521610893899137e-01 1.825837817773036302e-34 9.602999019172642638e-33 5.511521610893899137e-01 2.020457013198977008e-34 -3.990061490866478591e-33 5.511521610893899137e-01 1.900093425692108319e-34 7.236292230237556541e-34 5.511521610893899137e-01 1.119048685104252743e-34 -4.546823513834103787e-33 5.511521610893899137e-01 6.935980761220657147e-35 8.836395442841935703e-33 5.511521610893899137e-01 4.084926185444964587e-35 -1.289885248227656694e-32 5.511521610893899137e-01 1.255302636380236061e-35 2.932761959762336215e-33 5.511521610893899137e-01 -4.509529047892060847e-36 -8.951878579547795097e-34 5.511521610893899137e-01 -5.880793396288818814e-36 1.023267826489446956e-33 5.511521610893899137e-01 -3.532495649918603502e-36 2.853858458901780832e-35 5.511521610893899137e-01 -5.365131284508042127e-36 -1.242946472815877787e-33 5.511521610893899137e-01 -2.806322324567701582e-36 1.642691454571552590e-36 5.511521610893899137e-01 1.072004369155120361e-37 -9.765765009792075833e-34 5.511521610893899137e-01 -9.663381986857736476e-37 2.308659076579265217e-33 5.511521610893899137e-01 1.260146771585506233e-37 1.424476173859684447e-34 5.511521610893899137e-01 -1.282820976068467938e-37 2.091326642826814645e-33 5.511521610893899137e-01 1.734424440223135084e-37 9.942975825973756746e-31 4.108416391083759029e-29 5.511521610893899137e-01 1.694466978071154796e-30 2.879704434879503872e-29 5.511521610893899137e-01 1.872996459437099683e-31 -3.471064477946677397e-28 5.511521610893899137e-01 7.687608739825321013e-31 -2.481915189565772335e-29 5.511521610893899137e-01 1.903163228811187253e-32 -4.762648758124759363e-29 5.511521610893899137e-01 4.120665466624815181e-31 -1.228110786088164720e-30 5.511521610893899137e-01 1.028320477955721576e-30 -2.342972818317967151e-31 5.511521610893899137e-01 2.247330918814019639e-31 -2.626521983575185370e-31 5.511521610893899137e-01 -5.607940717539653123e-32 -6.855912233401724089e-32 5.511521610893899137e-01 1.325538945151555855e-32 5.046074733967154048e-32 5.511521610893899137e-01 -8.066475638589354568e-32 -1.731495490470145186e-32 5.511521610893899137e-01 2.349298806889960130e-31 -4.925693231242576936e-32 5.511521610893899137e-01 -4.204768928243035181e-31 -2.275350319505702927e-31 5.511521610893899137e-01 1.468905998478072015e-31 -2.842563117938824155e-32 5.511521610893899137e-01 -4.520619358755593171e-31 -7.046678515316162260e-32 5.511521610893899137e-01 -4.162423886925431250e-31 -7.948841650148264529e-32 5.511521610893899137e-01 2.208702846878285599e-31 3.273080632989616601e-32 5.511521610893899137e-01 -1.802185303913225370e-31 -3.041282362580032157e-34 5.511521610893899137e-01 1.226021397410734054e-31 8.786685572202163262e-32 5.511521610893899137e-01 8.802904790080362200e-32 2.428479497016023395e-31 5.511521610893899137e-01 -2.471986719052780083e-32 4.088585123942755468e-31 5.511521610893899137e-01 7.155258673008218071e-32 1.689182572571753279e-31 5.511521610893899137e-01 -1.789690272568214350e-32 1.105575149559474501e-30 5.511521610893899137e-01 1.643402474908239138e-32 4.237703690488337019e-32 5.511521610893899137e-01 -9.716741310014274257e-35 -3.750784399351634456e-33 5.511521610893899137e-01 -3.070865982252067423e-33 -4.348864211762690035e-33 5.511521610893899137e-01 1.365673676454876113e-32 -3.770714491817210719e-33 5.511521610893899137e-01 1.226056933539344084e-32 -1.124695824809048175e-33 5.511521610893899137e-01 3.067647984389174742e-33 -1.210694289232809478e-32 5.511521610893899137e-01 4.654431603932868533e-33 -3.562921864560867240e-33 5.511521610893899137e-01 1.124440004305540693e-33 -1.203742859893032863e-32 5.511521610893899137e-01 1.005598138711710790e-34 -4.517774605587343724e-33 5.511521610893899137e-01 1.529347374910233844e-34 -6.017889594246625378e-33 5.511521610893899137e-01 5.599816241143319680e-33 -5.273096919655771717e-33 5.511521610893899137e-01 -1.158196583934431043e-33 -3.004323016122179853e-33 5.511521610893899137e-01 -3.010634469532647036e-33 -1.506735091628562241e-33 5.511521610893899137e-01 -9.398904360574760081e-34 -5.268107402464707528e-33 5.511521610893899137e-01 -5.178706242641185794e-34 -3.008509009268687593e-33 5.511521610893899137e-01 -1.311035468714979987e-33 -5.267336264898178871e-33 5.511521610893899137e-01 -6.140429152333295727e-34 -4.514901477231906738e-33 5.511521610893899137e-01 -5.257717173353933981e-34 -3.310165083552622606e-33 5.511521610893899137e-01 -7.896988047986915536e-33 -3.296709251670625592e-33 5.511521610893899137e-01 4.152363634485582691e-33 -6.267413639303598356e-33 5.511521610893899137e-01 -2.413982160259627036e-33 3.367903834239951517e-33 5.511521610893899137e-01 -9.158256581189675172e-34 -4.925213790001215978e-33 5.511521610893899137e-01 4.320145222270692769e-34 -3.324231069694394901e-33 5.511521610893899137e-01 -6.843049430542406552e-34 -3.048022767086260110e-33 5.511521610893899137e-01 -9.042311532760118781e-34 -3.108800400525101071e-33 5.511521610893899137e-01 -5.664766445869374180e-34 -6.568801759416477704e-33 5.511521610893899137e-01 7.853838189085814910e-33 -3.007335291667411233e-33 5.511521610893899137e-01 -5.982309999929781922e-34 -4.778151630910291400e-33 5.511521610893899137e-01 3.829379978604814926e-33 -4.820696691808509002e-33 5.511521610893899137e-01 -2.936344435061161726e-33 -4.849207237566265671e-33 5.511521610893899137e-01 2.137320683870446837e-32 -2.996712511741253756e-33 5.511521610893899137e-01 3.617043637372483973e-33 -4.894566028468608426e-33 5.511521610893899137e-01 2.366366155393414663e-34 -4.895937292817005625e-33 5.511521610893899137e-01 -3.850151013787885202e-33 -3.388956226018107084e-33 5.511521610893899137e-01 1.307272369824395214e-33 -6.776212592020882888e-33 5.511521610893899137e-01 1.089590271795947122e-33 -4.892862821745283761e-33 5.511521610893899137e-01 5.814442342299030255e-33 -3.197237433799706242e-33 5.511521610893899137e-01 -2.503974908514965981e-34 -3.386390068566874718e-33 5.511521610893899137e-01 1.271011556946934550e-34 -6.582642349927652142e-33 5.511521610893899137e-01 1.328560682228456524e-34 -3.291512464400012793e-33 5.511521610893899137e-01 -6.290035997558984419e-35 -3.314720626874827970e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener deleted file mode 100644 index 628200486..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_0.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04275027929649642 -1 0.04278020085843042 -2 0.042841306080199114 -3 0.04293616991274339 -4 0.04306878310572499 -5 0.043244710139460636 -6 0.04347130612588618 -7 0.04375799752770975 -8 0.0441166318622986 -9 0.044561900975706614 -10 0.04511184046984128 -11 0.04578840368360244 -12 0.04661810119826244 -13 0.04763268470416382 -14 0.048869835332139476 -15 0.050373788872664964 -16 0.05219579100648223 -17 0.05439422210924104 -18 0.05703416152266364 -19 0.06018607576352497 -20 0.0639232188721544 -21 0.06831723895029577 -22 0.07343138940685787 -23 0.07930835809046836 -24 0.08595531643455993 -25 0.09332781491095406 -26 0.10129875441183091 -27 0.10963150524586682 -28 0.1179797107559022 -29 0.12588668450888285 -30 0.1328434305277984 -31 0.13854559498311456 -32 0.14278838898884882 -33 0.1453885360112828 -34 0.1461854077451984 -35 0.14512910883487187 -36 0.1424782687516996 -37 0.1386015608427453 -38 0.13378570900164893 -39 0.12806948908144877 -40 0.12148133678532885 -41 0.11416218889878457 -42 0.10645677618433959 -43 0.09868394933803322 -44 0.09109590790904701 -45 0.08387528274125837 -46 0.07712198267203546 -47 0.070891806102701 -48 0.06521352205057637 -49 0.06009428336266686 -50 0.05552463757222115 -51 0.05147705342355682 -52 0.0479089553970462 -53 0.04477923434803962 -54 0.04205021062749422 -55 0.039687820590206646 -56 0.037661691498033195 -57 0.035945151713104466 -58 0.03451522317228356 -59 0.03335251502993871 -60 0.0324411007228787 -61 0.03176840003345971 -62 0.03132507558492764 -63 0.031104950321266492 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz deleted file mode 100644 index 344b33b94..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9113467178159012 1.52981473979834e-17 -7.285963317525396e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9118207030005194 2.4356512675384276e-17 -4.0371305039281874e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9127743388359983 3.454511287684024e-17 -2.4342198996719724e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9142190279772142 -3.7805832133561053e-17 -6.187356610896914e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9161720534593132 8.08847126094152e-17 -1.8444388620018818e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9186567927099443 7.624575724484052e-17 -4.2919769635106175e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9217030010428517 6.272071258496405e-17 -3.9391032327044283e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.925347162129954 1.4141367885175324e-17 3.146741008977123e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9296329011007516 1.1088047906842848e-18 5.835085188499181e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9346114531277034 -2.0504488237343844e-17 1.7701525078822793e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.940342176301173 3.559466455352199e-17 2.7495111659289614e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.946893091891418 -3.045864829789633e-17 2.119102352303812e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9543414272689816 8.067035165472685e-18 4.121068695006254e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9627741262623368 -1.870788975333611e-17 5.3084548060882654e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9722882779667155 3.660444927292243e-17 3.251847136040509e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9829913973364102 1.3581447031430828e-17 3.125576604787391e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9950014687017616 -4.118705058000745e-17 3.446492762707248e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0084466362117483 -8.865062328403779e-17 1.7844272464522037e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.023464393037961 -7.602811454023911e-18 -9.871186330915401e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.040200084553638 -3.138237495724817e-17 -6.265535927027836e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.058804501263267 8.677553375451521e-17 -2.931272198935586e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.0794302982439206 6.094602264010128e-17 -2.2996176940207053e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.1022268171987384 3.197486758250074e-17 -1.3578778968453203e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.12732287599752 1.1318785368923217e-17 -7.646027667241512e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.1548113892755625 5.856403062013724e-18 -2.9676360444466984e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.184740467910381 1.441457238308895e-18 2.0153685010153982e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.2171055515686695 7.804693693893463e-18 1.6432711070823478e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.2518435689574163 1.153667377461574e-18 3.3992772049736565e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.288831104402282 9.909985187319486e-18 2.4231000161257828e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.327894237667093 1.991549964551224e-18 2.7065499685146866e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.368811106170914 5.066131804225531e-18 1.5278164473742527e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4113136582980177 2.515670410582171e-18 1.3655658877007711e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.4550878098511 -1.343254400198156e-18 4.472104759015239e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.4997817856351814 4.997962653857424e-18 -1.7534271430040907e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.5450212267834305 -5.125458072305984e-18 -2.21598359122604e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.5904292073919266 3.982635935733684e-18 -5.515340484734182e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.635639130456872 -4.045198320447347e-18 5.424655960822307e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.6803020888246514 -2.174743890960021e-18 -8.825199777786374e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7240933384758597 8.631783923228953e-19 -6.31502755059402e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.766719372056884 -6.178874722888603e-18 2.9446121414646406e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.807927284146484 7.483317567898438e-18 -1.6695814083938387e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.847512053619732 -7.662581215227974e-18 8.093731858821852e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.8853201853486885 7.242012928022721e-18 9.588665338036008e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.9212436403689885 -2.811830352432161e-18 1.1515156930841316e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9552123071239187 1.1669855271938639e-18 -1.6094522284859282e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9871872780225495 3.3800547434177307e-18 -8.558646627551363e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.0171547361444437 -8.44164941413383e-18 1.4818503032186843e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.0451205324165964 1.1886871268958032e-17 -1.0706329863426312e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0711057380030007 -1.4680856377692787e-17 1.4999959841514587e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.095143219172094 1.5904706042676323e-17 -1.3944790716929502e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.1172743484169367 -1.6426454527125003e-17 1.4766377831313285e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.13754618894071 1.5724518477437784e-17 -7.225885441206907e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.1560091217074677 -1.395724218161694e-17 8.968709669575571e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1727148674098062 1.2261064884780166e-17 -1.302289598660321e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.187714854623662 -9.88644752264553e-18 1.0227256347251076e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.201058886885623 7.329293159836358e-18 1.1842007005921356e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.212794064539282 -4.966689961692812e-18 2.675882485238888e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.2229638372071734 3.675682829397587e-18 -1.461982837251266e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.231607017584284 -2.510742621139139e-18 5.638588561064134e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.2387573434972587 1.4051126587625507e-18 -6.375374530429193e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2444432086929433 -8.575319617855292e-19 -1.0301959660137817e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2486874830520263 3.741308854417688e-19 7.590407877874241e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2515073967721797 -7.699661337650653e-20 3.7502729432308877e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.25291446930372 -2.1132103023772633e-19 -7.945729957343846e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener deleted file mode 100644 index f2faacc95..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_1.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04139064492444978 -1 0.04139364161946814 -2 0.04139998021778682 -3 0.041410381392008914 -4 0.04142600406782261 -5 0.04144854541319732 -6 0.041480385309005906 -7 0.0415247855094199 -8 0.04158615700073799 -9 0.04167041273763614 -10 0.04178542686323676 -11 0.04194162540489177 -12 0.042152736679326286 -13 0.04243673116281114 -14 0.04281697859365053 -15 0.043323641749235024 -16 0.0439953074233546 -17 0.04488081951294205 -18 0.04604121850887172 -19 0.047551595586775304 -20 0.04950252605066836 -21 0.052000545274302 -22 0.055166864099561605 -23 0.05913286995808192 -24 0.06403041987551535 -25 0.06997518063752493 -26 0.07704141806248538 -27 0.08523000464733294 -28 0.09443335334864929 -29 0.10437372905599929 -30 0.11455911316135221 -31 0.12429544251244935 -32 0.13274800822157265 -33 0.13938270350379953 -34 0.14390050573425775 -35 0.14604213071632915 -36 0.14562799323555595 -37 0.14289197665023395 -38 0.1384066592716264 -39 0.13261661604699776 -40 0.12557217304176357 -41 0.11733397399292311 -42 0.10829039744168133 -43 0.09898268175666296 -44 0.08984253266411547 -45 0.08117207549876683 -46 0.07312961503322109 -47 0.06580301945931642 -48 0.05923313727922417 -49 0.053422687918401525 -50 0.048326116660702086 -51 0.04387450309753007 -52 0.04000268514533666 -53 0.03665078010935086 -54 0.03376462174129549 -55 0.03129590603530467 -56 0.029202139995884453 -57 0.027446539034470693 -58 0.025997903409307174 -59 0.02482995333621405 -60 0.02392107195187513 -61 0.02325417023185736 -62 0.0228165590528654 -63 0.022599842604787725 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz deleted file mode 100644 index 865e77043..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_1.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8754554710550593 -1.0117280927497715e-16 6.54891966628024e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8757029994054615 -1.0785147578832718e-16 9.248986920727721e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8762033488347074 -9.187177964338296e-17 1.901372736118508e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8769672088227105 -4.882863848419154e-17 2.998682467214636e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8780108746037532 3.9879104169806975e-17 6.444485400642168e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8793565629604898 9.768716065079919e-17 6.828716923373327e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8810328372586376 5.62802815842055e-17 9.662669808964605e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8830751444542202 4.416405072647162e-17 6.055447299932795e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8855264665537634 3.526188401201809e-17 1.2496816720913084e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8884380879910998 6.57361598499468e-17 3.18127926442687e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.891870478289674 1.1413238519924338e-17 7.393123203481303e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8958942858016457 -5.896847597045772e-18 2.404971119692142e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9005914327192939 -4.0853904377836766e-18 7.977821093806274e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9060562932485339 1.0851257954117667e-17 -1.422217718075068e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9123969249453066 -1.6394207633757912e-17 3.429222511870093e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9197363066466604 1.6061491555818797e-19 -8.390663036487738e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9282135138669405 -2.783326274702666e-17 5.0862059588829254e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9379847324419386 -3.586215282786781e-17 5.1877344978725064e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9492239719226123 -9.873439940931157e-17 2.6900560224089524e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9621232900962573 -8.445977421416774e-17 8.033071485273681e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9768922777531195 -4.326833584675276e-17 7.680947061608919e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9937564780159092 -2.450974237262555e-17 3.284131485991176e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0129543179088945 -1.3982457403739633e-17 2.0611718955244116e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.034730287338102 -9.547658830400087e-18 9.822623988157096e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0593221063872647 -5.569784772181392e-18 4.3621576134997676e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0869423393415976 -2.2632856235234153e-18 -1.4843798897101864e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.117753387565026 -2.6343251244706676e-18 -1.3753483408430078e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.1518435689574162 5.1455531568557315e-18 -2.8427656773134777e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1892121226488337 1.4077638251012128e-18 3.4901157262163745e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.2297619722543107 7.308424313180803e-18 -7.247922711243705e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.273302758942622 3.2040269411787295e-18 1.5383609857300669e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.319561571414803 4.006904323032681e-18 2.0045323494221884e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.3681862979434865 5.9632748616899954e-18 2.454162043199172e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.418745563724671 4.2597699495209943e-19 9.608068169755085e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.4707387040705324 5.7718222464802e-18 -2.312841075898914e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.523623837875957 -4.0727874131366255e-18 7.3343808690901e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.5768553826843323 -1.1779505737004018e-18 -1.5069670270277176e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.6299039969752194 -5.410160398397614e-18 -1.9933757234623016e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.6822692463057045 -5.402515342958978e-18 -1.822103240630447e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7334888014956893 1.5620104241094017e-18 -9.810787146283103e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.783155732028479 -6.298245235489619e-18 3.570728196081138e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.830934764101847 6.673248351744974e-18 -1.9847501131499126e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.876572091132655 -2.675131134566011e-18 2.397478499917473e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.919889675439072 5.4610226313770996e-18 -1.7115679724314351e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9607727784947424 -3.0056578977413296e-20 -1.2550977514231167e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.999158175502586 -9.122899582573474e-19 1.2480625321834901e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.0350236115355105 5.3863199368340706e-18 -3.376231569737864e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.068379040386745 -8.968964254970196e-18 3.936066519133359e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0992592252108997 8.890564085631831e-18 -5.067911839411626e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.1277173788244417 -1.1499082030324815e-17 6.45094179727298e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.153819714044437 1.1282535442927314e-17 -6.224287350971898e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.177640871681009 -1.1920373870642032e-17 6.088276775015901e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.1992599404884623 1.0095211447248937e-17 -6.269575609418405e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.218756929414201 -8.00254552602578e-18 5.277186166929336e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.236210031962295 7.179197382270634e-18 -3.598464294868181e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.251693587833473 -4.217060674370166e-18 4.016630260218693e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.265276605087503 4.771534282466994e-18 -3.642832574620289e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.2770217160672384 -2.6573735416704896e-18 1.5225079431333288e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.286984463577432 -1.6511119480392004e-19 -1.151572053197526e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.2952128637981164 -1.3960117053933124e-18 1.5674485715388363e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.301747137962336 1.025830638329932e-18 -3.0033910893406807e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.3066195571860764 7.936027332520631e-19 5.272900083565806e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.3098543608583566 1.7114222808427938e-19 -3.150938632238916e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.311467719190404 -6.562217458251147e-19 -1.4414422374156033e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener deleted file mode 100644 index 3f33482b1..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_10.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0414320986123798 -1 0.041435349290263455 -2 0.04144208130851779 -3 0.041452770943414256 -4 0.04146817083925893 -5 0.04148935830058169 -6 0.04151780380235514 -7 0.04155546343155764 -8 0.041604900113974864 -9 0.041669439734878105 -10 0.04175336961685284 -11 0.04186218822460827 -12 0.042002916324086675 -13 0.04218448095011686 -14 0.042418184132971895 -15 0.0427182679278418 -16 0.04310258517220661 -17 0.043593380531021984 -18 0.04421817732675026 -19 0.04501075042427065 -20 0.046012141501810606 -21 0.04727163726920011 -22 0.04884758008936617 -23 0.05080781062453124 -24 0.053229451328237 -25 0.05619762863182935 -26 0.059802607443922205 -27 0.06413469173519454 -28 0.06927616410956103 -29 0.07528955408518653 -30 0.0822017282356714 -31 0.08998380476862505 -32 0.09852074696509402 -33 0.1075580277822716 -34 0.11669225616613076 -35 0.12536887548274395 -36 0.13294561957672707 -37 0.13903020895880616 -38 0.14337679937002537 -39 0.14576896116002383 -40 0.14603401559909782 -41 0.14423362904947454 -42 0.14078125541196979 -43 0.13613481607804123 -44 0.13049219233787873 -45 0.12389388619614902 -46 0.11645462428483375 -47 0.108538041836738 -48 0.10054310626611064 -49 0.09277747238442538 -50 0.0854601588639929 -51 0.07871121766078981 -52 0.07258820582110381 -53 0.06711518705827169 -54 0.062291116600872824 -55 0.05809712636072085 -56 0.05450231294315485 -57 0.0514647597546257 -58 0.04894153722492347 -59 0.04689553994141874 -60 0.04529580546150961 -61 0.044117590309882895 -62 0.04334237604740632 -63 0.042957843824442454 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz deleted file mode 100644 index 370d1a7e7..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8783910259994623 -9.851488804632187e-19 1.3301653027420989e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8785884877949415 -1.3402566400439807e-18 1.673603835717979e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8789866970796802 -8.078868289395344e-19 1.1983679293246106e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8795922742024418 -1.2575578386977063e-18 1.2325706247290434e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8804152724198606 -1.6024958523873823e-18 -2.5324712291786793e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8814693260738478 -6.542499824014205e-19 -2.655620564833909e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8827718495703336 4.484427668140076e-19 -2.442648988119337e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8843442881850287 -1.3795490220637562e-19 -3.755208021960591e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8862124217313263 3.595741379800149e-21 -1.464723975739869e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8884067219416205 -2.8113853609811726e-19 -8.663991270071356e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.890962763960794 2.8580415186412374e-19 5.146086523556533e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8939216915400294 -5.548542431787984e-19 1.7876785759864272e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.897330734230395 1.983610005787487e-19 1.7546338353654138e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.901243772955289 -3.7561193032082804e-19 6.495149006003024e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9057219475994507 -1.5559638822904065e-18 1.8891729326278332e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9108342964414653 -8.264773006513298e-19 2.184597201060651e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9166584120798988 -1.66153169304808e-20 1.9450435749120716e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9232810915862848 -3.5633341894780336e-19 5.866799029020349e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.930798949519093 -1.2170793044142193e-18 5.994199016440623e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9393189506259083 -7.790082073594774e-19 -2.0800345874759729e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9489588039599155 -1.825347961463535e-18 -7.791970269175018e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9598471410939584 -1.3461329097134964e-18 -4.624785494037522e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.9721233775106988 -5.138865418919494e-19 -2.312974835984229e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9859371275340094 -3.3866165419647196e-19 -1.879558083817356e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.001447009098177 -5.990390137237601e-20 -6.103559653020911e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0188186354777424 -7.275305021777005e-20 -7.743374556754355e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.0382215480437273 -7.275118425393616e-20 -5.2366823587254586e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.059824799900073 -9.168704561260868e-21 1.495919591134385e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.083790860003999 -1.0215597267619105e-19 -2.6231564500496814e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1102674796304464 5.511378450911044e-20 4.7124690613815086e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1393771611006067 -8.30316737176043e-21 5.262917351342211e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.1712039118955 1.115364989605363e-19 2.782544596065962e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2057770810002104 1.579854630218318e-19 6.777610655308823e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.2430543790963036 3.838516830074238e-21 5.422901457180961e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.282913395343749 1.108231762634283e-19 1.0787293061895563e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.3251499036050984 -1.1185863813271345e-19 -4.855545455497648e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3694826723541773 4.1658537682434424e-20 -4.431785405487333e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4155642765610335 -1.09175928821316e-19 -6.479880280404295e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.462989568854928 -7.14026162048998e-20 -4.3578162339263e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.5113053414786815 5.855705902481826e-20 1.128785728864534e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.560028588319711 -1.0322448221211242e-19 -6.463082197429434e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6086727267151524 1.7725952600460433e-19 8.082531667083235e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6567698079163007 -1.149124792263937e-19 -5.485023054623841e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.703882221109272 1.3744526403119772e-19 6.777163788827528e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.7496121390535166 -9.034986400327364e-20 -2.19306936881376e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.793613977886753 -2.76983174201291e-20 -4.339049483382573e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.835606740411229 7.082907415655858e-20 3.0138009875708696e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.8753803423529423 -1.6940527731858444e-19 -8.841203590084194e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9127885671292395 2.48020764270714e-19 1.2684795337521353e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9477375035631006 -2.5630339419960277e-19 -1.2211352481384955e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.980174933253151 3.2707453511593737e-19 1.6612675616768303e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0100809680184417 -3.1273475294927187e-19 -1.5084561698632757e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0374603302279812 2.9793319400328865e-19 1.4047456034506751e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0623359002599226 -2.8241385116855197e-19 -1.5136009942368388e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0847432090941282 2.2292052023083817e-19 1.0196047541853823e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1047258072686836 -1.9713971334166315e-19 -1.0739594560230513e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.122331423497043 1.177168376978391e-19 6.543448527564912e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1376088096052817 -1.0768795202030094e-19 -5.1995135879384954e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.150605076887851 1.0382610766816056e-19 4.641259342300025e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.161363576277215 -2.0980419395223303e-20 -9.634800448710992e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1699223275537047 2.611904629461775e-20 3.8009207215517174e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1763128797573956 -2.728179729354991e-20 -5.8770462728048404e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1805595070850963 3.2114719888882228e-21 -1.0202382770207982e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1826786669044314 -2.560099661307703e-21 -1.2930540084198142e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener deleted file mode 100644 index 2da25988f..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_11.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041431523605681135 -1 0.041434753480376105 -2 0.04144144243563891 -3 0.04145206374107273 -4 0.04146736529244385 -5 0.041488417603703844 -6 0.041516681893528695 -7 0.04155410195916442 -8 0.04160322466553608 -9 0.041667355127127215 -10 0.041750754010369553 -11 0.04185888578819251 -12 0.041998728136566695 -13 0.04217915379629884 -14 0.042411396835426524 -15 0.042709614871993894 -16 0.04309155675102233 -17 0.04357934038986184 -18 0.044200336574154515 -19 0.04498813945207321 -20 0.04598358080747046 -21 0.0472357097911629 -22 0.048802609159670614 -23 0.05075184981202897 -24 0.0531602952489517 -25 0.056112857193514505 -26 0.05969967971640681 -27 0.06401110908639907 -28 0.06912972425438511 -29 0.07511871632294978 -30 0.0820061025290169 -31 0.08976475969599965 -32 0.0982826882348466 -33 0.1073095245222959 -34 0.11644610021451877 -35 0.1251422399768002 -36 0.13275452681938668 -37 0.1388827711810835 -38 0.14328005287921095 -39 0.1457296491882826 -40 0.14605678720801793 -41 0.14431166473213178 -42 0.14090226991169702 -43 0.13628848280661082 -44 0.13067830918347245 -45 0.12411211862513782 -46 0.11669991012051818 -47 0.10879810764542852 -48 0.10080771631551246 -49 0.09303872933718235 -50 0.08571271699430998 -51 0.07895252276612656 -52 0.07281685346023217 -53 0.06733062476527923 -54 0.062493451860995454 -55 0.05828695927961056 -56 0.05468069792464334 -57 0.05163329767362211 -58 0.049101810282993014 -59 0.04704905704832793 -60 0.04544400767767934 -61 0.04426186044095481 -62 0.04348405109802231 -63 0.04309822933372733 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz deleted file mode 100644 index beac65819..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_11.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8783557255360728 3.167224099333261e-19 -9.321016871223934e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8785525580001896 -2.914690788139957e-19 -1.5470207957232792e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8789494977301089 1.006912992183837e-19 -3.5103958857828874e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8795531431379864 -2.519525425282082e-19 -1.3959929047950352e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8803735141950442 1.4489618619572955e-19 -3.3084568857982466e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8814242001540722 2.612241851419053e-19 -7.294441216867245e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8827225579252445 4.723331694796115e-19 -4.2226622959070253e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8842899621354297 2.377523118271864e-19 -1.4166715838776653e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.886152107913881 3.617668206609701e-21 1.034243868520375e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8883393672678854 9.485696240287965e-20 -2.795147295664801e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.890887199466296 -1.1294418234714679e-21 1.843368150973366e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8938366150476658 4.497095689943134e-19 1.1380476332318427e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.897234691794111 -7.675549194009782e-19 2.168578996536718e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9011351391093252 -1.0154088592991967e-18 7.171499685183263e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.905598904521361 -1.5283142897715705e-18 9.146924070027737e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.910694812251114 -1.5026797061098611e-18 8.777202548382583e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9165002186510165 3.476217929649274e-19 8.345743035220681e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9231016624535056 -7.373452999462007e-19 -2.2614003508442343e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9305954787355424 -3.8366003359017046e-19 1.2956971210348385e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.939088333780911 -1.03177156590877e-18 -2.6598209693645523e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9486976230218995 -1.0984385458222306e-18 -6.295372781671454e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9595516553206715 -5.273965170102473e-19 -1.494978563909243e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.9717895233877394 -2.4524235188707244e-19 -4.260462941498117e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9855605315809908 -6.109764467771963e-20 1.4278497232837836e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.001023018428773 1.3482596558474488e-20 3.0888545584440624e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.018342372208258 3.905215292143839e-20 3.6899429611767715e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.037687994977772 5.723915048975112e-20 -1.0318291107887755e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0592289262890526 -1.7302377253309623e-20 2.9301157906369024e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.083127797434045 2.5725012807896028e-20 -5.680998739969661e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1095327589462394 -5.250645109376495e-20 -8.010490387316411e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1385670213257733 -5.176863406034446e-21 -2.1001910597861954e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.1703156907383168 -1.4788119181418952e-20 4.8845853276100886e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2048096938161352 -1.410619835290788e-20 7.903798468244585e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.242008727616783 2.4544492787511778e-20 3.552885409465278e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.2817925237798975 -5.356624007937554e-20 3.358596933408221e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.323959005843907 2.6007506488053363e-20 -5.718945442069232e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3682289107296226 -4.2395978353347025e-20 -4.2178832919211465e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4142565108881238 1.5884312447477484e-20 -7.005523258345597e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.461638189995924 2.1500190829291523e-20 -5.3917428080386654e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.509921979572976 -2.8382824612187316e-20 1.816694699830254e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.5586254954837924 5.702515351548381e-20 2.9195274908427252e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.607262037437914 -4.200468953232298e-20 9.294552580494238e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6553630915491726 8.460063694884053e-20 1.199275841301308e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.702490201285616 -3.870550237737808e-20 4.8999629654570516e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.7482444137021638 5.7597992939959424e-21 -3.3255937789275525e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.7922785882487338 -2.8295510973839034e-20 -5.432072538392806e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.8343098244488303 -6.135608424111156e-20 -1.1136089082961671e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.874126031351556 7.531502460842483e-20 -7.68399178538083e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9115792820095225 -7.966397236771155e-20 8.007453802539009e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.94657424945964 1.1852627940933556e-19 -4.610395606893448e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.979057566243054 -1.2262642321168788e-19 1.291926771454475e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.009008424465314 1.19615522025406e-19 -8.347955237812826e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.036430807386101 -1.0508399572539226e-19 7.86407380595151e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.06134700958731 1.0702918398051738e-19 -9.806141162607922e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0837921050158252 -7.520188542120663e-20 4.218929959367957e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1038092933708112 6.425188308257616e-20 -7.236053804859407e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1214460385872416 -5.356790023747801e-20 4.7966651592619505e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1367508976062575 2.737186320984367e-20 -1.7814768530248604e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1497708499089487 -2.5163936237082562e-20 3.958134771270676e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.160549161462604 1.6780237656099325e-20 3.7637775130012435e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1691237999029753 -7.106408289942292e-21 2.0996446407208497e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1755262841641856 3.381340201084727e-21 -9.922934918980257e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1797808723528984 -2.7210551267011493e-21 -9.40045616944471e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1819040140989525 3.662625570675696e-21 -1.4858145192915057e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener deleted file mode 100644 index ad4d71b29..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_12.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041431159968245763 -1 0.0414343766705071 -2 0.041441038357545174 -3 0.04145161639296752 -4 0.04146685566220852 -5 0.04148782237410154 -6 0.041515971878580755 -7 0.04155324018025903 -8 0.04160216395934773 -9 0.041666035157624556 -10 0.041749097534570685 -11 0.041856794000993965 -12 0.041996074896036975 -13 0.0421757785109457 -14 0.04240709578511528 -15 0.04270413074377016 -16 0.04308456621417947 -17 0.043570439631689925 -18 0.04418902489774111 -19 0.044973801339273416 -20 0.045965467324147594 -21 0.04721292091934338 -22 0.04877407965050171 -23 0.05071634252842101 -24 0.0531164077453049 -25 0.056059049433738156 -26 0.05963433320190204 -27 0.0639326298686573 -28 0.06903670360728371 -29 0.07501016202250434 -30 0.08188174891400904 -31 0.08962545358340034 -32 0.09813118445377166 -33 0.10715123022230368 -34 0.11628910559140161 -35 0.1249974229295405 -36 0.13263221526469673 -37 0.13878816780384723 -38 0.14321763872385676 -39 0.1457037199935348 -40 0.14607037256371103 -41 0.144360598186313 -42 0.14097874693428394 -43 0.13638579915652513 -44 0.13079625951414806 -45 0.12425050723715576 -46 0.11685567710490194 -47 0.10896346274333556 -48 0.1009761158622855 -49 0.09320511837625593 -50 0.0858736465464215 -51 0.07910634090531145 -52 0.07296265326499976 -53 0.06746804380934066 -54 0.06262254989024513 -55 0.05840811151609661 -56 0.05479456174331278 -57 0.051740885430423565 -58 0.049204130031355486 -59 0.04714707031454202 -60 0.04553863288563279 -61 0.04435397899054626 -62 0.043574515271603956 -63 0.04318787140600699 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz deleted file mode 100644 index 2a2271a28..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_12.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8783333422653203 3.0949281007768247e-19 -1.1000076338027177e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8785297747426166 -1.42833431820084e-19 -5.250080142786166e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8789259075692553 6.642204773721767e-20 -1.0865807581321575e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8795283252010604 1.6271991821093396e-19 3.342303702065465e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.88034702643248 4.168295514510483e-19 5.540217709260785e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8813955718294244 8.917118398962562e-19 8.821054777696175e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.882691281721143 5.653468921288331e-19 5.989277418850332e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8842554857841827 3.5785730898880224e-19 3.001701555560058e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8861138252662064 1.7844336290746563e-19 2.985640514280362e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.888296608721087 1.200071271939896e-19 6.126338575788869e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.890839221685344 1.2057247932965619e-19 -1.1757101721021457e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.893782589930785 -2.9177333775389784e-20 -4.560134156117137e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.897173694660969 1.0478345055603712e-19 -2.699061379360931e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.901066136127572 -1.1660629455478366e-20 -1.7374376383675212e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.905520739440012 2.3851824741424325e-19 6.373690707344213e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9106061925816686 3.4015705870174317e-19 4.844048565658888e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9163997015353937 2.3821548045123213e-19 5.329409436079684e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9229876405889992 -2.0919769592492554e-20 3.131089926545402e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9304661669001044 3.590013077262543e-21 -5.573783355852306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9389417567274243 2.3989104206553085e-19 -1.0175099104619003e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9485316057998638 4.325305148366821e-19 5.432922105314611e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9593638174506798 2.2150301168744425e-19 3.1109184491357803e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.971577278771488 1.2881779313862214e-19 1.0513865830929054e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9853210965882924 9.119765945782808e-20 -3.478077156380651e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0007534312692954 4.930483443329068e-20 1.7429733859548817e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.018039527464748 2.584094596805484e-21 -1.8992644779579915e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.037348698026179 -2.2101925513111336e-21 -9.900541704532163e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0588499732049517 -3.6239781408397987e-20 -2.0472670151039673e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.082706086782238 4.4456444007387515e-21 -7.147769657771003e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1090654423999817 -2.0865152808835925e-20 -2.8737803696694503e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1380517000970323 8.087539002600304e-21 9.532465815109054e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.169750663933322 7.422472280911661e-21 5.30383241538462e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.204194262559518 9.571046787953284e-23 -5.5247586574942045e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.241343456102475 3.608788285539383e-20 4.739828509977617e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.281079339255744 -6.072359737695206e-21 -7.490252788923752e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.323201203745981 3.077282625009981e-20 -2.145292842919299e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3674310399967773 -7.425693806885901e-21 -9.983613626924786e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4134242024188106 9.978110420136703e-21 -4.629439075945029e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.4607780501430954 5.376165897239119e-21 1.4876873606198793e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.5090414044151057 -3.8742415548454794e-20 6.723126756384934e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.557732279404554 1.2140947272953879e-20 1.7127995807041196e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6063639035839103 -4.448000129437174e-20 -1.2770119184577303e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6544674049098544 2.963206307905874e-20 5.291313169986185e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.701603790003181 -1.4316447681710713e-20 -9.542808052828657e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.747373390281946 1.8502133993105775e-20 -3.708657223867362e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.791428076061492 1.585269652375784e-20 2.2546296639158953e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.833483736652398 -1.8300393184683892e-20 -1.9352476226650636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.87332700512417 4.1563893383718353e-20 2.6123435141668744e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.910808865120798 -5.858347020637631e-20 -1.862051488475525e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9458330877781975 5.404928592663921e-20 3.594425272028334e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.9783455735565445 -6.510486110470244e-20 -3.853490941218289e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.008324928478876 5.945756852718273e-20 3.164232068934169e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.035774664858374 -5.123000300461315e-20 -3.719003168207221e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0607167039670182 5.229410337127496e-20 3.2029642179955153e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0831858284548233 -3.8048094731352424e-20 -2.6498765875939152e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1032250143709224 2.72857965639939e-20 2.1723485641180438e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.120881556829117 -2.1848337229898458e-20 -1.764306532859029e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1362038885663495 1.4559858188829543e-20 1.7603789328098527e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.149238904919009 -1.0103545981417903e-20 -8.967479564094792e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1600298175889807 5.681232309598346e-21 4.178612640398914e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1686145608857506 -1.9673941768269033e-21 -8.422023452429667e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1750246344837882 5.782485733295224e-21 2.275710584955142e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1792842861823307 1.1006241727322953e-21 6.632280138536292e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1814099606453445 -4.243055911518313e-21 1.5003185818924737e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener deleted file mode 100644 index 4faed9f89..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_2.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04157195801479472 -1 0.04157932549027338 -2 0.04159452585964221 -3 0.04161851756828408 -4 0.04165280867767965 -5 0.041699545206190645 -6 0.04176163543936573 -7 0.04184291592837965 -8 0.041948366431396725 -9 0.042084382565968956 -10 0.04225911631124153 -11 0.04248289551544847 -12 0.0427687338816991 -13 0.04313294198748004 -14 0.04359584694068441 -15 0.044182622131034986 -16 0.04492421758331545 -17 0.04585836347015007 -18 0.047030591554960456 -19 0.048495178201915276 -20 0.050315854091923094 -21 0.05256604586812437 -22 0.05532831055248588 -23 0.058692494633858 -24 0.06275200060907327 -25 0.06759738932380878 -26 0.07330642377286588 -27 0.0799294711471809 -28 0.0874690364596107 -29 0.09585078356451426 -30 0.10486712758550402 -31 0.1141477563402789 -32 0.12315620989328348 -33 0.1312126432464777 -34 0.13780807080564067 -35 0.14265272501748136 -36 0.1454979447188084 -37 0.14613323032868536 -38 0.1445490200844069 -39 0.14114859626998372 -40 0.13642648534344332 -41 0.1306191090839431 -42 0.1237590010399058 -43 0.1159574399218824 -44 0.10760911880118629 -45 0.09914524419813159 -46 0.09089952384544306 -47 0.08310547056543953 -48 0.07588433787121183 -49 0.06929878616783347 -50 0.0633754049498601 -51 0.058113080621306934 -52 0.053489160222783196 -53 0.04945579711162347 -54 0.045958362691300006 -55 0.0429472149153323 -56 0.04037808000377092 -57 0.03821211347456315 -58 0.036415835494770565 -59 0.034960994016314764 -60 0.03382439609718616 -61 0.0329877351573271 -62 0.03243743376656774 -63 0.032164515601952805 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz deleted file mode 100644 index a53581294..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_2.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.884989317295536 -5.0108954078447624e-17 -4.742247366741344e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8852700136672462 -5.883953842516014e-17 -1.3715544777791804e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8858358478859487 2.5633983856080006e-17 2.9903671811213294e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8866957645298275 2.668180929495165e-17 8.65248077350837e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.887863334741747 5.171362194483314e-17 9.760975576643867e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8893569418884497 6.003408106611861e-17 5.78003631756551e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.891200029834506 1.0917461984979519e-17 2.1499151166995855e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8934214141368355 1.6431404584195373e-17 2.2396622601378082e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8960556561148083 8.205781727190208e-18 -1.1138783000909959e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8991434990707494 -5.792684861855456e-18 -3.687153742641566e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.902732364807378 1.485356059365815e-17 -7.045968937403926e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.9068769068693248 2.213875216434845e-17 2.2462933636920996e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9116396144397412 -1.0340336745334172e-17 4.9377316933258047e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9170914573152236 2.8721248469766036e-17 6.368244599243866e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9233125575737495 3.6582065253840844e-17 6.433977382982912e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9303928670682555 5.17189435389041e-17 7.203661983316977e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9384328212725248 8.862710164759301e-17 1.3383926529173477e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9475439287078322 5.494824397455874e-17 1.1611293635329614e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9578492404998924 4.207915517996141e-17 8.765126833124805e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9694836257111257 6.198078601709982e-17 3.6995307173223434e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9825937539592913 5.928586450316247e-17 2.391166752772385e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9973376562717196 3.01240569422641e-17 1.740789214068586e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.0138836967982185 1.6854911860689905e-17 9.545995825412685e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0324087404252817 1.005148797685407e-17 5.515107833617539e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.053095233905976 6.505914042148056e-18 3.6634482083271354e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0761268211639776 4.5721264836472885e-18 4.580346723926299e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.101681990669658 5.402002215023801e-18 4.494616263110479e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.129924400440045 1.2939087423805524e-18 8.699910047048996e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1609870919354206 3.019425293391911e-18 5.851739846362596e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.194948233479877 -1.120829868726922e-18 7.88005518260951e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.2318076266997973 1.0625122004335556e-18 2.7681091167719145e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2714745120644273 -4.400234267428504e-19 1.1671374015309262e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.3137661403688585 -1.694712186181077e-18 -3.2487082201372366e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.3584186367031412 -1.9233838196118363e-19 -3.329672726553708e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.405091335138688 -4.014623638089361e-18 -1.8413889643869384e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.4533636102737986 6.949928666476694e-19 -3.886055873384936e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.502748042238719 -1.7433393363065483e-18 -1.4017628939559986e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.5527300953815506 1.877777505113591e-18 -1.8701334277356672e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.6027991264632204 2.3403513366244345e-18 -1.0509255191162959e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.652458924124138 1.2846930698250825e-19 1.4947410374256058e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.701232070356048 3.305720553805393e-18 -2.293322862115787e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.74868034351546 -3.540355367613809e-18 3.643646950762984e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.7944358238859706 2.255867989178734e-18 -2.01619340638025e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8382211797675962 -3.448513098646837e-18 3.310536797969935e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.879837677310483 8.451210918739354e-19 -6.872803895786421e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.91915217467959 9.560492453772601e-20 -2.0825670753846824e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.956084067503216 -1.5516351806771173e-18 1.4947550108437544e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9905944219558633 3.866509755268147e-18 -4.454570456124455e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.022677383407258 -4.325638010915628e-18 4.0257036634383485e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.052352615070973 6.2025524192515265e-18 -5.878393128601746e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.079658822026951 -6.595622548425217e-18 6.9660731420796e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.1046487323251144 6.053316716543601e-18 -5.9248535788955695e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.12738439168631 -6.236906148126373e-18 6.335657676722336e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1479326128831646 5.668119246240927e-18 -5.484662708444005e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1663614192681724 -4.546045063920738e-18 4.626945140291536e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1827373641010657 3.736473259020216e-18 -4.0227822285373624e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.197123545382946 -2.9404762934001575e-18 2.9188929665039917e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.2095781632805447 1.8876159438894476e-18 -2.1438549405222784e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.220153494631111 -1.5459296778614354e-18 1.8596640478959765e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.2288951822406537 9.690785854359564e-19 -8.480037638425914e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2358417504462063 -5.565240479889735e-19 6.291180013270469e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2410242854861724 2.6687195721090655e-19 -6.006520162150756e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2444662333943772 -2.1320580227752767e-19 1.691968391565676e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.246183278899612 -2.7346252962316175e-20 1.2280832254384746e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener deleted file mode 100644 index b9b465ec0..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_3.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0414586067293743 -1 0.04146298037959526 -2 0.04147204730433017 -3 0.0414864677858511 -4 0.04150728601655086 -5 0.04153599797703809 -6 0.041574647642724526 -7 0.04162595661486482 -8 0.04169349377491985 -9 0.04178189315946592 -10 0.04189712989185801 -11 0.042046865568348565 -12 0.04224087576573757 -13 0.04249157295748899 -14 0.042814637532817806 -15 0.04322976695736643 -16 0.04376154715373442 -17 0.04444043916542588 -18 0.04530385572151752 -19 0.04639727334786675 -20 0.04777528237112576 -21 0.049502415231536145 -22 0.051653508760727065 -23 0.05431324565904421 -24 0.05757438496723718 -25 0.061534038910397236 -26 0.06628720590430467 -27 0.07191667017045388 -28 0.0784784047772787 -29 0.08598179449643652 -30 0.09436169300496523 -31 0.10342550420888139 -32 0.1128136247204845 -33 0.12199717818538072 -34 0.13029031208530534 -35 0.1371328491390891 -36 0.14222269699322038 -37 0.145308263954973 -38 0.14617177455363273 -39 0.1447697075085206 -40 0.14148719572478802 -41 0.1368315004796831 -42 0.1310747919132957 -43 0.1242525885432 -44 0.11646812508050722 -45 0.1081076271237402 -46 0.09961614403421955 -47 0.09133891407928739 -48 0.08351908058034527 -49 0.07628433304493165 -50 0.06969966710560682 -51 0.06379259587961304 -52 0.05856198666449303 -53 0.05398514846508404 -54 0.050015439788023884 -55 0.04659799128392859 -56 0.04368306530574811 -57 0.04122664271453125 -58 0.039190525999689856 -59 0.03754231185829019 -60 0.03625529087634873 -61 0.035308315471243246 -62 0.0346856654401191 -63 0.03437693165912537 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz deleted file mode 100644 index 6d5851f07..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_3.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8799105122941488 -1.4818039547426395e-17 8.764177354853186e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8801438142297389 -2.1611756731588002e-17 8.768115972514028e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8806143821668642 -1.73166004851659e-17 -1.1148193301621493e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8813302031330725 1.4374257505516665e-17 -9.363638813796147e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8823034052283742 2.0632215233429184e-17 -6.8376706336636196e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8835504355494204 2.6494136059998168e-17 -3.464505766557596e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8850922987190912 1.509210046786807e-17 -2.7622113106934002e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8869548568700507 4.615140851063601e-18 -9.669561639694123e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8891691917871605 2.7700940671753266e-18 -2.1032729473972124e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8917720294923865 -5.304300170309955e-18 -2.167382154382066e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.8948062267528696 2.37553908536632e-19 -1.960926676215573e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8983213176818905 7.123531887961463e-18 -4.595575935295597e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.9023741166176247 -2.498107909340288e-17 -3.9303946201610456e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9070293705939625 1.3255167196590463e-18 -3.010360634286847e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.912360450699874 1.2305850236951042e-18 -3.066258351279711e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9184500661203119 -1.2035671906394122e-17 -3.565276057664299e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9253909772567166 -1.6850762086372362e-17 -3.0918062888306485e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9332866745320818 1.7019547078288147e-17 9.307318213571045e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9422519766965138 9.014130387809894e-18 3.4368479632978663e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9524134859585833 9.210366991730079e-19 1.448927624198405e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9639098162906274 1.1020386192761802e-17 1.2825507356529638e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9768914849375068 1.8012507408866832e-18 -5.762941028792815e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.9915203246853552 2.3436906144304097e-18 -1.205386359754901e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.0079682351278803 4.2548394131358493e-19 7.918028149299706e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0264150435044437 -5.588696464160026e-20 1.3721120958224374e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0470451890202512 -8.93256721441966e-19 -7.40651727486165e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.070042881382301 -7.684726851792031e-19 -1.77530053819022e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.095585316864181 -3.7214240819596913e-19 -1.0472359525435372e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.1238334766072695 -3.309214348747377e-19 8.186434157007143e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1549196184069537 -2.149982312841141e-19 1.2826161666784079e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1889222410911957 -2.8910103527373565e-19 6.955200010624968e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.225843045231043 -5.047421097371697e-19 2.025313010214588e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.26559523403105 -1.5831161307032564e-19 -2.2389360599032424e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.307998098550897 -2.261812384344355e-19 2.2565270863236893e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3527878956705406 5.065899291860715e-19 3.149182113277332e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.3996269882386483 1.0383173420431231e-19 4.554963500846137e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4481021550151265 5.741472342134584e-20 -3.565171847655363e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.497731272924313 9.577173256440004e-20 -7.457967190892717e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5479957721031035 -9.757996259475069e-20 -3.100616674328214e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.598376943092892 1.6198443988384673e-19 -9.863903182490844e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.648370815226264 -1.823381437664442e-19 6.430123848049863e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.697494772645707 5.262114574221734e-19 3.5447561568294535e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.7453032732283527 -3.129105374352937e-19 3.6815357787302563e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7914152626632656 -2.40559870104534e-19 -3.9040395157938506e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.8355354801897885 7.694711161765388e-20 -5.920933898056655e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8774500127611233 2.1524878276153628e-19 7.152451335832207e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9170129276559305 4.1753944841999717e-19 3.099060585188274e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9541332819067936 -7.475722945733658e-19 5.620834793056669e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.988763675139281 3.3409953797282103e-19 -5.393487286056188e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0208910536726523 -4.930396167767249e-19 8.572447661604486e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.050528869489975 6.516460959330137e-19 -6.51242302947236e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0777104936304487 -4.598748608951661e-19 2.9290663724454975e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.1024836401282645 5.631556635382123e-19 2.5255422033388196e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.124905506164225 -4.509559522972745e-19 7.187309576835938e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.145038292980541 1.3310096361445248e-19 -5.950517357367694e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1629454843040827 -1.0985602684744378e-19 -4.51591260772626e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.178689033406833 4.3019655729368527e-19 -1.955404597954926e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1923272747216185 -2.460772687576164e-19 3.2054176024782314e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.203913401700197 -1.094030958348145e-19 4.2725967407467936e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.213494380522006 8.116697895669598e-20 4.3049559829646744e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.2211101860382603 1.304608057140352e-19 -3.624827048561639e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.2267932763420575 -3.768999954537053e-20 -9.037285109619152e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.2305682424987436 7.450864072794135e-21 -2.497588208932462e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.232451585406962 1.6750060038730048e-20 8.385129816166974e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener deleted file mode 100644 index fc5c7da78..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_4.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041459080819323514 -1 0.041463266696433784 -2 0.04147193209502261 -3 0.041485683192457545 -4 0.04150547752883694 -5 0.04153268491730249 -6 0.041569173727612464 -7 0.041617427080000075 -8 0.04168069483465271 -9 0.041763188706713146 -10 0.041870329336341675 -11 0.04200905560470784 -12 0.04218820773650762 -13 0.0424189964757561 -14 0.04271557040093348 -15 0.04309569155328883 -16 0.043581524955702444 -17 0.04420053883626715 -18 0.044986497443778986 -19 0.045980504637466404 -20 0.04723202071098073 -21 0.04879972345750561 -22 0.05075201357885669 -23 0.05316687145502611 -24 0.05613065713604213 -25 0.059735314239021634 -26 0.06407330792707908 -27 0.06922953116338072 -28 0.0752694107318753 -29 0.08222262584793823 -30 0.0900622783790213 -31 0.09867211816276647 -32 0.10779090004496208 -33 0.11700211790076079 -34 0.12573067925013412 -35 0.1333183777373251 -36 0.13937196072972097 -37 0.14363604060969207 -38 0.14588288856285453 -39 0.1459364183364081 -40 0.14389765477961405 -41 0.14020886193159668 -42 0.13532787355879522 -43 0.12940848983223147 -44 0.12249050504400215 -45 0.11472482654541673 -46 0.1065275360850208 -47 0.09829908580578099 -48 0.09034506161117566 -49 0.08287391131061793 -50 0.07599089898368076 -51 0.06974915339593592 -52 0.06416838206795744 -53 0.0592431215229901 -54 0.054949760747959625 -55 0.05124670150327936 -56 0.04808356464695303 -57 0.045414725213881804 -58 0.043200303861606566 -59 0.04140627936351526 -60 0.04000448663295717 -61 0.0389725520598811 -62 0.03829380399516897 -63 0.037957185175737894 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz deleted file mode 100644 index 7d537aaa6..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_4.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.879936010982227 7.065757362297639e-19 -4.185955767784441e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8801589386050144 -1.7839760375315284e-17 -4.2297060552550195e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.880608507723525 8.950786087621875e-18 -7.831584021347905e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8812922009247397 -2.2727782303556557e-18 -2.4458798754215535e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8822213794974036 -3.35609544394301e-17 -4.658203839781102e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8834114491398541 -2.4493112297663907e-17 -3.7533830657906356e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8848820821520327 -2.457917587374665e-18 -3.059480649067188e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8866574969403591 -3.74321740884732e-18 -2.4351222531532415e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8887667955452834 8.322483134643879e-18 -1.0519442361574095e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8912443595280617 -1.03374848938201e-17 -4.494180773268634e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.894130303829676 -2.762338817768821e-19 -8.313797466446848e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8974709870251014 1.1362965882607877e-17 -2.95543911428465e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.901319574587844 6.548243631061822e-18 -1.2982718033004681e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9057366491584975 9.109298954366831e-18 -2.3301966156362085e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9107908581380517 -3.4083406720379194e-18 -1.7627230277966106e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9165595838929044 3.847517374050949e-18 -1.481971297289927e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9231296150962724 4.0082297611608184e-19 -7.497972130578195e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9305977887838615 -1.438262172710932e-17 -1.9100807504074708e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9390715610385563 -2.094187358979795e-18 -1.848474145498587e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9486694492225969 -1.698047899660851e-17 -4.2380471687500544e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9595212696792217 -4.214195735110433e-18 -2.510399448234755e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.971768071133231 -6.448136005462612e-18 -3.472465658461082e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.9855616350309646 -6.074151969575942e-19 -2.6815487984281575e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.001063379371996 -1.977169747459427e-18 -1.0624324230774459e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0184424623047796 2.196954502456048e-19 -3.958767479299041e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.037872836815875 -1.4139233952391604e-18 2.530508643805923e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.059528960621076 -1.541127416404053e-18 2.206367360604349e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0835798204395943 -1.3850189537065089e-18 -9.749619666275856e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.110180894789757 -2.3188207387249985e-18 -4.913525895212078e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1394636657467223 -1.064274984800763e-18 -3.851035982549103e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.171522054580109 -1.7893674161786327e-18 1.0619970777484762e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.2063924359207 -1.7198056957621688e-19 4.681802318675927e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.244035676661467 6.748538187233446e-19 1.892100503429274e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.284329044979419 -3.8268916941973404e-20 2.3474573847887815e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3270639255075363 1.6441736266156921e-18 -1.531835616134155e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.37195431517773 -1.6404917084902775e-19 2.416663584079753e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.4186474306266654 1.4963493613718155e-18 -1.7892138404523974e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4667276556583704 -5.698799654018461e-19 1.552650840260815e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.5157247694511127 -9.424463594428599e-20 -5.078339958634567e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.565139500355549 4.280600920723459e-19 -5.988256677955406e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.6144764027154346 -1.2372424164223354e-18 2.7256904704554126e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.663260221263783 1.1633434656570315e-18 -5.1467383957617427e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.711043733707909 -1.7849496684066456e-18 2.568050601086811e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7574192067063534 1.3675518739658064e-18 -4.879299750176103e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.802036841026258 -8.946487796950821e-19 -3.9574834727837375e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.844624286563518 5.633965830487279e-19 -8.329239409850754e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.884984951011993 4.158009442681183e-19 1.0781823355337375e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.922985568337913 -1.4243912073953643e-18 2.9824406149399207e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.958544267253878 1.9750262361069174e-18 -1.9931819154190334e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9916195226316766 -2.379225047834592e-18 1.1541346162304602e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0222013519378534 3.1753306925044314e-18 -3.943940291157273e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.050303921839971 -3.331727280502606e-18 4.460971981042191e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0759591607151067 3.0700268937754346e-18 -1.9100151840347504e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0992113689883127 -3.0338295184036957e-18 1.5849189587568082e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1201129834500847 2.6358980230685945e-18 -2.7217165727866418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1387206414099773 -2.2356823142169837e-18 1.6285195707846627e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.155091682119706 1.962536576335668e-18 -5.1584548171598114e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1692814839363757 -1.3625471930520277e-18 1.0339936888897448e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1813414769057555 8.044901973759628e-19 -9.101893940806207e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.191317683545453 -8.883320840462678e-19 -6.155636391345769e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1992496664228263 5.81833156212664e-19 -6.63319856591771e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.205169784884851 -1.1477474004530748e-19 6.110244386811439e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.209102684523402 1.6029912979484747e-19 -4.398972900491817e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.2110649616649267 -1.6261945703752335e-19 -3.93313171567345e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener deleted file mode 100644 index ae991dec4..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_5.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041445327042583135 -1 0.0414490665634075 -2 0.04145681112300285 -3 0.0414691089658215 -4 0.04148682645109605 -5 0.041511203596971386 -6 0.04154393282698502 -7 0.04158726512726232 -8 0.04164414909248003 -9 0.04171840971547714 -10 0.04181497523065795 -11 0.04194016178215449 -12 0.042102027012853004 -13 0.04231080461612225 -14 0.042579432065452505 -15 0.04292418253274048 -16 0.043365408526629554 -17 0.04392839774329313 -18 0.04464432924807358 -19 0.045551298039680686 -20 0.04669534531080781 -21 0.048131386795849884 -22 0.04992386877741169 -23 0.0521468974767896 -24 0.0548834816345962 -25 0.05822340371487408 -26 0.0622591046855921 -27 0.06707885759287759 -28 0.07275646482092221 -29 0.07933682096362389 -30 0.08681704903421228 -31 0.09512213116502652 -32 0.10405415568233825 -33 0.11326187082959766 -34 0.12223954935490432 -35 0.1303388660460896 -36 0.13704039604370064 -37 0.14206557396698827 -38 0.14518279871707157 -39 0.14618868358926546 -40 0.14502005744481944 -41 0.14201245338891041 -42 0.13764394234232671 -43 0.13222453245224994 -44 0.12579864370985502 -45 0.11844274864070704 -46 0.11045966382432254 -47 0.10228037238279487 -48 0.09424883187500871 -49 0.08661714918640119 -50 0.079533644201776 -51 0.07306989699766377 -52 0.06725949636324598 -53 0.06210760370183106 -54 0.05759867149555112 -55 0.053701950951108135 -56 0.05037142279618738 -57 0.04756009567434832 -58 0.04522666387322327 -59 0.043335754297950356 -60 0.04185799620450135 -61 0.04077000602659984 -62 0.04005433101347692 -63 0.03969938290923216 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz deleted file mode 100644 index 94bcedee6..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_5.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8791738669209226 1.701546495325969e-19 -6.095187601120418e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8793858847500051 6.779906370997021e-18 -1.1303739639494601e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8798134622309113 7.934864771648852e-18 -4.253374111315632e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.880463735596428 5.269618450359536e-18 6.132925725812283e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8813475409831628 -9.532768133161335e-18 5.584606804129179e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8824795734364483 -1.156367439526095e-17 -1.2996133510111979e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.88387860024689 -6.709933013602591e-18 -2.033116546323147e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8855677295414592 -2.15095962621934e-18 -1.608198026865791e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8875747349889345 2.6029057209308463e-18 -1.2960581700498522e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.889932437186588 1.5187163577237834e-18 -7.410482738698371e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.8926791416847986 -5.339413785787683e-18 3.490112885397532e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8958591325732497 1.7940851611418407e-17 2.371092200444163e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.899523218956968 2.929772676161413e-19 3.697692966180753e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9037293293142268 7.422123620791183e-20 3.132238956835482e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.908543145431589 5.933833575283083e-18 1.734174600577743e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9140387630684275 1.852075420518976e-18 7.54247042907666e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.920299360373361 -5.581105133524472e-18 1.0491184536359983e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.927417846932732 5.723603522324887e-18 7.126024422488742e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9354974556773346 3.423210528513448e-18 7.993441526130269e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9446522261231145 9.073058689909978e-18 5.536698041976434e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.955007309932994 -6.076500391144077e-19 -1.4448666034074638e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9666990078748852 2.5934008097566354e-18 1.4868707466913588e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.979874420294782 4.492781609608977e-19 1.0767130417496557e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9946905607481384 3.7057544084843425e-19 1.0146569395474371e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.011312744385329 5.367458261400043e-21 -3.5913081914744495e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.029912019711389 2.3417341025938267e-19 -8.334466317655181e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.050661366357251 3.5614568167931924e-19 -1.1706838604087939e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0737303363830977 -2.308323489194424e-19 -9.85119660552973e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.0992777792624 3.11023697892734e-19 -1.0932607899062592e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1274422721685298 -6.375642989763246e-20 -5.785255621145808e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1583298941329843 1.2542387610216678e-19 -3.20112994703731e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.1919988476784034 -5.968528118427075e-20 3.594675500491886e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.228439426895967 -3.2239377164550785e-19 9.053662187334257e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.2675623155769165 3.4827992774571505e-19 6.418688255804601e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.3091942847450535 -9.750376802910433e-20 7.303051436242485e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.3530802223831495 7.846049486376997e-19 -2.5284151159504445e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3988946281692924 -5.548994004891861e-20 -1.9614394599730856e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.446249960953354 -2.5186104652729252e-20 -1.5770962460579075e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.4947031938512993 2.2413228033662523e-19 -1.7871817876548288e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.543770898352245 -4.436095960325143e-19 8.081261953487728e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.5929571750008256 3.483257044575158e-19 -3.229267690244833e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6417803411954486 -8.216434129956713e-19 4.4119626025400685e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6897854690631116 4.738979686539391e-19 -2.229418137936172e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7365525778792663 -2.6424244663308556e-19 1.4545091713552163e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.7817100862428474 1.427389828164629e-19 -6.71814686836178e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.824950214816541 3.6097123476891045e-19 -1.133606053656544e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.866041039181137 -4.781106571631652e-19 3.027009444526241e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.904819222801416 9.769850121951713e-19 -5.588514870714049e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.941177988748218 -1.1604044608505294e-18 6.112581570969967e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9750559222024013 1.0888525935236551e-18 -4.930797474649088e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.006426930397174 -1.3625421027346555e-18 7.29018416799337e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0352922049876696 1.2282256101670867e-18 -7.477157855253858e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.061673399850161 -1.067337682617537e-18 4.874121613603069e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.085606782979188 1.0227434669254665e-18 -5.197502602906365e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1071383127889627 -6.864152512679844e-19 4.269094811613597e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1263196578995314 5.901087217658505e-19 -2.846873999230078e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.143204718028132 -4.768332157268248e-19 1.9970172371679599e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.157846591433172 2.328689939257137e-19 -1.311792382103001e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1702952697849898 -2.454675357301998e-19 1.7817110018561744e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.180595927717503 1.642494831250929e-19 -8.149948469376971e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.188787675401489 6.083923678236937e-20 -6.504484279954105e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.194902667214529 6.145501169718553e-20 -1.698293134280198e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1989654821995472 -8.333668336106109e-20 5.855595978162093e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.200992712276598 -3.487767525085576e-21 -3.229866238427112e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener deleted file mode 100644 index 8e54d47e3..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_6.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04144054208436112 -1 0.04144409586587292 -2 0.04145145516537695 -3 0.041463139752019186 -4 0.041479970942061115 -5 0.041503124208672235 -6 0.04153420378298187 -7 0.041575343251204606 -8 0.041629337369100405 -9 0.041699811641437316 -10 0.04179143762776264 -11 0.04191020337411097 -12 0.04206374970876496 -13 0.042261784161005865 -14 0.04251658461059021 -15 0.04284360390273965 -16 0.04326218374958333 -17 0.043796380104186704 -18 0.04447589119702167 -19 0.04533706137193542 -20 0.04642390594938778 -21 0.047789061226911025 -22 0.04949450577064875 -23 0.051611821106958666 -24 0.054221660231121814 -25 0.05741197342604569 -26 0.06127441277227098 -27 0.06589822239909815 -28 0.07136086373388549 -29 0.0777146936853932 -30 0.08496931100329116 -31 0.093069534900205 -32 0.10185300150988472 -33 0.11100739353852199 -34 0.12006912117295708 -35 0.12842328987454232 -36 0.13548342550570078 -37 0.1409414415783029 -38 0.14456251414739757 -39 0.14613594206416028 -40 0.14553726481164225 -41 0.14299755447632337 -42 0.13898061076570395 -43 0.13388074575243838 -44 0.12777934152209108 -45 0.1207312816332953 -46 0.11294983310286946 -47 0.1048612848929129 -48 0.09683196333433751 -49 0.0891368402052708 -50 0.08195478659549262 -51 0.07537288884538088 -52 0.06943408362004713 -53 0.06415095473351323 -54 0.059513639343837854 -55 0.055496680702518085 -56 0.052060826230550805 -57 0.04915936171404459 -58 0.04675029165805342 -59 0.044797559285974085 -60 0.04327116666277864 -61 0.04214719496511254 -62 0.041407772321972534 -63 0.04104102329826275 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz deleted file mode 100644 index d1a86153c..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_6.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8788968686814775 5.935145963695602e-18 5.704790165259476e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8791032222507325 2.9274815436505934e-18 5.793965900895888e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8795193681735805 2.5190875798009857e-18 8.900212472558596e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8801522351135014 -3.510246453286521e-18 -4.8728782663666265e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8810123441253772 -4.757831036282159e-18 -8.61393887921492e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8821139631990096 -4.1577456549347416e-18 -4.3964652857853916e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8834753146737977 -3.016693039638362e-18 -3.6230642114608365e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8851188364843414 -1.0544489568002812e-18 -2.850056884915772e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8870714981616468 -9.466658271804622e-19 1.0284960315504387e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8893651722642852 -5.457454638720269e-18 -7.770016627960046e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.8920370613657955 -4.739719757395633e-20 3.530547525812142e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.895130179779739 -9.37344272143462e-19 9.207528050881052e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.898693887730515 9.032711818302275e-18 2.1066459598316248e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9027844735079193 1.5126181290146976e-18 1.1792738966272956e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.907465776069129 8.451625998763317e-18 2.1415381140017713e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9128098363027637 4.624861281979817e-18 1.1787682937451602e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9188975594232192 -3.958487541906101e-18 6.829826471555455e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9258193633149077 -1.489946378709708e-19 7.497662653481627e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9336757776198055 -3.261961950262656e-18 3.779757798115109e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9425779453969048 3.5943618242475434e-18 -3.7026408766279606e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9526479626603697 8.290609905004844e-18 -3.925592244535189e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9640189703546316 6.5481518474515024e-18 -1.9096723868723105e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.9768348877302018 3.6194909549906556e-18 -3.2600820180075725e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9912496451399382 1.445318514600938e-18 1.0693496942470345e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.007425737853255 6.837807135547284e-19 5.669186629001252e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0255318810712284 2.317023194913422e-19 3.8936035876136174e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.045739501561417 -9.254144366723115e-20 1.6361794024769926e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.068217756634081 5.939509468160047e-20 3.0727549107325935e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.093126732730186 -3.6292929066298753e-19 -1.3204598285230481e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1206084537744645 2.936200371590237e-19 3.4395487860547965e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1507753390710076 -1.4824900058487393e-19 -8.429750419115118e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.183695813820083 -1.4693817486493102e-19 5.520918018319251e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.219376336561411 -1.7058509399533282e-19 2.2738013061659693e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.2577465538333716 -6.796851472466944e-19 -1.0092007447912085e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.2986538519327055 7.147743274542969e-20 2.1276117009906205e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.3418637789088748 -4.96768393906934e-19 -3.7693456358085478e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.387068140326381 2.58861687936319e-19 -3.771388005819843e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.433895845497993 2.6222466695798722e-20 -1.5629586959442755e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.4819202223406913 1.0311514378442223e-19 -2.961007642812898e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.5306705751521883 5.820310130697113e-19 9.118438454382897e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.5796556416858563 -2.514463393136698e-19 -2.4867095475600336e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.628391711514693 4.827239387630167e-19 6.497041585612647e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.676419000405795 -6.774532423083731e-19 -1.5369928012155972e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.7233115805329935 3.087804276153838e-19 3.2148461881181123e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.768687459928029 -2.808217824434559e-19 -1.4599353692968685e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.8122231845020473 -2.1642722139935498e-19 -2.530866950845011e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.8536657152416125 3.625168827844602e-19 3.0464896507684116e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.8928330655126198 -4.568937621636928e-19 -5.518216854887877e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.929602750433735 9.025175823034918e-19 6.827752259482073e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9639004676757765 -8.699812588041144e-19 -8.977199557686857e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.9956898234445206 8.985971605544934e-19 1.0482825971955224e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0249636270814184 -1.07477927865434e-18 -7.964424496160624e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0517368036825014 8.300023499126894e-19 9.218184439056004e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.076040305097591 -7.157098004287063e-19 -8.5339361711595815e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0979159466633113 6.262574208719875e-19 6.051351959909549e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.117412095375455 -4.225078019687824e-19 -6.009853494448832e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.134580173456733 3.7681638211452194e-19 4.2455341842587125e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1494715881155266 -2.455898786989531e-19 -3.1642063846161596e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1621352219848124 1.5370450667441352e-19 2.5231059206953404e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1726155577606354 -9.252921911876231e-20 -9.240331520884381e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1809513011719464 -9.934521898350259e-21 1.848869642804555e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1871743901273693 -9.301413057086079e-20 -1.466720353893475e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1913093011615783 1.4976094974661644e-20 -3.211747369080815e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.193372585416903 4.57564569586905e-20 -8.561986249752828e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener deleted file mode 100644 index 3f8ba8648..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_7.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04143664422359852 -1 0.041440060138863546 -2 0.041447134249361355 -3 0.04145836681308158 -4 0.04147454835323606 -5 0.04149681034919958 -6 0.041526697132302434 -7 0.04156626286344886 -8 0.041618198653083985 -9 0.04168599617971524 -10 0.04177415555216281 -11 0.04188844658703223 -12 0.04203623402269071 -13 0.042226878262796926 -14 0.04247222370610243 -15 0.04278718605997436 -16 0.04319044748227577 -17 0.04370526283493567 -18 0.0443603702056194 -19 0.04519098206673684 -20 0.046239807303146065 -21 0.04755801559816582 -22 0.049206000739820586 -23 0.05125372496893626 -24 0.05378033065898682 -25 0.056872590062549085 -26 0.06062163720121381 -27 0.06511730877998273 -28 0.07043935237753572 -29 0.07664480506276257 -30 0.0837511003850631 -31 0.09171500347875826 -32 0.1003958679581365 -33 0.10950652120736357 -34 0.11860985372907501 -35 0.12711661644633437 -36 0.13440694442202114 -37 0.14014245023155936 -38 0.144084121187044 -39 0.1460181275569136 -40 0.1457938767500849 -41 0.14356816545299292 -42 0.13978819313128785 -43 0.1348852190278622 -44 0.12898369836731932 -45 0.12213003076816675 -46 0.11448737980731134 -47 0.10646450874323858 -48 0.09844237551962157 -49 0.09071024508420758 -50 0.08346555146590494 -51 0.07680809067379347 -52 0.07078696456998052 -53 0.06541964315707728 -54 0.06069999153105468 -55 0.056605356374527266 -56 0.05310056742000245 -57 0.05014017370164885 -58 0.04768170413972135 -59 0.045688632616641335 -60 0.04413053167984842 -61 0.04298311647066296 -62 0.04222822874751713 -63 0.041853796953166204 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz deleted file mode 100644 index ed353fe9e..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_7.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.878666181269265 -5.295902948453637e-18 -2.2763669763097563e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8788685976452955 -7.074040512991991e-18 2.7205839553710903e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8792768022019717 -6.269370321728867e-19 -3.803996482068257e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.879897588717999 -3.892428033712656e-19 3.19856404599831e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8807412736114943 1.3060528883337608e-18 -2.0725065284868638e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8818218477238382 1.254314980204004e-18 -8.385927755970823e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.883157180079009 2.0692760813997338e-18 -2.636909425380721e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.884769274608177 3.2334758832707515e-19 -2.0887361650984814e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.886684580814134 6.443878487414969e-19 1.068240950634624e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8889343591291927 -1.0453272785659841e-18 -1.1734116518224594e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.8915551012144196 -1.0337190428865879e-18 -1.1659706678602371e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.8945890045622686 2.5540781101460144e-19 -2.6767002802559535e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.8980844993726955 -3.972563373242129e-18 -8.711744242226363e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9020968236123423 8.722814034504926e-18 3.172783994760613e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9066886392382447 2.146963557526456e-18 -5.834059133678907e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9119306785105374 8.352675556375602e-19 -7.585362609531923e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.917902403821648 -3.6339796171428855e-19 -2.4926091532387773e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9246926571409713 1.6411719033056341e-18 -3.904087728225159e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.93240026555296 2.6788036733043113e-18 -1.8589456383769035e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9411345569072345 2.4319619125959372e-18 -4.713597403378293e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.951015723696946 1.9546721999125473e-19 -3.942506826806461e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.962174953275782 1.2910563486175442e-19 -2.804674475397091e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.974754217794278 4.95631203342041e-19 -1.0558951097225412e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9889055872593737 9.425863692544096e-20 -7.140957369348489e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0047898937157678 5.4774655195103995e-19 -2.7931101405081773e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0225745340952788 1.9856036252859662e-19 -2.8052097276690033e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.042430155237719 1.4418746786167191e-19 -2.0932107010875307e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0645259200679633 1.6488396417264893e-19 -1.9428249651211215e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.089023014631418 -3.105194946964913e-19 -3.0571688906496266e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.116066031056947 1.7180208112985426e-19 2.194568710889839e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1457718660183827 -5.663581096082585e-20 -6.686184839026045e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.178215828746498 1.618475694230528e-19 1.8166095979731e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2134146430093233 3.5066708975922184e-19 1.4847758806234251e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.2513103032641157 -2.6473790242586913e-20 1.5038598095973467e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.291763454225462 3.3616110398438134e-19 2.562263499052595e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.3345528789645984 -4.650170937975025e-19 -1.0134763257849567e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3793819304501036 1.5337422280057186e-20 1.0296799433048626e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4258898052884756 -4.445220700319764e-19 -2.200003147156826e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.4736592595665066 -2.1296684235905591e-19 -2.433258662404368e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.522227193970893 3.499315352040772e-19 6.874286984112056e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.571105746533172 -1.6914165095849844e-19 -1.355172064033723e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6198095381228983 7.054627456941059e-19 3.1102907713383783e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6678750861050737 -3.9992804557186476e-19 -1.6041188820687685e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.714871422832011 3.469597586476596e-19 2.830047780617147e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.760409524101228 -3.2815607800274294e-19 -7.555230552037239e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.804156146669714 -1.5096924594108338e-19 -7.875607566655785e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.845845564899815 1.922654067293942e-19 1.1362167723804078e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.8852835601153406 -5.363893870300963e-19 -3.834060602367143e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9223373377336324 8.626659384511526e-19 3.472185571459152e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9569240892055437 -8.721386489033879e-19 -4.649106823395035e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.9890005904525982 1.0672991153029092e-18 6.901788608443445e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0185541530398625 -1.0225910308312507e-18 -4.587361663297308e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0455952904121864 9.070858931208286e-19 5.710484779722701e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.070151470176567 -9.24078979154795e-19 -5.206070299114703e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0922617999701725 7.372970549893983e-19 3.0159321146517975e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1119725739497195 -5.659453094545259e-19 -4.716866605429622e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1293336033981363 4.375843850926666e-19 2.401303307859121e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1443951647810437 -3.4844152072140765e-19 -1.1797139584447788e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.157205390469654 2.1661664533273546e-19 2.2622623664806454e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1678082867449375 -1.0380023611613293e-19 -5.542766535944786e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1762422731044215 1.168326506194776e-19 7.173920892492914e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.182539127279872 -3.95627195515269e-20 -1.6559273739345036e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1867232440796434 1.2657788408820301e-20 1.780519663735972e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.188811137832341 -5.2324703105615905e-20 -6.496331901895322e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener deleted file mode 100644 index 3642ca07b..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_8.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0414344481013313 -1 0.04143778367518003 -2 0.04144469142280824 -3 0.04145565987586224 -4 0.041471461032988474 -5 0.0414931998740958 -6 0.04152238459525 -7 0.0415610213607754 -8 0.04161173853160419 -9 0.041677946604529406 -10 0.04176404146921561 -11 0.041875660006592 -12 0.04201999840611084 -13 0.04220620467867648 -14 0.04244585737152615 -15 0.042753541957449334 -16 0.04314753403271842 -17 0.04365059324125735 -18 0.04429086224177583 -19 0.04510284901837189 -20 0.04612844578315571 -21 0.04741790044411718 -22 0.04903060356778962 -23 0.05103548159245915 -24 0.05351069368497902 -25 0.05654221631407445 -26 0.06022077410686769 -27 0.06463645697678157 -28 0.06987028872854513 -29 0.07598204323811703 -30 0.08299383357361578 -31 0.09086954477839329 -32 0.09948138729871513 -33 0.10855809484578015 -34 0.11767912729212285 -35 0.12627221561018004 -36 0.133703510023137 -37 0.1396104583975605 -38 0.14375099351938908 -39 0.14590993209975922 -40 0.14592453594698993 -41 0.1439043685117157 -42 0.14028206112170988 -43 0.13550454160630426 -44 0.12973038300824416 -45 0.12300219736281041 -46 0.11545684373325323 -47 0.10748390682837579 -48 0.09947339789693144 -49 0.09172354566745906 -50 0.08444268021089006 -51 0.07774005507031738 -52 0.07166879798086584 -53 0.06624957514229825 -54 0.061478716665723465 -55 0.057335400595689694 -56 0.05378672100349848 -57 0.0507887477874041 -58 0.048298740308704145 -59 0.046279890500890195 -60 0.04470151067861862 -61 0.04353909298849611 -62 0.0427743040960467 -63 0.04239495225578481 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz deleted file mode 100644 index bf41fc2d0..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8785340972958648 -1.2670569672736025e-18 6.425794799095023e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8787341044083754 -4.337545924023283e-19 1.6804719236274879e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8791374483448158 -2.377832955841299e-18 6.6481916477523565e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8797508381046804 -3.469293035945451e-18 1.447686596711303e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8805844614571932 -2.262631876194173e-18 3.4019660322292756e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8816521349554456 -2.9754471048622068e-18 5.161294357873187e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8829715053495577 -1.2513202332486155e-18 -1.6990575717744405e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8845643034058837 -1.3741722495969553e-18 -9.221031783553793e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8864566511362162 -1.4060559251597187e-18 -7.176133770239653e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.8886794232379154 1.3947649363921136e-20 6.888511842824963e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.89126866306627 6.877685992938176e-19 7.128781444974133e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.894266052611152 4.8409253000533344e-18 -5.223279801249339e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.897719434608663 -3.4276477209160546e-18 2.7373209049324054e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.90168338292633 -5.603806978988592e-18 -3.50445236792668e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.9062198145237463 -4.668936472887255e-18 1.743311974277051e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.911398632353882 -2.804022461051219e-18 2.2480557251438288e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9172983832301314 -1.348499691650589e-18 3.189005133543193e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.924006907557009 3.3352230010164243e-18 6.39590216263746e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9316219484570565 5.343876476667432e-18 3.2294972875354107e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9402516756866148 4.751341737359195e-18 4.139252512654213e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9500150642234215 1.990523507222396e-18 2.993642402107367e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9610420478749542 4.2191629023308243e-19 1.3231164362871559e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.973473344078394 2.6929497384442736e-19 6.187796906445316e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9874598167058128 -5.925436038136735e-20 3.2564012588794363e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.003161208939032 -1.3597097024969224e-19 4.409952501067069e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0207440384542332 -1.4173590062523954e-19 -1.084299719544451e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.0403784035992305 -1.6481626199315845e-19 -1.6256464448296567e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0622334048811357 -8.433373824411512e-20 -2.6221497546583496e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.086470846330306 -1.2370480437912777e-19 -1.2533596338286803e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1132368551550527 6.92776145088423e-20 -1.9066999777616782e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1426510594543666 -1.4814550558710061e-21 -2.5417201658540117e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.1747930127177915 8.706167019965151e-20 -1.1881402441880038e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.2096856439982133 1.1714112424363978e-19 8.163739109961441e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.2472786291195423 5.674076419730481e-20 2.164549170770715e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.287440897392976 1.647169115765989e-19 7.495230249431295e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.32995954143029 -4.489984577088448e-20 2.0588786195948482e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.374545408659291 4.881538457807048e-20 -4.2361067641546e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4208442435206194 -7.90687336315312e-20 5.921049070052113e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.4684447287998714 -4.5934366128061294e-21 -1.2467904747339818e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.516888647666397 3.1208187326510955e-20 -9.507997464446168e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.565690517943155 -1.4186756676965046e-19 2.7676452725120506e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6143643136516985 6.643623751917365e-20 -1.9639759331910475e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6624443857699136 -1.390141688201603e-19 9.960221488988363e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.709496554171786 1.512456374549945e-19 -1.0938122836013374e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.755127526733694 -2.5670840141905562e-20 9.07614893505934e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.798998029015574 4.2911037595489473e-20 6.415070617866911e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.840834787313864 5.76925661484952e-20 -4.0563820150736766e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.8804358454984107 -1.162858414518964e-19 1.6640554457606538e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9176618714286695 1.6032434852473695e-19 -1.846205301375823e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.952424650162928 -2.426706635597313e-19 2.2905864275628376e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.984676583819176 2.224739065741512e-19 -2.908177341431064e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0144014794189005 -2.630906050896412e-19 2.9604994113598316e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.041607030966647 2.7236931044564986e-19 -2.9973610249582957e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.06631847309043 -2.0107028716041818e-19 2.4224819180449774e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0885731726924135 1.8093348815540446e-19 -2.0910074414054282e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.108416088915517 -1.6294403054485878e-19 2.1182917183052314e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1258960139712415 1.307359156683172e-19 -1.531973541197499e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1410624836862175 -1.0126712266726253e-19 9.586326303283239e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.153963135911982 3.9417375862766083e-20 -8.277948695606817e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1646416602889196 -3.7649750373833883e-20 6.601546725613741e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.173136283860058 4.6609347386997157e-20 -3.0282315941351194e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.179478674823999 1.175465515193212e-20 1.2368941317716678e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1836931706739104 1.1100315434655062e-20 -2.158059616815489e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1857962589672835 -3.232829637545908e-20 7.16797356694354e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener deleted file mode 100644 index 74cfb6854..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_9.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04143299769934156 -1 0.04143628099242074 -2 0.04144308053013499 -3 0.04145387731392976 -4 0.04146943145123786 -5 0.04149083092002364 -6 0.04151956074573737 -7 0.041557596336294585 -8 0.04160752586979329 -9 0.04167270789257375 -10 0.04175747164676185 -11 0.04186736905709821 -12 0.04200948866315067 -13 0.04219284289955177 -14 0.04242884069763604 -15 0.04273185692669434 -16 0.04311990799000635 -17 0.04361543789051498 -18 0.04424620981105288 -19 0.04504628272284443 -20 0.04605702816760372 -21 0.04732810600701867 -22 0.04891826607797455 -23 0.05089577195028999 -24 0.05333815118656699 -25 0.05633086461175904 -26 0.059964362356287625 -27 0.06432887504836521 -28 0.06950620996739645 -29 0.07555784417102926 -30 0.08250881995612358 -31 0.09032747315371806 -32 0.09889390621499143 -33 0.10794707435974155 -34 0.11707693920515837 -35 0.1257220594295827 -36 0.13324269076770417 -37 0.1392585526558932 -38 0.14352535744759665 -39 0.14582713872911565 -40 0.1459947775336761 -41 0.14410829257333344 -42 0.14058913198263934 -43 0.13589155730004834 -44 0.1301978223671541 -45 0.12354897073798175 -46 0.11606774345062948 -47 0.10812852165300742 -48 0.10012691473060215 -49 0.09236691378634396 -50 0.0850634595100194 -51 0.07833230638313023 -52 0.07222925237588612 -53 0.06677703147284206 -54 0.061973569617895685 -55 0.05779923098847468 -56 0.05422236589579418 -57 0.05120022998815947 -58 0.048689947560732326 -59 0.046654527985621135 -60 0.0450631150370987 -61 0.043891056411423136 -62 0.04311990533693745 -63 0.042737392193991 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz deleted file mode 100644 index 6501c64ce..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_9.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8784459952495691 2.894202302058075e-19 8.162905450825316e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8786444424378275 5.347128259809661e-19 1.6876496936962949e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8790446396026663 9.873637064641165e-19 -3.8518418269937636e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8796532415215153 1.2509083847765793e-18 -1.6962286421816882e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.8804803536921602 -3.4418253851156475e-20 -3.496485187146204e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.88153968122524 3.8263745134124396e-19 1.3518799287760575e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.8828487287708964 9.48228766045267e-19 1.1684960557174846e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8844290524980885 3.6247164888609844e-19 1.0529101514863037e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8863065651497035 4.613331572248561e-19 -2.075552412959067e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.888511895005338 -2.2241301360681767e-19 2.9380042230354935e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.891080799120573 4.711903895950514e-19 9.288641039226765e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.894054630386051 -1.389956649141753e-19 1.4051044223713203e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.897480856640477 1.879203955720753e-18 1.6447580435121759e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.9014136281235303 2.4314199639482696e-18 1.4493620237384326e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.905914386776276 3.1850808938569172e-18 1.6460386710873221e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9110525070370765 2.7675955912522337e-18 1.5411044466572425e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9169059525407672 3.790391829160873e-18 1.0776780235045617e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.923561926130345 2.5035942111221374e-18 7.762345575142862e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.931117481387896 1.7164394223945824e-18 1.6096498674494737e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.939680051955247 1.8552452558776846e-18 1.8318477894124125e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9493678396549075 1.6229741741067104e-18 1.898362168029549e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.960309983188094 7.842315893590362e-19 7.579302121036494e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.9726464053589228 3.5343301396104686e-19 4.845198960989993e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9865272078098624 1.7571416269682663e-19 3.013797565784802e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0021114479199054 -4.5370069195624867e-20 2.000636332617781e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.0195650930892532 -1.2429673538363789e-19 1.4183780460364358e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.039057904381386 -1.1184042460780548e-19 5.247195546246644e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0607589572194933 -1.6989416091629736e-19 1.6828840243049422e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.084830466774558 2.2377315264914018e-20 -1.1752605987122382e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.111419558552922 -3.205571856441104e-20 -6.173178495028939e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.140647624024987 9.124231548749985e-20 -1.1174008899654617e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.1725969465691066 8.739334059739365e-20 5.256274759805444e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.207294394324863 -1.4580928438236474e-20 1.099287550517872e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.2446945613161926 3.598097899268279e-20 -3.28435780472313e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.2846716751463814 -1.5048798981079808e-19 6.699737068618943e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.3270181370640244 6.864272876592856e-20 -4.823682202877192e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3714496284538806 -5.2380656673143745e-20 -3.9870155006478456e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.417616064749429 1.7499219681411703e-20 -8.025310754105896e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.465109895102292 6.811684154471355e-20 -1.289963659255413e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.5134759627474867 -2.568226189593235e-20 5.63602523180321e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.5622302871590676 1.807186076900261e-19 -3.06635040934288e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6108864785880854 -1.468575184648461e-19 1.7243482026118764e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6589774727126785 6.981119624874818e-20 -2.410429331630257e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.706066983242395 -1.448074247037089e-19 5.2552924569815663e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.7517589434227765 -1.7977069302379405e-20 2.2057117639125374e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.7957102125419784 -1.2852725898398536e-20 -8.354107393220575e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.8376427805089905 -4.8898168711142545e-20 8.450405565951978e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.8773497170747895 1.9620291331677434e-19 -2.464135865405214e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.914687484318064 -1.3169950201921972e-19 2.079599188149943e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.94956438808568 2.008440353805706e-19 -2.187136012667402e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.9819300090759095 -1.8417343803023756e-19 3.2219930594051214e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.011765898556824 1.4224607896132489e-19 -2.5882563248221003e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.03907793619327 -1.7732915280824656e-19 2.3822993646970667e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.063889919530172 8.904874498519592e-20 -2.0419007133438084e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0862380950502506 -6.247414158592887e-20 1.929161174385223e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1061665624881596 5.743466869026258e-20 -1.857318953347886e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.123723464987119 -3.217546325657478e-20 8.139989371751067e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.138957859895444 6.175946367904081e-21 -9.195281327578959e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.151917064412695 4.089035713947293e-20 7.698558929235852e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.162644562054567 1.2368362290054365e-20 -6.358989720537693e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.171178453844319 -1.8693948562544736e-20 5.05390480163755e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1775503356211026 -4.812978242452787e-20 -3.2768094871757204e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1817845065102768 1.2354718316957766e-21 -1.961811956705475e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1838974358136816 2.5548210421753337e-20 3.333217090712742e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 deleted file mode 100644 index 6d1ef51ef..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL.hess_12 +++ /dev/null @@ -1 +0,0 @@ -1.808106747070066175e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.807078580715130306e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.805004350307681110e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.801847939345325306e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.797554364154923395e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.792048785868505245e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.785235163869434982e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.776994525102073771e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.767182816516461863e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.755628300419606602e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.742128444632521159e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.726446251218766159e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.708305959465872964e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.687388051157759014e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.663323479909889491e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.635687042703695693e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.603989812840880130e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.567670562473844065e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.526086124315449710e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.478500682799109567e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.424074054506016887e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.361849129507392182e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.290738817657252624e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.209513101114317521e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.116787167333753786e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.011012123102545887e-02 0.000000000000000000e+00 0.000000000000000000e+00 8.904705120817103456e-03 0.000000000000000000e+00 0.000000000000000000e+00 7.532798172563831551e-03 0.000000000000000000e+00 0.000000000000000000e+00 5.974083548811051983e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.207094541101505381e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.209814951728908405e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.936941851754964528e-05 0.000000000000000000e+00 0.000000000000000000e+00 -2.376112240447952884e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.522524792054723880e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.387991281830767906e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.879719163931013168e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.021013665270310664e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.972270141313742051e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.068179250183457114e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094379480659390599e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.071069278947441548e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.022161199875585430e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.590483874896173211e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.791868462450572186e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.680965917186222472e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.280487282043275415e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.751820235034294460e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.391192401969948117e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.200452284327990282e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.165985124838061354e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.683708331995340868e-04 0.000000000000000000e+00 0.000000000000000000e+00 5.214653808973020166e-04 0.000000000000000000e+00 0.000000000000000000e+00 1.214011141617175535e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.817885645353806839e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.341179196580205762e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.791321399079477183e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.172640149024354497e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.481488964810755191e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.726849142404297516e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.917876876403285705e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.062026997202422898e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.165140973873835209e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.231525313351568521e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.264014455361304218e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.805559322863033612e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -7.523163845262640051e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.394689268473244043e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -8.275480229788904056e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.317832805195906491e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -9.027796614315168061e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.761581922631320025e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener deleted file mode 100644 index ad4d71b29..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.041431159968245763 -1 0.0414343766705071 -2 0.041441038357545174 -3 0.04145161639296752 -4 0.04146685566220852 -5 0.04148782237410154 -6 0.041515971878580755 -7 0.04155324018025903 -8 0.04160216395934773 -9 0.041666035157624556 -10 0.041749097534570685 -11 0.041856794000993965 -12 0.041996074896036975 -13 0.0421757785109457 -14 0.04240709578511528 -15 0.04270413074377016 -16 0.04308456621417947 -17 0.043570439631689925 -18 0.04418902489774111 -19 0.044973801339273416 -20 0.045965467324147594 -21 0.04721292091934338 -22 0.04877407965050171 -23 0.05071634252842101 -24 0.0531164077453049 -25 0.056059049433738156 -26 0.05963433320190204 -27 0.0639326298686573 -28 0.06903670360728371 -29 0.07501016202250434 -30 0.08188174891400904 -31 0.08962545358340034 -32 0.09813118445377166 -33 0.10715123022230368 -34 0.11628910559140161 -35 0.1249974229295405 -36 0.13263221526469673 -37 0.13878816780384723 -38 0.14321763872385676 -39 0.1457037199935348 -40 0.14607037256371103 -41 0.144360598186313 -42 0.14097874693428394 -43 0.13638579915652513 -44 0.13079625951414806 -45 0.12425050723715576 -46 0.11685567710490194 -47 0.10896346274333556 -48 0.1009761158622855 -49 0.09320511837625593 -50 0.0858736465464215 -51 0.07910634090531145 -52 0.07296265326499976 -53 0.06746804380934066 -54 0.06262254989024513 -55 0.05840811151609661 -56 0.05479456174331278 -57 0.051740885430423565 -58 0.049204130031355486 -59 0.04714707031454202 -60 0.04553863288563279 -61 0.04435397899054626 -62 0.043574515271603956 -63 0.04318787140600699 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz deleted file mode 100644 index 2a2271a28..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_12.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.8783333422653203 3.0949281007768247e-19 -1.1000076338027177e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.8785297747426166 -1.42833431820084e-19 -5.250080142786166e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.8789259075692553 6.642204773721767e-20 -1.0865807581321575e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.8795283252010604 1.6271991821093396e-19 3.342303702065465e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.88034702643248 4.168295514510483e-19 5.540217709260785e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.8813955718294244 8.917118398962562e-19 8.821054777696175e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.882691281721143 5.653468921288331e-19 5.989277418850332e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.8842554857841827 3.5785730898880224e-19 3.001701555560058e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.8861138252662064 1.7844336290746563e-19 2.985640514280362e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.888296608721087 1.200071271939896e-19 6.126338575788869e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 1.890839221685344 1.2057247932965619e-19 -1.1757101721021457e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 1.893782589930785 -2.9177333775389784e-20 -4.560134156117137e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 1.897173694660969 1.0478345055603712e-19 -2.699061379360931e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 1.901066136127572 -1.1660629455478366e-20 -1.7374376383675212e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 1.905520739440012 2.3851824741424325e-19 6.373690707344213e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 1.9106061925816686 3.4015705870174317e-19 4.844048565658888e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 1.9163997015353937 2.3821548045123213e-19 5.329409436079684e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 1.9229876405889992 -2.0919769592492554e-20 3.131089926545402e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 1.9304661669001044 3.590013077262543e-21 -5.573783355852306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 1.9389417567274243 2.3989104206553085e-19 -1.0175099104619003e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 1.9485316057998638 4.325305148366821e-19 5.432922105314611e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 1.9593638174506798 2.2150301168744425e-19 3.1109184491357803e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 1.971577278771488 1.2881779313862214e-19 1.0513865830929054e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 1.9853210965882924 9.119765945782808e-20 -3.478077156380651e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.0007534312692954 4.930483443329068e-20 1.7429733859548817e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.018039527464748 2.584094596805484e-21 -1.8992644779579915e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.037348698026179 -2.2101925513111336e-21 -9.900541704532163e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.0588499732049517 -3.6239781408397987e-20 -2.0472670151039673e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.082706086782238 4.4456444007387515e-21 -7.147769657771003e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.1090654423999817 -2.0865152808835925e-20 -2.8737803696694503e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.1380517000970323 8.087539002600304e-21 9.532465815109054e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.169750663933322 7.422472280911661e-21 5.30383241538462e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.204194262559518 9.571046787953284e-23 -5.5247586574942045e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.241343456102475 3.608788285539383e-20 4.739828509977617e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.281079339255744 -6.072359737695206e-21 -7.490252788923752e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.323201203745981 3.077282625009981e-20 -2.145292842919299e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.3674310399967773 -7.425693806885901e-21 -9.983613626924786e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.4134242024188106 9.978110420136703e-21 -4.629439075945029e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.4607780501430954 5.376165897239119e-21 1.4876873606198793e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.5090414044151057 -3.8742415548454794e-20 6.723126756384934e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.557732279404554 1.2140947272953879e-20 1.7127995807041196e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.6063639035839103 -4.448000129437174e-20 -1.2770119184577303e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.6544674049098544 2.963206307905874e-20 5.291313169986185e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.701603790003181 -1.4316447681710713e-20 -9.542808052828657e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.747373390281946 1.8502133993105775e-20 -3.708657223867362e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.791428076061492 1.585269652375784e-20 2.2546296639158953e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.833483736652398 -1.8300393184683892e-20 -1.9352476226650636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.87332700512417 4.1563893383718353e-20 2.6123435141668744e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.910808865120798 -5.858347020637631e-20 -1.862051488475525e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9458330877781975 5.404928592663921e-20 3.594425272028334e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 2.9783455735565445 -6.510486110470244e-20 -3.853490941218289e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.008324928478876 5.945756852718273e-20 3.164232068934169e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.035774664858374 -5.123000300461315e-20 -3.719003168207221e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0607167039670182 5.229410337127496e-20 3.2029642179955153e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0831858284548233 -3.8048094731352424e-20 -2.6498765875939152e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1032250143709224 2.72857965639939e-20 2.1723485641180438e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.120881556829117 -2.1848337229898458e-20 -1.764306532859029e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1362038885663495 1.4559858188829543e-20 1.7603789328098527e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.149238904919009 -1.0103545981417903e-20 -8.967479564094792e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1600298175889807 5.681232309598346e-21 4.178612640398914e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1686145608857506 -1.9673941768269033e-21 -8.422023452429667e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1750246344837882 5.782485733295224e-21 2.275710584955142e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1792842861823307 1.1006241727322953e-21 6.632280138536292e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1814099606453445 -4.243055911518313e-21 1.5003185818924737e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz deleted file mode 100644 index 4c66b97d3..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_FINAL_forces_12.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0002134372911426838 -1.7057763111594283e-19 6.06271584585194e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00021698799244651535 7.872295462345334e-20 2.893593016589088e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00022414232036500895 -3.660865515435014e-20 5.988713330426863e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002350064854528676 -8.968343457424502e-20 -1.8421179084104493e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002497406732533568 -2.2973650808816637e-19 -3.0535029633647913e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00026856000085121503 -4.914689076278177e-19 -4.861743403815135e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00029173563868637955 -3.1159216136197656e-19 -3.3010031927632434e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0003195959486150547 -1.9723382921081193e-19 -1.6543942992923095e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00035252742910291037 -9.834944509850796e-20 -1.645542221681659e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0003909751813445287 -6.614218749909666e-20 -3.3765447456113306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.00043544251075924715 -6.64537825504458e-20 6.479952021688762e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.00048648915056515355 1.608115056513253e-20 2.5133277950015017e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005447274306665914 -5.775162522036312e-20 1.4875935121476868e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006108155074341768 6.426781124049498e-21 9.575925091443053e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0006854465087359711 -1.3145984752161396e-19 -3.512873407468126e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007693321236612947 -1.8747829801327623e-19 -2.6698078353848553e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008631787681542657 -1.3129297685564392e-19 -2.9373155280255044e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0009676539784995367 1.1529976220394379e-20 -1.7257069795807174e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0010833401216692815 -1.978643465872421e-21 3.07200274202207e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001210671872156191 -1.3221646626040307e-19 5.608027860809481e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0013498532141710518 -2.3839012798934374e-19 -2.9943667593744656e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015007490405354032 -1.2208186357934328e-19 -1.7145894262140387e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0016627458376335892 -7.099820507511757e-20 -5.794739874120442e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0018345756442293716 -5.026378709647618e-20 1.9169497411748356e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020140977336178196 -2.717446605006273e-20 -9.606435483903244e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002198033727515264 -1.4242293214887583e-21 1.046783721506859e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023816547436167766 1.2181524010788035e-21 5.4567049564085345e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0025584245949650843 1.9973633840645646e-20 1.1283556397015762e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027196121609157258 -2.4502265189021085e-21 3.939508693849657e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028539002275411937 1.1499874062050273e-20 1.5838902612395834e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029470387783142532 -4.457464599177887e-21 -5.253839134508088e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002981618916053307 -4.090911638250555e-21 -2.9232186977951922e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00293907123493911 -5.275103121068116e-23 3.044982673575248e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0028097263164663737 -1.9889914624891055e-20 -2.6123667264672667e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0025914818113492066 3.3467941923429138e-21 4.128269011721156e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0022892337847080055 -1.6960509690570815e-20 1.1823827865445726e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0019145714576364913 4.092687189253263e-21 5.5024902259610776e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0014768912502634323 -5.499457121646904e-21 2.551525351338771e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.000986477095241831 -2.9630854526384194e-21 -8.19942103831017e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.0004626016485823241 2.135296605535404e-20 -3.7054658410594565e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 6.645801536188381e-05 -6.691509327160866e-21 -9.440131904180764e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0005760515617787356 2.4515248838651843e-20 7.038278785948858e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0010531551399952182 -1.6331775603560346e-20 -2.916318688638637e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0014875008364888058 7.890541078898045e-21 5.259539281177747e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0018658171068570337 -1.0197491135065711e-20 2.0440344436742742e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002174544747575507 -8.737247948163392e-21 -1.2426440117234909e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0024063844232184834 1.008630125252407e-20 1.066615909474954e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002568281521687816 -2.2908029661725366e-20 -1.439798773340924e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026728035103071863 3.2288406208360194e-20 1.0262737019330008e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002731536079283084 -2.978938074380554e-20 -1.9810752565527344e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027547226464451494 3.5882684895281315e-20 2.123859859990847e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002750841348061253 -3.277016738687726e-20 -1.7439733429814187e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027269549713935903 2.823552686860848e-20 2.049736633255698e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002689093692548725 -2.882200808531014e-20 -1.765320650640216e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026423315206418134 2.0970289636518718e-20 1.4604852078725645e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025908797516205257 -1.5038625743290687e-20 -1.197294605753093e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025381967175690926 1.204175828046831e-20 9.724013584093825e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002487189894409341 -8.024697305928453e-21 -9.702366531543843e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002440191927531488 5.5685912023244984e-21 4.942445741275785e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023989351240101043 -3.131223465085994e-21 -2.3030513871113032e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023646773172610446 1.084333552272829e-21 4.641816426552135e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002338306776228957 -3.187029508374228e-21 -1.2542628069120262e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002320422666736375 -6.0661139134862655e-22 -3.655395531304516e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002311393182161269 2.3385694352564296e-21 -8.269038287326057e-22 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz deleted file mode 100644 index a658a399d..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.000781429855081113 -8.43160699906258e-18 4.015674428072143e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0007891575002701956 -1.3424144597639162e-17 2.2250732018399183e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0008046679848871945 -1.903961361714741e-17 1.3416255582710055e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0008280705271667897 2.0836766082194876e-17 3.4101749675265574e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0008595258910245344 -4.457978415377342e-17 1.0165664647895922e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0008992423149247493 -4.202301387939086e-17 2.3655323787847544e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0009474693978479268 -3.456865628626943e-17 2.1710452594592475e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0010044892986785586 -7.794045470674477e-18 -1.7343331074863486e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0010706043731418592 -6.111201566119122e-19 -3.216019811782014e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0011461200909839223 1.1301093004044035e-17 -9.756233801771216e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0012313217349751542 -1.961807629192555e-17 -1.5153990210411553e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0013264429738327637 1.678734983324723e-17 -1.1679478410418557e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0014316239186382698 -4.446163865034375e-18 -2.271335917250529e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0015468557203771021 1.0310893866973251e-17 -2.9257663384209064e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0016719081634916572 -2.0174621322258143e-17 -1.79226257656107e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.00180623610059575 -7.485443882094181e-18 -1.7226683003790084e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.001948860041155035 2.2700331936069118e-17 -1.8995419343450417e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0020982158981989723 4.885998260491882e-17 -9.834909331889217e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002251969048900105 4.1903059632404455e-18 5.440525678800069e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0024067888401012225 1.729646377780488e-17 3.4532636665646057e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002558081996778296 -4.782652295848636e-17 1.615577007184596e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0026996877962159617 -3.3590532087894703e-17 1.2674392617389112e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002823544689447477 -1.762301736864236e-17 7.48397337341814e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0029193217789043025 -6.2383730169889985e-18 4.2141246725494264e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0029742070607698913 -3.227769203839384e-18 1.6356190192235667e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002973027417493166 -7.944622720118912e-19 -1.110774704726121e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0029032409583940595 -4.301573796030116e-18 -9.056924219241903e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002759396582056336 -6.358462682662754e-19 -1.873518977663132e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0025407427949425314 -5.461909752354977e-18 -1.3354968104234607e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002251933981569124 -1.0976470668799053e-18 -1.4917208642432899e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0019020997614424644 -2.7922094922625915e-18 -8.420593367182336e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0014978976451738466 -1.3865171833809964e-18 -7.526345901162312e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.001047080880568305 7.403375655620459e-19 -2.4648102025493944e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0005638983854983842 -2.754637917717582e-18 9.664051591794993e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -7.035256401898056e-05 2.8249072931245018e-18 1.221344145242859e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.00041174351160693423 -2.1950384028118846e-18 3.0397918273050477e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.000870057541071249 2.229519796349726e-18 -2.9898108559736554e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0012958504974688407 1.198614795318564e-18 4.864027929572564e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0016797399795649775 -4.75742636334429e-19 3.4805410818489315e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.002008952579598087 3.4055001566206588e-18 -1.622929345338293e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0022732209561222507 -4.124446649665421e-18 9.201934013509314e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0024695917308510495 4.2232481962958625e-18 -4.46087780526771e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0026066025521308068 -3.991451075917023e-18 -5.2848136230214714e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0026941095805829885 1.5497463753597264e-18 -6.346603627716657e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0027412287928526282 -6.43186595272939e-19 8.87053073900154e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002756047334462461 -1.8629244764351258e-18 4.717116584775352e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002745236991818988 4.652633317758843e-18 -8.167249970299456e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002714535675026289 -6.551474788477598e-18 5.900816841563284e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002668934404535075 8.091385719208333e-18 -8.267260282904828e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0026127144001070767 -8.765913106912533e-18 7.6857015395749575e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002549504584876266 9.053475911661538e-18 -8.138521053190775e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0024824991975716786 -8.666602340929877e-18 3.9825623767055463e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002414547771062899 7.692564191246168e-18 -4.943123716569884e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.00234788501865464 -6.75771240850382e-18 7.177597266658701e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002284211054660715 5.448936917602929e-18 -5.636774437802611e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0022247973322563445 -4.039555764301492e-18 -6.526747752949251e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0021705770825989007 2.7374019058479726e-18 -1.4748184145606605e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0021222215542208342 -2.0258605349016433e-18 8.057750002266332e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0020802040829722454 1.3838012215800757e-18 -3.107720270924411e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002044850475076598 -7.744308784510383e-19 3.5138014502003045e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0020163787078646724 4.726305939413185e-19 5.677947330140674e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.001994929662642328 -2.0620304604151786e-19 -4.183469705440318e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0019805901725577827 4.24368498590258e-20 -2.0669710373367705e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0019734094146990925 1.164700424991592e-19 4.379306237422766e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz deleted file mode 100644 index 1414ebfeb..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00016118581925062618 5.576161247538833e-17 -3.60945122687116e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0001656970133946807 5.944257395741653e-17 -5.097599129246586e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00017480610168316501 5.0635329893578736e-17 -1.047945692548162e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00018868731626167534 2.6912009623614717e-17 -1.6527303222262102e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00020760400728772672 -2.1979454445498014e-17 -3.551892055672954e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00023191081598682948 -5.3840489703374385e-17 -3.763662089784899e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00026205616017347874 -3.101899882185425e-17 -5.325601347104044e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0002985846173486225 -2.4341112000356276e-17 -3.3374728657208713e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.000342138604261337 -1.9434663577307178e-17 -6.887647542469269e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.00039345850248996816 -3.6230626563015764e-17 -1.7533689416177343e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.00045338004629070437 -6.2904310752849686e-18 -4.0747358307988333e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0005228273466748668 3.2500602967265532e-18 -1.325505029975894e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0006027993449328371 2.251671768678402e-18 -4.396993336635848e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006943467364901696 -5.980694271950384e-18 7.838583688566945e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0007985354477195169 9.035702966693846e-18 -1.8900233982735877e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.00091639155355609 -8.852325781308518e-20 4.62453206553308e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0010488210760414478 1.534036291319255e-17 -2.803273405984057e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0011964964184620517 1.976550303239732e-17 -2.8592310796604126e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0013596993436878525 5.4417677608305053e-17 -1.4826301902022226e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0015381085854997566 4.655018708326048e-17 -4.4274447092941446e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0017305187581792853 2.38474368086793e-17 -4.233370572218955e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0019344768609799916 1.3508597476416764e-17 -1.8100561658057462e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002145824337668358 7.706461615411439e-18 -1.1360193445949936e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0023581225024961864 5.262212797719205e-18 -5.413760438641265e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0025619738906388287 3.06979891399055e-18 -2.4042125956929327e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0027443255736624783 1.2474147625674776e-18 8.181191840913995e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0028878804403961937 1.4519139853640846e-18 7.580262103063306e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029708403906774815 -2.835982742401369e-18 1.5667964465220665e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002967441311753757 -7.758920745079994e-19 -1.9235848249562203e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028585075343672195 -4.02805385436784e-18 3.9947082657108387e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.00263988653420942 -1.7659063728192843e-18 -8.478709818207305e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0023177157093757965 -2.2084139769178812e-18 -1.1048023363576311e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0019077516335051993 -3.2866718271904736e-18 -1.3526167137727763e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0014235711438092267 -2.3477814134221376e-19 -5.295507535654695e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0008795880789932278 -3.1811523045713797e-18 1.274727357237996e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.00030309880961089527 2.244725584407917e-18 -4.0423598662516864e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0002696488148107171 6.49230004351463e-19 8.305681336367797e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0008133186889337842 2.9818215954170803e-18 1.0986533378493736e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0013138945212059013 2.9776080065904273e-18 1.0042561388014515e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0017565355312659562 -8.609054208920512e-19 5.407236537661941e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002121392091817916 3.471291472611057e-18 -1.968014561932938e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.002394157095213907 -3.677975250550452e-18 1.0938993140849854e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0025791132029956733 1.4744043060135684e-18 -1.321375456394864e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0026915307498752376 -3.009854425041555e-18 9.433343868569707e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002745813722938356 1.6565748458355264e-20 6.917498380752847e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027545341273276618 5.028105820336864e-19 -6.878723617876268e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027278597953494395 -2.968681873504964e-18 1.860817325999247e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002674470806099238 4.9432640318603135e-18 -2.169371568211943e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002601775584671402 -4.9000536090997e-18 2.7931905625022225e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0025160262308341315 6.3377439115576915e-18 -3.555450512628876e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0024229303189933576 -6.218393791937026e-18 3.4305294247295157e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002327355998172432 6.5699398197978515e-18 -3.3555669018603555e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0022329504811495877 -5.5639976058055994e-18 3.455490146244283e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0021423717611575993 4.4106202608853375e-18 -2.9085325603741377e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0020575044162266156 -3.956830152125751e-18 1.9833013727196057e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0019796409485710697 2.324242104124197e-18 -2.213774448216571e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0019096306681199672 -2.629841431493795e-18 2.0077550459887983e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0018480048739474087 1.4646171703134563e-18 -8.391335431336962e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0017950805495360288 9.100139183623179e-20 6.346914257699624e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0017510056423632489 7.694148683336089e-19 -8.639026676001068e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0017158167299872367 -5.653887732272503e-19 1.655325489486733e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0016894898158072028 -4.373958614783212e-19 -2.9061702762657185e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0016719774385454045 -9.432540886230386e-20 1.736646636618525e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0016632344909509786 3.616780333653643e-19 7.944540042371351e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz deleted file mode 100644 index 39aebf2a6..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_10.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00021448018820844085 5.429669344620961e-19 -7.331234812124304e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002180488938694068 7.386853435746445e-19 -9.224103708634566e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0002252394775816804 4.452685716856786e-19 -6.604830740274765e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00023615864275656177 6.9310572049314325e-19 -6.793339635147116e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00025096731054967755 8.832190521800897e-19 1.3957769908585326e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0002698815708122417 3.605912916932382e-19 1.4636510133416353e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.000293173794347618 -2.4716020005444566e-19 1.3462712685847843e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0003211737554759144 7.603414248391937e-20 2.0696910166437928e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00035426955305368775 -1.9818006321953968e-21 8.072857846284719e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0003929080400696078 1.549501117359848e-19 4.775177512159436e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.000437594371413545 -1.57521575948232e-19 -2.836276708611169e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0004888901501956188 3.058091152176126e-19 -9.852829104881225e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005474094876858834 -1.0932709414483108e-19 -9.670702302822126e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006138120820263688 2.070193271272817e-19 -3.57981541125617e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0006887921568942849 8.575728563013946e-19 -1.0412217444894107e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007730617731063618 4.555147503453059e-19 -1.2040454684744102e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008673266241453014 9.157567833419622e-21 -1.0720149697258209e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.000972251943121949 1.9639393392145277e-19 -3.2334989635216997e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001088415581410094 6.707958888450684e-19 -3.3037157419111447e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001216244675836969 4.293520569925475e-19 1.1464155580280603e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0013559316279085707 1.0060444737007397e-18 4.294561253000086e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015073244312433938 7.419240623021422e-19 2.548960519613642e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0016697858071058537 2.832296781185012e-19 1.274801079398085e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0018420153214102535 1.8665410258849317e-19 1.0359224997889684e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020218289483927444 3.301616469907071e-20 3.363990093100482e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002205891858486691 4.009800085336887e-20 4.2677776210797595e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023894031888950333 4.0096972423369306e-20 2.88620879895022e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002565737106188528 5.053351333329074e-21 -8.244793154696728e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002726053767644317 5.630348510867136e-20 1.4457583463204542e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028589082335136553 -3.0376081438011154e-20 -2.5972875072473073e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029499064031579176 4.5763086408326705e-21 -2.9006682718271074e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002981485628037983 -6.147358244244408e-20 -1.533605467449359e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.002935231460463323 -8.707402936519048e-20 -3.735494759695934e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002801911873843739 -2.115606846273411e-21 -2.9888438575000884e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0025796965370810643 -6.108043309637889e-20 -5.945439883368321e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0022738228580517473 6.165113014336106e-20 2.6761443710652948e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0018960148821540227 -2.2960193071497517e-20 2.4425881037187615e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0014555084697767569 6.017254910880972e-20 3.5714000201453496e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0009628284704643068 3.9353706228766814e-20 2.4018198349589066e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.0004378252898714587 -3.2273849628567547e-20 -6.221326938705501e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 9.103051642959901e-05 5.689239644853904e-20 3.562141720411595e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0005996204408875667 -9.769697083111858e-20 -4.4547047953863544e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0010751973812516316 6.33342612617665e-20 3.0230823101810566e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0015074791797740177 -7.575325430229642e-20 -3.7352484682690495e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0018829421848463247 4.9796522799536745e-20 1.2087149220406482e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0021881882888749055 1.5265987504644047e-20 2.3914764998401058e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0024163929085959253 -3.9037597289347914e-20 -1.6610629273930224e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002575175447023442 9.336808469408523e-20 4.872848465306177e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026770998174196464 -1.3669718022284615e-19 -6.991252363251511e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002733705046709045 1.4126216960765687e-19 6.730313309939602e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002755168561673398 -1.8026783686645643e-19 -9.156112067658865e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027498859352584806 1.7236443493574766e-19 8.313888779287683e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.00272487348855362 -1.64206523735177e-19 -7.742285751226588e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002686119093173064 1.5565300439312475e-19 8.342244590006829e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026386577140640626 -1.2286312647639756e-19 -5.619573637262896e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025866657094750323 1.0865397904480048e-19 5.919150751094903e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025335748941174236 -6.487988949377299e-20 -3.606435796944588e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024822795171641934 5.93524474792794e-20 2.8657231506059494e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024350834353240743 -5.722398361880638e-20 -2.5580401166849795e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023936943436300775 1.1563403490239076e-20 5.310241088972087e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023593511347499816 -1.4395568810872393e-20 -2.0948856698126724e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002332927968355708 1.50364215367427e-20 3.2391467540787326e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0023150140409815573 -1.770009726953785e-21 5.623065312061286e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002305971192104205 1.4110044609339557e-21 7.126695111458789e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz deleted file mode 100644 index ac82d241a..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_11.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00021384199171302655 -1.7456224070019234e-19 5.137298592125735e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00021739969048406612 1.6064381267906748e-19 8.526438548131129e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00022456810948682542 -5.549622716711057e-20 1.9347622787285416e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002354536510749442 1.3886418830638838e-19 7.694045063432386e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.000250216787076366 -7.985984615538697e-20 1.8234631624787766e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0002690730131862875 -1.43974274169776e-19 4.020347040615901e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00029229396709052816 -2.6032744711288894e-19 2.327329449939842e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00032020856053576314 -1.3103770046755232e-19 7.808016050081042e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00035320391516925105 -1.9938856501773144e-21 -5.700257432284555e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.000391725814516038 -5.2280619822722136e-20 1.5405514725688192e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0004362782846603279 6.224943018310407e-22 -1.0159763400923235e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.00048742178787759003 -2.4785840081379395e-19 -6.272374124783955e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005457693492826101 4.2303955258264165e-19 -1.1952170004342727e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006119797280248245 5.596447871920646e-19 -3.952587549740635e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0006867464822715822 8.423337236313972e-19 -5.041346968516345e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007707814510329725 8.282051674476194e-19 -4.8375741528603615e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008647907761860704 -1.9159250243438822e-19 -4.599774309758603e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0009694411071531416 4.0638945553445294e-19 1.2463756904561046e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0010853130660645474 2.1145505663685037e-19 -7.141262683756521e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0012128384103086956 5.686631283012024e-19 1.4659660753761492e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.001352216637584809 6.054067783538093e-19 3.469708313481546e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015033060911113145 2.906757301012151e-19 8.239606662808918e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0016654840428666946 1.351658522332046e-19 2.3481633574479464e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0018374699369969351 3.3674098901596836e-20 -7.869624606987447e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020171062488659863 -7.430962230299585e-21 -1.7024288651772584e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0022010926948477644 -2.1523678477844102e-20 -2.0337200373491605e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023846724553701496 -3.154748149134714e-20 5.686948442861772e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002561274542129829 9.536242615145502e-21 -1.6149396502516754e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027221256179582086 -1.417839640312413e-20 3.13109473268038e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028558588596408214 2.8939043991462913e-20 4.414999088355224e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029481682681272723 2.8532394539004647e-21 1.1575248413017777e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002981585178362607 8.150503845286515e-21 -2.692149759337826e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.002937596950218824 7.77466170696077e-21 -4.3561956065880133e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002806705964374628 -1.352775024268006e-20 -1.95818047152975e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0025869154627362473 2.9523148981180924e-20 -1.851097958076139e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.002283254037057757 -1.433409340543694e-20 3.1520091395487736e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.001907366454839772 2.336663509094621e-20 2.3246954915651704e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0014685849598256777 -8.754673132846314e-21 3.86110928339916e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0009772853264928773 -1.1849876639398306e-20 2.971670700688686e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.0004529647123015533 1.5643255122828165e-20 -1.001275209851085e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 7.602158278614791e-05 -3.1429536596513126e-20 -1.609103885937852e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0005852272621065483 2.3150975411628687e-20 -5.122712741098365e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.001061739336216024 -4.662782388389235e-20 -6.609834716755122e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0014952860227254831 2.133262128134245e-20 -2.7006251776696298e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.001872496753553123 -3.174525828327006e-21 1.8329081981613513e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0021798735536899183 1.559513202235993e-20 2.9938985187295234e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002410297770434798 3.38165384254713e-20 6.137679564158287e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0025709806607893473 -4.151003857543393e-20 4.235048678305764e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026744896872678866 4.390697053142967e-20 -4.413325468092828e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027323924432685423 -6.532601504234017e-20 2.5410295022163535e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027549068966852526 6.75858181597839e-20 -7.120482320563722e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027504789083481035 -6.592635346413803e-20 4.6009935699980306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027261530885393623 5.791727133995816e-20 -4.3343012731166383e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026879431535051074 -5.898936605049607e-20 5.404675893718979e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002640907916095478 4.144768166789472e-20 -2.3252723645904217e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002589245070897267 -3.541256421502466e-20 3.988166692307365e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025364024878714274 2.952406398090685e-20 -2.6436923685494068e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024852825746275323 -1.5086061561148503e-20 9.818648174753773e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024382068664029616 1.3869157838583664e-20 -2.181534533068891e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002396898073788279 -9.248464247752702e-21 -2.0744141101502846e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023626066438473775 3.91671228658525e-21 -1.157223681253052e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0023362153425667163 -1.8636329592062797e-21 5.469047024945339e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0023183194470744687 1.499715413524702e-21 5.18108173301554e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0023092846720935774 -2.0186639985391698e-21 8.189098832855064e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz deleted file mode 100644 index 4c66b97d3..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_12.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0002134372911426838 -1.7057763111594283e-19 6.06271584585194e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00021698799244651535 7.872295462345334e-20 2.893593016589088e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00022414232036500895 -3.660865515435014e-20 5.988713330426863e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002350064854528676 -8.968343457424502e-20 -1.8421179084104493e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002497406732533568 -2.2973650808816637e-19 -3.0535029633647913e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00026856000085121503 -4.914689076278177e-19 -4.861743403815135e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00029173563868637955 -3.1159216136197656e-19 -3.3010031927632434e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0003195959486150547 -1.9723382921081193e-19 -1.6543942992923095e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00035252742910291037 -9.834944509850796e-20 -1.645542221681659e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0003909751813445287 -6.614218749909666e-20 -3.3765447456113306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.00043544251075924715 -6.64537825504458e-20 6.479952021688762e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.00048648915056515355 1.608115056513253e-20 2.5133277950015017e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005447274306665914 -5.775162522036312e-20 1.4875935121476868e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006108155074341768 6.426781124049498e-21 9.575925091443053e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0006854465087359711 -1.3145984752161396e-19 -3.512873407468126e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007693321236612947 -1.8747829801327623e-19 -2.6698078353848553e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008631787681542657 -1.3129297685564392e-19 -2.9373155280255044e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0009676539784995367 1.1529976220394379e-20 -1.7257069795807174e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0010833401216692815 -1.978643465872421e-21 3.07200274202207e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001210671872156191 -1.3221646626040307e-19 5.608027860809481e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0013498532141710518 -2.3839012798934374e-19 -2.9943667593744656e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015007490405354032 -1.2208186357934328e-19 -1.7145894262140387e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0016627458376335892 -7.099820507511757e-20 -5.794739874120442e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0018345756442293716 -5.026378709647618e-20 1.9169497411748356e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020140977336178196 -2.717446605006273e-20 -9.606435483903244e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002198033727515264 -1.4242293214887583e-21 1.046783721506859e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023816547436167766 1.2181524010788035e-21 5.4567049564085345e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0025584245949650843 1.9973633840645646e-20 1.1283556397015762e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027196121609157258 -2.4502265189021085e-21 3.939508693849657e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028539002275411937 1.1499874062050273e-20 1.5838902612395834e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029470387783142532 -4.457464599177887e-21 -5.253839134508088e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002981618916053307 -4.090911638250555e-21 -2.9232186977951922e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00293907123493911 -5.275103121068116e-23 3.044982673575248e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0028097263164663737 -1.9889914624891055e-20 -2.6123667264672667e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0025914818113492066 3.3467941923429138e-21 4.128269011721156e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0022892337847080055 -1.6960509690570815e-20 1.1823827865445726e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0019145714576364913 4.092687189253263e-21 5.5024902259610776e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0014768912502634323 -5.499457121646904e-21 2.551525351338771e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.000986477095241831 -2.9630854526384194e-21 -8.19942103831017e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.0004626016485823241 2.135296605535404e-20 -3.7054658410594565e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 6.645801536188381e-05 -6.691509327160866e-21 -9.440131904180764e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0005760515617787356 2.4515248838651843e-20 7.038278785948858e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0010531551399952182 -1.6331775603560346e-20 -2.916318688638637e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0014875008364888058 7.890541078898045e-21 5.259539281177747e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0018658171068570337 -1.0197491135065711e-20 2.0440344436742742e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002174544747575507 -8.737247948163392e-21 -1.2426440117234909e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0024063844232184834 1.008630125252407e-20 1.066615909474954e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002568281521687816 -2.2908029661725366e-20 -1.439798773340924e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026728035103071863 3.2288406208360194e-20 1.0262737019330008e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002731536079283084 -2.978938074380554e-20 -1.9810752565527344e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027547226464451494 3.5882684895281315e-20 2.123859859990847e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002750841348061253 -3.277016738687726e-20 -1.7439733429814187e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027269549713935903 2.823552686860848e-20 2.049736633255698e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002689093692548725 -2.882200808531014e-20 -1.765320650640216e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026423315206418134 2.0970289636518718e-20 1.4604852078725645e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025908797516205257 -1.5038625743290687e-20 -1.197294605753093e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025381967175690926 1.204175828046831e-20 9.724013584093825e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002487189894409341 -8.024697305928453e-21 -9.702366531543843e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002440191927531488 5.5685912023244984e-21 4.942445741275785e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023989351240101043 -3.131223465085994e-21 -2.3030513871113032e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023646773172610446 1.084333552272829e-21 4.641816426552135e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002338306776228957 -3.187029508374228e-21 -1.2542628069120262e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002320422666736375 -6.0661139134862655e-22 -3.655395531304516e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002311393182161269 2.3385694352564296e-21 -8.269038287326057e-22 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz deleted file mode 100644 index 734930982..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0003326218989528543 2.7617658330265403e-17 2.61369988459996e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0003375969137801967 3.242953876052921e-17 7.55935214479825e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0003476130153929089 -1.412822559960903e-17 -1.6481473343258077e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.000362802413323527 -1.4705736854687574e-17 -4.768833477103534e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0003833635212338227 -2.8502074492654484e-17 -5.379782783408022e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0004095608901147525 -3.3087913518606905e-17 -3.18567950760139e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0004417247941166601 -6.0171827666327225e-18 -1.1849303627277245e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00048025015947046867 -9.056204146313389e-18 -1.2343946947853004e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0005255944092309327 -4.5226343323687095e-18 6.139164322857284e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0005782736493008512 3.192650780121429e-18 2.0321827535257312e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0006388564358022485 -8.18657202106689e-18 3.883401006818886e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0007079541306231229 -1.2201821099203057e-17 -1.2380494418396556e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0007862065598774593 5.699098943582957e-18 -2.72144149365609e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0008742613271557329 -1.5829778163296885e-17 -3.5098717732190924e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0009727446878852369 -2.0162284321767462e-17 -3.5461005390312893e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0010822213522271443 -2.850500750072714e-17 -3.9703138698626326e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0012031399455602698 -4.8847018604159915e-17 -7.37658003041558e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0013357601205304557 -3.0284843414645096e-17 -6.3995895801553954e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0014800565028223734 -2.3192017314251527e-17 -4.8309185962993365e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0016355938136946291 -3.41608441593436e-17 -2.0390043498687905e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0018013667447074103 -3.2675532342970746e-17 -1.317896723315599e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0019755976413780704 -1.6602939084508697e-17 -9.594397373350017e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002155485083020173 -9.28962109699043e-18 -5.261296228926496e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002336897510061175 -5.53989932060714e-18 -3.0396636011393303e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002514008828992838 -3.585748584191709e-18 -2.0191173970585544e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0026788786303317694 -2.519937392236236e-18 -2.524467995430687e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0028209903167235677 -2.977325195020039e-18 -2.4772174666808586e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0029267768926896113 -7.131405996154962e-19 -4.794974223714351e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029792056308620527 -1.664162775700917e-18 -3.2251990624556394e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002958310746728321 6.177478043623802e-19 -4.343109443398878e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002850423075087114 -5.856058954527972e-19 -1.525649321840083e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002650888941286115 2.4251986257928084e-19 -6.43270301142025e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.002362228253415845 9.34044283838225e-19 1.7905325562775033e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0019949156299296296 1.0600771487834288e-19 1.8351563189604776e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0015593487588417996 2.2126684940935e-18 1.0148855071280148e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.001065370608717932 -3.830468203945732e-19 2.1418080927302242e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0005314613452943762 9.608452427174969e-19 7.725846483387659e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 1.277587437384818e-05 -1.0349411299883987e-18 1.0307280802220213e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.000539540549201639 -1.2898896968889995e-18 5.792198710049355e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.001033863365763062 -7.080613617706567e-20 -8.238297530461193e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0014842313050933136 -1.8219550271874575e-18 1.2639698515308211e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0018758317430887699 1.9512745118847722e-18 -2.0082038911597845e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002193273723302718 -1.2433265173682359e-18 1.1112293531006533e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0024284999612931217 1.9006554468642727e-18 -1.8246095105670787e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002589665453761893 -4.657903161685444e-19 3.7879607199062643e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0026901028987589173 -5.269286076975573e-20 1.147811344211878e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027420043391204914 8.551870830525193e-19 -8.238374545257297e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002756001587826272 -2.131035207489247e-18 2.4551461336179427e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027407225843634566 2.3840847378065585e-18 -2.2187752740095196e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002703464992151357 -3.418550170140703e-18 3.2398890765618725e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.00265044647232578 3.635191621294467e-18 -3.8393662665639286e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0025868833354692785 -3.336298590081536e-18 3.2654958541464997e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0025171283521914535 3.437484302051553e-18 -3.491911420448099e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002445044729542906 -3.1239961718780507e-18 3.0228837046053e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0023737878980673297 2.5055625613896685e-18 -2.5501508133137304e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002305719753224704 -2.059365311561708e-18 2.2171651188503592e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002242576191518404 1.6206498637396157e-18 -1.6087541664772952e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002185609554138115 -1.0403636067814576e-18 1.1815902835310191e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0021357050657231412 8.520424828455545e-19 -1.0249578588981103e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.00209347425586339 -5.341097566284763e-19 4.673791070537809e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0020593285312783213 3.067294317473381e-19 -3.4673974601163954e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002033535817146026 -1.4708705595094634e-19 3.310506567996382e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002016262792533886 1.1750883868205654e-19 -9.325320355063615e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0020076047715262817 1.507194641787769e-20 -6.768607236980436e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz deleted file mode 100644 index f8221751a..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0002418890912603295 8.166994519672103e-18 -4.830395289298026e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002460867378322417 1.1911366427552897e-17 -4.832566066933504e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0002545446654163565 9.544081780120762e-18 6.144350830430947e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.000267388448930672 -7.922403088220893e-18 5.160789767884239e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002848071684065379 -1.1371490013965926e-17 3.7685969465611626e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00030705413325844477 -1.4602300345664324e-17 1.9094698403448724e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0003344476073144295 -8.318043788243679e-18 1.522398733274224e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00036737130265043804 -2.54364485379563e-18 5.329399794504481e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0004062743185657267 -1.5267433315445791e-18 1.1592234303188244e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0004516700853584303 2.923476501933151e-18 1.1945573582942535e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0005041337233338858 -1.30928350065196e-19 1.0807689753340476e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0005642970369177745 -3.926149994639142e-18 2.5328616081885627e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0006328401215937834 1.3768375728673976e-17 2.166245488835872e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.000710478256062311 -7.305614046002024e-19 1.6591667692456223e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.000797942371150134 -6.782395952137947e-19 1.6899749167662025e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0008959509181330565 6.6334865813719775e-18 1.965009604061939e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.001005170391999146 9.287333939907284e-18 1.7040557177587784e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0011261610947173907 -9.380360152961124e-18 -5.1297485473563216e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0012593039559598432 -4.968157443582963e-18 -1.894226182307287e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.001404703390358982 -5.076313671918416e-19 -7.985795913390662e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0015620603226483448 -6.073909666180341e-18 -7.068806096619178e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.001730508772808718 -9.927632385035601e-19 3.176257402249872e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0019084089696431571 -1.2917301470682405e-18 6.643512971265865e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0020930901934262604 -2.3450639376381348e-19 -4.3640383260531556e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0022805379594168784 3.0802221338944303e-20 -7.562425468694285e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0024650235528616564 4.923203724303628e-19 4.082118002185898e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0026386805112197384 4.2354538117468417e-19 9.784607282066967e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002791044033015019 2.0510709251021828e-19 5.771863584148763e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0029085875819328416 1.8238806398201348e-19 -4.511970877250485e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029743180244362214 1.18496739802636e-19 -7.069166721129936e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002967844460887509 1.5933866036429935e-19 -3.8333735166648986e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002873340893795541 2.781897045744591e-19 -1.1162556424622276e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0026852637044336063 8.725378766925729e-20 1.2339944479566358e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0024054587076563477 1.246602783610137e-19 -1.243689780184046e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0020441190229020345 -2.792081342570243e-19 -1.7356785273968534e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0016127065685414888 -5.722708469636585e-20 -2.5104779771746415e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0011209534299640661 -3.164424889202437e-20 1.9649521684903064e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0005863102935876441 -5.278479737414418e-20 4.110474734594288e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -3.822077733964758e-05 5.3781407263118673e-20 1.708911580765792e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0004940473527234025 -8.927807410483649e-20 5.43651155580634e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.000994416084178316 1.004960619859036e-19 -3.5439766549251056e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0014512041549679066 -2.900225819482283e-19 -1.9537000163714736e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.001849856583370825 1.7246131893510458e-19 -2.0290864005750908e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002174464269921146 1.3258509227949683e-19 2.1517198161081562e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0024160595461254824 -4.240956685765644e-20 3.2633355135813506e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0025819842820327954 -1.1863483179088134e-19 -3.9420890108306145e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026858684638254794 -2.301277693367533e-19 -1.7080539388734665e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002740239510015288 4.1202608572466453e-19 -3.0979352433196167e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002756064437475968 -1.84139682372687e-19 2.9726321735180168e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027422672231135117 2.7173985028917655e-19 -4.724723054519e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.00270637592779901 -3.591561540389444e-19 3.5893360266220027e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002654806679240631 2.534610234130534e-19 -1.6143612611475957e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002592943101368493 -3.1038446098881507e-19 -1.3919580432926498e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0025252621077361927 2.4854534766476666e-19 -3.9613012056915957e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002455685218253947 -7.335888373918574e-20 3.2796405011131304e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.00238743915465618 6.054738660566267e-20 2.4889549930391505e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002322938774452006 -2.371037622456302e-19 1.0777254699669872e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0022639569395830365 1.3562601847073488e-19 -1.7666728387998482e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0022117718032271545 6.029775269922765e-20 -2.354850927126079e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0021672866297253756 -4.473535586108003e-20 -2.372685793405679e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0021311251623827806 -7.190375500675353e-20 1.9978312613900226e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002103705657618092 2.077292470088909e-20 4.98091921854756e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002085296448751538 -4.1065598357037816e-21 1.3765511388645053e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002076055449545017 -9.231831788723096e-21 -4.621482419195507e-19 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz deleted file mode 100644 index aebb27b92..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00024234801114993143 -3.894307439963611e-19 2.307098567638991e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00024635876211808567 9.832422484171884e-18 2.3312116331266824e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0002544391505558975 -4.933245095641642e-18 4.3163944581190325e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00026670726193601995 1.2526466333374389e-18 1.348051979103637e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002833409642874032 1.8497192567514456e-17 2.5673791130902487e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0003045786766017165 1.3499431774662575e-17 2.0686851881068285e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00033072018347130386 1.3546865900611662e-18 1.68623937154455e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00036212729351606514 2.063082364313627e-18 1.3421228923422735e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00039922405897261054 -4.586954565288974e-18 5.7978133910368376e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0004424961717505628 5.6975271394578705e-18 2.4769774455133933e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0004924890206754478 1.5224690090743966e-19 4.582167440491675e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0005498037278668969 -6.2627232025843386e-18 1.6288966548060973e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0006150902702949029 -3.609078628599557e-18 7.155453100704723e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006890365254218376 -5.020609804708599e-18 1.284292900471079e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0007723517467145819 1.8785143271225627e-18 9.715286061721346e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0008657425648547343 -2.120567515537155e-18 8.1679168317379e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0009698791147595451 -2.209144495006594e-19 4.132523543556189e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.001085348302581414 7.927013047027515e-18 1.0527451334423211e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001212590555816958 1.154215888627796e-18 1.0187905200094096e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0013518156658449904 9.358827695313778e-18 2.3358088558553627e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.001502892587474987 2.322663086659805e-18 1.3836120810921973e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0016652074035612017 3.5539040944090254e-18 1.9138569519695167e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0018374832676058353 3.3477819848171547e-19 1.4779414153203359e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0020175562862254585 1.0897213791528265e-18 5.855619259905713e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.00220210243662701 -1.210856221843716e-19 2.181883251466063e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002386313384621587 7.792869349009108e-19 -1.3946953076890155e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0025635243988042303 8.49395706065202e-19 -1.21604413895418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002724806673561617 7.63356189485108e-19 5.3735239488675546e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002858550780765744 1.2780230613271784e-18 2.708100415714816e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029500892836917675 5.865774578663182e-19 2.12250680421494e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.00298143613324072 9.862137184097912e-19 -5.853219844716895e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.002933696288591909 9.478746258731611e-20 -2.5803854657315538e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0027973610491171556 -3.7194714060879874e-19 -1.042835281463367e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0025705058453528128 2.1091996275119012e-20 -1.2938062106915845e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.002258579213685612 -9.061898475154185e-19 8.442745102660366e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0018735308951461777 9.041605503836419e-20 -1.3319493569915866e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0014245589861274456 -8.247161842648046e-19 9.861290748163858e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0009227441619401436 3.1409057449277425e-19 -8.557468660270053e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0003894652260247667 5.1943134771776017e-20 2.798938042948045e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.00014555662620502373 -2.359262448217966e-19 3.3004406092130924e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0006585872190207138 6.81908831602629e-19 -1.5022701932522565e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.001136909348119088 -6.411792651860934e-19 2.836635989385824e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.001569561604330459 9.837788671781127e-19 -1.4153866385759026e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0019415326541954191 -7.537291707380992e-19 2.6892366019124796e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0022391435656554538 4.930876083449301e-19 2.1811755685003007e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002457141076673022 -3.1051724429768434e-19 4.590678300970158e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0026055947840126488 -2.291695890163824e-19 -5.942425242778251e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0026973465511387395 7.850562921926804e-19 -1.6437785902449064e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002744079092896333 -1.0885399782385712e-18 1.09854652012749e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027559276604176273 1.3113150268320426e-18 -6.361037879234918e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002741142078551636 -1.7500903733472862e-18 2.1737112146788486e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002706729419966196 1.8362886908094872e-18 -2.4586743479106204e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002658651309209621 -1.6920519571068777e-18 1.0527089963943014e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026019049377079594 1.6721016954449799e-18 -8.735315092703605e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025406289630762334 -1.4527808918255066e-18 1.5000799709641654e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024783665027780645 1.232201138990019e-18 -8.975620808143325e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024180706669036196 -1.0816562752643758e-18 2.8430935203596036e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023619646075072834 7.509708300369073e-19 -5.698878561843732e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023116851632782793 -4.433965108589918e-19 5.016528515481764e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0022684163369933517 4.896061478871421e-19 3.392692299970714e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022329969200674767 -3.206786014400704e-19 3.655901724540588e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002206004884941566 6.325834601444416e-20 -3.3676743985754394e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0021878212163921 -8.83492118071788e-20 2.4245034206797268e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002178675557590342 8.96280651814142e-20 2.1677540449426416e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz deleted file mode 100644 index 2c1664e72..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00022861638995061412 -9.378110280929854e-20 3.3593758186027728e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00023243939180693924 -3.7367600483587315e-18 6.230080530699251e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00024014209330393277 -4.373317866846334e-18 2.3442563333732737e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002518382278624516 -2.9043615970321798e-18 -3.380175267582155e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00026769920350782695 5.2540057577559385e-18 -3.0779681089303083e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00028795496622194587 6.3733441330821165e-18 7.162847069904456e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00031289496426522293 3.6981940812121115e-18 1.1205565782525992e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0003428690328541022 1.1855060464068156e-18 8.863618179667735e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00037828794650171434 -1.4345971132029724e-18 7.143252613205361e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.00041962329428608627 -8.370438026412703e-19 4.084303576149228e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.00046740621519373546 2.9428294469873624e-18 -1.923583259232776e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0005222243794051642 -9.888139137417317e-18 -1.3068325904169973e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005847164085985652 -1.614750541967008e-19 -2.0379914693555584e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006555626845391649 -4.0907194734716683e-20 -1.7263402701082524e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0007354711900911078 -3.270445198562052e-18 -9.557940788147526e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0008251566496440725 -1.020775370519574e-18 -4.157048876938419e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.000925310777397244 3.076038155609101e-18 -5.782239029602394e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0010365608959495873 -3.1545764505482054e-18 -3.927523760430442e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0011594135558912343 -1.8867098806541395e-18 -4.4056025716683686e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0012941790853822975 -5.0006359046347534e-18 -3.0515630911347053e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0014408722675839385 3.349076322439581e-19 7.963413509539103e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015990836638596889 -1.4293584608683432e-18 -8.194920252995373e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0017678156159625586 -2.476206293438656e-19 -5.934327198334533e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.001945276909826115 -2.0424345507026795e-19 -5.592303649959164e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002128630844137283 -2.958286220327733e-21 1.9793572708691714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002313693584880558 -1.2906518113413107e-19 4.5935591225023825e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0024945840144819462 -1.9629046212021078e-19 6.452249396167764e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0026633339004071156 1.2722374795629077e-19 5.429508298454172e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002809479495267787 -1.7142138324359386e-19 6.025530469911282e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0029196741859781636 3.513949412142433e-20 3.188556138049053e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029773879116115286 -6.912764036591711e-20 1.7643096882375778e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0029632784975306605 3.2895671709938725e-20 -1.9812131705111873e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0028636101055322526 1.7768802396418092e-19 -4.989945480322569e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002673935692083534 -1.9195523484110742e-19 -3.5376739035457927e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.002396584039323478 5.373941246359942e-20 -4.025092581632018e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.002041583792532888 -4.3243671304309796e-19 1.393541455287168e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.001619813638242889 3.0583400376682175e-20 1.0810515972101722e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0011404340597322062 1.3881376008775268e-20 8.692200042607799e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0006193858021004246 -1.2353099067742396e-19 9.85009104525558e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -8.387897945003379e-05 2.4449638753331153e-19 -4.4540049899942265e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0004379962644822379 -1.9198046477474397e-19 1.7798178662145821e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0009303229594475738 4.528505427174263e-19 -2.4316627230355277e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0013822139181560917 -2.611898895594905e-19 1.2287486246954047e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0017810926095463654 1.4563779551337288e-19 -8.016558731167652e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002111861169213919 -7.867089885099482e-20 3.7027211650135125e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0023645402985356776 -1.9895007613399052e-19 6.247894262968191e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0025426956607321597 2.635117219353469e-19 -1.6683427969886317e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0026590722882421625 -5.384674008233126e-19 3.0801220482742405e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027257989817026816 6.395594263355376e-19 -3.368962542675276e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027536938814982205 -6.001234600283495e-19 2.717619684046951e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002751784651691069 7.509680244974869e-19 -4.0180007589292017e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027275378112395702 -6.769391993489244e-19 4.1210517107296714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002687343670386002 5.882654703867969e-19 -2.686382660749836e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026365967385867935 -5.636872720360258e-19 2.8646147918595725e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025797878249249097 3.783192491410663e-19 -2.3529208313163357e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002520637312960096 -3.2523969727894597e-19 1.569060757024852e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002462345553716518 2.6280765732704274e-19 -1.100660365997884e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024074476262056646 -1.283462492528691e-19 7.229972062966677e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023578271345748416 1.3528996279498665e-19 -9.819938691097725e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023148592037393867 -9.052645758221024e-20 4.491861711664283e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0022795274365317213 -3.353167683163198e-20 3.584960567668669e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022525162174536558 -3.3871062506677544e-20 9.360179311218046e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002234280871200433 4.593119313247102e-20 -3.227324377830378e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002225098015441253 1.922290608828308e-21 1.780147757338762e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz deleted file mode 100644 index 91e57f2b6..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00022361814476765522 -3.2711685242718005e-18 -3.144207428144258e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002273420366594921 -1.6134877793323278e-18 -3.1933568275570026e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00023484509123430445 -1.3884005635807542e-18 -4.905371338405412e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002462381958094024 1.9346799186852328e-18 2.685697387233486e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00026168851148389635 2.6222888577450834e-18 4.74759102877122e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00028142037042053886 2.2915505029773037e-18 2.423121343415101e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0003057162980879161 1.6626568881400038e-18 1.9968596699122665e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0003349179919269955 5.811618212989277e-19 1.5708150113490225e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0003694270204264124 5.217569164799866e-19 -5.668578104608857e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.000409704920302203 3.007887918177992e-18 4.2824614562006734e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.00045627225859984734 2.6123067872466822e-20 -1.9458688986801605e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0005097060843493566 5.166193212766302e-19 -5.07474898353427e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005706350129672349 -4.9783986391549716e-18 -1.1610824734114321e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006397309568174205 -8.336827507094403e-19 -6.4995935664243976e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0007176962272854219 -4.658131933937677e-18 -1.1803133595873725e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.000805244376928629 -2.5490022903018226e-18 -6.496806925212978e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0009030727152886576 2.1817289633669746e-18 -3.764273619663312e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0010118239121114812 8.211871665331662e-20 -4.132352974585609e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0011320334970685516 1.7978373782786236e-18 -2.083221678825616e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0012640593880964 -1.9810402871712353e-18 2.0407185208914137e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0014079888657353796 -4.569387565892521e-18 2.163598649131318e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015635177288136 -3.609028041864377e-18 1.0525200629974077e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0017297958453163559 -1.9948902618865995e-18 1.796801249553533e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0019052331651456115 -7.965904227848139e-19 -5.893743949445315e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002087260828909099 -3.768672179869336e-19 -3.124584462193114e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002272043803403633 -1.277032341170775e-19 -2.145968031738647e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002454145243694464 5.100441666752648e-20 -9.017838136051412e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0026261495403984104 -3.2735734791873024e-20 -1.6935555095483044e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027782620556483163 2.000292628715449e-19 7.277742881222032e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.00289792036941702 -1.6182931801934286e-19 -1.8957147466064888e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0029694758495876564 8.17077570516955e-20 4.646075160939488e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0029741360034581887 8.09852926233374e-20 -3.042865896994007e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0028958985850256074 9.40183432051644e-20 -1.2532105037812516e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.0027286805148889408 3.746099377653758e-19 5.562231714646964e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.002473084507358168 -3.93949415267651e-20 -1.1726377869600534e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0021373126240092255 2.7379497386271195e-19 2.0774829930687415e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0017330851739728599 -1.4267217872934948e-19 2.0786086497142112e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0012691008951134358 -1.4452569188484022e-20 8.614280629631421e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0007586067454050657 -5.683213433782749e-20 1.631965761338529e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.00022620031967893203 -3.207876506744183e-19 -5.0256470598937305e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.00029911468540063795 1.3858519331074513e-19 1.3705553411393315e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0007982851277944509 -2.66054342058819e-19 -3.5808585105980472e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0012600418700553112 3.7337981853527396e-19 8.471169039688114e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0016732519339176866 -1.701849999823247e-19 -1.771869424151285e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002022876905381713 1.5477553227468522e-19 8.046465338388056e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002297264418550507 1.1928433079282638e-19 1.3948927893879424e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002495165107209903 -1.9980196337804428e-19 -1.6790793547574708e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0026282430016582553 2.5181798440478103e-19 3.0413771449313497e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027088198681152207 -4.974245159077408e-19 -3.7631304131965097e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002748017067722794 4.794920508971555e-19 4.947802936749827e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002755360633505076 -4.952637669883986e-19 -5.777632188767106e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002738628358883448 5.923669221244351e-19 4.389609772892203e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027044568645953693 -4.574575888636508e-19 -5.080622274906302e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002658474742244099 3.9446500321913744e-19 4.703497363333518e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026053870460311327 -3.451631309118635e-19 -3.3352157102166633e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002549077817824225 2.3286608813222246e-19 3.3123437412960956e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002492817177722575 -2.0768316333630412e-19 -2.3399353406330693e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024393242559482393 1.3535739238660911e-19 1.7439591870140416e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002390648411373088 -8.471457102278156e-20 -1.3906152808486717e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002348294934311981 5.099767908121954e-20 5.092828686917836e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.00231334732132588 5.4754332136656124e-21 -1.0190084992042989e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022865642088470226 5.126493907598062e-20 8.083860927621836e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002268453301584673 -8.254107109964718e-21 1.7701615033420535e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002259324564038492 -2.5218770136575924e-20 4.718957224768912e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz deleted file mode 100644 index 9af24fb7f..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0002194524800612796 2.918848354959894e-18 1.2546245784256423e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002231077870895615 3.898872716369432e-18 -1.4994557264278967e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0002304727628029204 3.4553770014905485e-19 2.0965808818683565e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00024165648250340662 2.145320122665655e-19 -1.7628954863347913e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00025682340653841805 -7.198338719021919e-19 1.1422664520474042e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.00027619430301428197 -6.913184120262321e-19 4.621922205442818e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00030004731216197206 -1.1404859841540479e-18 1.453338328395566e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00032871899161852474 -1.7821372208950986e-19 1.1512114513395927e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00036260511734779414 -3.551557554136189e-19 -5.887633085064573e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0004021609322952062 5.761343886273329e-19 6.467283677494194e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0004479004285773042 5.697364844461988e-19 6.42627253358009e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0005003941125500401 -1.407685669998081e-19 1.4752691440516443e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005602645277872137 2.1894868882269562e-18 4.801496665961109e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006281785899755989 -4.80759780589825e-18 -1.7486867553821396e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0007048355102810914 -1.183303604510871e-18 3.2154542994504237e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007909487395172728 -4.6035951837749355e-19 4.180688994890173e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008872199449205367 2.0028757193430952e-19 1.3738069215587463e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0009943025273774946 -9.045354412260874e-19 2.151746388493863e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.001112751598511882 -1.4764284336758671e-18 1.024561905939126e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0012429566744556395 -1.3403810638143367e-18 2.597909395377283e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0013850526371152708 -1.0773218072031526e-19 2.1729211577040543e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.001538803828335631 -7.115684966287363e-20 1.545802398267358e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.001703455595122856 -2.731682088253008e-19 5.819588716072971e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.001877547393175203 -5.195085144279695e-20 3.9357540863636244e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020586819985752144 -3.0189169583707746e-19 1.5394286901017714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002243246955989694 -1.0943697291432874e-19 1.54609740371375e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002426087807453508 -7.946923451396743e-20 1.1536776015198297e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.00260013886475009 -9.087615318274101e-20 1.0707921781449247e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027560275551210085 1.7114349056235656e-19 1.6849652408967945e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.002881684136044738 -9.468908829437387e-20 -1.2095412876660914e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002962011256509088 3.1214949606109326e-20 3.685105223472319e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0029787141681943286 -8.920263765458061e-20 -1.001228305778602e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00291452046945091 -1.932709243437222e-19 -8.183374353390028e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002762087189692616 1.459108670442898e-20 -8.288555840350561e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.002520928566014164 -1.8527591893518689e-19 -1.4121970647832997e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.002197953298067628 2.5629517619000103e-19 5.585796671693134e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0018051345991662263 -8.453253435194077e-21 -5.675103259828754e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0013512075684881594 2.449992995500529e-19 1.2125364889589438e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0008480783944642337 1.173771354065771e-19 1.3410957702736459e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.0003183592786555245 -1.9286552186105507e-19 -3.788778127242024e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.00020891039315346958 9.322278645600371e-20 7.469060117401556e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0007124138316730492 -3.8881731685736115e-19 -1.7142434802395326e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0011803997856740293 2.2042120659718926e-19 8.841135884964981e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0016022842256609644 -1.9122762078971074e-19 -1.5597869502733722e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0019634978963277575 1.808639315658302e-19 4.1640816462839086e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0022515526214084967 8.320702615846372e-20 4.340658130254288e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0024624418537030892 -1.0596749442163614e-19 -6.262283295634732e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002606492626846252 2.9563216984705076e-19 2.1131507867423388e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002696152568201153 -4.754601962755594e-19 -1.91370258141311e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002742731643223398 4.806811011126829e-19 2.5623652728496025e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027560613068236474 -5.882442139279923e-19 -3.803935706925738e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002744166138027287 5.636032565532708e-19 2.5283342944249297e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027138477983584073 -4.999423502872441e-19 -3.1473460272122354e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026708917537944547 5.093081263784426e-19 2.8693368961403553e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002620146606781617 -4.063628652222496e-19 -1.6622375026892317e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025656222509702867 3.119219803642655e-19 2.599711223152911e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025106450386819454 -2.41175579502795e-19 -1.3234835075576556e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024580284893025188 1.9204429715887727e-19 6.502018976641585e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002409931986528058 -1.1938873220307107e-19 -1.246850792237005e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002367947102369918 5.72097244569956e-20 3.0549077546999205e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023332234473285927 -6.439256787472673e-20 -3.953922003381795e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002306568724125822 2.1805078379397512e-20 9.1266795075108e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022885252006694425 -6.97636743613354e-21 -9.813372605302348e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022794248197213797 2.883887319502092e-20 3.5804673668835534e-20 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz deleted file mode 100644 index a0a0efa6c..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00021706610394002683 6.983411857362144e-19 -3.5415906902381836e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002206792994821459 2.3906478098499074e-19 -9.261957323573343e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00022795947095620916 1.310547772321504e-18 -3.6641651939951433e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0002390145343909575 1.9121083542137058e-18 -7.978955963575787e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.00025400722037746226 1.2470544483141597e-18 -1.8750009306158625e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0002731560106480483 1.6399241020519739e-18 -2.8446585393602823e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00029673622596165 6.896678507698539e-19 9.364392524987741e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00032508110934421653 7.573780050744305e-19 5.082191594979625e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00035858268600743676 7.749507617643204e-19 3.9551416357341367e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.00039769210090058146 -7.687277089042188e-21 -3.796618188862834e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.00044291903139917043 -3.7906514983021026e-19 -3.929043299331437e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0004948296397346446 -2.6680864407966987e-18 2.878821950433132e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005540423598932023 1.8891554488360056e-18 -1.5086803323486599e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006212205981519654 3.0885503267973678e-18 1.9314864960176196e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0006970611556086289 2.573294427020884e-18 -9.608301620758076e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007822768447318071 1.545443039151569e-18 -1.2390207711623967e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008775713605561285 7.43228519281598e-19 -1.7576270710774893e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0009836039732779227 -1.8382153647252427e-18 -3.5251152990539384e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0011009410309938017 -2.94528906871001e-18 -1.7799444092574644e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.00122999060820394 -2.618712266619737e-18 -2.281357967644057e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0013709159358824144 -1.0970813327048553e-18 -1.6499524794503076e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0015235225625257487 -2.3254007516078165e-19 -7.292384832325581e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0016871136339548913 -1.484225068048669e-19 -3.4104176373695773e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0018603074313121642 3.265816877816014e-20 -1.7947725912056112e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020408116747255007 7.494069409853902e-20 -2.4305548512646754e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002225150546996695 7.811804793355178e-20 5.976141336955435e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002408343592469608 9.083883898020436e-20 8.95978551235149e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002583541534979211 4.6480722085990986e-20 1.4452035039799628e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.002741633846633535 6.81801702706965e-20 6.907918708068836e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028708580132458784 -3.818250695166611e-20 1.0508818132924406e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002956462304839964 8.165071556001079e-22 1.400874562294921e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0029805050563186677 -4.798422767858966e-20 6.548460632614937e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0029250805467947063 -6.456258377932278e-20 -4.4994624530252206e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002781968413069122 -3.127279480920803e-20 -1.1929959532545267e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0025500193458723687 -9.078408178341243e-20 -4.131012349836625e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.0022353208981889285 2.4746647029203284e-20 -1.1347554006104405e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0018498112320817284 -2.690470470461322e-20 2.3347393976691903e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.0014024048232324092 4.3578903415619743e-20 -3.2633989908755444e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.0009042872269975533 2.5316825159752253e-21 6.871712645753005e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.0003767324712604629 -1.7200459888689024e-20 5.240353350161946e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.00015142132740265628 7.819061601358617e-20 -1.5253936730738503e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0006574521897756214 -3.6616475883340566e-20 1.0824495799057973e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.001129187072176272 7.661795956727663e-20 -5.489597598584919e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0015562427934796722 -8.33593599386626e-20 6.028570039329978e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.001924518723889883 1.4148539021191514e-20 -5.00233909992712e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0022210593667823368 -2.365051110534208e-20 -3.535680034578396e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002440363462568505 -3.179738251153571e-20 2.235683713811991e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0025915606994420673 6.409119282031086e-20 -9.171477551035524e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026871675774132737 -8.836311116465733e-20 1.0175400416679732e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002738606399436009 1.3374846065394218e-19 -1.2624616597132832e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027558836324093 -1.2261697439434246e-19 1.6028482265609275e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002747198405155534 1.45002955557471e-19 -1.6316856484748379e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002719455626432948 -1.5011693406654686e-19 1.6520020064708736e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002678539157018419 1.108203232993287e-19 -1.33515614433046e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026293881289056282 -9.97218830102927e-20 1.1524632701845978e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002576093256297602 8.980695457141448e-20 -1.1675010583616853e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002522027069045359 -7.205538245259325e-20 8.443505279627671e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024700470661557497 5.581359350536609e-20 -5.2835244589626196e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024223837999610086 -2.1724971891236282e-20 4.562409312970794e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023806850947726524 2.075074128301461e-20 -3.6384567443546e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.00234614380360798 -2.5688842539309594e-20 1.6690163873867394e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0023195998126868318 -6.47860358984792e-21 -6.817168737647394e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002301618114437729 -6.117962840584048e-21 1.1894192215675975e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022925451279314224 1.7817810411672563e-20 -3.950644122052555e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz deleted file mode 100644 index 6694e8d70..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst.instanton_forces_9.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00021547384651826305 -1.5951458534091953e-19 -4.499002979990733e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0002190597849224076 -2.947081296016243e-19 -9.3015177584256e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.00022628507087591452 -5.441876405989279e-19 2.122950947122117e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00023725688003110689 -6.894408595944497e-19 9.34880081840159e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0002521368383331612 1.896969499098811e-20 1.9270953671126704e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0002711419675324041 -2.1089145822046288e-19 -7.450915442782946e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00029454578817711765 -5.226183336129744e-19 -6.440191263331198e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0003226794271754594 -1.9977703261720773e-19 -5.803137054246331e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.00035593251543604665 -2.5426476658667075e-19 1.1439451978566877e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.00039475358216540336 1.2258341310380144e-19 -1.6192873768157662e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0004396495507433153 -2.5969760150986417e-19 -5.119454582353429e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0004911838104532393 7.66077610995044e-20 -7.744263389462121e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0005499721712688019 -1.0357273213232232e-18 -9.065119501508926e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0006166757967942274 -1.3400823676459752e-18 -7.988190115843288e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0006919899438326246 -1.7554642178937657e-18 -9.072177708064851e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0007766270057118787 -1.5253662911401367e-18 -8.493830462396077e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0008712919508430892 -2.089082648017581e-18 -5.939645716130816e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0009766477604794288 -1.3798613599508526e-18 -4.2782335388626513e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0010932678981876332 -9.460192970317982e-19 -8.871620030420274e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0012215721963753005 -1.022522432127824e-18 -1.0096268679214729e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0013617418492768785 -8.945057234511813e-19 -1.0462864114398255e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.001513608514769939 -4.322309352697997e-19 -4.1773487435586606e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0016765119566637433 -1.947953694449675e-19 -2.670441878257701e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.001849120387193805 -9.684524050436866e-20 -1.6610610414682363e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002029207990543852 2.5005811685943805e-20 -1.1026550382762415e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0022133854723126256 6.850641432304806e-20 -7.817421253147278e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023967825454849624 6.164109171974697e-20 -2.892003164972459e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0025726869446069302 9.363753394548587e-20 -9.275251668584783e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0027321540465956575 -1.2333305667635956e-20 6.477474188234604e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0028636158805277825 1.766757856204842e-20 3.402360668325748e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.002952539655481474 -5.0288399363735457e-20 6.158579153076719e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0029812149194108507 -4.8167028535074625e-20 -2.897007193146384e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0029314034303744474 8.036310219423775e-21 -6.058747091265871e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -0.002794277434355201 -1.9830994329929058e-20 1.8101809018639573e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H -0.0025682692094889325 8.294178080221945e-20 -3.692574564100025e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H -0.00225894510404842 -3.7832588302414357e-20 2.6585828705241933e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H -0.0018781332552006693 2.886971212468455e-20 2.197452209478956e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H -0.001434930833372014 -9.644732744788045e-21 4.423167365539387e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H -0.000940108421542915 -3.7542744423952413e-20 7.109662585253982e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H -0.00041407129640509037 1.415483414560681e-20 -3.1063074864626687e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.00011454772515692837 -9.960345117742353e-20 1.6900256547666636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0006221600404147328 8.094083867412492e-20 -9.503782383401408e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.001096259021836397 -3.847659168073307e-20 1.3285133352812701e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0015265346962142477 7.981092506723827e-20 -2.89646579482216e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0018992299128765496 9.90810059606014e-21 -1.2156828054206853e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002201111317032433 7.083807654791922e-21 4.6043843437463696e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002425842183551068 2.6950331358459802e-20 -4.6574592897562413e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002581657558426352 -1.0813765968657442e-19 1.3581138074359578e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026811085101957053 7.258646515228943e-20 -1.146175586748582e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002735689115271835 -1.1069562414191538e-19 1.2054447399780698e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027555118866057393 1.0150758838562827e-19 -1.7758084377061478e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027488947212349637 -7.839923382602622e-20 1.4265230668789825e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002722810239002734 9.773534579441574e-20 -1.313009443214669e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026832058827096672 -4.907940824088871e-20 1.125397990889407e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026350793306151006 3.443275814728922e-20 -1.0632613503521611e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002582573593359264 -3.165524177009134e-20 1.0236653549699711e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002529096373471574 1.773357610791345e-20 -4.486372733485266e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024775285523954914 -3.403886187442503e-21 5.0679991755200574e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024301457838222145 -2.2536808705137473e-20 -4.24307739112236e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023886323356769623 -6.816849605299979e-21 3.5047709268195654e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023542090762057617 1.0303210149540425e-20 -2.7854705533625803e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0023277367410486785 2.6526833596040676e-20 1.8060206303351137e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002309795043077232 -6.809329700041944e-22 1.0812568995892273e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002300739778039746 -1.4080951385915824e-20 -1.837109802926417e-21 diff --git a/drivers/py/pes/friction/onheH/060K/inst1D.dat b/drivers/py/pes/friction/onheH/060K/inst1D.dat deleted file mode 100644 index 5902cd8fd..000000000 --- a/drivers/py/pes/friction/onheH/060K/inst1D.dat +++ /dev/null @@ -1,64 +0,0 @@ -1.8783333422653203 0.041431159968245763 -1.8785297747426166 0.0414343766705071 -1.8789259075692553 0.041441038357545174 -1.8795283252010604 0.04145161639296752 -1.88034702643248 0.04146685566220852 -1.8813955718294244 0.04148782237410154 -1.882691281721143 0.041515971878580755 -1.8842554857841827 0.04155324018025903 -1.8861138252662064 0.04160216395934773 -1.888296608721087 0.041666035157624556 -1.890839221685344 0.041749097534570685 -1.893782589930785 0.041856794000993965 -1.897173694660969 0.041996074896036975 -1.901066136127572 0.0421757785109457 -1.905520739440012 0.04240709578511528 -1.9106061925816686 0.04270413074377016 -1.9163997015353937 0.04308456621417947 -1.9229876405889992 0.043570439631689925 -1.9304661669001044 0.04418902489774111 -1.9389417567274243 0.044973801339273416 -1.9485316057998638 0.045965467324147594 -1.9593638174506798 0.04721292091934338 -1.971577278771488 0.04877407965050171 -1.9853210965882924 0.05071634252842101 -2.0007534312692954 0.0531164077453049 -2.018039527464748 0.056059049433738156 -2.037348698026179 0.05963433320190204 -2.0588499732049517 0.0639326298686573 -2.082706086782238 0.06903670360728371 -2.1090654423999817 0.07501016202250434 -2.1380517000970323 0.08188174891400904 -2.169750663933322 0.08962545358340034 -2.204194262559518 0.09813118445377166 -2.241343456102475 0.10715123022230368 -2.281079339255744 0.11628910559140161 -2.323201203745981 0.1249974229295405 -2.3674310399967773 0.13263221526469673 -2.4134242024188106 0.13878816780384723 -2.4607780501430954 0.14321763872385676 -2.5090414044151057 0.1457037199935348 -2.557732279404554 0.14607037256371103 -2.6063639035839103 0.144360598186313 -2.6544674049098544 0.14097874693428394 -2.701603790003181 0.13638579915652513 -2.747373390281946 0.13079625951414806 -2.791428076061492 0.12425050723715576 -2.833483736652398 0.11685567710490194 -2.87332700512417 0.10896346274333556 -2.910808865120798 0.1009761158622855 -2.9458330877781975 0.09320511837625593 -2.9783455735565445 0.0858736465464215 -3.008324928478876 0.07910634090531145 -3.035774664858374 0.07296265326499976 -3.0607167039670182 0.06746804380934066 -3.0831858284548233 0.06262254989024513 -3.1032250143709224 0.05840811151609661 -3.120881556829117 0.05479456174331278 -3.1362038885663495 0.051740885430423565 -3.149238904919009 0.049204130031355486 -3.1600298175889807 0.04714707031454202 -3.1686145608857506 0.04553863288563279 -3.1750246344837882 0.04435397899054626 -3.1792842861823307 0.043574515271603956 -3.1814099606453445 0.04318787140600699 diff --git a/drivers/py/pes/friction/onheH/080K/RESTART b/drivers/py/pes/friction/onheH/080K/RESTART deleted file mode 100644 index 245aa5ac7..000000000 --- a/drivers/py/pes/friction/onheH/080K/RESTART +++ /dev/null @@ -1,309 +0,0 @@ - - - [ step, potential{electronvolt} ] - - 9 - 30 - - - - - - - - - 2.53345216e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 1.72235221e-03, 1.72564486e-03, 1.73232409e-03, 1.74257898e-03, 1.75669626e-03, - 1.77506375e-03, 1.79817438e-03, 1.82663050e-03, 1.86114762e-03, 1.90255678e-03, - 1.95180434e-03, 2.00994772e-03, 2.07814516e-03, 2.15763721e-03, 2.24971723e-03, - 2.35568786e-03, 2.47680008e-03, 2.61417169e-03, 2.76868215e-03, 2.94084215e-03, - 3.13063787e-03, 3.33735276e-03, 3.55924133e-03, 3.79301177e-03, 4.03384766e-03, - 4.27534006e-03, 4.50944956e-03, 4.72663307e-03, 4.91885423e-03, 5.08171010e-03, - 5.21152470e-03, 5.30503079e-03, 5.35913346e-03, 5.37145175e-03, 5.34187041e-03, - 5.27555224e-03, 5.17916092e-03, 5.05953489e-03, 4.92050141e-03, 4.76260264e-03, - 4.58670740e-03, 4.39431766e-03, 4.18989655e-03, 3.97974921e-03, 3.76927721e-03, - 3.56289325e-03, 3.36407393e-03, 3.17538524e-03, 2.99830210e-03, 2.83366253e-03, - 2.68193764e-03, 2.54330027e-03, 2.41768821e-03, 2.30486163e-03, 2.20445393e-03, - 2.11601603e-03, 2.03905164e-03, 1.97301970e-03, 1.91739906e-03, 1.87173957e-03, - 1.83566484e-03, 1.80887313e-03, 1.79113792e-03, 1.78230810e-03 ] - - - [ -1.46119364e-03, 2.24939908e-20, -1.53818802e-19, -1.47160522e-03, -3.19290121e-19, - -1.33296168e-19, -1.49240296e-03, 6.26085011e-20, -1.73921107e-19, -1.52353182e-03, - -2.35010365e-19, -2.78168273e-19, -1.56489872e-03, 1.69081922e-19, 2.56295273e-19, - -1.61635955e-03, 4.10905170e-20, 3.84167235e-19, -1.67770132e-03, 2.09909161e-19, - 5.96731936e-19, -1.74861908e-03, 1.67268409e-19, 6.81154786e-19, -1.82868699e-03, - 2.52653425e-19, 5.11026697e-19, -1.91732303e-03, 8.31480652e-20, 3.40808208e-19, - -2.01374676e-03, 3.39291017e-19, 2.55411188e-19, -2.11692956e-03, 5.77639498e-19, - -2.35170091e-19, -2.22553704e-03, 7.24223704e-19, -3.99338501e-19, -2.33786324e-03, - 2.89816092e-19, -5.18413026e-19, -2.45175720e-03, 3.10880212e-19, -9.08921653e-20, - -2.56454250e-03, -2.74647698e-19, 1.88771344e-20, -2.67293174e-03, -2.57628376e-19, - 1.56808051e-19, -2.77293901e-03, -5.02102387e-19, 3.40645543e-19, -2.85979516e-03, - -3.50295848e-19, 2.79837259e-19, -2.92787285e-03, -1.82219837e-19, 4.94526008e-20, - -2.97063112e-03, -1.68944567e-19, -5.63844996e-20, -2.98059366e-03, -1.74352096e-20, - -1.76983680e-20, -2.95054936e-03, -4.37544593e-20, -2.62584083e-20, -2.87653675e-03, - 3.50530467e-20, 7.43358094e-21, -2.75647028e-03, -2.22494527e-20, -2.34102534e-20, - -2.59006520e-03, 4.53247734e-20, 1.31476173e-20, -2.37917153e-03, -3.94147882e-20, - -1.24887493e-20, -2.12795610e-03, 1.23820294e-20, 3.32129629e-20, -1.84072789e-03, - -7.52763048e-20, 6.02017608e-21, -1.52040337e-03, -8.49976229e-21, 4.19050075e-20, - -1.17093233e-03, -6.75903551e-20, 8.07117489e-21, -7.98459585e-04, 7.22669326e-21, - 3.00884721e-20, -4.13096283e-04, -4.73647459e-20, -1.01143055e-20, -2.63215801e-05, - 7.58789048e-21, 6.48513860e-22, 3.51447939e-04, -3.79951542e-20, -2.47213209e-20, - 7.14481562e-04, 1.63960510e-20, 3.88107751e-21, 1.05839467e-03, -9.48372184e-21, - -4.52205912e-21, 1.37933108e-03, 2.81056352e-20, 7.57482876e-21, 1.67236800e-03, - 1.05590930e-20, -5.50743343e-21, 1.93160759e-03, 1.93366596e-20, 6.79359489e-21, - 2.15252345e-03, 1.47127517e-21, 7.66540291e-21, 2.33233287e-03, -5.54214058e-22, - 8.81946734e-21, 2.47283258e-03, -6.67944187e-21, -6.19663174e-21, 2.57904871e-03, - -7.06738199e-21, -1.75653954e-20, 2.65588959e-03, 6.38406425e-21, -1.30041614e-20, - 2.70793752e-03, 4.39210831e-21, -8.57813338e-22, 2.73939133e-03, 2.05529704e-21, - 9.20875254e-21, 2.75401485e-03, 8.35284089e-22, 1.11117163e-20, 2.75501256e-03, - -6.74803833e-21, 4.29093582e-21, 2.74518995e-03, -1.84794302e-21, -1.69735699e-21, - 2.72704547e-03, -4.76543171e-21, -5.48556113e-21, 2.70278454e-03, 5.50901133e-21, - 4.05429556e-21, 2.67433801e-03, -4.90393550e-21, 1.24661741e-21, 2.64338320e-03, - 9.68782409e-21, 1.43698701e-21, 2.61136606e-03, -5.03491651e-21, -9.60137985e-21, - 2.57952335e-03, 4.36270792e-21, -4.47107769e-21, 2.54890572e-03, -5.90028026e-21, - -3.14743979e-21, 2.52041794e-03, 2.61174983e-21, 7.34430602e-21, 2.49481058e-03, - -4.86087916e-21, 3.25906618e-21, 2.47267563e-03, 2.81973215e-21, 3.32643419e-21, - 2.45447022e-03, -2.57217687e-21, -7.85741671e-22, 2.44053675e-03, 2.59810588e-21, - 2.80128902e-22, 2.43111851e-03, 1.33066557e-21, -2.29443557e-21, 2.42637137e-03, - -9.38114746e-23, -2.51975753e-21 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00 ] - - - [ 1.37851002e-02, 0.00000000e+00, 0.00000000e+00, 1.37414965e-02, 0.00000000e+00, - 0.00000000e+00, 1.36538616e-02, 0.00000000e+00, 0.00000000e+00, 1.35213375e-02, - 0.00000000e+00, 0.00000000e+00, 1.33426284e-02, 0.00000000e+00, 0.00000000e+00, - 1.31159914e-02, 0.00000000e+00, 0.00000000e+00, 1.28392233e-02, 0.00000000e+00, - 0.00000000e+00, 1.25096457e-02, 0.00000000e+00, 0.00000000e+00, 1.21240878e-02, - 0.00000000e+00, 0.00000000e+00, 1.16788681e-02, 0.00000000e+00, 0.00000000e+00, - 1.11697762e-02, 0.00000000e+00, 0.00000000e+00, 1.05920564e-02, 0.00000000e+00, - 0.00000000e+00, 9.94039479e-03, 0.00000000e+00, 0.00000000e+00, 9.20891247e-03, - 0.00000000e+00, 0.00000000e+00, 8.39116920e-03, 0.00000000e+00, 0.00000000e+00, - 7.48018104e-03, 0.00000000e+00, 0.00000000e+00, 6.46845836e-03, 0.00000000e+00, - 0.00000000e+00, 5.34807095e-03, 0.00000000e+00, 0.00000000e+00, 4.11074889e-03, - 0.00000000e+00, 0.00000000e+00, 2.74802931e-03, 0.00000000e+00, 0.00000000e+00, - 1.25146059e-03, 0.00000000e+00, 0.00000000e+00, -3.85657281e-04, 0.00000000e+00, - 0.00000000e+00, -2.04525306e-03, 0.00000000e+00, 0.00000000e+00, -3.62426524e-03, - 0.00000000e+00, 0.00000000e+00, -5.08727294e-03, 0.00000000e+00, 0.00000000e+00, - -6.39714725e-03, 0.00000000e+00, 0.00000000e+00, -7.51622135e-03, 0.00000000e+00, - 0.00000000e+00, -8.41975585e-03, 0.00000000e+00, 0.00000000e+00, -9.20560546e-03, - 0.00000000e+00, 0.00000000e+00, -9.89176595e-03, 0.00000000e+00, 0.00000000e+00, - -1.04641162e-02, 0.00000000e+00, 0.00000000e+00, -1.08343833e-02, 0.00000000e+00, - 0.00000000e+00, -1.09427101e-02, 0.00000000e+00, 0.00000000e+00, -1.07818608e-02, - 0.00000000e+00, 0.00000000e+00, -1.04585206e-02, 0.00000000e+00, 0.00000000e+00, - -1.00573991e-02, 0.00000000e+00, 0.00000000e+00, -9.58247094e-03, 0.00000000e+00, - 0.00000000e+00, -9.02764460e-03, 0.00000000e+00, 0.00000000e+00, -8.31126177e-03, - 0.00000000e+00, 0.00000000e+00, -7.42995057e-03, 0.00000000e+00, 0.00000000e+00, - -6.40266827e-03, 0.00000000e+00, 0.00000000e+00, -5.28087887e-03, 0.00000000e+00, - 0.00000000e+00, -4.23529950e-03, 0.00000000e+00, 0.00000000e+00, -3.28532244e-03, - 0.00000000e+00, 0.00000000e+00, -2.42597415e-03, 0.00000000e+00, 0.00000000e+00, - -1.65178765e-03, 0.00000000e+00, 0.00000000e+00, -9.57028042e-04, 0.00000000e+00, - 0.00000000e+00, -3.31980647e-04, 0.00000000e+00, 0.00000000e+00, 2.35459946e-04, - 0.00000000e+00, 0.00000000e+00, 7.49031970e-04, 0.00000000e+00, 0.00000000e+00, - 1.21216873e-03, 0.00000000e+00, 0.00000000e+00, 1.62815677e-03, 0.00000000e+00, - 0.00000000e+00, 2.00009876e-03, 0.00000000e+00, 0.00000000e+00, 2.33088703e-03, - 0.00000000e+00, 0.00000000e+00, 2.62318547e-03, 0.00000000e+00, 0.00000000e+00, - 2.87941805e-03, 0.00000000e+00, 0.00000000e+00, 3.10081772e-03, 0.00000000e+00, - 0.00000000e+00, 3.28614225e-03, 0.00000000e+00, 0.00000000e+00, 3.43845273e-03, - 0.00000000e+00, 0.00000000e+00, 3.56080308e-03, 0.00000000e+00, 0.00000000e+00, - 3.65570915e-03, 0.00000000e+00, 0.00000000e+00, 3.72516352e-03, 0.00000000e+00, - 0.00000000e+00, 3.77064849e-03, 0.00000000e+00, 0.00000000e+00, 3.79314631e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -4.81482486e-32, 5.51152161e-01, - 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, - -4.81482486e-32, 5.51152161e-01, 0.00000000e+00, -4.81482486e-32, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 2.40741243e-32, - 5.51152161e-01, 0.00000000e+00, 1.20370622e-32, 5.51152161e-01, 0.00000000e+00, - 1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -1.50463277e-33, 5.51152161e-01, - 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -6.01853108e-33, - 5.51152161e-01, 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, 0.00000000e+00, - -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, - 0.00000000e+00, -1.50463277e-33, 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, - 5.51152161e-01, 0.00000000e+00, -3.76158192e-33, 5.51152161e-01, 0.00000000e+00, - -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, - 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, - 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, - -1.50463277e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, 5.51152161e-01, - 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, - 5.51152161e-01, 0.00000000e+00, -4.51389831e-33, 5.51152161e-01, 0.00000000e+00, - -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, - 0.00000000e+00, -6.39468927e-33, 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, - 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, - -3.38542373e-33, 5.51152161e-01, 0.00000000e+00, -3.19734463e-33, 5.51152161e-01, - 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -6.77084746e-33, - 5.51152161e-01, 0.00000000e+00, -3.19734463e-33, 5.51152161e-01, 0.00000000e+00, - -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, - 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -3.00926554e-33, - 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, - -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, -3.38542373e-33, 5.51152161e-01, - 0.00000000e+00, -6.77084746e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, - 5.51152161e-01, 0.00000000e+00, -3.19734463e-33, 5.51152161e-01, 0.00000000e+00, - -3.38542373e-33, 5.51152161e-01, 0.00000000e+00, -6.58276836e-33, 5.51152161e-01, - 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, - 5.51152161e-01 ] - - True - - - - - [ 1.95647695e+00, -4.08126692e-20, 2.79085910e-19, 1.95723343e+00, 5.79313924e-19, - 2.41850032e-19, 1.95875176e+00, -1.13595674e-19, 3.15559149e-19, 1.96104273e+00, - 4.26398338e-19, 5.04703224e-19, 1.96412245e+00, -3.06779023e-19, -4.65017270e-19, - 1.96801233e+00, -7.45538527e-20, -6.97025725e-19, 1.97273902e+00, -3.80855191e-19, - -1.08269908e-18, 1.97833428e+00, -3.03488620e-19, -1.23587429e-18, 1.98483482e+00, - -4.58409570e-19, -9.27197121e-19, 1.99228210e+00, -1.50862268e-19, -6.18355932e-19, - 2.00072201e+00, -6.15603168e-19, -4.63413202e-19, 2.01020447e+00, -1.04805812e-18, - 4.26688141e-19, 2.02078291e+00, -1.31401772e-18, 7.24552182e-19, 2.03251357e+00, - -5.25836806e-19, 9.40598736e-19, 2.04545460e+00, -5.64055146e-19, 1.64913016e-19, - 2.05966499e+00, 4.98315561e-19, -3.42503137e-20, 2.07520313e+00, 4.67436026e-19, - -2.84509546e-19, 2.09212515e+00, 9.11005022e-19, -6.18060795e-19, 2.11048285e+00, - 6.35570125e-19, -5.07731401e-19, 2.13032123e+00, 3.30616207e-19, -8.97258585e-20, - 2.15167555e+00, 3.06529810e-19, 1.02302964e-19, 2.17456799e+00, 3.16341128e-20, - 3.21115824e-20, 2.19900374e+00, 7.93872589e-20, 4.76427567e-20, 2.22496730e+00, - -6.35995814e-20, -1.34873479e-20, 2.25242040e+00, 4.03689838e-20, 4.24751185e-20, - 2.28130094e+00, -8.22364070e-20, -2.38547868e-20, 2.31152283e+00, 7.15134422e-20, - 2.26593492e-20, 2.34297695e+00, -2.24657187e-20, -6.02609683e-20, 2.37553331e+00, - 1.36579896e-19, -1.09228930e-20, 2.40904329e+00, 1.54218071e-20, -7.60316487e-20, - 2.44334113e+00, 1.22634655e-19, -1.46441862e-20, 2.47824598e+00, -1.31119748e-20, - -5.45919516e-20, 2.51356506e+00, 8.59376943e-20, 1.83512035e-20, 2.54909895e+00, - -1.37673242e-20, -1.17665121e-21, 2.58464747e+00, 6.89376852e-20, 4.48538946e-20, - 2.62001510e+00, -2.97486832e-20, -7.04175323e-21, 2.65501396e+00, 1.72070846e-20, - 8.20473808e-21, 2.68946603e+00, -5.09943300e-20, -1.37436253e-20, 2.72320521e+00, - -1.91582175e-20, 9.99258248e-21, 2.75607982e+00, -3.50840674e-20, -1.23261694e-20, - 2.78795566e+00, -2.66945368e-21, -1.39079613e-20, 2.81871837e+00, 1.00555545e-21, - -1.60018738e-20, 2.84827489e+00, 1.21190523e-20, 1.12430508e-20, 2.87655246e+00, - 1.28229235e-20, 3.18703195e-20, 2.90349609e+00, -1.15831248e-20, 2.35945031e-20, - 2.92906600e+00, -7.96895779e-21, 1.55640021e-21, 2.95323521e+00, -3.72909186e-21, - -1.67081855e-20, 2.97598744e+00, -1.51552357e-21, -2.01608868e-20, 2.99731508e+00, - 1.22435124e-20, -7.78539235e-21, 3.01721760e+00, 3.35287268e-21, 3.07965224e-21, - 3.03570007e+00, 8.64630867e-21, 9.95289780e-21, 3.05277184e+00, -9.99544539e-21, - -7.35603677e-21, 3.06844546e+00, 8.89760732e-21, -2.26183891e-21, 3.08273563e+00, - -1.75774038e-20, -2.60724190e-21, 3.09565836e+00, 9.13525678e-21, 1.74205610e-20, - 3.10723019e+00, -7.91561429e-21, 8.11223834e-21, 3.11746761e+00, 1.07053563e-20, - 5.71065491e-21, 3.12638643e+00, -4.73870923e-21, -1.33253692e-20, 3.13400139e+00, - 8.81948671e-21, -5.91318769e-21, 3.14032574e+00, -5.11606840e-21, -6.03541893e-21, - 3.14537093e+00, 4.66690880e-21, 1.42563474e-21, 3.14914636e+00, -4.71395389e-21, - -5.08260552e-22, 3.15165925e+00, -2.41433430e-21, 4.16298027e-21, 3.15291447e+00, - 1.70209755e-22, 4.57180015e-21 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/onheH/080K/clean.sh b/drivers/py/pes/friction/onheH/080K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/onheH/080K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/onheH/080K/control.in b/drivers/py/pes/friction/onheH/080K/control.in deleted file mode 100644 index 687e6ee90..000000000 --- a/drivers/py/pes/friction/onheH/080K/control.in +++ /dev/null @@ -1,181 +0,0 @@ -# Physical settings -xc pbe -spin none -relativistic atomic_zora scalar -charge 0.0 -#vdw_correction_hirshfeld - -# k-grid settings (to be adjusted) -k_grid 12 12 12 - -# accuracy requirements -sc_iter_limit 200 -sc_init_iter 200 - -#Mixing settings - mixer pulay - n_max_pulay 10 - charge_mix_param 0.05 - - -# occupation gaussian broadening -occupation_type gaussian 0.1 - -final_forces_cleaned .true. -compute_forces .true. - - -# IPI - output_level MD_light -# use_pimd_wrapper localhost 41000 - use_pimd_wrapper drag092 41111 - -#=============================================================================== - -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for Pd atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species Pd -# global species definitions - nucleus 46 - mass 106.42 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 62 5.0 - radial_multiplier 2 - angular_grids specified - division 0.5211 50 - division 0.9161 110 - division 1.2296 194 - division 1.5678 302 -# division 1.9785 434 -# division 2.0474 590 -# division 2.1195 770 -# division 2.1568 974 -# division 2.7392 1202 -# outer_grid 974 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 5 s 1. - valence 4 p 6. - valence 4 d 9. -# ion occupancy - ion_occ 5 s 0. - ion_occ 4 p 6. - ion_occ 4 d 8. -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A -# -################################################################################ -# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV - ionic 5 p auto - hydro 4 f 8 -# hydro 5 g 10 - hydro 3 s 2.6 - hydro 3 d 2.5 -# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV -# hydro 5 f 17.2 -# hydro 6 h 14 -# hydro 4 d 4 -# hydro 5 f 7.6 -# hydro 3 p 3.3 -# hydro 4 s 9.4 -# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV -# hydro 4 f 20 -# hydro 5 g 12.8 -# hydro 5 d 9.8 -# hydro 6 h 15.2 -# hydro 5 s 10 -# hydro 6 p 9.8 -# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV -# hydro 5 f 9.2 -# hydro 2 s 5.6 -# hydro 5 f 43.2 -# hydro 5 d 13.2 -# hydro 5 g 14 -# hydro 4 p 4.7 -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for H atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species H -# global species definitions - nucleus 1 - mass 1.00794 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 24 5.0 - radial_multiplier 2 - angular_grids specified - division 0.2421 50 - division 0.3822 110 - division 0.4799 194 - division 0.5341 302 -# division 0.5626 434 -# division 0.5922 590 -# division 0.6542 770 -# division 0.6868 1202 -# outer_grid 770 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 1 s 1. -# ion occupancy - ion_occ 1 s 0.5 -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A -# -################################################################################ -# "First tier" - improvements: -1014.90 meV to -62.69 meV - hydro 2 s 2.1 - hydro 2 p 3.5 -# "Second tier" - improvements: -12.89 meV to -1.83 meV -# hydro 1 s 0.85 -# hydro 2 p 3.7 -# hydro 2 s 1.2 -# hydro 3 d 7 -# "Third tier" - improvements: -0.25 meV to -0.12 meV -# hydro 4 f 11.2 -# hydro 3 p 4.8 -# hydro 4 d 9 -# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/080K/geometry.in b/drivers/py/pes/friction/onheH/080K/geometry.in deleted file mode 100644 index cd6ad1f1f..000000000 --- a/drivers/py/pes/friction/onheH/080K/geometry.in +++ /dev/null @@ -1,11 +0,0 @@ -#=======================================# -# iterations/iteration0105/aims-chain-node-0.56500/geometry.in -#=======================================# -lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 -lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 -lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 -atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd -atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd -atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd -atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd -atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/080K/get1D.sh b/drivers/py/pes/friction/onheH/080K/get1D.sh deleted file mode 100755 index 152292560..000000000 --- a/drivers/py/pes/friction/onheH/080K/get1D.sh +++ /dev/null @@ -1,5 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 diff --git a/drivers/py/pes/friction/onheH/080K/hessian.dat b/drivers/py/pes/friction/onheH/080K/hessian.dat deleted file mode 100644 index 536cf2c98..000000000 --- a/drivers/py/pes/friction/onheH/080K/hessian.dat +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 diff --git a/drivers/py/pes/friction/onheH/080K/init.xyz b/drivers/py/pes/friction/onheH/080K/init.xyz deleted file mode 100644 index cf8e637e3..000000000 --- a/drivers/py/pes/friction/onheH/080K/init.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1448613 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1460477 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1477077 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1498430 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1524556 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1555471 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1591193 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1631742 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1677134 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1727363 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1782411 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1842257 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1906879 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1976222 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2050185 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2128665 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2211559 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2298731 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2389979 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2485087 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2686011 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2791254 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2899215 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3009534 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3121847 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3235746 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3350802 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3466586 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3582672 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3698644 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3814100 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3928638 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4041854 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4153390 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4262942 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4370210 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4474895 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4576725 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4675494 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4771003 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4951464 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5036114 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5116899 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5193718 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5266471 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5335107 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5399597 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5459909 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5516014 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5567903 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5615583 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5659063 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5698349 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5733452 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5764386 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5791165 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5813803 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5832315 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5846716 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5857018 0.0000000 0.0000000 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0000000 0.0000000 diff --git a/drivers/py/pes/friction/onheH/080K/input.xml b/drivers/py/pes/friction/onheH/080K/input.xml deleted file mode 100644 index d47b32ac2..000000000 --- a/drivers/py/pes/friction/onheH/080K/input.xml +++ /dev/null @@ -1,37 +0,0 @@ - - - [ step, potential{electronvolt}] - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - - - 80 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - true - 0.1 - - - -
diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 deleted file mode 100644 index f7e8f1301..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -3.720388398520301215e-03 0.000000000000000000e+00 -3.513905651654643162e-34 3.628497141532409549e-03 0.000000000000000000e+00 -1.097723571798680044e-35 3.471748552227420671e-03 -3.519601097638216313e-34 -3.519601097638216313e-34 3.249222392664132507e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.959728025341050884e-03 -6.657880537766638369e-32 0.000000000000000000e+00 2.601883413800640168e-03 0.000000000000000000e+00 3.596523669747883986e-34 2.174579628642227085e-03 9.113501074465804053e-35 7.290800859572643243e-34 1.677119110686054859e-03 8.531191684765963609e-33 3.709213775985201625e-34 1.109548526236916587e-03 -4.738419593504333497e-35 1.895367837401733399e-34 4.731838728439276276e-04 9.733607136199079481e-35 0.000000000000000000e+00 -2.285868201143117714e-04 0.000000000000000000e+00 3.559277566511445698e-32 -9.896360316961694617e-04 1.045352753337825443e-34 -4.181411013351301770e-34 -1.800147854025753533e-03 -2.189773281193647412e-34 4.379546562387294823e-34 -2.645196782636759485e-03 0.000000000000000000e+00 4.625518685498290597e-34 -3.504199937986752882e-03 1.232943443907731305e-34 -1.232943443907731305e-34 -4.360530276483679316e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.199960111110484527e-03 -1.449814991114558867e-34 4.291452373699094178e-32 -6.007494845101184720e-03 -3.208134005606111901e-34 1.604067002803055951e-34 -6.767257757396674504e-03 -3.606719440075965691e-34 -1.803359720037982846e-34 -7.463101494303889250e-03 -2.040602554990365392e-31 -1.020301277495182696e-31 -8.088272755342108822e-03 0.000000000000000000e+00 -2.417500258340856453e-34 -8.651093239563707737e-03 1.451912754051572494e-34 1.451912754051572494e-34 -9.171714450910542493e-03 0.000000000000000000e+00 8.998845484584648052e-35 -9.653378848991200911e-03 0.000000000000000000e+00 -3.826729872359883178e-32 -1.008926111218761724e-02 -1.969748780522787136e-35 -1.969748780522787136e-35 -1.046862453772033283e-02 -3.588135771442574632e-36 0.000000000000000000e+00 -1.075208387036870154e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.091014043248580111e-02 6.955007809062499502e-37 6.955007809062499502e-37 -1.093655829433645525e-02 -1.876459997565012593e-36 1.172787498478132871e-37 -1.082770332390313971e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.061780710133074929e-02 1.306233917284244291e-31 -5.280272929437481793e-36 -1.036704283126274606e-02 -2.102903362163559967e-36 2.102903362163559967e-36 -1.007778135951150830e-02 0.000000000000000000e+00 -7.480946858195232559e-37 -9.752005558120672296e-03 6.138936750297449125e-36 0.000000000000000000e+00 -9.392071648532880276e-03 -1.505759228245271097e-35 0.000000000000000000e+00 -8.981681739335552889e-03 0.000000000000000000e+00 2.569620310081615780e-36 -8.491157508742217669e-03 -3.771020965051682968e-36 -3.771020965051682968e-36 -7.922355579451168320e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.283773455459888885e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.584733888446865288e-03 0.000000000000000000e+00 7.795334798217239055e-36 -5.851746685917010374e-03 0.000000000000000000e+00 -1.328502525980003046e-35 -5.128575549245638354e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.444328221387646057e-03 2.561676267283421041e-36 0.000000000000000000e+00 -3.810490951361692261e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.225596648193097132e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.687318318504710625e-03 0.000000000000000000e+00 -7.742020258660349347e-36 -2.193351025710558316e-03 -9.006363132329547732e-37 7.205090505863638186e-36 -1.741393204441632394e-03 -3.381399755828298125e-36 3.381399755828298125e-36 -1.328434488297760814e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.514480039316190567e-04 1.217766394414828974e-35 1.095989754973346151e-33 -6.079201835421683010e-04 5.831357630064511284e-36 -5.831357630064511284e-36 -2.957298309948781616e-04 0.000000000000000000e+00 0.000000000000000000e+00 -1.300140438349945728e-05 0.000000000000000000e+00 2.121685937160069116e-38 2.419260244223479881e-04 1.055445309325769750e-35 0.000000000000000000e+00 4.704780900424327967e-04 1.029491115625907456e-35 -4.021449670413700999e-38 6.738306562621098044e-04 0.000000000000000000e+00 0.000000000000000000e+00 8.529669652356337492e-04 9.897457043082654278e-36 -2.474364260770663569e-36 1.008766725249479745e-03 0.000000000000000000e+00 3.046843455169255892e-37 1.142006124013858958e-03 -4.815795818440879545e-36 1.203948954610219886e-36 1.253359553552030282e-03 0.000000000000000000e+00 2.384954796105029227e-36 1.343405367478624126e-03 1.184061246318775849e-36 1.480076557898469812e-37 1.412623403756171512e-03 -2.357012814476019401e-36 0.000000000000000000e+00 1.461384522050945475e-03 -2.351352180683899304e-36 0.000000000000000000e+00 1.489980234621267633e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 2.284581611628351038e-33 0.000000000000000000e+00 5.511521610893899137e-01 -1.533271994972200045e-34 -3.519601097638216313e-34 5.511521610893899137e-01 -2.681055618252375158e-33 0.000000000000000000e+00 5.511521610893899137e-01 -2.334515315613904659e-34 -6.657880537766638369e-32 5.511521610893899137e-01 -2.524572737686037579e-33 0.000000000000000000e+00 5.511521610893899137e-01 -1.293237893762834565e-33 9.113501074465804053e-35 5.511521610893899137e-01 -6.977117514041343461e-34 8.531191684765963609e-33 5.511521610893899137e-01 -3.019312854241421090e-34 -4.738419593504333497e-35 5.511521610893899137e-01 1.637144051700637228e-34 9.733607136199079481e-35 5.511521610893899137e-01 2.377342091299156848e-34 0.000000000000000000e+00 5.511521610893899137e-01 4.238990875016434757e-34 1.045352753337825443e-34 5.511521610893899137e-01 4.972190997625102208e-34 -2.189773281193647412e-34 5.511521610893899137e-01 1.666342080923118078e-33 0.000000000000000000e+00 5.511521610893899137e-01 2.994295440080899154e-34 1.232943443907731305e-34 5.511521610893899137e-01 3.853827869165482578e-34 0.000000000000000000e+00 5.511521610893899137e-01 -8.605668569862531845e-34 -1.449814991114558867e-34 5.511521610893899137e-01 4.693718325351158097e-34 -3.208134005606111901e-34 5.511521610893899137e-01 8.014240604749163135e-34 -3.606719440075965691e-34 5.511521610893899137e-01 -2.080742260399432118e-33 -2.040602554990365392e-31 5.511521610893899137e-01 -3.303589686086969831e-33 0.000000000000000000e+00 5.511521610893899137e-01 -1.611319943094616615e-33 1.451912754051572494e-34 5.511521610893899137e-01 -1.121425758458653676e-33 0.000000000000000000e+00 5.511521610893899137e-01 -3.519283806609853180e-34 0.000000000000000000e+00 5.511521610893899137e-01 -1.050071631896146472e-34 -1.969748780522787136e-35 5.511521610893899137e-01 -4.432946259850522337e-35 -3.588135771442574632e-36 5.511521610893899137e-01 -1.163815802272215079e-35 0.000000000000000000e+00 5.511521610893899137e-01 -7.489761885728126613e-36 6.955007809062499502e-37 5.511521610893899137e-01 -1.090268449465668511e-36 -1.876459997565012593e-36 5.511521610893899137e-01 -6.790675498879699020e-37 0.000000000000000000e+00 5.511521610893899137e-01 -2.671766473508398401e-35 1.306233917284244291e-31 5.511521610893899137e-01 1.811275820073521366e-35 -2.102903362163559967e-36 5.511521610893899137e-01 2.613147140783643399e-36 0.000000000000000000e+00 5.511521610893899137e-01 -1.572637468450369771e-36 6.138936750297449125e-36 5.511521610893899137e-01 -5.052015181260325457e-36 -1.505759228245271097e-35 5.511521610893899137e-01 -4.136186617747369634e-36 0.000000000000000000e+00 5.511521610893899137e-01 -1.657646950322285497e-36 -3.771020965051682968e-36 5.511521610893899137e-01 -9.459506930102962977e-37 0.000000000000000000e+00 5.511521610893899137e-01 2.681011899131245594e-37 0.000000000000000000e+00 5.511521610893899137e-01 6.049371375343659353e-38 0.000000000000000000e+00 5.511521610893899137e-01 4.658868807797164616e-36 0.000000000000000000e+00 5.511521610893899137e-01 2.279295074798339914e-36 0.000000000000000000e+00 5.511521610893899137e-01 1.280762921376554794e-35 2.561676267283421041e-36 5.511521610893899137e-01 8.309357011954357807e-37 0.000000000000000000e+00 5.511521610893899137e-01 2.336814336934363091e-36 0.000000000000000000e+00 5.511521610893899137e-01 3.047138595688059386e-37 0.000000000000000000e+00 5.511521610893899137e-01 -4.021487232928875715e-37 -9.006363132329547732e-37 5.511521610893899137e-01 1.515061908020372453e-37 -3.381399755828298125e-36 5.511521610893899137e-01 6.564841159741037121e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.337833138823370560e-37 1.217766394414828974e-35 5.511521610893899137e-01 -1.404997745109831350e-36 5.831357630064511284e-36 5.511521610893899137e-01 6.620286138483144266e-37 0.000000000000000000e+00 5.511521610893899137e-01 -1.086345715346688597e-37 0.000000000000000000e+00 5.511521610893899137e-01 -4.145305894034167181e-39 1.055445309325769750e-35 5.511521610893899137e-01 1.834722100254906101e-36 1.029491115625907456e-35 5.511521610893899137e-01 1.071668996725874423e-38 0.000000000000000000e+00 5.511521610893899137e-01 6.865741817485312000e-37 9.897457043082654278e-36 5.511521610893899137e-01 2.726783511179729697e-37 0.000000000000000000e+00 5.511521610893899137e-01 3.669909137330053024e-38 -4.815795818440879545e-36 5.511521610893899137e-01 -1.902692891817905052e-37 0.000000000000000000e+00 5.511521610893899137e-01 1.891180700246646344e-37 1.184061246318775849e-36 5.511521610893899137e-01 -4.260455179752835906e-39 -2.357012814476019401e-36 5.511521610893899137e-01 1.750927410743645403e-38 -2.351352180683899304e-36 5.511521610893899137e-01 7.933108980870365549e-38 0.000000000000000000e+00 5.511521610893899137e-01 -1.262733634977123532e-38 -3.513905651654643162e-34 -4.349671206845358535e-33 5.511521610893899137e-01 -1.097723571798680044e-35 -6.787580017970930240e-33 5.511521610893899137e-01 -3.519601097638216313e-34 -9.315308436726084388e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.867704350035100638e-33 5.511521610893899137e-01 0.000000000000000000e+00 -9.158825556159747152e-33 5.511521610893899137e-01 3.596523669747883986e-34 -7.927490712236544822e-33 5.511521610893899137e-01 7.290800859572643243e-34 -7.331964569877843748e-33 5.511521610893899137e-01 3.709213775985201625e-34 -6.936184103897851767e-33 5.511521610893899137e-01 1.895367837401733399e-34 -6.470538413303646513e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.396518609343793247e-33 5.511521610893899137e-01 3.559277566511445698e-32 -6.210353730972065841e-33 5.511521610893899137e-01 -4.181411013351301770e-34 -6.137033718711199523e-33 5.511521610893899137e-01 4.379546562387294823e-34 -4.967910737550591495e-33 5.511521610893899137e-01 4.625518685498290597e-34 -6.334823274465619016e-33 5.511521610893899137e-01 -1.232943443907731305e-34 -6.248870031557161144e-33 5.511521610893899137e-01 0.000000000000000000e+00 -7.494819675459962757e-33 5.511521610893899137e-01 4.291452373699094178e-32 -6.164880985938593849e-33 5.511521610893899137e-01 1.604067002803055951e-34 -5.832828757998793088e-33 5.511521610893899137e-01 -1.803359720037982846e-34 -8.714995078873141691e-33 5.511521610893899137e-01 -1.020301277495182696e-31 -9.937842504560679404e-33 5.511521610893899137e-01 -2.417500258340856453e-34 -8.245572761568326530e-33 5.511521610893899137e-01 1.451912754051572494e-34 -7.755678576932363249e-33 5.511521610893899137e-01 8.998845484584648052e-35 -6.986181199134695361e-33 5.511521610893899137e-01 -3.826729872359883178e-32 -6.739259981663324819e-33 5.511521610893899137e-01 -1.969748780522787136e-35 -6.678582281072214518e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.645890976496431582e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.641742580359437530e-33 5.511521610893899137e-01 6.955007809062499502e-37 -6.635343086923175037e-33 5.511521610893899137e-01 1.172787498478132871e-37 -6.634931886023597849e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.660970483208793990e-33 5.511521610893899137e-01 -5.280272929437481793e-36 -6.616140060272973849e-33 5.511521610893899137e-01 2.102903362163559967e-36 -6.631639671332925835e-33 5.511521610893899137e-01 -7.480946858195232559e-37 -6.635825455942159846e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.639304833654969526e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.638389005091456977e-33 5.511521610893899137e-01 2.569620310081615780e-36 -6.635910465424031449e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.635198769166719287e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633984717283796719e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634192324759956735e-33 5.511521610893899137e-01 7.795334798217239055e-36 -6.629593949665912017e-33 5.511521610893899137e-01 -1.328502525980003046e-35 -6.631973523398911258e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.621445189259943651e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633421882772514022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.631916004136775141e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633948104614140239e-33 5.511521610893899137e-01 -7.742020258660349347e-36 -6.634654967197003085e-33 5.511521610893899137e-01 7.205090505863638186e-36 -6.634101312282908183e-33 5.511521610893899137e-01 3.381399755828298125e-36 -6.633596334357735389e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634119035159827639e-33 5.511521610893899137e-01 1.095989754973346151e-33 -6.635657816218819237e-33 5.511521610893899137e-01 -5.831357630064511284e-36 -6.633590789859860725e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634361453045243790e-33 5.511521610893899137e-01 2.121685937160069116e-38 -6.634256963779604039e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.632418096373454488e-33 5.511521610893899137e-01 -4.021449670413700999e-38 -6.634242101783742257e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633566244291961454e-33 5.511521610893899137e-01 -2.474364260770663569e-36 -6.633980140122591332e-33 5.511521610893899137e-01 3.046843455169255892e-37 -6.634216119382336707e-33 5.511521610893899137e-01 1.203948954610219886e-36 -6.634443087762890697e-33 5.511521610893899137e-01 2.384954796105029227e-36 -6.634063700403684845e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.634257078928888653e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634235309199602474e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634173487383901324e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634265445810059126e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 deleted file mode 100644 index a9bbb13f5..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -9.827793029467396871e-03 -1.313072854774100455e-31 -3.284324436952458275e-32 9.750204098219517751e-03 -1.334967946554760315e-33 -1.097723571798680044e-35 9.610134022608032844e-03 -3.519601097638216313e-34 -3.361032150056577907e-32 9.406280498061712902e-03 -2.223349691391654800e-32 0.000000000000000000e+00 9.136838307760174541e-03 6.237782611722223566e-32 0.000000000000000000e+00 8.799456282326626258e-03 3.201402136139794068e-32 3.596523669747883986e-34 8.391283698408726066e-03 4.209302585735506597e-34 -5.901009053583062380e-34 7.908933069386116579e-03 8.201137449676728405e-33 1.031029847776990184e-33 7.348482289054148603e-03 1.650157890555946013e-32 -3.290838941924883654e-32 6.705523437178024376e-03 8.250043336339598356e-33 -1.663817809179103254e-32 5.975305921006326092e-03 -8.139441989634019748e-33 -2.952276025195770101e-32 5.152706218838658085e-03 1.045352753337825443e-34 -7.580603191080839879e-34 4.232218142429054059e-03 -2.189773281193647412e-34 4.379546562387294823e-34 3.208009985506830603e-03 3.346046045488447714e-32 8.166308151623631949e-34 2.075775594242275368e-03 1.232943443907731305e-34 6.065129588385682335e-34 8.433428111268804692e-04 -6.899071533928664013e-32 3.449535766964332007e-32 -4.691052986403277877e-04 -3.551557327994071153e-32 -9.856784338632608523e-32 -1.828331592089020054e-03 -7.358391594353104887e-32 1.604067002803055951e-34 -3.182952945957112732e-03 -1.890590739130997557e-31 -4.060517638328558960e-34 -4.477407138834214179e-03 1.104285757212834090e-31 2.129493256723933938e-31 -5.680096744224743394e-03 1.657072673191274145e-31 -8.255385666801503823e-32 -6.762244321929002273e-03 1.451912754051572494e-34 -8.745368250111906597e-32 -7.698678224436266045e-03 0.000000000000000000e+00 8.998845484584648052e-35 -8.495041237012211990e-03 -5.089376209619579482e-32 3.799662015622823384e-32 -9.189813109712195727e-03 -5.057074406811382823e-35 -1.969748780522787136e-35 -9.806963835353970163e-03 -3.588135771442574632e-36 -7.800541400908408347e-33 -1.033518958454863503e-02 2.514803731408052415e-35 -8.911835723177285468e-33 -1.072721116669373906e-02 -2.092288613741648783e-32 -1.046217921707650360e-32 -1.091977900575028491e-02 1.276834031488163357e-32 3.192671472469647800e-33 -1.089832599009789293e-02 -1.651397423339197651e-32 6.191727790050192879e-33 -1.067730935182415776e-02 4.149019558991640952e-33 -6.651086801518780795e-36 -1.036705635975119881e-02 4.120215327670808708e-32 2.102903362163559967e-36 -9.994547422934924388e-03 3.320367168419178455e-31 -1.037689549599575235e-32 -9.562901166257322533e-03 -8.265645646404846644e-32 -4.133129770039938243e-32 -9.067363863078780478e-03 -8.359949198748722588e-33 2.086222901616567436e-33 -8.442118091881327391e-03 -1.053974638421897927e-32 6.588811387326720514e-33 -7.681744665209582629e-03 1.551126130366083905e-32 -3.771020965051682968e-36 -6.799966844091973571e-03 -2.426171402493807335e-35 -1.239773586674335625e-32 -5.820402522067262378e-03 1.294900492558985001e-33 1.035920394047188001e-32 -4.845014295757305717e-03 -8.951383859584458994e-33 8.971930453441914298e-33 -3.944395071345497064e-03 -3.974804566422024178e-33 -5.343456633476997506e-35 -3.120120795041275100e-03 7.184302837709172696e-33 3.280503578862635717e-35 -2.368402889714455242e-03 -6.594431780811218674e-33 -3.312297970081256184e-33 -1.685141025544654308e-03 0.000000000000000000e+00 3.067878973098073851e-33 -1.064976569288402040e-03 -5.224038455800806536e-36 0.000000000000000000e+00 -5.004944678057860613e-04 6.766274219515330324e-34 6.735517977063315254e-34 1.443162376945760633e-05 1.284128139968962451e-33 1.143215884889717618e-35 4.844891902074204004e-04 4.369285821298746159e-36 -6.147357750200534932e-34 9.129340172727414080e-04 0.000000000000000000e+00 -3.590184075811312277e-36 1.302338225724948388e-03 6.341201238429676836e-33 -1.206693974592854967e-33 1.655101305999523648e-03 5.831357630064511284e-36 -5.831357630064511284e-36 1.973464747902746105e-03 1.156639227075116307e-33 -6.007540215290330127e-36 2.259278915194569415e-03 1.064840554854361517e-33 1.327675124443156022e-34 2.513576909143040369e-03 -2.074946730704518240e-33 -3.133768974595599924e-33 2.737647690487645530e-03 -5.014722320215609345e-34 5.290693244731488679e-36 2.933084541066641876e-03 1.642066764582142795e-33 5.175939368265225558e-36 3.101630647833304114e-03 9.897457043082654278e-36 1.494245046463509335e-33 3.245048836207884563e-03 -5.561523571099444735e-34 -1.967238765696775577e-33 3.365024562146119030e-03 -2.697337926555218090e-33 1.203948954610219886e-36 3.463101276857102895e-03 4.867560527952439794e-34 2.384954796105029227e-36 3.540636234542143736e-03 5.905021681553023089e-37 1.480076557898469812e-37 3.598765699386124832e-03 -3.536408013145037568e-36 -3.620743259913885313e-34 3.638376485709382459e-03 -4.702454580752408467e-36 -5.995311120174697882e-35 3.660104868431910546e-03 -3.009265538105055593e-34 -1.175494350822287341e-36 -1.313072854774100455e-31 5.511521610893899137e-01 4.740129544181353730e-33 -1.334967946554760315e-33 5.511521610893899137e-01 -6.101623870577366213e-33 -3.519601097638216313e-34 5.511521610893899137e-01 -3.655718644991668957e-33 -2.223349691391654800e-32 5.511521610893899137e-01 -1.807764881136610865e-34 6.237782611722223566e-32 5.511521610893899137e-01 -6.627279241460255689e-33 3.201402136139794068e-32 5.511521610893899137e-01 -5.012842472936626480e-33 4.209302585735506597e-34 5.511521610893899137e-01 -4.968536906870112276e-33 8.201137449676728405e-33 5.511521610893899137e-01 -1.719923352233032322e-33 1.650157890555946013e-32 5.511521610893899137e-01 8.056737417437420275e-34 8.250043336339598356e-33 5.511521610893899137e-01 3.872781655026149313e-34 -8.139441989634019748e-33 5.511521610893899137e-01 5.597982227556824211e-34 1.045352753337825443e-34 5.511521610893899137e-01 7.374384702389412775e-34 -2.189773281193647412e-34 5.511521610893899137e-01 2.656257851845567947e-33 3.346046045488447714e-32 5.511521610893899137e-01 -3.725985926887611149e-34 1.232943443907731305e-34 5.511521610893899137e-01 -1.536173513476463148e-33 -6.899071533928664013e-32 5.511521610893899137e-01 -1.834698473672432104e-33 -3.551557327994071153e-32 5.511521610893899137e-01 -1.288656420355414443e-33 -7.358391594353104887e-32 5.511521610893899137e-01 4.410136388223073198e-33 -1.890590739130997557e-31 5.511521610893899137e-01 -2.733511032959989919e-33 1.104285757212834090e-31 5.511521610893899137e-01 2.645342797528125074e-33 1.657072673191274145e-31 5.511521610893899137e-01 5.162242846726272109e-33 1.451912754051572494e-34 5.511521610893899137e-01 1.125798312144947706e-33 0.000000000000000000e+00 5.511521610893899137e-01 2.003523169800430207e-34 -5.089376209619579482e-32 5.511521610893899137e-01 2.437240037609632547e-35 -5.057074406811382823e-35 5.511521610893899137e-01 5.557199172430913484e-36 -3.588135771442574632e-36 5.511521610893899137e-01 8.711006937094480917e-36 2.514803731408052415e-35 5.511521610893899137e-01 -1.376965024937131914e-36 -2.092288613741648783e-32 5.511521610893899137e-01 5.635303257322522463e-37 1.276834031488163357e-32 5.511521610893899137e-01 -7.538694690190427531e-37 -1.651397423339197651e-32 5.511521610893899137e-01 -2.655068620293160516e-35 4.149019558991640952e-33 5.511521610893899137e-01 1.801137478264412865e-35 4.120215327670808708e-32 5.511521610893899137e-01 2.613947356900190221e-36 3.320367168419178455e-31 5.511521610893899137e-01 -4.406601281731207271e-35 -8.265645646404846644e-32 5.511521610893899137e-01 2.556548808093504941e-35 -8.359949198748722588e-33 5.511521610893899137e-01 -2.906489641777393917e-36 -1.053974638421897927e-32 5.511521610893899137e-01 -1.136177508209943075e-36 1.551126130366083905e-32 5.511521610893899137e-01 -4.554783074442939826e-36 -2.426171402493807335e-35 5.511521610893899137e-01 -1.574581655330030468e-35 1.294900492558985001e-33 5.511521610893899137e-01 -4.606570047530403123e-37 -8.951383859584458994e-33 5.511521610893899137e-01 8.029673726870002088e-36 -3.974804566422024178e-33 5.511521610893899137e-01 -7.115429633753438028e-36 7.184302837709172696e-33 5.511521610893899137e-01 3.533694496133001204e-35 -6.594431780811218674e-33 5.511521610893899137e-01 7.058500471975295707e-36 0.000000000000000000e+00 5.511521610893899137e-01 -2.456613369037341704e-37 -5.224038455800806536e-36 5.511521610893899137e-01 8.812145403188231737e-37 6.766274219515330324e-34 5.511521610893899137e-01 -3.051245130375756472e-37 1.284128139968962451e-33 5.511521610893899137e-01 5.391444708964997325e-37 4.369285821298746159e-36 5.511521610893899137e-01 5.701362940991431369e-37 0.000000000000000000e+00 5.511521610893899137e-01 6.738966364474223023e-37 6.341201238429676836e-33 5.511521610893899137e-01 -1.699595811087869029e-36 5.831357630064511284e-36 5.511521610893899137e-01 3.448324794889830205e-38 1.156639227075116307e-33 5.511521610893899137e-01 -1.400192913861544130e-37 1.064840554854361517e-33 5.511521610893899137e-01 3.622678341956968819e-38 -2.074946730704518240e-33 5.511521610893899137e-01 7.339631684888037912e-37 -5.014722320215609345e-34 5.511521610893899137e-01 -2.778033876711282708e-37 1.642066764582142795e-33 5.511521610893899137e-01 6.702258500782770616e-37 9.897457043082654278e-36 5.511521610893899137e-01 -1.640376304901322737e-38 -5.561523571099444735e-34 5.511521610893899137e-01 6.955944190147575259e-38 -2.697337926555218090e-33 5.511521610893899137e-01 -2.109098202465021155e-37 4.867560527952439794e-34 5.511521610893899137e-01 2.795735386577763507e-37 5.905021681553023089e-37 5.511521610893899137e-01 -1.277117505736407808e-38 -3.536408013145037568e-36 5.511521610893899137e-01 4.244610241015805687e-39 -4.702454580752408467e-36 5.511521610893899137e-01 8.795604253984678790e-38 -3.009265538105055593e-34 5.511521610893899137e-01 -4.043053316555132800e-39 -3.284324436952458275e-32 -1.894123274292355843e-33 5.511521610893899137e-01 -1.097723571798680044e-35 -1.273587668905107715e-32 5.511521610893899137e-01 -3.361032150056577907e-32 -1.028997146346537853e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.815029306587371900e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.326153205993396526e-32 5.511521610893899137e-01 3.596523669747883986e-34 -1.164709529141033605e-32 5.511521610893899137e-01 -5.901009053583062380e-34 -1.160278972534382117e-32 5.511521610893899137e-01 1.031029847776990184e-33 -8.354176170706741895e-33 5.511521610893899137e-01 -3.290838941924883654e-32 -5.828579076729968230e-33 5.511521610893899137e-01 -1.663817809179103254e-32 -6.246974652971093359e-33 5.511521610893899137e-01 -2.952276025195770101e-32 -6.074454595718026724e-33 5.511521610893899137e-01 -7.580603191080839879e-34 -5.896814348234768295e-33 5.511521610893899137e-01 4.379546562387294823e-34 -3.977994966628141968e-33 5.511521610893899137e-01 8.166308151623631949e-34 -7.006851411162470303e-33 5.511521610893899137e-01 6.065129588385682335e-34 -8.170426331950172208e-33 5.511521610893899137e-01 3.449535766964332007e-32 -8.468951292146141676e-33 5.511521610893899137e-01 -9.856784338632608523e-32 -7.922909238829123674e-33 5.511521610893899137e-01 1.604067002803055951e-34 -2.224116430250636375e-33 5.511521610893899137e-01 -4.060517638328558960e-34 -9.367763851433700176e-33 5.511521610893899137e-01 2.129493256723933938e-31 -3.988910020945584499e-33 5.511521610893899137e-01 -8.255385666801503823e-32 -1.472009971747437464e-33 5.511521610893899137e-01 -8.745368250111906597e-32 -5.508454506328761867e-33 5.511521610893899137e-01 8.998845484584648052e-35 -6.433900501493667194e-33 5.511521610893899137e-01 3.799662015622823384e-32 -6.609880418097613996e-33 5.511521610893899137e-01 -1.969748780522787136e-35 -6.628695619301278467e-33 5.511521610893899137e-01 -7.800541400908408347e-33 -6.625541811536615391e-33 5.511521610893899137e-01 -8.911835723177285468e-33 -6.635629783498646017e-33 5.511521610893899137e-01 -1.046217921707650360e-32 -6.633689288147976844e-33 5.511521610893899137e-01 3.192671472469647800e-33 -6.635006687942729225e-33 5.511521610893899137e-01 6.191727790050192879e-33 -6.660803504676641483e-33 5.511521610893899137e-01 -6.651086801518780795e-36 -6.616241443691064712e-33 5.511521610893899137e-01 2.102903362163559967e-36 -6.631638871116809666e-33 5.511521610893899137e-01 -1.037689549599575235e-32 -6.678318831291021544e-33 5.511521610893899137e-01 -4.133129770039938243e-32 -6.608687330392774700e-33 5.511521610893899137e-01 2.086222901616567436e-33 -6.637159308115487671e-33 5.511521610893899137e-01 6.588811387326720514e-33 -6.635388995981918574e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.638807601548151527e-33 5.511521610893899137e-01 -1.239773586674335625e-32 -6.649998635027009584e-33 5.511521610893899137e-01 1.035920394047188001e-32 -6.634713475478463627e-33 5.511521610893899137e-01 8.971930453441914298e-33 -6.626223144746839189e-33 5.511521610893899137e-01 -5.343456633476997506e-35 -6.641368248107463369e-33 5.511521610893899137e-01 3.280503578862635717e-35 -6.598915873512379433e-33 5.511521610893899137e-01 -3.312297970081256184e-33 -6.627194318001733487e-33 5.511521610893899137e-01 3.067878973098073851e-33 -6.634498479810613508e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.633371603933390585e-33 5.511521610893899137e-01 6.735517977063315254e-34 -6.634557942986748372e-33 5.511521610893899137e-01 1.143215884889717618e-35 -6.633713674002813852e-33 5.511521610893899137e-01 -6.147357750200534932e-34 -6.633682682179610205e-33 5.511521610893899137e-01 -3.590184075811312277e-36 -6.633578921837261943e-33 5.511521610893899137e-01 -1.206693974592854967e-33 -6.635952414284797671e-33 5.511521610893899137e-01 -5.831357630064511284e-36 -6.634218335225760539e-33 5.511521610893899137e-01 -6.007540215290330127e-36 -6.634392837765095195e-33 5.511521610893899137e-01 1.327675124443156022e-34 -6.634216591690290642e-33 5.511521610893899137e-01 -3.133768974595599924e-33 -6.633518855305220060e-33 5.511521610893899137e-01 5.290693244731488679e-36 -6.634530621861381094e-33 5.511521610893899137e-01 5.175939368265225558e-36 -6.633582592623631910e-33 5.511521610893899137e-01 1.494245046463509335e-33 -6.634269222236758230e-33 5.511521610893899137e-01 -1.967238765696775577e-33 -6.634183259031808665e-33 5.511521610893899137e-01 1.203948954610219886e-36 -6.634463728293955097e-33 5.511521610893899137e-01 2.384954796105029227e-36 -6.633973244935052299e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.634265589648766268e-33 5.511521610893899137e-01 -3.620743259913885313e-34 -6.634248573863469293e-33 5.511521610893899137e-01 -5.995311120174697882e-35 -6.634164862431170501e-33 5.511521610893899137e-01 -1.175494350822287341e-36 -6.634256861527026154e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 deleted file mode 100644 index a229d3dc6..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.300499993350550006e-02 2.677279359636132140e-32 -3.087951667916717484e-32 1.294644402802191084e-02 -1.795056848215541513e-33 -1.097723571798680044e-35 1.283348758003878022e-02 -2.919759881160563500e-31 -4.702083634295266632e-31 1.266490241113778573e-02 -2.297749134614679399e-32 0.000000000000000000e+00 1.243890345731798498e-02 -4.495927186623138031e-31 2.585709822118868810e-33 1.215312439012616180e-02 9.768285357234000299e-31 3.596523669747883986e-34 1.180461765389846304e-02 4.209302585735506597e-34 -4.308537171031031474e-33 1.138982739691811463e-02 6.650677531837888319e-33 -7.470759643106884753e-33 1.090457353852358063e-02 2.419205547460373255e-31 -3.322949907144324724e-32 1.034405066813579369e-02 8.250043336339598356e-33 -1.663817809179103254e-32 9.702858478626374614e-03 -9.013349788719214587e-33 -1.029310153751141003e-31 8.974985631511245635e-03 -1.340462022764363421e-31 -3.465636496928655558e-32 8.153809526433578730e-03 2.457696916451168065e-31 5.872196252758873491e-34 7.232130807359616470e-03 3.147408753928573026e-32 8.166308151623631949e-34 6.202311958613668762e-03 -3.201964822810057856e-33 2.034473221580892580e-31 5.056416769117172937e-03 -6.618507395564509647e-32 3.449535766964332007e-32 3.786249515449842742e-03 -3.671044008520720134e-32 7.588271018258170159e-32 2.383522635342297767e-03 1.954818640571535403e-32 1.606420963542112964e-31 8.404978132148413321e-04 2.644665653213261353e-31 7.488278953200068596e-32 -8.116363860802451591e-04 1.104285757212834090e-31 3.618691424341870407e-32 -2.461875694578038402e-03 -3.722880471768886118e-31 9.769947932084961270e-34 -4.023251402757254888e-03 1.451912754051572494e-34 8.102130367078274725e-33 -5.455850367077730127e-03 1.223936145039006260e-31 1.531528108033107102e-32 -6.721295353746163832e-03 6.709898553041416394e-32 1.115261322062722242e-33 -7.783896214661429475e-03 -5.057074406811382823e-35 -1.969748780522787136e-35 -8.662003252624219871e-03 -6.630886050859738846e-35 6.248900940214269800e-33 -9.422635330936905002e-03 -2.774683649188397237e-32 4.974156541421739841e-33 -1.007754802845255669e-02 2.040747904937559891e-32 3.309592139775192262e-33 -1.058862366988968552e-02 -7.907133397377493655e-33 -2.526139414705666249e-34 -1.087360180215004614e-02 8.201728049331568593e-34 -7.420024444510445840e-34 -1.089066060949882460e-02 -2.874605469841992836e-33 -8.846042154057230684e-34 -1.066761795895846202e-02 -1.729055715192252240e-33 -1.786528525288388026e-33 -1.031395616518388653e-02 -1.494455606875295124e-33 4.285218883801469575e-33 -9.881133777898822024e-03 4.195796383251809339e-34 -7.345235710961355610e-33 -9.371894395189799692e-03 -8.359949198748722588e-33 -1.826740140296141767e-33 -8.746563136134541741e-03 5.751206958567186904e-33 -5.365100203023742960e-34 -7.949339571288287221e-03 3.614155498076019876e-33 -3.771020965051682968e-36 -6.986597788038257685e-03 -2.108718267383256201e-35 5.509795484842829906e-33 -5.885030248949318921e-03 1.294900492558985001e-33 9.124624072209571714e-34 -4.765083613266077496e-03 -2.896954574741941310e-32 8.971930453441914298e-33 -3.735673687650683909e-03 1.349715775509915567e-33 -5.343456633476997506e-35 -2.800476626354302719e-03 1.503785572341477963e-33 2.873063668472473868e-33 -1.954427718858644820e-03 5.577169285711319671e-33 4.905937806933842568e-34 -1.192014148171513174e-03 1.635168905919498698e-33 1.613567441605265766e-32 -5.050693164003807476e-04 -5.224038455800806536e-36 1.969263124263210691e-36 1.199733105226078421e-04 6.766274219515330324e-34 6.827601207292123160e-34 6.892955496274345275e-04 5.416384496311521110e-33 -2.056049082962311016e-33 1.206444647621798295e-03 -5.574863827906597679e-34 8.371756882679575963e-33 1.674899808472968569e-03 -9.813292311197593915e-33 1.959261272837758941e-32 2.098003848757089545e-03 2.768091664111754389e-32 -1.202165172512488288e-33 2.478912312563796676e-03 4.118308397239630259e-37 -5.831357630064511284e-36 2.820577918545143919e-03 2.685516054567531970e-32 -6.007540215290330127e-36 3.123983653899738491e-03 1.033585907547938591e-33 3.933348210917104740e-34 3.385864640658509898e-03 -2.074946730704518240e-33 -3.133768974595599924e-33 3.609242985434022929e-03 3.325522133223167797e-32 -1.721376913143734076e-35 3.798502250237810983e-03 1.695758804273943118e-33 5.175939368265225558e-36 3.957511670004687510e-03 2.002529389005303715e-32 2.154141195000205390e-32 4.089645859470344980e-03 -5.561523571099444735e-34 -4.529244353682226239e-32 4.197804652640391675e-03 -4.917764417702588864e-32 1.163197055440817204e-32 4.284434077814413058e-03 4.867560527952439794e-34 -1.907537384487932796e-34 4.351546142474803196e-03 -6.457330474434954398e-33 1.480076557898469812e-37 4.400735306612379820e-03 3.516566589829370984e-36 -3.705184287801258006e-33 4.433191365246738624e-03 -4.702454580752408467e-36 -9.070667127788109195e-34 4.449713999228352077e-03 -3.009265538105055593e-34 8.436911341969221425e-34 2.677279359636132140e-32 5.511521610893899137e-01 -7.365805051968623702e-33 -1.795056848215541513e-33 5.511521610893899137e-01 2.175109345038894931e-32 -2.919759881160563500e-31 5.511521610893899137e-01 2.453166706555872560e-32 -2.297749134614679399e-32 5.511521610893899137e-01 -3.612595562895692594e-32 -4.495927186623138031e-31 5.511521610893899137e-01 -1.343804300737656851e-31 9.768285357234000299e-31 5.511521610893899137e-01 -2.064940258710220441e-31 4.209302585735506597e-34 5.511521610893899137e-01 -1.615802161525644894e-31 6.650677531837888319e-33 5.511521610893899137e-01 -1.750018263095921767e-33 2.419205547460373255e-31 5.511521610893899137e-01 2.668216440975985984e-33 8.250043336339598356e-33 5.511521610893899137e-01 -1.260356687825045381e-34 -9.013349788719214587e-33 5.511521610893899137e-01 5.990804722602347133e-33 -1.340462022764363421e-31 5.511521610893899137e-01 -2.481610797581635377e-33 2.457696916451168065e-31 5.511521610893899137e-01 -2.019729683382158985e-33 3.147408753928573026e-32 5.511521610893899137e-01 -4.140627713284038700e-33 -3.201964822810057856e-33 5.511521610893899137e-01 -2.483134921002883152e-32 -6.618507395564509647e-32 5.511521610893899137e-01 -5.086501793016976630e-32 -3.671044008520720134e-32 5.511521610893899137e-01 -2.480660726176012984e-32 1.954818640571535403e-32 5.511521610893899137e-01 4.138054526473353298e-33 2.644665653213261353e-31 5.511521610893899137e-01 -1.296236066594374196e-32 1.104285757212834090e-31 5.511521610893899137e-01 4.756583233480971275e-33 -3.722880471768886118e-31 5.511521610893899137e-01 8.629972842718394302e-34 1.451912754051572494e-34 5.511521610893899137e-01 -1.138831359727056795e-33 1.223936145039006260e-31 5.511521610893899137e-01 -2.175690293323457535e-34 6.709898553041416394e-32 5.511521610893899137e-01 -8.818753803586929292e-35 -5.057074406811382823e-35 5.511521610893899137e-01 -3.269409452189366199e-35 -6.630886050859738846e-35 5.511521610893899137e-01 -5.572560526864203333e-35 -2.774683649188397237e-32 5.511521610893899137e-01 -2.605365239789392194e-35 2.040747904937559891e-32 5.511521610893899137e-01 -7.474300650804326902e-36 -7.907133397377493655e-33 5.511521610893899137e-01 -4.026436312402781817e-37 8.201728049331568593e-34 5.511521610893899137e-01 -2.649925669022457098e-35 -2.874605469841992836e-33 5.511521610893899137e-01 1.818489586830184980e-35 -1.729055715192252240e-33 5.511521610893899137e-01 1.932777436927567416e-36 -1.494455606875295124e-33 5.511521610893899137e-01 -4.326791465681436628e-35 4.195796383251809339e-34 5.511521610893899137e-01 2.710301783988453129e-35 -8.359949198748722588e-33 5.511521610893899137e-01 -6.017867277171347747e-36 5.751206958567186904e-33 5.511521610893899137e-01 -1.737842857672541956e-36 3.614155498076019876e-33 5.511521610893899137e-01 -4.551930513783058723e-36 -2.108718267383256201e-35 5.511521610893899137e-01 -1.380806751921065513e-35 1.294900492558985001e-33 5.511521610893899137e-01 -2.062085481483129848e-37 -2.896954574741941310e-32 5.511521610893899137e-01 1.048674051382297611e-35 1.349715775509915567e-33 5.511521610893899137e-01 -7.834953174496037320e-36 1.503785572341477963e-33 5.511521610893899137e-01 3.592110003330151294e-35 5.577169285711319671e-33 5.511521610893899137e-01 6.519553689324360236e-36 1.635168905919498698e-33 5.511521610893899137e-01 6.187473100117064002e-37 -5.224038455800806536e-36 5.511521610893899137e-01 1.130819175754849439e-36 6.766274219515330324e-34 5.511521610893899137e-01 -9.868162610712666859e-37 5.416384496311521110e-33 5.511521610893899137e-01 -1.685993349848737115e-37 -5.574863827906597679e-34 5.511521610893899137e-01 4.531930584758000118e-37 -9.813292311197593915e-33 5.511521610893899137e-01 2.629391622917063538e-35 2.768091664111754389e-32 5.511521610893899137e-01 8.101310657899353335e-36 4.118308397239630259e-37 5.511521610893899137e-01 1.243809643931513686e-35 2.685516054567531970e-32 5.511521610893899137e-01 8.833864664219796195e-35 1.033585907547938591e-33 5.511521610893899137e-01 -1.329276758881976038e-38 -2.074946730704518240e-33 5.511521610893899137e-01 1.175670432004550569e-34 3.325522133223167797e-32 5.511521610893899137e-01 5.034213723467814691e-35 1.695758804273943118e-33 5.511521610893899137e-01 5.940143821568172711e-35 2.002529389005303715e-32 5.511521610893899137e-01 3.526757412550569678e-35 -5.561523571099444735e-34 5.511521610893899137e-01 3.484494696848043159e-35 -4.917764417702588864e-32 5.511521610893899137e-01 4.687247205117440797e-35 4.867560527952439794e-34 5.511521610893899137e-01 1.739766122033099802e-37 -6.457330474434954398e-33 5.511521610893899137e-01 1.077484886448584865e-35 3.516566589829370984e-36 5.511521610893899137e-01 2.060528750578635321e-36 -4.702454580752408467e-36 5.511521610893899137e-01 -3.543121703534686902e-37 -3.009265538105055593e-34 5.511521610893899137e-01 7.413944312209265929e-37 -3.087951667916717484e-32 -1.400005787044233328e-32 5.511521610893899137e-01 -1.097723571798680044e-35 1.511684063191523974e-32 5.511521610893899137e-01 -4.702083634295266632e-31 1.789741424708501329e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.276020844743063277e-32 5.511521610893899137e-01 2.585709822118868810e-33 -1.410146828922394029e-31 5.511521610893899137e-01 3.596523669747883986e-34 -2.131282786894957618e-31 5.511521610893899137e-01 -4.308537171031031474e-33 -1.682144689710381853e-31 5.511521610893899137e-01 -7.470759643106884753e-33 -8.384271081569630997e-33 5.511521610893899137e-01 -3.322949907144324724e-32 -3.966036377497724273e-33 5.511521610893899137e-01 -1.663817809179103254e-32 -6.760288487256212914e-33 5.511521610893899137e-01 -1.029310153751141003e-31 -6.434480958713617557e-34 5.511521610893899137e-01 -3.465636496928655558e-32 -9.115863616055344950e-33 5.511521610893899137e-01 5.872196252758873491e-34 -8.653982501855868900e-33 5.511521610893899137e-01 8.166308151623631949e-34 -1.077488053175774759e-32 5.511521610893899137e-01 2.034473221580892580e-31 -3.146560202850253836e-32 5.511521610893899137e-01 3.449535766964332007e-32 -5.749927074864347313e-32 5.511521610893899137e-01 7.588271018258170159e-32 -3.144086008023383668e-32 5.511521610893899137e-01 1.606420963542112964e-31 -2.496198292000356275e-33 5.511521610893899137e-01 7.488278953200068596e-32 -1.959661348441745154e-32 5.511521610893899137e-01 3.618691424341870407e-32 -1.877669584992737955e-33 5.511521610893899137e-01 9.769947932084961270e-34 -5.771255534201870143e-33 5.511521610893899137e-01 8.102130367078274725e-33 -7.773084178200766368e-33 5.511521610893899137e-01 1.531528108033107102e-32 -6.851821847806056310e-33 5.511521610893899137e-01 1.115261322062722242e-33 -6.722440356509580063e-33 5.511521610893899137e-01 -1.969748780522787136e-35 -6.666946912995602626e-33 5.511521610893899137e-01 6.248900940214269800e-33 -6.689978423742351660e-33 5.511521610893899137e-01 4.974156541421739841e-33 -6.660306470871603377e-33 5.511521610893899137e-01 3.309592139775192262e-33 -6.641727119124513929e-33 5.511521610893899137e-01 -2.526139414705666249e-34 -6.634655462104950859e-33 5.511521610893899137e-01 -7.420024444510445840e-34 -6.660752075163934764e-33 5.511521610893899137e-01 -8.846042154057230684e-34 -6.616067922605407124e-33 5.511521610893899137e-01 -1.786528525288388026e-33 -6.632320041036781914e-33 5.511521610893899137e-01 4.285218883801469575e-33 -6.677520733130523961e-33 5.511521610893899137e-01 -7.345235710961355610e-33 -6.607149800633824983e-33 5.511521610893899137e-01 -1.826740140296141767e-33 -6.640270685750882298e-33 5.511521610893899137e-01 -5.365100203023742960e-34 -6.635990661331380585e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.638804748987490963e-33 5.511521610893899137e-01 5.509795484842829906e-33 -6.648060885992920207e-33 5.511521610893899137e-01 9.124624072209571714e-34 -6.634459027021858989e-33 5.511521610893899137e-01 8.971930453441914298e-33 -6.623766077959885635e-33 5.511521610893899137e-01 -5.343456633476997506e-35 -6.642087771648206353e-33 5.511521610893899137e-01 2.873063668472473868e-33 -6.598331718440407590e-33 5.511521610893899137e-01 4.905937806933842568e-34 -6.627733264784384037e-33 5.511521610893899137e-01 1.613567441605265766e-32 -6.633634071163698004e-33 5.511521610893899137e-01 1.969263124263210691e-36 -6.633121999297953967e-33 5.511521610893899137e-01 6.827601207292123160e-34 -6.635239634734781923e-33 5.511521610893899137e-01 -2.056049082962311016e-33 -6.634421417808694929e-33 5.511521610893899137e-01 8.371756882679575963e-33 -6.633799625415233350e-33 5.511521610893899137e-01 1.959261272837758941e-32 -6.607958902244539269e-33 5.511521610893899137e-01 -1.202165172512488288e-33 -6.626151507815810356e-33 5.511521610893899137e-01 -5.831357630064511284e-36 -6.621814722034394947e-33 5.511521610893899137e-01 -6.007540215290330127e-36 -6.545914171831510510e-33 5.511521610893899137e-01 3.933348210917104740e-34 -6.634266111241298585e-33 5.511521610893899137e-01 -3.133768974595599924e-33 -6.516685775273253190e-33 5.511521610893899137e-01 -1.721376913143734076e-35 -6.583910681239032196e-33 5.511521610893899137e-01 5.175939368265225558e-36 -6.574851380258028744e-33 5.511521610893899137e-01 2.154141195000205390e-32 -6.598985244348203577e-33 5.511521610893899137e-01 -4.529244353682226239e-32 -6.599407871505229574e-33 5.511521610893899137e-01 1.163197055440817204e-32 -6.587380346422534058e-33 5.511521610893899137e-01 -1.907537384487932796e-34 -6.634078841861506551e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.623477969609223100e-33 5.511521610893899137e-01 -3.705184287801258006e-33 -6.632192289723132357e-33 5.511521610893899137e-01 -9.070667127788109195e-34 -6.634607130644063137e-33 5.511521610893899137e-01 8.436911341969221425e-34 -6.633511424042488234e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 deleted file mode 100644 index f3d8aacd8..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ -1.335517212929382587e-02 -6.693878877587190951e-31 -3.087951667916717484e-32 1.330744334312728566e-02 -1.213684258199182118e-33 -2.056035141828573141e-30 1.321149323456228923e-02 -2.908832234922288907e-31 8.602325660804059089e-31 1.306634490577402406e-02 -2.098265043872291450e-32 9.974204537119394011e-34 1.287052877579535244e-02 -4.460480003079173007e-31 2.585709822118868810e-33 1.262207064290500787e-02 9.768285357234000299e-31 1.116281277743738823e-30 1.231847643336966662e-02 -2.189480928175688640e-33 1.022888264814794615e-30 1.195671419516994120e-02 -4.614427952413710396e-31 -8.015054378889686537e-33 1.153319406656717894e-02 -2.308295574419196490e-30 -3.322949907144324724e-32 1.104374729980958647e-02 8.250043336339598356e-33 -1.663817809179103254e-32 1.048360588549852521e-02 1.364662146398175274e-30 -1.029310153751141003e-31 9.847384977699566097e-03 1.093440458118657728e-30 -3.465636496928655558e-32 9.129070877879286172e-03 2.457696916451168065e-31 1.371231758106487328e-31 8.322018242813868441e-03 3.030045097757395693e-32 2.443462173703552736e-31 7.418961350791642220e-03 -2.274089918700068490e-33 -4.458331419928759206e-31 6.412046708685887123e-03 -6.691853979703237233e-32 -6.158866755208911626e-32 5.292901377773730730e-03 -3.671044008520720134e-32 -4.375963896546078666e-31 4.052750384497899594e-03 3.341293584360434652e-31 8.131854037054789675e-33 2.682599786428978283e-03 -8.084581200777077534e-33 7.488278953200068596e-32 1.173507829047855389e-03 -1.330091461042922317e-31 -8.553194666936911631e-32 -4.772777403827129471e-04 -4.312376629269142029e-32 7.384699519880633653e-34 -2.145690171865280264e-03 4.990122847809326256e-32 -4.145878512108949148e-32 -3.732202035930033256e-03 -2.441492490279639564e-32 -1.631934737255446559e-33 -5.199234474029683188e-03 1.536435921600750742e-32 3.701144807132212868e-33 -6.507616137674143708e-03 1.901018688329583423e-32 3.806238379284469876e-35 -7.617791493188826209e-03 -6.007015725491252284e-35 -1.149397111326550325e-32 -8.516242898279445875e-03 -2.807664107056711941e-33 4.974156541421739841e-33 -9.300172437905922240e-03 4.728734298667183786e-33 7.229278327452296042e-33 -9.980195345422368525e-03 -4.187968409212115054e-33 -2.526139414705666249e-34 -1.053442523316933804e-02 8.201728049331568593e-34 -7.866643019918072708e-33 -1.086563676104390641e-02 -2.874605469841992836e-33 -8.846042154057230684e-34 -1.092540260003757764e-02 -1.725556898675415706e-33 1.536472461577130125e-33 -1.071922285387321740e-02 -1.446351582126238043e-32 -2.200977341096902360e-33 -1.037340825884860637e-02 6.788482342927266514e-33 -9.795447575970917515e-34 -9.947561538293363606e-03 -2.067960857596216102e-33 -1.833000825212711464e-33 -9.445983948244454989e-03 -3.602261324782308961e-33 -5.488415539653268128e-34 -8.839683008156611760e-03 -2.609067848005286795e-33 -3.771020965051682968e-36 -8.057966258612131449e-03 -3.114936696831152682e-33 -7.025067205227635856e-34 -7.108271329195539091e-03 1.294900492558985001e-33 9.186809407640757886e-34 -6.012257102638814132e-03 5.787674294264362624e-33 -5.248658299956383594e-33 -4.880972386200791747e-03 1.336763904575895575e-33 -5.343456633476997506e-35 -3.842163781311953505e-03 1.503785572341477963e-33 -3.816486951666632537e-34 -2.899569485978191995e-03 5.549710211502845341e-33 -6.099584029340474043e-33 -2.047902957581568609e-03 8.329951469600288070e-33 1.702489949495875322e-33 -1.281440075611148428e-03 -1.258099185939569056e-35 -4.238144151087907391e-34 -5.926086820032599664e-04 -1.057347131215684707e-33 4.656554367195578838e-34 3.214943058440144705e-05 1.103671635066414801e-34 1.039251585824396595e-33 6.000005873694487079e-04 -7.765458341713399787e-33 -6.044187035165903733e-33 1.114605034138820309e-03 4.887847880882840826e-33 -2.454818997405439943e-33 1.579498506452312739e-03 -2.271225877154838061e-33 -1.618045741211125268e-32 1.998061839655331136e-03 1.525946530332796774e-32 1.900398525897112685e-33 2.373487090107689618e-03 3.575658482313705526e-33 3.876295643168201569e-33 2.708753866618097538e-03 1.681192735973695812e-32 3.834641038867126558e-34 3.005677903174185615e-03 1.396143913708608939e-32 -1.115196190849090322e-32 3.263101423712487428e-03 6.997649623631846345e-34 -2.051601876692518513e-33 3.481863470881151751e-03 1.693063388322277934e-33 8.253148751463969105e-33 3.665850751461711445e-03 3.318442495156327830e-33 2.753110071300010349e-33 3.818850432747788060e-03 -4.776960015542009270e-33 2.193760082574472263e-33 3.944120696478450178e-03 -2.303899171572938198e-33 -2.616492699908066494e-33 4.044410688330879293e-03 4.852942590358737918e-34 -1.922155322081634885e-34 4.121979380377128674e-03 2.187371392533901365e-33 1.480076557898469812e-37 4.178612422650197777e-03 -5.397317873062446844e-34 -4.470025210314790508e-34 4.215636310568740032e-03 5.401325912133581821e-34 -3.086406895955253009e-33 4.233929391276620470e-03 -3.024365710429179756e-34 -2.476738205291551856e-34 -6.693878877587190951e-31 5.511521610893899137e-01 7.023763879665523519e-32 -1.213684258199182118e-33 5.511521610893899137e-01 -5.057396149036795677e-33 -2.908832234922288907e-31 5.511521610893899137e-01 -5.372272997721580511e-32 -2.098265043872291450e-32 5.511521610893899137e-01 -1.560313012198098189e-31 -4.460480003079173007e-31 5.511521610893899137e-01 -6.463023859117665993e-31 9.768285357234000299e-31 5.511521610893899137e-01 -5.358928332297334934e-31 -2.189480928175688640e-33 5.511521610893899137e-01 -3.612694783890924779e-31 -4.614427952413710396e-31 5.511521610893899137e-01 2.254261209392109348e-32 -2.308295574419196490e-30 5.511521610893899137e-01 4.000438915242548913e-32 8.250043336339598356e-33 5.511521610893899137e-01 4.709536657119106721e-32 1.364662146398175274e-30 5.511521610893899137e-01 8.507832497273994774e-32 1.093440458118657728e-30 5.511521610893899137e-01 -1.670196199016318176e-32 2.457696916451168065e-31 5.511521610893899137e-01 1.267514672358606805e-32 3.030045097757395693e-32 5.511521610893899137e-01 -2.807787351858833786e-32 -2.274089918700068490e-33 5.511521610893899137e-01 -3.117418833596663163e-32 -6.691853979703237233e-32 5.511521610893899137e-01 -4.416842538065583511e-32 -3.671044008520720134e-32 5.511521610893899137e-01 -2.924868368941431518e-32 3.341293584360434652e-31 5.511521610893899137e-01 4.444681120124257546e-33 -8.084581200777077534e-33 5.511521610893899137e-01 -2.546219467519335627e-32 -1.330091461042922317e-31 5.511521610893899137e-01 -6.819961976934326677e-34 -4.312376629269142029e-32 5.511521610893899137e-01 -1.241525506237106313e-33 4.990122847809326256e-32 5.511521610893899137e-01 -1.569887313977570801e-33 -2.441492490279639564e-32 5.511521610893899137e-01 -2.402920803610468942e-34 1.536435921600750742e-32 5.511521610893899137e-01 -9.165584842420585955e-35 1.901018688329583423e-32 5.511521610893899137e-01 -1.115131223519625417e-34 -6.007015725491252284e-35 5.511521610893899137e-01 -4.472257011736764337e-35 -2.807664107056711941e-33 5.511521610893899137e-01 -1.673033450966859962e-35 4.728734298667183786e-33 5.511521610893899137e-01 -1.351798589832718024e-35 -4.187968409212115054e-33 5.511521610893899137e-01 9.688298628882606315e-37 8.201728049331568593e-34 5.511521610893899137e-01 -2.212648313848077324e-35 -2.874605469841992836e-33 5.511521610893899137e-01 1.833731722420299415e-35 -1.725556898675415706e-33 5.511521610893899137e-01 2.356735283292187262e-36 -1.446351582126238043e-32 5.511521610893899137e-01 -4.396274526468345840e-35 6.788482342927266514e-33 5.511521610893899137e-01 2.910076078326331629e-35 -2.067960857596216102e-33 5.511521610893899137e-01 -9.839474111753336685e-36 -3.602261324782308961e-33 5.511521610893899137e-01 -6.132636074383660835e-36 -2.609067848005286795e-33 5.511521610893899137e-01 -1.013768860515183628e-35 -3.114936696831152682e-33 5.511521610893899137e-01 -1.096280944305474608e-35 1.294900492558985001e-33 5.511521610893899137e-01 4.592466625020779175e-36 5.787674294264362624e-33 5.511521610893899137e-01 9.540948615834967188e-36 1.336763904575895575e-33 5.511521610893899137e-01 -2.502762236464979207e-36 1.503785572341477963e-33 5.511521610893899137e-01 3.275855560540812230e-35 5.549710211502845341e-33 5.511521610893899137e-01 1.465587260610369653e-35 8.329951469600288070e-33 5.511521610893899137e-01 7.138082572971144980e-37 -1.258099185939569056e-35 5.511521610893899137e-01 1.221232805533752379e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -9.718413108749057898e-37 1.103671635066414801e-34 5.511521610893899137e-01 -1.868596250705185534e-37 -7.765458341713399787e-33 5.511521610893899137e-01 3.946115932493137485e-36 4.887847880882840826e-33 5.511521610893899137e-01 2.262990506617787507e-35 -2.271225877154838061e-33 5.511521610893899137e-01 1.301471940378096190e-35 1.525946530332796774e-32 5.511521610893899137e-01 1.159212928363959138e-35 3.575658482313705526e-33 5.511521610893899137e-01 8.723867927579395619e-35 1.681192735973695812e-32 5.511521610893899137e-01 7.454083659153999032e-36 1.396143913708608939e-32 5.511521610893899137e-01 1.109248066038083928e-34 6.997649623631846345e-34 5.511521610893899137e-01 5.120296241674980865e-35 1.693063388322277934e-33 5.511521610893899137e-01 6.057343973332397824e-35 3.318442495156327830e-33 5.511521610893899137e-01 3.678477219140497765e-35 -4.776960015542009270e-33 5.511521610893899137e-01 3.465568335247416883e-35 -2.303899171572938198e-33 5.511521610893899137e-01 4.684705414039010538e-35 4.852942590358737918e-34 5.511521610893899137e-01 6.277741512251677945e-37 2.187371392533901365e-33 5.511521610893899137e-01 1.022635762644438715e-35 -5.397317873062446844e-34 5.511521610893899137e-01 2.068001337598147530e-36 5.401325912133581821e-34 5.511521610893899137e-01 -3.348560208215807574e-37 -3.024365710429179756e-34 5.511521610893899137e-01 6.546199819497888909e-37 -3.087951667916717484e-32 6.360338597818152835e-32 5.511521610893899137e-01 -2.056035141828573141e-30 -1.169164896751050525e-32 5.511521610893899137e-01 8.602325660804059089e-31 -6.035698279568951195e-32 5.511521610893899137e-01 9.974204537119394011e-34 -1.626655540382835366e-31 5.511521610893899137e-01 2.585709822118868810e-33 -6.529366387302403171e-31 5.511521610893899137e-01 1.116281277743738823e-30 -5.425270860482072112e-31 5.511521610893899137e-01 1.022888264814794615e-30 -3.679037312075661956e-31 5.511521610893899137e-01 -8.015054378889686537e-33 1.590835927544738391e-32 5.511521610893899137e-01 -3.322949907144324724e-32 3.337013633395177682e-32 5.511521610893899137e-01 -1.663817809179103254e-32 4.046111375271736037e-32 5.511521610893899137e-01 -1.029310153751141003e-31 7.844407215426624090e-32 5.511521610893899137e-01 -3.465636496928655558e-32 -2.333621480863689133e-32 5.511521610893899137e-01 1.371231758106487328e-31 6.040893905112358474e-33 5.511521610893899137e-01 2.443462173703552736e-31 -3.471212633706204470e-32 5.511521610893899137e-01 -4.458331419928759206e-31 -3.780844115444033847e-32 5.511521610893899137e-01 -6.158866755208911626e-32 -5.080267819912953647e-32 5.511521610893899137e-01 -4.375963896546078666e-31 -3.588293650788802202e-32 5.511521610893899137e-01 8.131854037054789675e-33 -2.189571698349452027e-33 5.511521610893899137e-01 7.488278953200068596e-32 -3.209644749366706858e-32 5.511521610893899137e-01 -8.553194666936911631e-32 -7.316249016167142241e-33 5.511521610893899137e-01 7.384699519880633653e-34 -7.875778324710815202e-33 5.511521610893899137e-01 -4.145878512108949148e-32 -8.204140132451281058e-33 5.511521610893899137e-01 -1.631934737255446559e-33 -6.874544898834757194e-33 5.511521610893899137e-01 3.701144807132212868e-33 -6.725908666897916854e-33 5.511521610893899137e-01 3.806238379284469876e-35 -6.745765940825671730e-33 5.511521610893899137e-01 -1.149397111326550325e-32 -6.678975388591077954e-33 5.511521610893899137e-01 4.974156541421739841e-33 -6.650983152983377921e-33 5.511521610893899137e-01 7.229278327452296042e-33 -6.647770804372037280e-33 5.511521610893899137e-01 -2.526139414705666249e-34 -6.633283988610822863e-33 5.511521610893899137e-01 -7.866643019918072708e-33 -6.656379301612191533e-33 5.511521610893899137e-01 -8.846042154057230684e-34 -6.615915501249505788e-33 5.511521610893899137e-01 1.536472461577130125e-33 -6.631896083190416729e-33 5.511521610893899137e-01 -2.200977341096902360e-33 -6.678215563738392844e-33 5.511521610893899137e-01 -9.795447575970917515e-34 -6.605152057690446438e-33 5.511521610893899137e-01 -1.833000825212711464e-33 -6.644092292585463913e-33 5.511521610893899137e-01 -5.488415539653268128e-34 -6.640385454548091673e-33 5.511521610893899137e-01 -3.771020965051682968e-36 -6.644390507078859872e-33 5.511521610893899137e-01 -7.025067205227635856e-34 -6.645215627916764870e-33 5.511521610893899137e-01 9.186809407640757886e-34 -6.629660351848689748e-33 5.511521610893899137e-01 -5.248658299956383594e-33 -6.624711869857873796e-33 5.511521610893899137e-01 -5.343456633476997506e-35 -6.636755580710174881e-33 5.511521610893899137e-01 -3.816486951666632537e-34 -6.601494262868301039e-33 5.511521610893899137e-01 -6.099584029340474043e-33 -6.619596945867604289e-33 5.511521610893899137e-01 1.702489949495875322e-33 -6.633539010216412493e-33 5.511521610893899137e-01 -4.238144151087907391e-34 -6.633031585668175678e-33 5.511521610893899137e-01 4.656554367195578838e-34 -6.635224659784586199e-33 5.511521610893899137e-01 1.039251585824396595e-33 -6.634439678098780364e-33 5.511521610893899137e-01 -6.044187035165903733e-33 -6.630306702541216629e-33 5.511521610893899137e-01 -2.454818997405439943e-33 -6.611622913407531602e-33 5.511521610893899137e-01 -1.618045741211125268e-32 -6.621238099069928713e-33 5.511521610893899137e-01 1.900398525897112685e-33 -6.622660689190070508e-33 5.511521610893899137e-01 3.876295643168201569e-33 -6.547014139197914505e-33 5.511521610893899137e-01 3.834641038867126558e-34 -6.626798734814556325e-33 5.511521610893899137e-01 -1.115196190849090322e-32 -6.523328011869899619e-33 5.511521610893899137e-01 -2.051601876692518513e-33 -6.583049856056960128e-33 5.511521610893899137e-01 8.253148751463969105e-33 -6.573679378740386803e-33 5.511521610893899137e-01 2.753110071300010349e-33 -6.597468046282303665e-33 5.511521610893899137e-01 2.193760082574472263e-33 -6.599597135121235618e-33 5.511521610893899137e-01 -2.616492699908066494e-33 -6.587405764333317821e-33 5.511521610893899137e-01 -1.922155322081634885e-34 -6.633625044322484132e-33 5.511521610893899137e-01 1.480076557898469812e-37 -6.624026460847265075e-33 5.511521610893899137e-01 -4.470025210314790508e-34 -6.632184817136112924e-33 5.511521610893899137e-01 -3.086406895955253009e-33 -6.634587674494530571e-33 5.511521610893899137e-01 -2.476738205291551856e-34 -6.633598198491759197e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 deleted file mode 100644 index 482d7addf..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ -1.352487795931679726e-02 7.186542654010139890e-32 -3.087951667916717484e-32 1.347902063489157289e-02 -1.213684258199182118e-33 -3.728381140245989968e-31 1.338685543897583097e-02 1.244596995661276363e-31 8.602325660804059089e-31 1.324747790975055843e-02 -2.087992992792915651e-32 8.946999429181815743e-34 1.305952273106762013e-02 -4.460480003079173007e-31 2.488065541890253012e-33 1.282115356961373992e-02 -5.639353396631397563e-31 -3.883274034149998349e-32 1.253004999888494148e-02 -2.189480928175688640e-33 -2.072726182018415883e-31 1.218339197809170660e-02 -1.584327791517241873e-32 -8.015054378889686537e-33 1.177784255895553481e-02 4.173696107403246719e-31 -3.739286663231091606e-31 1.130952976400348073e-02 8.250043336339598356e-33 -1.637762504560468589e-32 1.077402893447631897e-02 1.325657781777226577e-31 -1.024616453300777401e-31 1.016634730596309606e-02 -7.201034342071760486e-32 -3.423592817219442872e-32 9.480913152518841841e-03 -3.045699438262729040e-31 1.378729573303645284e-31 8.711572575220295767e-03 1.598646754024827250e-31 -2.739106803292798204e-31 7.851597920008378598e-03 5.877695377250037967e-32 -1.422649841052083157e-30 6.893712917308904807e-03 4.785335463493405947e-32 -6.211065456485531337e-32 5.830140935948133381e-03 -3.717161035784631260e-32 -5.941014464402095621e-33 4.652684221773038982e-03 -4.773168640395984564e-31 8.233692167385567721e-33 3.352843638102343416e-03 -8.804626882755259802e-33 -2.044450833364208714e-32 1.921990210406904947e-03 5.851738340679510622e-31 4.161269354804123170e-33 3.516102942855809602e-04 -4.312376629269142029e-32 7.384699519880633653e-34 -1.318661627856292182e-03 4.964972510955454857e-32 3.826778270568354555e-32 -2.935937593277878222e-03 -2.452733776768732580e-32 -2.046108960648619085e-32 -4.454672386246005464e-03 1.541488543426084813e-32 4.819037385987356555e-33 -5.837891719854305939e-03 1.910162887349980249e-32 6.802518210044378673e-32 -7.047443236038019448e-03 -8.178224631464165513e-33 2.093696177985284751e-32 -8.045462492872012053e-03 -2.807664107056711941e-33 -2.610260701230273283e-32 -8.873783900947061418e-03 3.467920591293596858e-32 -7.745957479682096357e-33 -9.607251679285428933e-03 3.053024431578994055e-33 -2.359966314515394046e-34 -1.023298829193812487e-02 8.201728049331568593e-34 6.198001694690810088e-33 -1.070679857478515698e-02 -2.867127436010369084e-33 -8.883432323215349447e-34 -1.092797606233513602e-02 1.175779569425675511e-32 -1.834351620456271303e-33 -1.087938741911360051e-02 1.213360347696233966e-32 -1.550654545379245638e-32 -1.059978046650929782e-02 -6.392130789727320208e-33 -9.760997463235280629e-34 -1.022755686683541644e-02 -2.067960857596216102e-33 -1.832145783597374523e-33 -9.778534213702446548e-03 9.553355987303608217e-33 -1.371131432061721193e-32 -9.256712514380977322e-03 6.984727551396627871e-34 -5.504532811563710908e-36 -8.602940094676136615e-03 3.566129554394723763e-33 -6.954293198329056395e-34 -7.774398462956922003e-03 1.280325088873296754e-33 9.113932389212317506e-34 -6.789031593146552766e-03 -2.181899047452207293e-32 -5.233523067078759587e-33 -5.672495644084359252e-03 1.328845589686397400e-33 -2.176130677677727609e-35 -4.580069517414722159e-03 1.503785572341477963e-33 -3.816486951666632537e-34 -3.585733154740905222e-03 5.585033999733046451e-33 2.374901702517955987e-32 -2.684713382523221895e-03 -2.247294735251245164e-32 1.693095957784343629e-33 -1.871636065657945967e-03 -1.258099185939569056e-35 3.552886551768134949e-33 -1.140775523399708679e-03 -1.057347131215684707e-33 2.137839695420103116e-33 -4.842435682554318372e-04 1.161280181184095254e-34 1.039971692650867576e-33 1.119323573328583152e-04 -7.765458341713399787e-33 1.163327806531134959e-32 6.528000019293365031e-04 -1.345281257200419890e-32 -1.162514922384895981e-32 1.141894984960377217e-03 -2.271225877154838061e-33 2.182707160412247852e-32 1.582625513495812758e-03 1.519796386896772351e-32 -1.779543582797102153e-32 1.978230732617202673e-03 4.437464367616908315e-32 -1.653144583875621915e-32 2.331750625361230303e-03 -2.537583025027992611e-32 3.834641038867126558e-34 2.646005493915771015e-03 -7.335786731453534159e-32 1.067786470441445521e-32 2.923576025638687566e-03 6.997649623631846345e-34 -2.041560424246895454e-33 3.164506702616855412e-03 1.693063388322277934e-33 8.253148751463969105e-33 3.367940257553658778e-03 3.318442495156327830e-33 2.753110071300010349e-33 3.537532214964285871e-03 -4.765168369280247943e-33 -8.529065203080492639e-34 3.676707819580757840e-03 -2.303899171572938198e-33 -2.753640792485927969e-32 3.788361396662062210e-03 4.789130473037411658e-34 -1.922155322081634885e-34 3.874873947815511439e-03 -1.068994561995716177e-32 -3.219181245466976190e-33 3.938129203028682690e-03 -5.414126743061319719e-34 -4.470025210314790508e-34 3.979527298419899099e-03 5.401325912133581821e-34 1.836432394629107871e-33 3.999995488184198041e-03 2.991771276139138977e-33 -2.476738205291551856e-34 7.186542654010139890e-32 5.511521610893899137e-01 7.375498813085575161e-32 -1.213684258199182118e-33 5.511521610893899137e-01 -8.272286034813847021e-36 1.244596995661276363e-31 5.511521610893899137e-01 -4.645761386030501723e-32 -2.087992992792915651e-32 5.511521610893899137e-01 -1.525890740551217365e-31 -4.460480003079173007e-31 5.511521610893899137e-01 -6.364509604051161469e-31 -5.639353396631397563e-31 5.511521610893899137e-01 -5.267743907574309209e-31 -2.189480928175688640e-33 5.511521610893899137e-01 -3.608619759140272951e-31 -1.584327791517241873e-32 5.511521610893899137e-01 2.350448134052349784e-32 4.173696107403246719e-31 5.511521610893899137e-01 4.087365953498534383e-32 8.250043336339598356e-33 5.511521610893899137e-01 5.607498410558167040e-32 1.325657781777226577e-31 5.511521610893899137e-01 1.029393762699179707e-31 -7.201034342071760486e-32 5.511521610893899137e-01 -7.335191642943090101e-33 -3.045699438262729040e-31 5.511521610893899137e-01 2.061863713553203280e-32 1.598646754024827250e-31 5.511521610893899137e-01 -2.527508507457796887e-32 5.877695377250037967e-32 5.511521610893899137e-01 -2.956074415232851600e-32 4.785335463493405947e-32 5.511521610893899137e-01 -4.054527244633425411e-32 -3.717161035784631260e-32 5.511521610893899137e-01 -1.841190115371379237e-32 -4.773168640395984564e-31 5.511521610893899137e-01 9.086881186520693920e-33 -8.804626882755259802e-33 5.511521610893899137e-01 -2.611642102858723248e-32 5.851738340679510622e-31 5.511521610893899137e-01 -2.392091115194412587e-33 -4.312376629269142029e-32 5.511521610893899137e-01 -5.124866483382541518e-33 4.964972510955454857e-32 5.511521610893899137e-01 -2.822608425174638128e-33 -2.452733776768732580e-32 5.511521610893899137e-01 -3.937328338794265109e-34 1.541488543426084813e-32 5.511521610893899137e-01 -9.854212492071863451e-35 1.910162887349980249e-32 5.511521610893899137e-01 -3.676796705212713091e-34 -8.178224631464165513e-33 5.511521610893899137e-01 -2.864370589056947016e-35 -2.807664107056711941e-33 5.511521610893899137e-01 1.079476628716805687e-36 3.467920591293596858e-32 5.511521610893899137e-01 -5.282435735143124604e-35 3.053024431578994055e-33 5.511521610893899137e-01 8.322677113748318996e-36 8.201728049331568593e-34 5.511521610893899137e-01 -1.403648611406368769e-36 -2.867127436010369084e-33 5.511521610893899137e-01 2.293290744152356518e-35 1.175779569425675511e-32 5.511521610893899137e-01 2.368845860874853977e-36 1.213360347696233966e-32 5.511521610893899137e-01 -3.907747851017218974e-35 -6.392130789727320208e-33 5.511521610893899137e-01 3.477580932090751575e-35 -2.067960857596216102e-33 5.511521610893899137e-01 -9.358698069952256031e-36 9.553355987303608217e-33 5.511521610893899137e-01 -2.808092664944338853e-36 6.984727551396627871e-34 5.511521610893899137e-01 -9.901252986523509488e-36 3.566129554394723763e-33 5.511521610893899137e-01 -1.601157296717469955e-35 1.280325088873296754e-33 5.511521610893899137e-01 -1.591880489703040532e-36 -2.181899047452207293e-32 5.511521610893899137e-01 3.856754900133666074e-35 1.328845589686397400e-33 5.511521610893899137e-01 1.088088186796546475e-35 1.503785572341477963e-33 5.511521610893899137e-01 2.809006259237977320e-35 5.585033999733046451e-33 5.511521610893899137e-01 6.576658607155353788e-35 -2.247294735251245164e-32 5.511521610893899137e-01 1.127123287379117144e-35 -1.258099185939569056e-35 5.511521610893899137e-01 4.214765391998244750e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -9.542231530344836445e-37 1.161280181184095254e-34 5.511521610893899137e-01 2.662515279297182688e-37 -7.765458341713399787e-33 5.511521610893899137e-01 2.845542920351362250e-35 -1.345281257200419890e-32 5.511521610893899137e-01 3.157711679438059934e-35 -2.271225877154838061e-33 5.511521610893899137e-01 6.954581489809369995e-35 1.519796386896772351e-32 5.511521610893899137e-01 6.773543025730291336e-35 4.437464367616908315e-32 5.511521610893899137e-01 1.253048372883305449e-34 -2.537583025027992611e-32 5.511521610893899137e-01 1.039975329884152657e-34 -7.335786731453534159e-32 5.511521610893899137e-01 1.680674174095080494e-34 6.997649623631846345e-34 5.511521610893899137e-01 7.110698947443247607e-35 1.693063388322277934e-33 5.511521610893899137e-01 1.043360195983289936e-34 3.318442495156327830e-33 5.511521610893899137e-01 7.619196683124056831e-35 -4.765168369280247943e-33 5.511521610893899137e-01 3.787149463010952633e-35 -2.303899171572938198e-33 5.511521610893899137e-01 5.508198811764115733e-35 4.789130473037411658e-34 5.511521610893899137e-01 6.646139580992910234e-36 -1.068994561995716177e-32 5.511521610893899137e-01 1.214399063642611036e-35 -5.414126743061319719e-34 5.511521610893899137e-01 2.239305191503285967e-36 5.401325912133581821e-34 5.511521610893899137e-01 -1.742649129219119721e-37 2.991771276139138977e-33 5.511521610893899137e-01 9.498153568094589724e-37 -3.087951667916717484e-32 6.712073531238204478e-32 5.511521610893899137e-01 -3.728381140245989968e-31 -6.642525104508523420e-33 5.511521610893899137e-01 8.602325660804059089e-31 -5.309186667877872954e-32 5.511521610893899137e-01 8.946999429181815743e-34 -1.592233268735954543e-31 5.511521610893899137e-01 2.488065541890253012e-33 -6.430852132235898647e-31 5.511521610893899137e-01 -3.883274034149998349e-32 -5.334086435759046387e-31 5.511521610893899137e-01 -2.072726182018415883e-31 -3.674962287325010129e-31 5.511521610893899137e-01 -8.015054378889686537e-33 1.687022852204978827e-32 5.511521610893899137e-01 -3.739286663231091606e-31 3.423940671651163152e-32 5.511521610893899137e-01 -1.637762504560468589e-32 4.944073128710795261e-32 5.511521610893899137e-01 -1.024616453300777401e-31 9.630512345144425289e-32 5.511521610893899137e-01 -3.423592817219442872e-32 -1.396944446141680104e-32 5.511521610893899137e-01 1.378729573303645284e-31 1.398438431705832596e-32 5.511521610893899137e-01 -2.739106803292798204e-31 -3.190933789305167571e-32 5.511521610893899137e-01 -1.422649841052083157e-30 -3.619499697080222284e-32 5.511521610893899137e-01 -6.211065456485531337e-32 -4.717952526480795000e-32 5.511521610893899137e-01 -5.941014464402095621e-33 -2.504615397218749921e-32 5.511521610893899137e-01 8.233692167385567721e-33 2.452628368046984347e-33 5.511521610893899137e-01 -2.044450833364208714e-32 -3.275067384706094479e-32 5.511521610893899137e-01 4.161269354804123170e-33 -9.026343933668122502e-33 5.511521610893899137e-01 7.384699519880633653e-34 -1.175911930185625041e-32 5.511521610893899137e-01 3.826778270568354555e-32 -9.456861243648348385e-33 5.511521610893899137e-01 -2.046108960648619085e-32 -7.027985652353137281e-33 5.511521610893899137e-01 4.819037385987356555e-33 -6.732794943394429127e-33 5.511521610893899137e-01 6.802518210044378673e-32 -7.001932488994980241e-33 5.511521610893899137e-01 2.093696177985284751e-32 -6.662896524364280337e-33 5.511521610893899137e-01 -2.610260701230273283e-32 -6.633173341844992805e-33 5.511521610893899137e-01 -7.745957479682096357e-33 -6.687077175825141172e-33 5.511521610893899137e-01 -2.359966314515394046e-34 -6.625930141359962350e-33 5.511521610893899137e-01 6.198001694690810088e-33 -6.635656467085117545e-33 5.511521610893899137e-01 -8.883432323215349447e-34 -6.611319911032185144e-33 5.511521610893899137e-01 -1.834351620456271303e-33 -6.631883972612834125e-33 5.511521610893899137e-01 -1.550654545379245638e-32 -6.673330296983881880e-33 5.511521610893899137e-01 -9.760997463235280629e-34 -6.599477009152801790e-33 5.511521610893899137e-01 -1.832145783597374523e-33 -6.643611516543662662e-33 5.511521610893899137e-01 -1.371131432061721193e-32 -6.637060911138651825e-33 5.511521610893899137e-01 -5.504532811563710908e-36 -6.644154071460231987e-33 5.511521610893899137e-01 -6.954293198329056395e-34 -6.650264391440884925e-33 5.511521610893899137e-01 9.113932389212317506e-34 -6.635844698963413904e-33 5.511521610893899137e-01 -5.233523067078759587e-33 -6.595685269472372474e-33 5.511521610893899137e-01 -2.176130677677727609e-35 -6.623371936605743876e-33 5.511521610893899137e-01 -3.816486951666632537e-34 -6.606162755881328832e-33 5.511521610893899137e-01 2.374901702517955987e-32 -6.568486232402154153e-33 5.511521610893899137e-01 1.693095957784343629e-33 -6.622981585599918193e-33 5.511521610893899137e-01 3.552886551768134949e-33 -6.630038053081710685e-33 5.511521610893899137e-01 2.137839695420103116e-33 -6.635207041626746140e-33 5.511521610893899137e-01 1.039971692650867576e-33 -6.633986566945780633e-33 5.511521610893899137e-01 1.163327806531134959e-32 -6.605797389270196464e-33 5.511521610893899137e-01 -1.162514922384895981e-32 -6.602675701679329246e-33 5.511521610893899137e-01 2.182707160412247852e-32 -6.564707003575615766e-33 5.511521610893899137e-01 -1.779543582797102153e-32 -6.566517388216407611e-33 5.511521610893899137e-01 -1.653144583875621915e-32 -6.508947981185377296e-33 5.511521610893899137e-01 3.834641038867126558e-34 -6.530255285485295334e-33 5.511521610893899137e-01 1.067786470441445521e-32 -6.466185401064200369e-33 5.511521610893899137e-01 -2.041560424246895454e-33 -6.563145828999277332e-33 5.511521610893899137e-01 8.253148751463969105e-33 -6.529916798875381264e-33 5.511521610893899137e-01 2.753110071300010349e-33 -6.558060851642467593e-33 5.511521610893899137e-01 -8.529065203080492639e-34 -6.596381323843599753e-33 5.511521610893899137e-01 -2.753640792485927969e-32 -6.579170830356066972e-33 5.511521610893899137e-01 -1.922155322081634885e-34 -6.627606678892715882e-33 5.511521610893899137e-01 -3.219181245466976190e-33 -6.622108827837283404e-33 5.511521610893899137e-01 -4.470025210314790508e-34 -6.632013513282207412e-33 5.511521610893899137e-01 1.836432394629107871e-33 -6.634427083386631005e-33 5.511521610893899137e-01 -2.476738205291551856e-34 -6.633303003116899471e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 deleted file mode 100644 index 7d06dc3d5..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ -1.366656204287944494e-02 -7.134396634783323020e-32 -3.082174183584375122e-32 1.362186544593194625e-02 -6.067083750118049606e-31 5.610249228415866741e-33 1.353203334782232710e-02 -1.727618346397392621e-31 1.169325503883179940e-31 1.339618449607281325e-02 -3.103131708271034733e-31 8.946999429181815743e-34 1.321298848584204384e-02 1.129855520581791966e-31 2.820532177678916025e-31 1.298065577262019418e-02 -2.790333036934926304e-32 4.971992689522905098e-31 1.269692479289768333e-02 -6.597947278284737488e-32 4.788734921684516211e-32 1.235904663169389711e-02 -1.584327791517241873e-32 -7.870495053445142477e-33 1.196376786944822364e-02 -3.779407166869359818e-32 5.362704472460096848e-31 1.150731249622270053e-02 -2.050689120027880383e-31 -4.432411506951335326e-31 1.098536411592599543e-02 -6.689302491318191992e-32 -1.025601678309870529e-31 1.039305009707647970e-02 -7.218146662672772501e-32 3.374436752817847984e-31 9.724929881292360481e-03 3.869074434684825398e-31 8.294983175305971813e-31 8.974990358939317903e-03 -1.610855152810925171e-31 -3.313425548220183770e-32 8.136652084122550366e-03 5.877695377250037967e-32 3.638070269668059723e-31 7.202791145188095108e-03 4.794771755004121993e-32 1.449687626378026625e-31 6.165782738796785761e-03 -3.749616793116807751e-32 -5.941014464402095621e-33 5.017573903638333430e-03 -2.357519448523084983e-33 -5.113622590649885233e-32 3.749794412630991745e-03 -9.045619219375382885e-33 -2.044450833364208714e-32 2.353916413163103724e-03 5.847568746124586351e-31 4.057029490931012965e-33 8.214748930341094326e-04 -4.312376629269142029e-32 9.632701754114679024e-32 -8.402774866193213951e-04 -1.289132988155838495e-31 -5.097424163549574368e-32 -2.480909828515546860e-03 1.726233106828446219e-32 -2.049574107318268537e-32 -4.032243643174837633e-03 -2.387839061666339472e-32 4.819037385987356555e-33 -5.458098280921646825e-03 -1.801871852518050478e-32 -6.161004110428305843e-33 -6.720841420782373322e-03 3.575776222943790526e-32 -4.873442585609033859e-33 -7.782615217065468570e-03 -2.807664107056711941e-33 -1.021397376464776842e-33 -8.643586781484651274e-03 2.696027718034976488e-33 2.523697882540244466e-34 -9.404594565655547203e-03 3.046011347085767552e-33 -2.348277840360016398e-34 -1.006197496239105704e-02 8.201728049331568593e-34 1.563061441766223904e-33 -1.059251380753890338e-02 4.328350675908840005e-33 3.383235075161206022e-33 -1.089128701943809646e-02 -1.629880907234313314e-32 5.179799571193700419e-33 -1.092418393387812985e-02 -1.613789757140296833e-33 1.676760319096942015e-33 -1.069747082267891863e-02 -6.393946079633119551e-33 -9.760997463235280629e-34 -1.035048151228093113e-02 1.132544628211893051e-32 -8.530627082037335142e-33 -9.926118505544180570e-03 -3.764476433431380250e-33 6.268069765449794993e-33 -9.428761505219072220e-03 4.023148814668792818e-33 -5.504532811563710908e-36 -8.831330829500057267e-03 2.315748896178288668e-34 -6.954293198329056395e-34 -8.060102586323350526e-03 1.280325088873296754e-33 4.264900127547336508e-33 -7.127649161729271259e-03 5.312829288668759311e-33 1.553076664122386063e-33 -6.053502510666505278e-03 -1.242448515637765078e-32 1.373531694085295612e-32 -4.936383560452298203e-03 1.519290395529507966e-33 -3.797105922681595032e-34 -3.915422786098209096e-03 -2.293359984263769448e-32 -8.339482539759772360e-33 -2.989002605908963779e-03 -6.194287405139876844e-34 8.976200486547350384e-33 -2.151952979644487871e-03 -1.491023783572859234e-32 -3.902545441462505406e-33 -1.398677945971083664e-03 -1.057347131215684707e-33 2.133219758989594520e-33 -7.231344251934140660e-04 1.112717363552454929e-34 1.049684256177195556e-33 -1.120482336051193610e-04 -7.762903400619211630e-33 -4.429636593851766123e-33 4.426311403696781455e-04 1.950375715720784912e-32 4.850446186723344192e-33 9.444386677854262665e-04 -3.607962426292981500e-32 -1.419740505955672579e-33 1.396797706083545334e-03 1.518605591542135630e-32 -4.634094412326768154e-34 1.802974003988769974e-03 8.850310428880039942e-33 1.236975068910711962e-33 2.166041961975671056e-03 4.739728080661090458e-32 -1.891515429085440035e-33 2.488860863964215565e-03 3.832387832545956486e-32 1.372196332297391898e-33 2.774059100680896506e-03 7.069270408367962226e-34 2.712269162612777641e-33 3.023831589871018612e-03 1.685611295414068567e-33 -1.443887145343645982e-33 3.236652322032071601e-03 3.318442495156327830e-33 2.751178205633955512e-33 3.414210091042861606e-03 -2.484230417819268789e-32 -5.872190472536159764e-33 3.560027372072252679e-03 -2.303899171572938198e-33 3.008362282509692558e-33 3.677083403352577728e-03 4.810165638519463323e-34 -1.480619417983821228e-33 3.767830852629893562e-03 -2.840416255057275705e-34 1.984307027990159558e-33 3.834211282497319070e-03 -5.425012652783054140e-34 -4.470025210314790508e-34 3.877668460402704156e-03 1.857608603829714966e-33 -1.391631554808255105e-34 3.899158852862925038e-03 3.510474733419086596e-34 1.073102463723753950e-33 -7.134396634783323020e-32 5.511521610893899137e-01 7.370016823031501213e-32 -6.067083750118049606e-31 5.511521610893899137e-01 -1.033570866496180417e-33 -1.727618346397392621e-31 5.511521610893899137e-01 -4.581079108938876922e-32 -3.103131708271034733e-31 5.511521610893899137e-01 -1.536891070292911140e-31 1.129855520581791966e-31 5.511521610893899137e-01 -6.378134763139433223e-31 -2.790333036934926304e-32 5.511521610893899137e-01 -5.259685002585957695e-31 -6.597947278284737488e-32 5.511521610893899137e-01 -3.604605966067142658e-31 -1.584327791517241873e-32 5.511521610893899137e-01 2.256913192660706707e-32 -3.779407166869359818e-32 5.511521610893899137e-01 4.536898972670131666e-32 -2.050689120027880383e-31 5.511521610893899137e-01 5.964373176752747428e-32 -6.689302491318191992e-32 5.511521610893899137e-01 1.041649657761887850e-31 -7.218146662672772501e-32 5.511521610893899137e-01 -9.986639242867064905e-33 3.869074434684825398e-31 5.511521610893899137e-01 1.315194024202498009e-32 -1.610855152810925171e-31 5.511521610893899137e-01 -2.598415110504300076e-32 5.877695377250037967e-32 5.511521610893899137e-01 -3.563475423867367713e-32 4.794771755004121993e-32 5.511521610893899137e-01 -3.987871963990209838e-32 -3.749616793116807751e-32 5.511521610893899137e-01 -1.631194856726785084e-32 -2.357519448523084983e-33 5.511521610893899137e-01 7.418572790703306352e-33 -9.045619219375382885e-33 5.511521610893899137e-01 -2.391727801339516591e-32 5.847568746124586351e-31 5.511521610893899137e-01 -4.412523942666233873e-33 -4.312376629269142029e-32 5.511521610893899137e-01 -6.667175226338521208e-33 -1.289132988155838495e-31 5.511521610893899137e-01 -3.291857349116958804e-33 1.726233106828446219e-32 5.511521610893899137e-01 -5.585078699606674583e-34 -2.387839061666339472e-32 5.511521610893899137e-01 -1.182380714925217371e-34 -1.801871852518050478e-32 5.511521610893899137e-01 -3.887087285125440967e-34 3.575776222943790526e-32 5.511521610893899137e-01 -2.850461829078481743e-35 -2.807664107056711941e-33 5.511521610893899137e-01 -2.297822025990920700e-36 2.696027718034976488e-33 5.511521610893899137e-01 -5.506193210357685293e-35 3.046011347085767552e-33 5.511521610893899137e-01 8.964841219305158069e-36 8.201728049331568593e-34 5.511521610893899137e-01 -1.691139770251809627e-36 4.328350675908840005e-33 5.511521610893899137e-01 2.291445874382083696e-35 -1.629880907234313314e-32 5.511521610893899137e-01 1.983106821098385622e-36 -1.613789757140296833e-33 5.511521610893899137e-01 -3.890224275207955705e-35 -6.393946079633119551e-33 5.511521610893899137e-01 3.655242548207661351e-35 1.132544628211893051e-32 5.511521610893899137e-01 -1.052669591122636099e-35 -3.764476433431380250e-33 5.511521610893899137e-01 -2.259013236163149729e-36 4.023148814668792818e-33 5.511521610893899137e-01 -9.424867616837694123e-36 2.315748896178288668e-34 5.511521610893899137e-01 -1.653041701351388162e-35 1.280325088873296754e-33 5.511521610893899137e-01 -2.847933196720749754e-36 5.312829288668759311e-33 5.511521610893899137e-01 4.250788261074215558e-35 -1.242448515637765078e-32 5.511521610893899137e-01 1.307325185307763392e-35 1.519290395529507966e-33 5.511521610893899137e-01 3.043362934883631937e-35 -2.293359984263769448e-32 5.511521610893899137e-01 6.894800633473725781e-35 -6.194287405139876844e-34 5.511521610893899137e-01 1.297815138512067451e-35 -1.491023783572859234e-32 5.511521610893899137e-01 5.899594093370364673e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -2.505197991359449957e-36 1.112717363552454929e-34 5.511521610893899137e-01 -2.413852691743081970e-36 -7.762903400619211630e-33 5.511521610893899137e-01 3.011548806622389126e-35 1.950375715720784912e-32 5.511521610893899137e-01 3.791615587189680817e-35 -3.607962426292981500e-32 5.511521610893899137e-01 6.781707084506897065e-35 1.518605591542135630e-32 5.511521610893899137e-01 7.841859765923091749e-35 8.850310428880039942e-33 5.511521610893899137e-01 1.338168091979084000e-34 4.739728080661090458e-32 5.511521610893899137e-01 1.059670699522753937e-34 3.832387832545956486e-32 5.511521610893899137e-01 1.775916361844911737e-34 7.069270408367962226e-34 5.511521610893899137e-01 7.499044862713147347e-35 1.685611295414068567e-33 5.511521610893899137e-01 1.076798281036403395e-34 3.318442495156327830e-33 5.511521610893899137e-01 7.810114542282848248e-35 -2.484230417819268789e-32 5.511521610893899137e-01 4.011938740915588208e-35 -2.303899171572938198e-33 5.511521610893899137e-01 5.652826861667762090e-35 4.810165638519463323e-34 5.511521610893899137e-01 6.469262542570828636e-36 -2.840416255057275705e-34 5.511521610893899137e-01 1.256296601907252874e-35 -5.425012652783054140e-34 5.511521610893899137e-01 2.154077987855468232e-36 1.857608603829714966e-33 5.511521610893899137e-01 -1.808882583567832794e-37 3.510474733419086596e-34 5.511521610893899137e-01 9.771028344076606593e-37 -3.082174183584375122e-32 6.706591541184130530e-32 5.511521610893899137e-01 5.610249228415866741e-33 -7.667823684969890161e-33 5.511521610893899137e-01 1.169325503883179940e-31 -5.244504390786248153e-32 5.511521610893899137e-01 8.946999429181815743e-34 -1.603233598477648317e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.444477291324170401e-31 5.511521610893899137e-01 4.971992689522905098e-31 -5.326027530770694872e-31 5.511521610893899137e-01 4.788734921684516211e-32 -3.670948494251879836e-31 5.511521610893899137e-01 -7.870495053445142477e-33 1.593487910813335750e-32 5.511521610893899137e-01 5.362704472460096848e-31 3.873473690822760435e-32 5.511521610893899137e-01 -4.432411506951335326e-31 5.300947894905375650e-32 5.511521610893899137e-01 -1.025601678309870529e-31 9.753071295771505624e-32 5.511521610893899137e-01 3.374436752817847984e-31 -1.662089206134077721e-32 5.511521610893899137e-01 8.294983175305971813e-31 6.517687423551273252e-33 5.511521610893899137e-01 -3.313425548220183770e-32 -3.261840392351670760e-32 5.511521610893899137e-01 3.638070269668059723e-31 -4.226900705714738397e-32 5.511521610893899137e-01 1.449687626378026625e-31 -4.651297245837579426e-32 5.511521610893899137e-01 -5.941014464402095621e-33 -2.294620138574155767e-32 5.511521610893899137e-01 -5.113622590649885233e-32 7.843199722295974632e-34 5.511521610893899137e-01 -2.044450833364208714e-32 -3.055153083186887822e-32 5.511521610893899137e-01 4.057029490931012965e-33 -1.104677676113994345e-32 5.511521610893899137e-01 9.632701754114679024e-32 -1.330142804481222941e-32 5.511521610893899137e-01 -5.097424163549574368e-32 -9.926110167590669061e-33 5.511521610893899137e-01 -2.049574107318268537e-32 -7.192760688434378058e-33 5.511521610893899137e-01 4.819037385987356555e-33 -6.752490889966232080e-33 5.511521610893899137e-01 -6.161004110428305843e-33 -7.022961546986253242e-33 5.511521610893899137e-01 -4.873442585609033859e-33 -6.662757436764495475e-33 5.511521610893899137e-01 -1.021397376464776842e-33 -6.636550640499699985e-33 5.511521610893899137e-01 2.523697882540244466e-34 -6.689314750577287399e-33 5.511521610893899137e-01 -2.348277840360016398e-34 -6.625287977254405822e-33 5.511521610893899137e-01 1.563061441766223904e-33 -6.635943958243962459e-33 5.511521610893899137e-01 3.383235075161206022e-33 -6.611338359729888447e-33 5.511521610893899137e-01 5.179799571193700419e-33 -6.632269711652610758e-33 5.511521610893899137e-01 1.676760319096942015e-33 -6.673155061225788772e-33 5.511521610893899137e-01 -9.760997463235280629e-34 -6.597700392991632131e-33 5.511521610893899137e-01 -8.530627082037335142e-33 -6.644779514384937407e-33 5.511521610893899137e-01 6.268069765449794993e-33 -6.636511831709870927e-33 5.511521610893899137e-01 -5.504532811563710908e-36 -6.643677686090546381e-33 5.511521610893899137e-01 -6.954293198329056395e-34 -6.650783235487224035e-33 5.511521610893899137e-01 4.264900127547336508e-33 -6.637100751670431412e-33 5.511521610893899137e-01 1.553076664122386063e-33 -6.591744935862967059e-33 5.511521610893899137e-01 1.373531694085295612e-32 -6.621179566620632091e-33 5.511521610893899137e-01 -3.797105922681595032e-34 -6.603819189124871955e-33 5.511521610893899137e-01 -8.339482539759772360e-33 -6.565304812138970925e-33 5.511521610893899137e-01 8.976200486547350384e-33 -6.621274667088589029e-33 5.511521610893899137e-01 -3.902545441462505406e-33 -6.628353224380338190e-33 5.511521610893899137e-01 2.133219758989594520e-33 -6.636758016465070442e-33 5.511521610893899137e-01 1.049684256177195556e-33 -6.636666671165453940e-33 5.511521610893899137e-01 -4.429636593851766123e-33 -6.604137330407486697e-33 5.511521610893899137e-01 4.850446186723344192e-33 -6.596336662601813390e-33 5.511521610893899137e-01 -1.419740505955672579e-33 -6.566435747628640698e-33 5.511521610893899137e-01 -4.634094412326768154e-34 -6.555834220814479543e-33 5.511521610893899137e-01 1.236975068910711962e-33 -6.500436009275799911e-33 5.511521610893899137e-01 -1.891515429085440035e-33 -6.528285748521434735e-33 5.511521610893899137e-01 1.372196332297391898e-33 -6.456661182289216945e-33 5.511521610893899137e-01 2.712269162612777641e-33 -6.559262369846577832e-33 5.511521610893899137e-01 -1.443887145343645982e-33 -6.526572990370069597e-33 5.511521610893899137e-01 2.751178205633955512e-33 -6.556151673050880257e-33 5.511521610893899137e-01 -5.872190472536159764e-33 -6.594133431064553782e-33 5.511521610893899137e-01 3.008362282509692558e-33 -6.577724549857030199e-33 5.511521610893899137e-01 -1.480619417983821228e-33 -6.627783555931137886e-33 5.511521610893899137e-01 1.984307027990159558e-33 -6.621689852454636357e-33 5.511521610893899137e-01 -4.470025210314790508e-34 -6.632098740485854942e-33 5.511521610893899137e-01 -1.391631554808255105e-34 -6.634433706732066100e-33 5.511521610893899137e-01 1.073102463723753950e-33 -6.633275715639301544e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 deleted file mode 100644 index ed9f8aacf..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ -1.372662556860645804e-02 -4.234909387065355032e-31 -3.082174183584375122e-32 1.368250134313573826e-02 -1.407929672620088487e-31 5.610249228415866741e-33 1.359382013840655830e-02 2.861196083528416018e-31 -1.124918802302745697e-31 1.345971303480244206e-02 1.383532944120539956e-31 3.373634044557071413e-31 1.327886820249941403e-02 1.129855520581791966e-31 2.820532177678916025e-31 1.304952099368350896e-02 -4.481514149333622327e-31 7.697851048780055403e-32 1.276944115022624407e-02 3.369625855135215789e-31 4.509048083474762383e-31 1.243591754746156859e-02 -2.080690987759162558e-31 -3.923450099092570303e-31 1.204574108108417974e-02 -3.781469365794795584e-32 1.712199934653671199e-31 1.159518655059983520e-02 1.401549715765712816e-31 -4.432411506951335326e-31 1.107999471590855392e-02 -6.702407059519766207e-32 -1.404105881611290480e-30 1.049535612333133208e-02 -7.218146662672772501e-32 3.170856825897740560e-32 9.835898834547770336e-03 1.002110816481828714e-31 -3.069254157667034924e-32 9.095682869211127453e-03 -1.611747089090130951e-31 5.036329973438976555e-31 8.268205010134541469e-03 5.893294032328412785e-32 1.128636633934494789e-31 7.346418636668792732e-03 4.794771755004121993e-32 1.451049954974098503e-31 6.322774453786263529e-03 -3.761512147649702738e-32 -5.822060919073145761e-33 5.189289362048942617e-03 4.074331537174483756e-31 3.588103600076651278e-31 3.937652228804391918e-03 -9.045619219375382885e-33 -2.044450833364208714e-32 2.559376891769624216e-03 1.139805610010468293e-33 4.136866302066588700e-33 1.046014208814335890e-03 -9.724626417845067894e-34 -3.006537149215019376e-32 -6.043510931653036386e-04 -4.966723939998276002e-32 8.452527606403699121e-33 -2.254711724937969418e-03 3.595002152441394013e-32 1.687099333444658131e-32 -3.820385152401972045e-03 1.149081342034187561e-32 2.251041459490394407e-32 -5.265609391688706731e-03 -1.219030138328765601e-33 1.063868427642343334e-32 -6.553037895144557708e-03 -8.298043273236419417e-33 1.114754354353311293e-32 -7.644934929571492628e-03 1.254423573264168420e-32 -1.023729783003776976e-33 -8.526640699927411429e-03 -7.308974140610414607e-35 1.175363941442336983e-33 -9.300665657292591509e-03 3.046011347085767552e-33 -2.328085677093609735e-34 -9.973183030349818193e-03 8.201728049331568593e-34 1.564967207729202690e-33 -1.052706126070216547e-02 -7.521508965686632846e-33 3.383235075161206022e-33 -1.086379137781360964e-02 3.089444169687299439e-34 5.180236623088838582e-33 -1.093683476224183160e-02 -1.613789757140296833e-33 -1.598212667134254304e-33 -1.074324977006893382e-02 3.341517456861851002e-33 -9.763083127474642577e-34 -1.040895024457869772e-02 -4.827709811742814172e-33 -2.069364644492637814e-33 -9.997088006653720438e-03 -3.762822323726171175e-33 6.269723875155004067e-33 -9.511824858411019670e-03 -2.467564896535629111e-33 -4.873435510858590279e-33 -8.938714131281061057e-03 2.313626672360081871e-34 -7.241216464710521799e-33 -8.197001809551801230e-03 1.283806772546079155e-33 -2.362484743593903962e-33 -7.292134036912215934e-03 5.309232886795139008e-33 1.553076664122386063e-33 -6.243322654470531523e-03 1.316078844173357344e-33 -1.374581106024906013e-32 -5.121114702556004220e-03 1.519290395529507966e-33 -3.797105922681595032e-34 -4.087138538648990571e-03 -1.318839184499497256e-33 -1.133705469035395649e-33 -3.148241764250317085e-03 -6.194287405139876844e-34 8.976200486547350384e-33 -2.299363236033038181e-03 3.189479783564930644e-34 -9.524898794123405551e-35 -1.534979514310427264e-03 -1.057347131215684707e-33 -1.790883860662348888e-33 -8.493228634136516754e-04 1.122874913807457415e-33 5.095448502410753181e-33 -2.309330246805747560e-04 5.859510230768103454e-34 -2.557270013157968081e-34 3.305228359053031238e-04 -6.337803416602524376e-33 -3.761447862556045790e-33 8.385836893343564732e-04 3.501322500868305334e-32 -1.416611970078555386e-33 1.296676703495337583e-03 -1.230984062605623877e-32 8.699671279390421501e-33 1.708077397523512708e-03 8.857377119388985032e-33 1.236975068910711962e-33 2.075874114203437194e-03 8.508319913520023044e-33 -1.895260153292766982e-33 2.402942767493330967e-03 -1.661787723690776538e-33 1.372196332297391898e-33 2.691929803638716361e-03 4.175259252398907391e-32 2.712269162612777641e-33 2.945241577443824879e-03 1.685611295414068567e-33 -1.441696868575432563e-33 3.162904441581655159e-03 3.318442495156327830e-33 -1.875698974822404893e-32 3.344642580183998168e-03 1.904539912238210777e-32 -5.872786610858634141e-33 3.493956875720598786e-03 -2.463931921576500387e-32 3.008362282509692558e-33 3.613865762678063892e-03 4.810165638519463323e-34 -1.480619417983821228e-33 3.706855086025015022e-03 5.452570944226181775e-33 1.985611099954181230e-33 3.774893236395615841e-03 -5.425012652783054140e-34 -4.473346272288253629e-34 3.819444246570224705e-03 -1.055789363071097072e-33 1.339889204642479047e-34 3.841478154082504735e-03 -1.427032489764166980e-35 -3.879995418785415766e-34 -4.234909387065355032e-31 5.511521610893899137e-01 7.270275224928160318e-32 -1.407929672620088487e-31 5.511521610893899137e-01 8.187588626082599818e-34 2.861196083528416018e-31 5.511521610893899137e-01 -4.525887518784714309e-32 1.383532944120539956e-31 5.511521610893899137e-01 -1.538896994440143548e-31 1.129855520581791966e-31 5.511521610893899137e-01 -6.382529027475184607e-31 -4.481514149333622327e-31 5.511521610893899137e-01 -5.246733380363877111e-31 3.369625855135215789e-31 5.511521610893899137e-01 -3.597766919155931200e-31 -2.080690987759162558e-31 5.511521610893899137e-01 2.229545200799540252e-32 -3.781469365794795584e-32 5.511521610893899137e-01 4.580070477138157673e-32 1.401549715765712816e-31 5.511521610893899137e-01 5.900889209891985732e-32 -6.702407059519766207e-32 5.511521610893899137e-01 9.873819647000943499e-32 -7.218146662672772501e-32 5.511521610893899137e-01 -1.087026475338805773e-32 1.002110816481828714e-31 5.511521610893899137e-01 1.226785684485853119e-32 -1.611747089090130951e-31 5.511521610893899137e-01 -3.055706132796271869e-32 5.893294032328412785e-32 5.511521610893899137e-01 -3.751508003890474092e-32 4.794771755004121993e-32 5.511521610893899137e-01 -4.681874872402894436e-32 -3.761512147649702738e-32 5.511521610893899137e-01 -2.074476256557377878e-32 4.074331537174483756e-31 5.511521610893899137e-01 5.142306152042979811e-33 -9.045619219375382885e-33 5.511521610893899137e-01 -2.335850462108051587e-32 1.139805610010468293e-33 5.511521610893899137e-01 -4.317197814033340453e-33 -9.724626417845067894e-34 5.511521610893899137e-01 -6.699108621916015964e-33 -4.966723939998276002e-32 5.511521610893899137e-01 -3.306746331437724547e-33 3.595002152441394013e-32 5.511521610893899137e-01 -5.610237211043197337e-34 1.149081342034187561e-32 5.511521610893899137e-01 -1.185481832216937445e-34 -1.219030138328765601e-33 5.511521610893899137e-01 -3.836072691644952449e-34 -8.298043273236419417e-33 5.511521610893899137e-01 -2.808432812971475788e-35 1.254423573264168420e-32 5.511521610893899137e-01 1.438904298163230538e-36 -7.308974140610414607e-35 5.511521610893899137e-01 -5.506408367809550110e-35 3.046011347085767552e-33 5.511521610893899137e-01 1.146833615355744859e-35 8.201728049331568593e-34 5.511521610893899137e-01 6.757733677485679143e-38 -7.521508965686632846e-33 5.511521610893899137e-01 2.308600771301224795e-35 3.089444169687299439e-34 5.511521610893899137e-01 1.812977777053995821e-36 -1.613789757140296833e-33 5.511521610893899137e-01 -3.904013942332606856e-35 3.341517456861851002e-33 5.511521610893899137e-01 3.648912484725514879e-35 -4.827709811742814172e-33 5.511521610893899137e-01 -1.065941382022208925e-35 -3.762822323726171175e-33 5.511521610893899137e-01 -3.598852698914864518e-36 -2.467564896535629111e-33 5.511521610893899137e-01 -9.385774252057225130e-36 2.313626672360081871e-34 5.511521610893899137e-01 -1.643727554979938561e-35 1.283806772546079155e-33 5.511521610893899137e-01 -1.420508505100495152e-36 5.309232886795139008e-33 5.511521610893899137e-01 4.367926809114917680e-35 1.316078844173357344e-33 5.511521610893899137e-01 5.525607584683205437e-36 1.519290395529507966e-33 5.511521610893899137e-01 3.090417360262301682e-35 -1.318839184499497256e-33 5.511521610893899137e-01 6.863476749759568873e-35 -6.194287405139876844e-34 5.511521610893899137e-01 9.890703958695879778e-36 3.189479783564930644e-34 5.511521610893899137e-01 5.215191442010362092e-36 -1.057347131215684707e-33 5.511521610893899137e-01 -2.857070070711378891e-36 1.122874913807457415e-33 5.511521610893899137e-01 -2.329212285125192115e-36 5.859510230768103454e-34 5.511521610893899137e-01 3.009782217765291258e-35 -6.337803416602524376e-33 5.511521610893899137e-01 3.693426710451537334e-35 3.501322500868305334e-32 5.511521610893899137e-01 6.581809406505216634e-35 -1.230984062605623877e-32 5.511521610893899137e-01 7.650381101582838797e-35 8.857377119388985032e-33 5.511521610893899137e-01 1.284073521696871404e-34 8.508319913520023044e-33 5.511521610893899137e-01 1.016506807592022085e-34 -1.661787723690776538e-33 5.511521610893899137e-01 1.741240377890612296e-34 4.175259252398907391e-32 5.511521610893899137e-01 7.191170016566425111e-35 1.685611295414068567e-33 5.511521610893899137e-01 1.038236939594640267e-34 3.318442495156327830e-33 5.511521610893899137e-01 7.504580932864171131e-35 1.904539912238210777e-32 5.511521610893899137e-01 3.940389510467470156e-35 -2.463931921576500387e-32 5.511521610893899137e-01 5.513970573065718098e-35 4.810165638519463323e-34 5.511521610893899137e-01 5.818126286040120663e-36 5.452570944226181775e-33 5.511521610893899137e-01 1.225354253067425628e-35 -5.425012652783054140e-34 5.511521610893899137e-01 1.993086446614312619e-36 -1.055789363071097072e-33 5.511521610893899137e-01 -1.820987456794831188e-37 -1.427032489764166980e-35 5.511521610893899137e-01 9.827998333934936987e-37 -3.082174183584375122e-32 6.606849943080789634e-32 5.511521610893899137e-01 5.610249228415866741e-33 -5.815493955865449420e-33 5.511521610893899137e-01 -1.124918802302745697e-31 -5.189312800632085540e-32 5.511521610893899137e-01 3.373634044557071413e-31 -1.605239522624880726e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.448871555659921784e-31 5.511521610893899137e-01 7.697851048780055403e-32 -5.313075908548614289e-31 5.511521610893899137e-01 4.509048083474762383e-31 -3.664109447340668378e-31 5.511521610893899137e-01 -3.923450099092570303e-31 1.566119918952169294e-32 5.511521610893899137e-01 1.712199934653671199e-31 3.916645195290786442e-32 5.511521610893899137e-01 -4.432411506951335326e-31 5.237463928044613954e-32 5.511521610893899137e-01 -1.404105881611290480e-30 9.210394365153570626e-32 5.511521610893899137e-01 3.170856825897740560e-32 -1.750451757186176867e-32 5.511521610893899137e-01 -3.069254157667034924e-32 5.633604026384823671e-33 5.511521610893899137e-01 5.036329973438976555e-31 -3.719131414643642552e-32 5.511521610893899137e-01 1.128636633934494789e-31 -4.414933285737844775e-32 5.511521610893899137e-01 1.451049954974098503e-31 -5.345300154250263478e-32 5.511521610893899137e-01 -5.822060919073145761e-33 -2.737901538404748288e-32 5.511521610893899137e-01 3.588103600076651278e-31 -1.491946666430729078e-33 5.511521610893899137e-01 -2.044450833364208714e-32 -2.999275743955423092e-32 5.511521610893899137e-01 4.136866302066588700e-33 -1.095145063250705003e-32 5.511521610893899137e-01 -3.006537149215019376e-32 -1.333336144038972417e-32 5.511521610893899137e-01 8.452527606403699121e-33 -9.940999149911434804e-33 5.511521610893899137e-01 1.687099333444658131e-32 -7.195276539578029905e-33 5.511521610893899137e-01 2.251041459490394407e-32 -6.752801001695403809e-33 5.511521610893899137e-01 1.063868427642343334e-32 -7.017860087638204690e-33 5.511521610893899137e-01 1.114754354353311293e-32 -6.662337146603425389e-33 5.511521610893899137e-01 -1.023729783003776976e-33 -6.632813914175546366e-33 5.511521610893899137e-01 1.175363941442336983e-33 -6.689316902151806154e-33 5.511521610893899137e-01 -2.328085677093609735e-34 -6.622784482320153083e-33 5.511521610893899137e-01 1.564967207729202690e-33 -6.634185241136935342e-33 5.511521610893899137e-01 3.383235075161206022e-33 -6.611166810760696814e-33 5.511521610893899137e-01 5.180236623088838582e-33 -6.632439840696654862e-33 5.511521610893899137e-01 -1.598212667134254304e-33 -6.673292957897035791e-33 5.511521610893899137e-01 -9.763083127474642577e-34 -6.597763693626453831e-33 5.511521610893899137e-01 -2.069364644492637814e-33 -6.644912232293932868e-33 5.511521610893899137e-01 6.269723875155004067e-33 -6.637851671172622512e-33 5.511521610893899137e-01 -4.873435510858590279e-33 -6.643638592725765522e-33 5.511521610893899137e-01 -7.241216464710521799e-33 -6.650690094023509629e-33 5.511521610893899137e-01 -2.362484743593903962e-33 -6.635673326978810857e-33 5.511521610893899137e-01 1.553076664122386063e-33 -6.590573550382560385e-33 5.511521610893899137e-01 -1.374581106024906013e-32 -6.628727210889026751e-33 5.511521610893899137e-01 -3.797105922681595032e-34 -6.603348644871085193e-33 5.511521610893899137e-01 -1.133705469035395649e-33 -6.565618050976112473e-33 5.511521610893899137e-01 8.976200486547350384e-33 -6.624362114515013195e-33 5.511521610893899137e-01 -9.524898794123405551e-35 -6.629037627031698018e-33 5.511521610893899137e-01 -1.790883860662348888e-33 -6.637109888544422458e-33 5.511521610893899137e-01 5.095448502410753181e-33 -6.636582030758836324e-33 5.511521610893899137e-01 -2.557270013157968081e-34 -6.604154996296058093e-33 5.511521610893899137e-01 -3.761447862556045790e-33 -6.597318551369194285e-33 5.511521610893899137e-01 -1.416611970078555386e-33 -6.568434724408658176e-33 5.511521610893899137e-01 8.699671279390421501e-33 -6.557749007457881976e-33 5.511521610893899137e-01 1.236975068910711962e-33 -6.505845466304020807e-33 5.511521610893899137e-01 -1.895260153292766982e-33 -6.532602137714508006e-33 5.511521610893899137e-01 1.372196332297391898e-33 -6.460128780684646291e-33 5.511521610893899137e-01 2.712269162612777641e-33 -6.562341118308044819e-33 5.511521610893899137e-01 -1.441696868575432563e-33 -6.530429124514246401e-33 5.511521610893899137e-01 -1.875698974822404893e-32 -6.559207009145066910e-33 5.511521610893899137e-01 -5.872786610858634141e-33 -6.594848923369034342e-33 5.511521610893899137e-01 3.008362282509692558e-33 -6.579113112743050778e-33 5.511521610893899137e-01 -1.480619417983821228e-33 -6.628434692187669180e-33 5.511521610893899137e-01 1.985611099954181230e-33 -6.621999275943034141e-33 5.511521610893899137e-01 -4.473346272288253629e-34 -6.632259732027095841e-33 5.511521610893899137e-01 1.339889204642479047e-34 -6.634434917219388736e-33 5.511521610893899137e-01 -3.879995418785415766e-34 -6.633270018640315484e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 deleted file mode 100644 index 77afa96ca..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ -1.376153539822414125e-02 1.056572053411708736e-30 -3.089706694104596093e-32 1.371771874067423229e-02 -1.407929672620088487e-31 9.841555076915215953e-31 1.362965583224103917e-02 2.861196083528416018e-31 -4.735065036864974871e-31 1.349648408698318411e-02 1.383532944120539956e-31 -1.072245031109316571e-30 1.331690120491006539e-02 1.129855520581791966e-31 2.820532177678916025e-31 1.308915529338566808e-02 1.304571662274165895e-30 7.703793087215175515e-32 1.281103210298752647e-02 1.273864151648280798e-31 -1.225432765866856368e-30 1.247983978790464382e-02 5.891221791515320429e-31 4.048954469989395565e-31 1.209239178394603924e-02 1.508262249064671188e-31 9.259158617794845230e-31 1.164498863778779848e-02 -2.600040316987390054e-31 2.681439315858539969e-31 1.113339993875827813e-02 -6.705862409057813296e-32 -7.358412809530782214e-31 1.055284791580756755e-02 -7.218146662672772501e-32 3.172372878130401271e-32 9.897994790505838109e-03 -4.849212657601411213e-31 -3.066605061563230693e-32 9.162936642735578299e-03 -7.072200397230972715e-31 -4.245847554647640982e-32 8.341207371036911053e-03 -6.833146068375930820e-32 -2.530290086683952901e-31 7.425797331886956759e-03 4.794771755004121993e-32 1.451746311837644250e-31 6.409192428869707296e-03 -3.416135975891769074e-32 -4.477826413217854899e-31 5.283440785996493076e-03 -4.591318890068548846e-33 -4.653436733850406960e-31 4.040255642725729818e-03 -3.935518474402755398e-31 -4.049507365545422975e-31 2.671164673781398474e-03 3.604818972714993136e-31 -1.755341795286778428e-31 1.167717425232247608e-03 -1.112553309623048587e-33 6.725940148946867568e-33 -4.752819860221025412e-04 -4.966723939998276002e-32 3.558442974227194544e-32 -2.131182547778113362e-03 3.592269302088208612e-32 -2.027527509122277384e-32 -3.704820192637029320e-03 1.147862556285061438e-32 4.969040700605396538e-33 -5.160633143686203968e-03 -1.219030138328765601e-33 -5.989755266244782525e-33 -6.461401920645526258e-03 2.336612098669552867e-32 -1.259933869812144593e-32 -7.569429850991874972e-03 -2.592374176610800348e-33 -1.021460426195793077e-33 -8.463712003197735451e-03 -7.343497010401240768e-33 1.175363941442336983e-33 -9.244752719779801911e-03 6.555183801820643839e-33 5.030889140448438035e-33 -9.925356252983805541e-03 8.201728049331568593e-34 -1.367925418140472112e-34 -1.049044673279584880e-02 -8.876342765771785636e-34 6.700390352524380566e-33 -1.084701569037775648e-02 -1.315522384718889510e-33 3.117170545009075190e-32 -1.094091849549633060e-02 2.397068745533150407e-32 -1.598212667134254304e-33 -1.076623543209026881e-02 -2.985391692556573700e-33 -9.759118898684279460e-34 -1.043840459690959128e-02 1.460260361624653853e-33 -2.069364644492637814e-33 -1.003287783168555457e-02 -3.762822323726171175e-33 -3.538542410027737786e-33 -9.553706342736978038e-03 -2.467957188392308838e-33 -4.873435510858590279e-33 -8.991673383280822385e-03 3.399461316088347515e-33 -9.054167447995112694e-34 -8.264881821631254316e-03 -5.119313660667677494e-33 -7.618061496609576647e-34 -7.373877414191088581e-03 5.309232886795139008e-33 1.454031419757997548e-32 -6.337721753416431826e-03 7.924389906101558650e-33 1.268397333874021806e-32 -5.215133945614696190e-03 1.519290395529507966e-33 -1.386613460702025583e-32 -4.174295426105380756e-03 -1.316954674429814789e-33 -1.129936448896030714e-33 -3.228847122567313037e-03 -6.194287405139876844e-34 8.976200486547350384e-33 -2.373779647915001938e-03 -6.934621631196062400e-33 -9.524898794123405551e-35 -1.603602846860630645e-03 -8.511377957091233964e-33 -1.790883860662348888e-33 -9.125689642349054569e-04 -2.708426640480811327e-33 -2.568318074600126537e-33 -2.902838837517120684e-04 1.635461650469419602e-32 -8.139444115300032462e-33 2.747128084758758003e-04 3.801892638184811442e-33 -3.620691122421625000e-32 7.860337466820190586e-04 -1.505273556122659470e-32 3.196069507652787441e-32 1.247109834000481457e-03 4.850923037098799644e-33 8.699671279390421501e-33 1.661223206794162173e-03 4.138613390563257201e-35 1.236975068910711962e-33 2.031470794755687974e-03 8.506697469932747659e-33 -3.809846635976320450e-32 2.360738314678715189e-03 -1.662640508486751633e-33 1.368785193113492206e-33 2.651682617558633395e-03 3.751386120459172216e-33 2.712269162612777641e-33 2.906720571183749827e-03 1.685611295414068567e-33 -1.443564609773584029e-33 3.126650349335033906e-03 -6.588091281964322131e-33 -1.875698974822404893e-32 3.310497562430973675e-03 8.959283902301096644e-33 3.447167426946541175e-32 3.461573308801950497e-03 6.097665807270917610e-33 3.007322623965728181e-33 3.582917146455113794e-03 4.810165638519463323e-34 -1.481153287811754469e-33 3.677032758141057529e-03 2.044309607502370512e-34 1.985611099954181230e-33 3.745902933312134347e-03 -5.425012652783054140e-34 1.013551952675522389e-32 3.791002567515563103e-03 -1.055754318165421983e-33 2.794177620452879432e-33 3.813308966439189155e-03 -1.427032489764166980e-35 -3.879995418785415766e-34 1.056572053411708736e-30 5.511521610893899137e-01 7.068701298177106395e-32 -1.407929672620088487e-31 5.511521610893899137e-01 -1.567184847873423190e-33 2.861196083528416018e-31 5.511521610893899137e-01 -4.545423355492242495e-32 1.383532944120539956e-31 5.511521610893899137e-01 -1.517159406677904012e-31 1.129855520581791966e-31 5.511521610893899137e-01 -6.342380571885688336e-31 1.304571662274165895e-30 5.511521610893899137e-01 -5.211004789068694412e-31 1.273864151648280798e-31 5.511521610893899137e-01 -3.585546503855637706e-31 5.891221791515320429e-31 5.511521610893899137e-01 2.418015672626471617e-32 1.508262249064671188e-31 5.511521610893899137e-01 4.678595382418527072e-32 -2.600040316987390054e-31 5.511521610893899137e-01 5.887097748133637277e-32 -6.705862409057813296e-32 5.511521610893899137e-01 9.694122859313416736e-32 -7.218146662672772501e-32 5.511521610893899137e-01 -1.111307794880685589e-32 -4.849212657601411213e-31 5.511521610893899137e-01 1.144922944607209124e-32 -7.072200397230972715e-31 5.511521610893899137e-01 -3.231838547721487631e-32 -6.833146068375930820e-32 5.511521610893899137e-01 -3.754486458692319805e-32 4.794771755004121993e-32 5.511521610893899137e-01 -4.833001576365440140e-32 -3.416135975891769074e-32 5.511521610893899137e-01 -2.076643164464616413e-32 -4.591318890068548846e-33 5.511521610893899137e-01 6.153380524320890944e-33 -3.935518474402755398e-31 5.511521610893899137e-01 -2.136110690812948805e-32 3.604818972714993136e-31 5.511521610893899137e-01 -3.056391961751620659e-33 -1.112553309623048587e-33 5.511521610893899137e-01 -6.742755069106471805e-33 -4.966723939998276002e-32 5.511521610893899137e-01 -3.300678898400899102e-33 3.592269302088208612e-32 5.511521610893899137e-01 -5.343197290349816026e-34 1.147862556285061438e-32 5.511521610893899137e-01 -1.014428611499674110e-34 -1.219030138328765601e-33 5.511521610893899137e-01 -3.960708911661708158e-34 2.336612098669552867e-32 5.511521610893899137e-01 -2.657021517265820582e-35 -2.592374176610800348e-33 5.511521610893899137e-01 -4.964637578933830629e-37 -7.343497010401240768e-33 5.511521610893899137e-01 -5.602262879473437122e-35 6.555183801820643839e-33 5.511521610893899137e-01 1.144644256837599348e-35 8.201728049331568593e-34 5.511521610893899137e-01 1.501456517970947759e-37 -8.876342765771785636e-34 5.511521610893899137e-01 2.299967949213200169e-35 -1.315522384718889510e-33 5.511521610893899137e-01 1.777502719746697959e-36 2.397068745533150407e-32 5.511521610893899137e-01 -3.893670832227394999e-35 -2.985391692556573700e-33 5.511521610893899137e-01 3.627810392433023228e-35 1.460260361624653853e-33 5.511521610893899137e-01 -9.876011570360443886e-36 -3.762822323726171175e-33 5.511521610893899137e-01 -3.585508389890717887e-36 -2.467957188392308838e-33 5.511521610893899137e-01 -9.785480501058832114e-36 3.399461316088347515e-33 5.511521610893899137e-01 -1.646715491978906750e-35 -5.119313660667677494e-33 5.511521610893899137e-01 -1.492508691278042460e-36 5.309232886795139008e-33 5.511521610893899137e-01 4.505965243479946758e-35 7.924389906101558650e-33 5.511521610893899137e-01 8.234655014315482191e-36 1.519290395529507966e-33 5.511521610893899137e-01 3.019172645818915694e-35 -1.316954674429814789e-33 5.511521610893899137e-01 7.225177299326461897e-35 -6.194287405139876844e-34 5.511521610893899137e-01 1.272289193404573278e-35 -6.934621631196062400e-33 5.511521610893899137e-01 3.825409685401640750e-36 -8.511377957091233964e-33 5.511521610893899137e-01 -3.092690764262073980e-36 -2.708426640480811327e-33 5.511521610893899137e-01 -2.122304550573917473e-36 1.635461650469419602e-32 5.511521610893899137e-01 3.130586221767698324e-35 3.801892638184811442e-33 5.511521610893899137e-01 3.650580433319913701e-35 -1.505273556122659470e-32 5.511521610893899137e-01 6.821495601518767542e-35 4.850923037098799644e-33 5.511521610893899137e-01 7.892181242895256510e-35 4.138613390563257201e-35 5.511521610893899137e-01 1.305835635759968825e-34 8.506697469932747659e-33 5.511521610893899137e-01 1.049025502276222194e-34 -1.662640508486751633e-33 5.511521610893899137e-01 1.776058798569596914e-34 3.751386120459172216e-33 5.511521610893899137e-01 7.396871441847253618e-35 1.685611295414068567e-33 5.511521610893899137e-01 1.055902386070095799e-34 -6.588091281964322131e-33 5.511521610893899137e-01 7.654591600740086865e-35 8.959283902301096644e-33 5.511521610893899137e-01 4.040627677919829673e-35 6.097665807270917610e-33 5.511521610893899137e-01 5.576135709521746406e-35 4.810165638519463323e-34 5.511521610893899137e-01 5.909369603729218425e-36 2.044309607502370512e-34 5.511521610893899137e-01 1.255964006754921125e-35 -5.425012652783054140e-34 5.511521610893899137e-01 2.058604076816046383e-36 -1.055754318165421983e-33 5.511521610893899137e-01 -1.859802097249579627e-37 -1.427032489764166980e-35 5.511521610893899137e-01 9.968405903157467455e-37 -3.089706694104596093e-32 6.405276016329735712e-32 5.511521610893899137e-01 9.841555076915215953e-31 -8.201437666347132763e-33 5.511521610893899137e-01 -4.735065036864974871e-31 -5.208848637339613726e-32 5.511521610893899137e-01 -1.072245031109316571e-30 -1.583501934862641190e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.408723100070425514e-31 5.511521610893899137e-01 7.703793087215175515e-32 -5.277347317253431590e-31 5.511521610893899137e-01 -1.225432765866856368e-30 -3.651889032040374884e-31 5.511521610893899137e-01 4.048954469989395565e-31 1.754590390779100660e-32 5.511521610893899137e-01 9.259158617794845230e-31 4.015170100571155841e-32 5.511521610893899137e-01 2.681439315858539969e-31 5.223672466286265499e-32 5.511521610893899137e-01 -7.358412809530782214e-31 9.030697577466043863e-32 5.511521610893899137e-01 3.172372878130401271e-32 -1.774733076728056546e-32 5.511521610893899137e-01 -3.066605061563230693e-32 4.814976627598383718e-33 5.511521610893899137e-01 -4.245847554647640982e-32 -3.895263829568858315e-32 5.511521610893899137e-01 -2.530290086683952901e-31 -4.417911740539690489e-32 5.511521610893899137e-01 1.451746311837644250e-31 -5.496426858212809181e-32 5.511521610893899137e-01 -4.477826413217854899e-31 -2.740068446311986823e-32 5.511521610893899137e-01 -4.653436733850406960e-31 -4.808722941528179449e-34 5.511521610893899137e-01 -4.049507365545422975e-31 -2.799535972660320309e-32 5.511521610893899137e-01 -1.755341795286778428e-31 -9.690644780225330232e-33 5.511521610893899137e-01 6.725940148946867568e-33 -1.337700788758018001e-32 5.511521610893899137e-01 3.558442974227194544e-32 -9.934931716874609360e-33 5.511521610893899137e-01 -2.027527509122277384e-32 -7.168572547508691175e-33 5.511521610893899137e-01 4.969040700605396538e-33 -6.735695679623677796e-33 5.511521610893899137e-01 -5.989755266244782525e-33 -7.030323709639880047e-33 5.511521610893899137e-01 -1.259933869812144593e-32 -6.660823033646368896e-33 5.511521610893899137e-01 -1.021460426195793077e-33 -6.634749282231602523e-33 5.511521610893899137e-01 1.175363941442336983e-33 -6.690275447268445537e-33 5.511521610893899137e-01 5.030889140448438035e-33 -6.622806375905334715e-33 5.511521610893899137e-01 -1.367925418140472112e-34 -6.634102672821913552e-33 5.511521610893899137e-01 6.700390352524380566e-33 -6.611253138981576826e-33 5.511521610893899137e-01 3.117170545009075190e-32 -6.632475315753962829e-33 5.511521610893899137e-01 -1.598212667134254304e-33 -6.673189526795984090e-33 5.511521610893899137e-01 -9.759118898684279460e-34 -6.597974714549378854e-33 5.511521610893899137e-01 -2.069364644492637814e-33 -6.644128830044070885e-33 5.511521610893899137e-01 -3.538542410027737786e-33 -6.637838326863598256e-33 5.511521610893899137e-01 -4.873435510858590279e-33 -6.644038298974767647e-33 5.511521610893899137e-01 -9.054167447995112694e-34 -6.650719973393499081e-33 5.511521610893899137e-01 -7.618061496609576647e-34 -6.635745327164987983e-33 5.511521610893899137e-01 1.454031419757997548e-32 -6.589193166038910672e-33 5.511521610893899137e-01 1.268397333874021806e-32 -6.626018163459394917e-33 5.511521610893899137e-01 -1.386613460702025583e-32 -6.604061092015519181e-33 5.511521610893899137e-01 -1.129936448896030714e-33 -6.562001045480442869e-33 5.511521610893899137e-01 8.976200486547350384e-33 -6.621529926539663824e-33 5.511521610893899137e-01 -9.524898794123405551e-35 -6.630427408788306558e-33 5.511521610893899137e-01 -1.790883860662348888e-33 -6.637345509237973575e-33 5.511521610893899137e-01 -2.568318074600126537e-33 -6.636375123024284444e-33 5.511521610893899137e-01 -8.139444115300032462e-33 -6.602946956256034343e-33 5.511521610893899137e-01 -3.620691122421625000e-32 -6.597747014140510511e-33 5.511521610893899137e-01 3.196069507652787441e-32 -6.566037862458522111e-33 5.511521610893899137e-01 8.699671279390421501e-33 -6.555331006044757403e-33 5.511521610893899137e-01 1.236975068910711962e-33 -6.503669254897710980e-33 5.511521610893899137e-01 -3.809846635976320450e-32 -6.529350268246088145e-33 5.511521610893899137e-01 1.368785193113492206e-33 -6.456646938616747294e-33 5.511521610893899137e-01 2.712269162612777641e-33 -6.560284104055236748e-33 5.511521610893899137e-01 -1.443564609773584029e-33 -6.528662579866700827e-33 5.511521610893899137e-01 -1.875698974822404893e-32 -6.557706902466307432e-33 5.511521610893899137e-01 3.447167426946541175e-32 -6.593846541694511244e-33 5.511521610893899137e-01 3.007322623965728181e-33 -6.578491461378490388e-33 5.511521610893899137e-01 -1.481153287811754469e-33 -6.628343448869980164e-33 5.511521610893899137e-01 1.985611099954181230e-33 -6.621693178406158983e-33 5.511521610893899137e-01 1.013551952675522389e-32 -6.632194214396894022e-33 5.511521610893899137e-01 2.794177620452879432e-33 -6.634438798683434414e-33 5.511521610893899137e-01 -3.879995418785415766e-34 -6.633255977883392709e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 b/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 deleted file mode 100644 index 2290b4200..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton.hess_8 +++ /dev/null @@ -1 +0,0 @@ -1.377894896171173895e-02 6.064202065801056752e-31 -9.312791651478880243e-31 1.373529045637814083e-02 8.251745424238632282e-32 -1.695569550361220638e-30 1.364754549367405007e-02 6.630442007532069422e-32 1.285029956329312743e-30 1.351485477677841739e-02 1.383532944120539956e-31 -2.132847542082290999e-31 1.333592095490489064e-02 1.129721221400153403e-31 2.820532177678916025e-31 1.310899876018755197e-02 -1.104247062184055629e-30 7.701298943846059685e-32 1.283188225830649357e-02 1.273864151648280798e-31 -7.182327950798528679e-32 1.250188961847354015e-02 -1.435320737882880838e-31 3.854755368512528734e-32 1.211584598705594228e-02 1.508262249064671188e-31 -4.012272373923461683e-32 1.167006528972486419e-02 -2.600040316987390054e-31 -5.984043404151288114e-32 1.116033209929854011e-02 -3.756919171809059782e-31 1.901028214577663929e-31 1.058188511495570562e-02 -9.028371174250619079e-32 -1.130991000300852415e-31 9.929404321008859433e-03 3.286825917748208743e-31 -3.066605061563230693e-32 9.197004554564885276e-03 -8.132211801314553973e-32 -1.058363887783171700e-31 8.378239028153430107e-03 5.005036117991814020e-32 2.204809309226182362e-31 7.466117350174453215e-03 7.557031704580501511e-32 1.451746311837644250e-31 6.453143763116044908e-03 1.205095923235210117e-31 -3.530044101103742045e-32 5.331382676045966565e-03 -4.591318890068548846e-33 1.608677541118376665e-32 4.092560064867728671e-03 -3.358769446103082941e-32 -4.498658357529758704e-32 2.728210876118789072e-03 2.359186816329085369e-32 -7.097946384987224498e-33 1.229884061623049210e-03 -1.097111437127075297e-33 6.729800617070860891e-33 -4.088281395843180316e-04 2.455691295423150719e-32 -7.575179878904946086e-32 -2.067461321230328400e-03 -3.405225702143802442e-32 1.471219992993728143e-32 -3.645080634602862208e-03 1.147862556285061438e-32 -3.302133287085399590e-33 -5.106229758309582117e-03 3.019593915466053742e-32 -5.989755266244782525e-33 -6.413757319815078899e-03 -2.155827642017312870e-32 2.376570833403533010e-33 -7.529989691330842352e-03 1.174687468978895498e-32 2.765703730660371860e-32 -8.431078665774657463e-03 6.451089732483615126e-33 1.175363941442336983e-33 -9.215689638962978880e-03 1.988906132087914970e-32 -8.303428571324704753e-33 -9.900421325306668283e-03 8.197575625925496862e-34 2.576436369589415169e-32 -1.047095529356697335e-02 -8.876342765771785636e-34 -5.939629323683147762e-33 -1.083771538307339195e-02 -1.315522384718889510e-33 3.276588202493618830e-33 -1.094235380326372131e-02 -1.269217360213538421e-32 -1.598212667134254304e-33 -1.077789850274134785e-02 -1.509100948912604257e-32 -9.758211811869406914e-34 -1.045341460269087926e-02 1.460440062021556854e-33 2.202630217544366140e-32 -1.005117263897366796e-02 2.259967377911047252e-33 2.484247291609480641e-33 -9.575166733160179675e-03 -2.467957188392308838e-33 -4.873073355779610944e-33 -9.018558709909660007e-03 3.399829423258751042e-33 -9.052326912143095060e-34 -8.299530790594396648e-03 7.220547406051798895e-33 -7.618061496609576647e-34 -7.415760093088870353e-03 5.308454824225208040e-33 2.004170070854155516e-33 -6.386230086580635575e-03 -4.849951535559166044e-33 -1.286147757963710822e-32 -5.264148194509809912e-03 -1.153337882515834041e-32 1.224257923368843603e-32 -4.219785670721612134e-03 1.205648081427424040e-32 -1.128165484784436474e-33 -3.270969974676368568e-03 -7.482567298981486290e-33 -4.750076630387646826e-33 -2.412718568953263303e-03 -6.935607135575740282e-33 -9.524898794123405551e-35 -1.639558706638900550e-03 -1.252830580889936222e-33 -9.050213942090942589e-33 -9.457523472300477822e-04 -2.707319782988025475e-33 1.238311293794984630e-32 -3.214210080383905484e-04 -1.445376082115497785e-32 7.264744547624554477e-33 2.453933344820966966e-04 3.801892638184811442e-33 1.141415715969763644e-32 7.583888134402847793e-04 -2.787049445628177018e-33 -7.482427015187286489e-34 1.220998052689086216e-03 -3.570354852187196805e-33 -2.498403567798886132e-32 1.636506396934066156e-03 4.064239867531846595e-35 7.056499829787031305e-32 2.008015006096743483e-03 8.506697469932747659e-33 -2.460906709311838279e-33 2.338414463972164972e-03 -1.662433342116105311e-33 1.368785193113492206e-33 2.630366811209988373e-03 -5.625925439402529287e-33 2.714011105037866821e-33 2.886294175204549839e-03 -7.138375270547302707e-34 -1.444476861012998059e-33 3.107334782599794221e-03 -2.911933408127329889e-33 -1.875603800754054187e-32 3.292284287410564454e-03 -1.032022836526186273e-33 3.447266290821061273e-32 3.444281461139452136e-03 -4.061516595976628595e-33 2.332594296559100837e-32 3.566376523378684150e-03 -4.671046607573477556e-33 -1.480890420740072724e-33 3.661082164639476930e-03 -2.841474012123277531e-34 1.985611099954181230e-33 3.730388448310034341e-03 -5.424670519797801769e-34 -3.783639632501241327e-34 3.775775759052600166e-03 -1.055754318165421983e-33 -2.494134056632830348e-33 3.798225075990310524e-03 -1.340152645473097119e-33 -3.878602575525100379e-34 6.064202065801056752e-31 5.511521610893899137e-01 7.154332547762007387e-32 8.251745424238632282e-32 5.511521610893899137e-01 -2.159331316179330401e-33 6.630442007532069422e-32 5.511521610893899137e-01 -4.553398224457491757e-32 1.383532944120539956e-31 5.511521610893899137e-01 -1.528168683676282768e-31 1.129721221400153403e-31 5.511521610893899137e-01 -6.335724502694747699e-31 -1.104247062184055629e-30 5.511521610893899137e-01 -5.201272697232694243e-31 1.273864151648280798e-31 5.511521610893899137e-01 -3.583017733814280781e-31 -1.435320737882880838e-31 5.511521610893899137e-01 2.453060719620666870e-32 1.508262249064671188e-31 5.511521610893899137e-01 4.680821707099895665e-32 -2.600040316987390054e-31 5.511521610893899137e-01 5.911338788656846605e-32 -3.756919171809059782e-31 5.511521610893899137e-01 9.748890338359454700e-32 -9.028371174250619079e-32 5.511521610893899137e-01 -1.111489069725870190e-32 3.286825917748208743e-31 5.511521610893899137e-01 1.168381890479818342e-32 -8.132211801314553973e-32 5.511521610893899137e-01 -3.232048393658327839e-32 5.005036117991814020e-32 5.511521610893899137e-01 -3.742888522699395146e-32 7.557031704580501511e-32 5.511521610893899137e-01 -4.835215746690740518e-32 1.205095923235210117e-31 5.511521610893899137e-01 -2.067351790778555836e-32 -4.591318890068548846e-33 5.511521610893899137e-01 6.291746294872912818e-33 -3.358769446103082941e-32 5.511521610893899137e-01 -2.116190652677841877e-32 2.359186816329085369e-32 5.511521610893899137e-01 -2.940881873632561731e-33 -1.097111437127075297e-33 5.511521610893899137e-01 -6.763301249125649717e-33 2.455691295423150719e-32 5.511521610893899137e-01 -3.338050815085652377e-33 -3.405225702143802442e-32 5.511521610893899137e-01 -5.508182671909443971e-34 1.147862556285061438e-32 5.511521610893899137e-01 -1.033941548062041770e-34 3.019593915466053742e-32 5.511521610893899137e-01 -4.053818034089131357e-34 -2.155827642017312870e-32 5.511521610893899137e-01 -2.479122091683935377e-35 1.174687468978895498e-32 5.511521610893899137e-01 1.567842007869389214e-36 6.451089732483615126e-33 5.511521610893899137e-01 -5.803863815059445920e-35 1.988906132087914970e-32 5.511521610893899137e-01 1.190563908891027756e-35 8.197575625925496862e-34 5.511521610893899137e-01 9.472542134826449012e-37 -8.876342765771785636e-34 5.511521610893899137e-01 2.337968131264507603e-35 -1.315522384718889510e-33 5.511521610893899137e-01 1.815972682029053500e-36 -1.269217360213538421e-32 5.511521610893899137e-01 -3.889681105965282385e-35 -1.509100948912604257e-32 5.511521610893899137e-01 3.616566601704140078e-35 1.460440062021556854e-33 5.511521610893899137e-01 -1.012331976023168596e-35 2.259967377911047252e-33 5.511521610893899137e-01 -3.500248697524449140e-36 -2.467957188392308838e-33 5.511521610893899137e-01 -9.952833591698794073e-36 3.399829423258751042e-33 5.511521610893899137e-01 -1.633268419298944113e-35 7.220547406051798895e-33 5.511521610893899137e-01 -1.654258371941290799e-36 5.308454824225208040e-33 5.511521610893899137e-01 4.577296568609118834e-35 -4.849951535559166044e-33 5.511521610893899137e-01 9.743382582360134949e-36 -1.153337882515834041e-32 5.511521610893899137e-01 2.881297282473976975e-35 1.205648081427424040e-32 5.511521610893899137e-01 7.391799770079924616e-35 -7.482567298981486290e-33 5.511521610893899137e-01 1.341238106777642293e-35 -6.935607135575740282e-33 5.511521610893899137e-01 1.914486050150372402e-36 -1.252830580889936222e-33 5.511521610893899137e-01 -3.279769615464451954e-36 -2.707319782988025475e-33 5.511521610893899137e-01 -1.509571332885722117e-36 -1.445376082115497785e-32 5.511521610893899137e-01 3.296509455772354637e-35 3.801892638184811442e-33 5.511521610893899137e-01 3.558986254758442840e-35 -2.787049445628177018e-33 5.511521610893899137e-01 6.848022520939467857e-35 -3.570354852187196805e-33 5.511521610893899137e-01 7.989848297964953764e-35 4.064239867531846595e-35 5.511521610893899137e-01 1.280267621575875899e-34 8.506697469932747659e-33 5.511521610893899137e-01 1.055944472571503066e-34 -1.662433342116105311e-33 5.511521610893899137e-01 1.781931834372424351e-34 -5.625925439402529287e-33 5.511521610893899137e-01 7.279227397930132227e-35 -7.138375270547302707e-34 5.511521610893899137e-01 1.056993928380835180e-34 -2.911933408127329889e-33 5.511521610893899137e-01 7.666197139045511334e-35 -1.032022836526186273e-33 5.511521610893899137e-01 4.012154954288596230e-35 -4.061516595976628595e-33 5.511521610893899137e-01 5.597637315522439038e-35 -4.671046607573477556e-33 5.511521610893899137e-01 5.791675659046291598e-36 -2.841474012123277531e-34 5.511521610893899137e-01 1.256356950367158787e-35 -5.424670519797801769e-34 5.511521610893899137e-01 2.073877430217236620e-36 -1.055754318165421983e-33 5.511521610893899137e-01 -2.049317532704955566e-37 -1.340152645473097119e-33 5.511521610893899137e-01 1.012117222943897197e-36 -9.312791651478880243e-31 6.490907265914636703e-32 5.511521610893899137e-01 -1.695569550361220638e-30 -8.793584134653039289e-33 5.511521610893899137e-01 1.285029956329312743e-30 -5.216823506304862988e-32 5.511521610893899137e-01 -2.132847542082290999e-31 -1.594511211861019946e-31 5.511521610893899137e-01 2.820532177678916025e-31 -6.402067030879484877e-31 5.511521610893899137e-01 7.701298943846059685e-32 -5.267615225417431421e-31 5.511521610893899137e-01 -7.182327950798528679e-32 -3.649360261999017959e-31 5.511521610893899137e-01 3.854755368512528734e-32 1.789635437773295913e-32 5.511521610893899137e-01 -4.012272373923461683e-32 4.017396425252524434e-32 5.511521610893899137e-01 -5.984043404151288114e-32 5.247913506809474827e-32 5.511521610893899137e-01 1.901028214577663929e-31 9.085465056512081826e-32 5.511521610893899137e-01 -1.130991000300852415e-31 -1.774914351573241010e-32 5.511521610893899137e-01 -3.066605061563230693e-32 5.049566086324475904e-33 5.511521610893899137e-01 -1.058363887783171700e-31 -3.895473675505698522e-32 5.511521610893899137e-01 2.204809309226182362e-31 -4.406313804546765830e-32 5.511521610893899137e-01 1.451746311837644250e-31 -5.498641028538110106e-32 5.511521610893899137e-01 -3.530044101103742045e-32 -2.730777072625926520e-32 5.511521610893899137e-01 1.608677541118376665e-32 -3.425065236007956003e-34 5.511521610893899137e-01 -4.498658357529758704e-32 -2.779615934525213382e-32 5.511521610893899137e-01 -7.097946384987224498e-33 -9.575134692106270961e-33 5.511521610893899137e-01 6.729800617070860891e-33 -1.339755406759935792e-32 5.511521610893899137e-01 -7.575179878904946086e-32 -9.972303633559363318e-33 5.511521610893899137e-01 1.471219992993728143e-32 -7.185071085664653970e-33 5.511521610893899137e-01 -3.302133287085399590e-33 -6.737646973279914947e-33 5.511521610893899137e-01 -5.989755266244782525e-33 -7.039634621882622195e-33 5.511521610893899137e-01 2.376570833403533010e-33 -6.659044039390549718e-33 5.511521610893899137e-01 2.765703730660371860e-32 -6.632684976465839693e-33 5.511521610893899137e-01 1.175363941442336983e-33 -6.692291456624305668e-33 5.511521610893899137e-01 -8.303428571324704753e-33 -6.622347179384800096e-33 5.511521610893899137e-01 2.576436369589415169e-32 -6.633305564260227942e-33 5.511521610893899137e-01 -5.939629323683147762e-33 -6.610873137161064149e-33 5.511521610893899137e-01 3.276588202493618830e-33 -6.632436845791680282e-33 5.511521610893899137e-01 -1.598212667134254304e-33 -6.673149629533362824e-33 5.511521610893899137e-01 -9.758211811869406914e-34 -6.598087152456667215e-33 5.511521610893899137e-01 2.202630217544366140e-32 -6.644376138233942017e-33 5.511521610893899137e-01 2.484247291609480641e-33 -6.637753067171231735e-33 5.511521610893899137e-01 -4.873073355779610944e-33 -6.644205652065407136e-33 5.511521610893899137e-01 -9.052326912143095060e-34 -6.650585502666699955e-33 5.511521610893899137e-01 -7.618061496609576647e-34 -6.635907076845651856e-33 5.511521610893899137e-01 2.004170070854155516e-33 -6.588479852787619416e-33 5.511521610893899137e-01 -1.286147757963710822e-32 -6.624509435891349943e-33 5.511521610893899137e-01 1.224257923368843603e-32 -6.605439845648968424e-33 5.511521610893899137e-01 -1.128165484784436474e-33 -6.560334820772907601e-33 5.511521610893899137e-01 -4.750076630387646826e-33 -6.620840437405932634e-33 5.511521610893899137e-01 -9.524898794123405551e-35 -6.632338332423557793e-33 5.511521610893899137e-01 -9.050213942090942589e-33 -6.637532588089175775e-33 5.511521610893899137e-01 1.238311293794984630e-32 -6.635762389806596474e-33 5.511521610893899137e-01 7.264744547624554477e-33 -6.601287723915988079e-33 5.511521610893899137e-01 1.141415715969763644e-32 -6.598662955926125433e-33 5.511521610893899137e-01 -7.482427015187286489e-34 -6.565772593264315782e-33 5.511521610893899137e-01 -2.498403567798886132e-32 -6.554354335494060773e-33 5.511521610893899137e-01 7.056499829787031305e-32 -6.506226056316120850e-33 5.511521610893899137e-01 -2.460906709311838279e-33 -6.528658371216559844e-33 5.511521610893899137e-01 1.368785193113492206e-33 -6.456059635036464230e-33 5.511521610893899137e-01 2.714011105037866821e-33 -6.561460544494408636e-33 5.511521610893899137e-01 -1.444476861012998059e-33 -6.528553425635626996e-33 5.511521610893899137e-01 -1.875603800754054187e-32 -6.557590847083253765e-33 5.511521610893899137e-01 3.447266290821061273e-32 -6.594131268930824140e-33 5.511521610893899137e-01 2.332594296559100837e-32 -6.578276445318483846e-33 5.511521610893899137e-01 -1.480890420740072724e-33 -6.628461142814663070e-33 5.511521610893899137e-01 1.985611099954181230e-33 -6.621689248970037044e-33 5.511521610893899137e-01 -3.783639632501241327e-34 -6.632178941043492402e-33 5.511521610893899137e-01 -2.494134056632830348e-33 -6.634457750226980122e-33 5.511521610893899137e-01 -3.878602575525100379e-34 -6.633240701250765205e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener deleted file mode 100644 index 5fbefa515..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_0.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0661889008629074 -1 0.06647426016589354 -2 0.06697529215458661 -3 0.06769811048795421 -4 0.06865095284555046 -5 0.0698441545296568 -6 0.0712896123110296 -7 0.07300053792853292 -8 0.07499091120412098 -9 0.07727457573045982 -10 0.07986372993682027 -11 0.08276812093386218 -12 0.08599403010358495 -13 0.08954283840867194 -14 0.0934077973105164 -15 0.0975689208050062 -16 0.10199296029576237 -17 0.10663216503150544 -18 0.11142119975426476 -19 0.11627461504577619 -20 0.12108786698078905 -21 0.1257378776241308 -22 0.1300908657049122 -23 0.13405415055035094 -24 0.1375589084791528 -25 0.14054231608873866 -26 0.1429482501200824 -27 0.1447223736309907 -28 0.14581586041606556 -29 0.1461908979866841 -30 0.1458301542309095 -31 0.144787161074781 -32 0.1431509369239614 -33 0.14101759501455666 -34 0.1384864587589631 -35 0.135626607994573 -36 0.1324514769541923 -37 0.12897473945082955 -38 0.12521695630565963 -39 0.12120480594414136 -40 0.116992128264772 -41 0.11266843732548826 -42 0.10831567410704121 -43 0.10400353147677228 -44 0.09978860060153923 -45 0.09571660359025486 -46 0.09182368377574611 -47 0.08813725627969593 -48 0.08467277684336257 -49 0.08143820591821531 -50 0.07843817455899511 -51 0.07567447560855317 -52 0.07314611396405668 -53 0.07084997089325819 -54 0.06878171554530715 -55 0.06693636289825045 -56 0.06530836420926438 -57 0.06389196591851017 -58 0.06268155332674624 -59 0.06167185804744343 -60 0.06085809723238098 -61 0.06023613794123961 -62 0.05980268828196377 -63 0.05955516525759201 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz deleted file mode 100644 index f2d1a60b5..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.0695824750319134 -1.321091930945525e-16 4.6101616180197894e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.070917385620739 -1.9934935200041934e-16 -2.0481048764097164e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.073249939096383 -8.415275802989294e-17 -8.456720969152282e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0765906565452283 -3.5153537611166056e-17 -1.753421624541595e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.080952866624804 -6.665776359005689e-17 -9.92558767112015e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.0863532959256665 -4.0436545379531215e-17 -8.314368389892507e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.09281067305525 -1.7003874017972766e-17 -1.0591991704419853e-16 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.1003460942601073 -8.663254172978196e-18 -8.952302167191084e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.108982531926027 8.686959315558785e-18 -4.8336169607493295e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.118743413792699 1.2745224647980062e-17 -4.799677406836546e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.129649427524559 2.2668686296751706e-17 -4.8570263871007197e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.1417191772339454 2.0509143252621473e-17 -6.403035533497795e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.154969628863613 6.077867451706769e-17 -7.423276291226134e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.169415521127418 1.298535453207906e-17 -6.451426516722831e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.185063964358866 2.819156995135487e-17 -3.974959798032766e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.201911701494095 8.585775685847163e-17 3.045943637090697e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.2199504134198094 5.0240929036071634e-17 -2.988375355040894e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.239166193896984 1.0738593622452807e-16 -2.5369230966807917e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.2595342198647255 1.4436800705362121e-16 5.276445880251723e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.281013578211365 1.312447406915148e-16 1.0023226164593702e-16 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.303554533220748 6.429223795301395e-17 1.0523558707746308e-16 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.3271021703471417 5.966095837696054e-17 7.992359253402385e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.351591699338289 3.4922720718198633e-17 4.264157703220939e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.3769389717097305 1.911840503101732e-17 2.303056189182704e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.403050568927475 1.3072241409110677e-17 1.400621581024728e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.4298271623108074 4.789744044909626e-18 1.0594743883740396e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.457163387219769 7.22671222457911e-18 5.715650063986625e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.4849427892851907 2.8370112660284305e-18 4.041684243245267e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.513042384206452 7.851886055775445e-18 -8.400715471120835e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.541337114612673 7.338351623716453e-18 -3.514009487563341e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.569701892597987 3.9507572980053295e-18 -2.957310062870981e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.5980141841579845 2.1416871205201262e-18 -2.1371518184508387e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.626155557806009 -7.272423299783032e-18 -5.560432615556654e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.6540103904537737 -6.61786122740746e-18 -2.4401329465963064e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.681466192359639 -1.0761856636790291e-17 -1.4141278823410162e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.708420883533942 -2.7918601529734327e-18 -2.2551959734068473e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.734784344966453 -2.0933469540621586e-18 -1.6527634672725395e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.7604721823776264 5.876032616701535e-19 -1.6203711032979904e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7854062775364117 4.1932568623054767e-19 -4.999605624524417e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.80951890510272 -4.304902704323426e-18 3.6725333135503016e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.8327584737140246 -1.4556374065439704e-18 5.301049741753215e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.855081284731687 -7.952227041180378e-18 5.665439279558301e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.876450568407593 -1.0073811879829654e-18 3.1468731680026815e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.896838003120462 -3.917306117769094e-18 2.4765153191642078e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9162283670006377 1.0345630060001847e-18 -1.3213692026538376e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9346113737881425 -1.2042347780042088e-18 -1.6090422978900795e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9519796523222266 3.295729090839009e-19 -2.3656970731006255e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.968327773623951 1.828103864311354e-18 -1.963690218050901e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.983658515751084 -4.448053636917232e-19 1.7385643197693848e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 2.9979786438425 6.015174847061272e-18 1.41953145755536e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0112950313501243 -2.065441054131125e-18 2.0370043291356116e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.023615193065709 5.472471524447925e-18 1.3123213503683292e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0349494121015907 -3.809043454134746e-18 -7.446445094627161e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0453099568395836 5.253822277176958e-18 -2.4615914754261227e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0547089300977954 -4.062078553462646e-18 1.9075253747497964e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.0631574181550847 4.118426017717481e-18 -1.2323472033685116e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.0706665358949365 -3.593007805825208e-18 5.719864452506733e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.0772470534828558 1.8376832847303266e-18 -1.5305019290526255e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.082908879239535 -2.936985718639248e-18 -5.035551910619007e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.0876609824032335 1.5142254358496714e-18 -9.821046681780307e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.0915114721982144 -4.610038050889887e-19 -7.333802130010478e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.094467409429444 1.0856141503767438e-18 -1.288480926814136e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.0965343488289987 -1.3222642609112827e-18 4.813672015693527e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.09771729893857 1.1878160987894626e-19 8.545668624862993e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener deleted file mode 100644 index 5a85746ed..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_1.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.049212276192543675 -1 0.0493727740424248 -2 0.04967605629579452 -3 0.0501311047606533 -4 0.050750961829094804 -5 0.051552840547655784 -6 0.05255806778082637 -7 0.053792082293934486 -8 0.0552842580055289 -9 0.057067465581002126 -10 0.059177189019982424 -11 0.06165058265050006 -12 0.06452507446730768 -13 0.06783632467406664 -14 0.07161500148547112 -15 0.07588303366119621 -16 0.08065024324998213 -17 0.08591001391422491 -18 0.09163408572481874 -19 0.09776229283744474 -20 0.1041918990781323 -21 0.11078045669258897 -22 0.11734425291354399 -23 0.12365755236622873 -24 0.1294607903434953 -25 0.13455939493408156 -26 0.13884495015502188 -27 0.14222452221725151 -28 0.1446141094172517 -29 0.14593480440316134 -30 0.14612686239506376 -31 0.14520222178767364 -32 0.14330660426831154 -33 0.14061604296363822 -34 0.13730812359076108 -35 0.13346666988099654 -36 0.12909879510449512 -37 0.12422238622896949 -38 0.11887570366914746 -39 0.11318925978679491 -40 0.10733318171379257 -41 0.10145332506158518 -42 0.09567019042282474 -43 0.09007981266960467 -44 0.08475090343114401 -45 0.07972188634446903 -46 0.0750168274028329 -47 0.07065001052294281 -48 0.06662690386606146 -49 0.06294615895305478 -50 0.059601413896843966 -51 0.056582476305207074 -52 0.05387525712261223 -53 0.051461227986673894 -54 0.049322341796792554 -55 0.04744218379244872 -56 0.045805899717679906 -57 0.04440024144305188 -58 0.04321360868371972 -59 0.0422360409612827 -60 0.041459191285774175 -61 0.040876320907218266 -62 0.04048231642601388 -63 0.04027358936215093 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz deleted file mode 100644 index eee9865bc..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_1.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9747998182935025 2.3413452595916256e-18 1.9236610799633632e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.975960856358668 -2.0879806668123462e-17 4.7043319375347046e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.978128189061158 -5.4917171884487776e-17 -3.542573416048433e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.981318446828468 -3.664762989360992e-17 3.443985104657598e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9855545482718417 8.045137495581667e-18 -1.8340871724780148e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9908659092173828 -3.556555278265181e-19 5.33868512769177e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9972876498176761 2.2556592221353193e-17 5.2535216800269096e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.0048605559242043 1.7556845395523136e-17 -1.0400487827842166e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.013630519321497 -1.6374107627191435e-17 -1.1006227494455923e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.0236473866407367 3.7742717048168865e-18 -2.3808553091679628e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0349627645276955 1.4971313775839925e-17 -2.305573639135014e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.0476294094927368 7.936353650144929e-18 -3.6492687448230546e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.061700207115946 3.023145076949245e-17 -2.7500438533356724e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.0772262877414436 3.7438955869523425e-17 -2.4610748639638392e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.094252401245818 7.412362684820381e-17 2.2078690852435755e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.112813153653018 1.3399428066034368e-16 6.133091777017182e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.1329334154878707 8.228348584474181e-17 5.793095405547348e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.1546261971338665 2.851954494392917e-17 5.288276272848316e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.1778883377508853 1.0682773691268094e-16 2.0425531302350915e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.202696467442651 2.3294267075304505e-16 -1.9937415430715226e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.2290092461801163 2.3077058529100733e-16 1.1347268398344582e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.2567686685924575 1.460966251913758e-16 1.1834013243736439e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2858983695596407 7.826858891291837e-17 5.313013153224716e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.316300321267139 4.0139566199035594e-17 3.492887125255356e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.347860104613817 2.835888981171186e-17 2.9546401651094027e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.3804487457948778 2.2573535490438847e-17 6.3781554653107745e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.413923134773627 2.0669859305469454e-17 3.67631065172657e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.4481238798908325 1.0279676057098725e-17 2.394990422652913e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.4828790823780036 4.521960616013313e-18 -2.0581140618700734e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.518009345042883 2.2429118403966965e-18 -3.766521061882187e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.5533319921357442 3.714050534621025e-18 -1.0283868142392317e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.5886659751498478 8.22059253082117e-18 -1.2868179785107676e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.6238353425351666 1.8029507024234053e-18 -2.532035496868189e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.6586700855176786 -4.2743695835194354e-18 -3.94023132625152e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.6930076163543184 -1.2321506019883392e-17 -1.0906852839154659e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.7266974077497994 -4.959502884786761e-18 -2.106264772755008e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.7596030549167905 1.1611387533964197e-18 -8.088990820207083e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.791601136637689 4.5955213600736825e-18 1.8291953724380552e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.8225829680268535 5.531091322099494e-19 3.1791936324490246e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.8524575897500566 -8.494322511837476e-18 4.5252366370157864e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.881155087269166 -3.078681797506936e-18 -1.807039095304326e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.9086221035504827 -2.2289527148546533e-18 4.705547259923817e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.9348194256204785 3.54359574991542e-18 9.01108365428819e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.959720678451936 -9.566970436270318e-19 4.099396596601949e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.983312851734609 -8.330291345894043e-20 -2.4719213244582227e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 3.005591125329148 -8.420091698287096e-19 -2.226143104163662e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.026556777191456 -8.182704485774988e-19 -1.5149528885274374e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.046215712114616 5.290312807109392e-19 -2.1448476575558015e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0645805725764044 -2.1849514582032866e-18 2.645381499375215e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0816679915133562 5.473483423857046e-18 -2.7054198116554523e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0974961232950764 -8.801982948533646e-19 3.7755042389793954e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.1120843574943637 5.408081391591355e-18 -1.5499356091026515e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.125453862266544 -4.812448761136174e-18 1.3759188579104977e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1376268007103323 2.1664784883982008e-18 -3.799195398756738e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.1486249513795403 -3.491694156208152e-18 1.986978603031939e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1584690002809204 4.183809634475182e-18 -2.2696586596742585e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.167178781827028 -1.722221691912002e-18 1.212071111035693e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.174772879858774 1.934238302287272e-18 -1.600521731083773e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.181268197605641 -2.6459534504195567e-18 -1.9490419769903468e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1866797711799695 9.024797110283616e-19 -3.260234755536654e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1910206870321804 -3.003335576927157e-19 1.6537809569243012e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.194301897533666 7.084791016239853e-19 -2.892029494920417e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1965319308186526 -6.568423616884774e-19 4.218309064572069e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1977172989385703 2.041165007056945e-19 3.9102099430650353e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener deleted file mode 100644 index 4f23c0046..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_2.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.047915165445753465 -1 0.04802231351691342 -2 0.048239719461782744 -3 0.04857359109038855 -4 0.049033311488364366 -5 0.04963154230555014 -6 0.050384340402776485 -7 0.051311268786300504 -8 0.052435475555697775 -9 0.05378370520437249 -10 0.055386195179487493 -11 0.05727639680489201 -12 0.0594904455746757 -13 0.06206629026694555 -14 0.0650423753741142 -15 0.06845575305892444 -16 0.07233945913039769 -17 0.07671901401468893 -18 0.0816079443211183 -19 0.08700228487145303 -20 0.09287423442674834 -21 0.09915875532610371 -22 0.10574351235340454 -23 0.11246981896117804 -24 0.11913059360211073 -25 0.12547100728346633 -26 0.13121172893889496 -27 0.13617795168389776 -28 0.1402539718077934 -29 0.14333885382495576 -30 0.14533785432318114 -31 0.14616982718314578 -32 0.14578902132130592 -33 0.14428923094501506 -34 0.14185657791087153 -35 0.13869008110148298 -36 0.134941346543859 -37 0.13063373635553316 -38 0.1257833346636765 -39 0.12042219536906727 -40 0.11465716422975336 -41 0.10867396151296281 -42 0.1026372456157865 -43 0.09668288482253863 -44 0.09091912095272867 -45 0.0854257968016882 -46 0.08024828555399126 -47 0.07541378572647194 -48 0.07093818140076627 -49 0.06682800809037619 -50 0.0630822986922996 -51 0.05969427060379134 -52 0.056652831989178296 -53 0.05394301735753944 -54 0.051545513954305 -55 0.04944156947339861 -56 0.04761421591555752 -57 0.046048332504746284 -58 0.04473068132966597 -59 0.043649923607138014 -60 0.04279662300754023 -61 0.04216324119762606 -62 0.04174412965490374 -63 0.041535520841955234 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz deleted file mode 100644 index ad3c2b1cb..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_2.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9650132679969041 -1.027236473519677e-17 -9.69477580597205e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9658515958024922 -1.1629165275975635e-17 -4.922760317699093e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.967534841132966 -1.3756823493947977e-17 -5.926727309443253e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9700757519587975 -5.556146655316031e-17 -3.927718963015162e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.973493213557263 -7.580400487008263e-17 -8.546491321322492e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.977812201969367 -8.699329086965011e-17 -6.477453000556222e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9830637040052395 -6.748869966946929e-17 -5.0556680685806e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9892845899205776 -1.7510152462594275e-17 -1.046030331119537e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9965174233235843 -2.812415030282433e-17 2.047996806959193e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.0048101874625672 5.339633478649469e-18 8.171212430132518e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0142159007819123 -1.1464068905633786e-17 6.67604788088329e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.0247920860887367 -3.3482646729339375e-17 -4.709732875022879e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.036600056988615 -5.72805324135138e-17 -3.6084565197956685e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.0497039788018565 -3.827140930259664e-17 -3.3978980459807274e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0641696532154734 -1.5718293890837777e-17 -3.4785164027707723e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.0800629370695853 -1.5957759434596076e-17 -2.1910911233590822e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0974475411792692 7.595901689357475e-18 -3.524981885173811e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.116382064732366 2.72805788657125e-17 -2.3377178984354452e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.1369161084716124 1.2389246873642163e-17 -2.476612490768133e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.159085237912167 1.4930237293291557e-17 -1.4912973947975367e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1829058617995534 3.391737679052517e-18 -1.1407041218305458e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.2083720310075656 5.529880581304536e-18 -1.942968273117341e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2354530299111173 4.708064471677194e-18 -1.133069899923335e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2640918877702085 3.628015467615387e-18 -1.2445503635326376e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.294205778690126 2.1242570679962214e-18 -3.088664319660688e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.325688583006839 9.650562165422795e-19 -1.43177955654866e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3584129714025956 3.731346684832844e-19 -4.2901125350651685e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.392231073786434 7.842829073112183e-19 -1.675526087106893e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.426974757485298 3.607230549812257e-19 -1.2615457891709938e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4624568580652424 -7.652202747082546e-19 -1.63249126385454e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4984759515244073 -1.395022120638157e-18 -1.5074181086141033e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.5348227978200537 -1.7323521230324066e-18 -6.266845284245738e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5712888729031746 -1.3268865228142278e-18 -2.4575245876928464e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.6076702505373506 9.839232491590123e-20 -1.0664047419270732e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.6437703234060304 1.8112062959192348e-18 -2.8432929249766787e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6794021202127105 2.022296537243831e-18 -2.7394262214239845e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.71438987639957 1.1533145734731116e-18 -3.594047199342841e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.7485727100990425 -1.4274852510393468e-20 -2.340872079886466e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7818080776901253 -8.777825404214683e-19 -1.3954765361613596e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.8139744306958527 -1.2692742986861906e-18 -1.7756856349594444e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.8449726869292506 -1.1136582487972903e-18 4.896650380928023e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8747251541795853 -4.704371250968053e-19 -1.1470326333763167e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.90317291752343 -5.364748402383727e-19 5.815460893402686e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.930273232977083 -6.497947454557528e-19 -8.534575704694247e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.955997084368415 -7.002779053804548e-19 2.919407278444437e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.980326957220312 -4.351138875497886e-19 -5.02703159995171e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 3.0032548859985413 2.5504485583094813e-22 -8.192721279917134e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 3.024780720017808 5.739209914474032e-19 -4.86923915793121e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.044910581332539 8.206412058102072e-19 -1.6829667386892113e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.06365550747457 3.365392879078636e-19 5.074552031352709e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.081030256568861 -7.878472771334817e-20 -1.3181929772080142e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.097052256665566 -6.00572278933951e-19 2.3779544130001417e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.111740688661126 -8.219130754820186e-19 1.4029057957464382e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.1251156816792283 -1.0597546396341848e-18 2.6991475490634047e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.137197590141381 -2.890805767445367e-19 -3.8108916270328837e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.148006383366377 2.3019405686521205e-19 1.6520454553963294e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1575611432179076 2.1354148004543236e-19 -7.578499780267394e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.16587965566705 2.405391141606282e-19 3.2214775547068836e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1729780825291383 6.491842917699723e-19 -1.3740971105475293e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1788707009092145 4.880758975582393e-19 -3.4494286115983707e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1835696996208727 2.6512381195549234e-19 -1.1407351242836571e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.18708502351656 2.077536522276986e-19 -2.250246840904706e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1894242581456305 -1.525101016235837e-19 4.775697337160917e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1905925486021225 -7.21047028132917e-19 4.428198138859339e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener deleted file mode 100644 index a84bd3ad9..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_3.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.047635908894093054 -1 0.047736658930441475 -2 0.047940966348182706 -3 0.048254478149858324 -4 0.04868574357260001 -5 0.049246299382256956 -6 0.04995076690253158 -7 0.050816944832442625 -8 0.051865875874096856 -9 0.05312185787640378 -10 0.054612361481113945 -11 0.056367806151610536 -12 0.058421135263512176 -13 0.060807119223252895 -14 0.06356130449337603 -15 0.06671851773466381 -16 0.07031083087588776 -17 0.07436489874757661 -18 0.07889860095054747 -19 0.08391695992141349 -20 0.08940731511096373 -21 0.095332107673981 -22 0.101613619044304 -23 0.10813167536592573 -24 0.11472245344322811 -25 0.12117654707403866 -26 0.12724002241909602 -27 0.1326656507692956 -28 0.1373160706576441 -29 0.14108452461342894 -30 0.1438770092004632 -31 0.1456035703665189 -32 0.14619092368373748 -33 0.14561017563640133 -34 0.14397768037281183 -35 0.14147439678842552 -36 0.13829089398224598 -37 0.13455763180714708 -38 0.13029331393519364 -39 0.12551807150539487 -40 0.12026757024434293 -41 0.11465011902507723 -42 0.10884234623099907 -43 0.1029990587591007 -44 0.0972474606142983 -45 0.09168845452857409 -46 0.08639727236948326 -47 0.08141769099262364 -48 0.07677477429976638 -49 0.07248301187526605 -50 0.06854823449180729 -51 0.0649693795034727 -52 0.06174009754549972 -53 0.05885017744163621 -54 0.05628677955537999 -55 0.054034733493071134 -56 0.05207709731954445 -57 0.050398330669674495 -58 0.04898478374525714 -59 0.04782473558511518 -60 0.04690841406250522 -61 0.046228003937556855 -62 0.04577764789727002 -63 0.045553444301691885 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz deleted file mode 100644 index 72921e371..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_3.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9627999281414616 5.615666700743669e-18 -7.802698369529588e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9636033023206545 1.5631917922237036e-17 -3.5457764159104476e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9652156744583082 2.3135711135276877e-17 -2.908611619611816e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9676482692761101 2.1015556645079148e-17 -1.6293010205487683e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9709178745614298 5.264482388067828e-17 -2.4224867804184815e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9750467779119738 3.9764496981714424e-17 -2.239581594383687e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9800626707357945 2.6836147913233013e-17 -1.3452193008536546e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9859985093443238 6.113780007669188e-18 -3.0047957261304e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9928923200142923 1.7497876008183134e-17 -1.506032625542496e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.000786931616427 3.4223903242204847e-17 -2.964891655861859e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0097296158161195 4.503572926744883e-17 -3.541718869957726e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.019771610900813 2.480314109708142e-17 -4.0048418682697444e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0309675012097457 2.6005339674697617e-17 -4.182420433961385e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.043374419784329 1.6949426484700302e-17 -1.8044552934180284e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.057051037410491 1.5841557990729574e-17 -2.641422062326616e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.0720562966919926 1.0334126593527581e-17 -3.395549031073205e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.088447845963114 2.5109082217226552e-17 -2.161455039230948e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.10628012530331 2.625167014033862e-17 -5.158080107740414e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.125602055315431 4.076629767143062e-17 5.84362280576552e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.146454278053514 4.3193217971089304e-17 5.519632826307303e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1688656564057935 2.741686143348235e-17 7.560159924238478e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.192848608889898 1.181487879034784e-17 6.85959824003222e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2183950705385933 7.396757967977502e-18 2.9362410165355818e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2454742009314272 5.470917796575176e-18 -8.159672496524388e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.2740308428880067 7.19458899661785e-18 4.92673085055146e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.3039849162205006 -1.4634150309778754e-19 3.0342402578471095e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.335232531136875 -1.5066209032132934e-18 2.511319598937541e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.3676487944647193 -4.474024344559759e-18 -2.5689740806138534e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.401089321673525 1.1871163331441292e-18 -3.0892342979165742e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4353910948375144 3.927162490401126e-18 -3.645187667030783e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.470373418636353 1.909977579405276e-18 -2.9629148064070795e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.5058413756347697 5.110630872084528e-19 -1.0947366000092544e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.541591882407717 -3.2584898743361756e-18 -1.6747351392518235e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.5774213685598757 1.8398283990652606e-18 1.065871168625251e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.6131306344897287 -1.0904472208626752e-18 -6.954737597111917e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6485274926989413 7.125549320577437e-19 1.8337477648230484e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.683428475515728 -4.0524855431092898e-19 2.6465594795725192e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.717660527150706 1.2818655262485988e-18 -3.8297385308453583e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7510647209411916 2.066204177466895e-18 -1.3604078123000448e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.783499830062095 -2.5323639924527423e-18 -1.2181012883237012e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.8148465102208258 7.000553213216148e-19 2.819398627291298e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.845008945597195 -2.208252670923779e-18 3.9567079456696047e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.8739123782714886 2.6596430373372376e-18 2.8876181301389232e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.9015003828514594 -1.6690054277732773e-18 -9.4367419832238e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9277322612068843 4.040390429549002e-19 3.7618949274070425e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.952580573656623 -7.47173805446551e-19 -5.54547974486856e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.976028822493278 -1.6148921133437665e-19 -6.919257596163026e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.998069559473256 2.6929088856901298e-18 1.452422041239706e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0187027342820625 -1.7093620428203487e-18 9.237444753942063e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0379342077254545 2.2613186790724866e-18 3.7645809106935985e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.055774426656581 -4.709642589244995e-18 -1.0758640321438875e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0722372536606155 2.4095746657481957e-18 1.874656641636463e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.087338941630731 -3.323285900934374e-18 -4.140687038240485e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.101097264133858 4.943232690277298e-18 1.0201937998787694e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.113530804537935 -2.1733641078259865e-18 -1.1203428766215571e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.124658238323579 1.9211680989809644e-18 2.8452966989972284e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.134497714814392 -3.5475170164822086e-18 -1.4935515521127142e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.143066356534775 1.5944491405118208e-18 5.348207466252733e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1503798577082947 -6.831153260411624e-19 -1.3356915953181697e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1564521658541627 1.362003297347536e-18 7.423528537219815e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.161295232807656 -9.60049011021391e-19 -1.7317499257869902e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.164918823770258 2.9150528435514447e-19 1.7486105210360682e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1673303751628734 -2.2129296097256366e-19 -1.5710555680452162e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1685348940912927 1.3715065825250453e-19 2.1483667757638298e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener deleted file mode 100644 index 1984839bc..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_4.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04718852646213532 -1 0.047283160956172146 -2 0.04747511085420086 -3 0.04776977222179043 -4 0.04817532181699391 -5 0.048702807749296195 -6 0.049366255340950724 -7 0.05018277372745354 -8 0.05117264315183499 -9 0.05235935607724003 -10 0.05376957702399705 -11 0.05543297641806465 -12 0.0573818829113346 -13 0.05965068711633906 -14 0.06227491847629948 -15 0.06528990770908924 -16 0.06872894243048229 -17 0.0726208267543743 -18 0.07698677168847542 -19 0.08183657801729873 -20 0.08716413405331548 -21 0.09294206740748163 -22 0.09910890618412568 -23 0.10556009621595032 -24 0.11214892032667909 -25 0.11868411890989643 -26 0.1249297209467017 -27 0.13062086061936332 -28 0.135582035058129 -29 0.13970273151662863 -30 0.14288650458207605 -31 0.14504373842671953 -32 0.14609427346508827 -33 0.14598358456335261 -34 0.14476500856408567 -35 0.14260685330748896 -36 0.13969591304956003 -37 0.13620454668076543 -38 0.1321842062167212 -39 0.12764912184641014 -40 0.12262792998593118 -41 0.11718419552185473 -42 0.11147942830232825 -43 0.1056789135155068 -44 0.09992039979763345 -45 0.0943148745135693 -46 0.08894827611828168 -47 0.08387811232739326 -48 0.07913543918746634 -49 0.07473893706476613 -50 0.07069792536693773 -51 0.06701418041650571 -52 0.06368360931825462 -53 0.060697753863787604 -54 0.05804511314512036 -55 0.055712246510686576 -56 0.0536837711960523 -57 0.051943918084662845 -58 0.05047870977730197 -59 0.04927612126902506 -60 0.04832611164129625 -61 0.04762064094372308 -62 0.04715367769874584 -63 0.04692120114181102 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz deleted file mode 100644 index 8ccf5405c..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_4.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9591623897087491 2.070134595143028e-18 -6.783760938766883e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9599417509336194 1.5657871252664371e-18 -7.40912264689174e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.96150599254328 2.649335438522403e-18 -1.2560155795064998e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9638661371677213 4.27565993671242e-18 -5.388788981756545e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.967038677202195 7.401396410287035e-18 -6.887649545389201e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9710455184310463 5.224496278926808e-18 -1.1654374798988975e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9759138938407643 5.547843945403008e-18 -1.1894908566735771e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.981676237819601 2.0088448187928323e-18 -1.073606321281065e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.988370008046551 6.306272069412626e-18 -8.567391431742155e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9960374392078217 4.170387035260211e-18 -4.290004338645201e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.004725209214497 4.291772126818076e-18 2.385083727871297e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.0144839948322617 8.313034338403398e-18 9.742121691392556e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.025367889603238 1.3320577380955647e-17 1.3983843714884325e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.0374336527222745 8.175636905851956e-18 1.0896885535579161e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.050739753279555 1.3032647267658943e-17 2.6470260596752186e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.0653451702368053 2.7775635598627867e-18 1.0878461595797976e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0813079050346377 -6.496414834018879e-18 1.0921062166316429e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.098683161334266 -1.9292284308612504e-17 4.647423249378435e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.117521145803438 -1.685634833150637e-17 4.737451252291701e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1378644460045604 -1.2390799560837449e-17 -2.4809363991027904e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.159744947529074 -4.896826835741241e-18 -4.500756595315238e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.1831802365350215 -2.84984795398319e-18 -2.795721454616494e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2081691534984906 -1.921449511774351e-18 -1.8688730986320665e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2346887854848823 -3.642543202173335e-19 -1.0003429249525633e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.2626928171563434 -6.028137458323294e-19 -1.3792288783795987e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.2921106890576133 9.668263066562822e-19 -5.365580164859738e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.322847764984687 1.5344569997899088e-19 -9.840334175992458e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.3547868322334535 9.732191014961078e-19 2.306202689523431e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.387790905613603 -2.3784745551563042e-20 -2.094329168817619e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.421704637705814 -2.3200171578979375e-19 -5.489898439244999e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.456355886292428 -2.407158432039951e-19 -3.195871263255272e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.491557636479438 -1.3248215336109345e-18 -5.339278512798408e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5271123722753113 -1.9787540708548694e-19 4.146618048738028e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.562817935706392 -1.0441478069224949e-18 -7.879366834690151e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.598474256401861 7.68543442429244e-19 -4.970616645056197e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6338872879275166 -1.083795443859572e-19 -7.763724889080983e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.668871475681362 1.0495466337728284e-19 5.00131964233327e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.7032517080925986 1.0020421915087044e-21 1.1186574316191638e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.736865321333763 -1.5372039177542188e-19 7.071745194078075e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7695655118629543 1.2379173373589056e-18 7.063144903159402e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.801224258680319 -1.6792148689602195e-19 -7.955353390905458e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.831735012212891 9.301170204693042e-19 4.047240060712058e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.8610132120529315 -1.1135558607642494e-18 -3.970977002219774e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8889937559728893 -7.51979331251582e-20 6.833437605083813e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9156283589471013 -7.887792725835566e-19 -2.467763755253983e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.940883057096827 7.420338528205208e-20 -5.49193801066067e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9647358875990797 6.737963799975154e-19 -5.579571452709694e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.987174756287578 -3.7536693144354833e-19 -4.90229849295237e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.0081956454717558 6.196062671159742e-19 1.010771075958298e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.027801057127224 -1.2167075646167704e-18 -4.9261404432017096e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0459986188884542 1.577466411785048e-18 9.78359929333458e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.062799847258894 -7.946468116502053e-19 -8.023100636470702e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0782190596156394 1.2933669270871441e-18 4.727962327033744e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0922724246231175 -1.693294412970421e-18 -8.441487634997011e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.104977143938317 7.220789580341456e-19 3.610071324180944e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1163507608169834 -8.24222751011127e-19 -6.211882397052009e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.12641055072195 9.327036456363698e-19 4.374508912433152e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.135172975630471 -6.7651400495527e-19 -2.60141522429332e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1426532383943475 3.6614387332279455e-19 4.164695698805335e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1488649278701555 -3.1668225657813854e-19 -6.368054093416723e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.153819740337267 3.6657845904974868e-19 1.5372418993555608e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.157527265087609 -4.602067317279346e-20 5.955629206820233e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.159994824330749 1.798197357343166e-20 -4.14579951653377e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.161227359702318 -6.554049029427552e-20 -1.1761102323255732e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener deleted file mode 100644 index caa49a382..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_5.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.047036854765933556 -1 0.04712900790101059 -2 0.047315930542456676 -3 0.0476028898307433 -4 0.047997869685386794 -5 0.04851166259751311 -6 0.04915797781803408 -7 0.04995355222838543 -8 0.050918244845668405 -9 0.05207508936003967 -10 0.05345027118229685 -11 0.05507298616288022 -12 0.0569751275905025 -13 0.05919073674965188 -14 0.06175514111536677 -15 0.06470369471440168 -16 0.06807002963436441 -17 0.07188372949569241 -18 0.0761673494842717 -19 0.08093273905728887 -20 0.08617667944375318 -21 0.09187587020690466 -22 0.09797612894449244 -23 0.10438049481285447 -24 0.11095040890210024 -25 0.11750346019655901 -26 0.12381277704619206 -27 0.12961471829131488 -28 0.13471194133926062 -29 0.1389906438288615 -30 0.14235280546648552 -31 0.1447094850599291 -32 0.14597828453910686 -33 0.14609855818334724 -34 0.14509266838326926 -35 0.14311679012306955 -36 0.14035470358888175 -37 0.13698820383232263 -38 0.1330950671307344 -39 0.12868831059937463 -40 0.12379390210321599 -41 0.11846088739219184 -42 0.11283150314354558 -43 0.1070750673236984 -44 0.10133404517523462 -45 0.09572409113342542 -46 0.09033565698980993 -47 0.08523311836794935 -48 0.08045177478094767 -49 0.07601245157361881 -50 0.07192630503415656 -51 0.06819665462749051 -52 0.06482068009588983 -53 0.061790953751580564 -54 0.05909679467706789 -55 0.05672544347371355 -56 0.05466271320439372 -57 0.05289320471183739 -58 0.05140282968680471 -59 0.050179456032365045 -60 0.04921294562019397 -61 0.04849517579438169 -62 0.04802005029660842 -63 0.047783503910963754 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz deleted file mode 100644 index 86d6d7209..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_5.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9579016196103356 1.9061681691180945e-18 -4.429263672163551e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9586693800630925 9.236287765412034e-18 -5.894202949517587e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9602103505813253 6.414121357685495e-18 -3.242634139832782e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9625354159063504 1.0538689384431185e-18 -4.119747017369274e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9656608647109681 1.8330881035885337e-18 -9.914472816614703e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9696083371705981 6.948885083516049e-18 -7.217414171911495e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.97440474437409 4.572250982324322e-18 -6.2797750605372646e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9800821500581967 3.45523003086403e-18 -1.3808282286374264e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9866776023342545 -1.8962804285780227e-18 -1.2465895521431162e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9942328999926282 -1.8716183419198823e-18 5.43475830759884e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0027942745895326 1.4055548571304785e-18 9.876766033570556e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.012411965840516 1.2081179993556865e-18 2.6747347678271915e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0231396638921497 1.850379308993011e-18 7.38709429055637e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.035033787892219 2.413443762450223e-18 8.206420580080375e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.048152566073836 6.978045199711779e-18 2.913355951021742e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.062554878535755 9.612997932721302e-18 8.422060714036835e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0782988203951884 8.272994870065851e-18 7.085410910580019e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0954399405101456 5.829277844705627e-18 6.561772401992629e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.1140291102138513 1.3734003861532918e-18 1.0315532680630012e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1341099783954602 4.762844467970076e-18 1.3629911668069608e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1557159749894486 5.437042480656109e-18 6.553779945197074e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.1788668359306556 3.0752497883457786e-18 2.8441943413378477e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2035645793494307 1.2238234554997648e-18 5.721625276266621e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.229789992371192 5.135502732562802e-19 2.7434462711898953e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.257500839442421 1.0983998253699747e-18 -5.0186618951263285e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.2866309102739657 4.828755110817989e-19 -5.101342536101578e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3170900349991457 9.587958752488802e-19 -4.551209335414568e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.3487652341322893 2.3215195735623688e-21 -1.323974143173429e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.3815231597338884 6.139111203801745e-19 -4.0463899326435914e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4152120473454475 5.394040489766463e-19 -4.571253565152978e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.449663236757119 2.0630158953819175e-19 -3.034119481431522e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4846932597853146 -3.31978525464747e-20 -1.5037657706164457e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5201074101394667 -9.858593055536743e-19 1.7106435017246197e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.555705271726889 1.1678372459113928e-19 4.564450595796579e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.591286844063972 -2.944444015281836e-19 -3.529784755159539e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.626657540619206 6.85179124814894e-19 -5.313182419613488e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.66163080618566 -9.245280282850101e-20 -2.3522830249114407e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.696030347654437 1.2546670431874163e-19 1.6684727217366112e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7296920199656576 4.694242302963509e-19 3.4414607201511627e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.762466727128341 3.4593335592561516e-19 4.89072781216662e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.7942234312141343 7.697789035573366e-19 -4.94778371378389e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8248513924493666 -6.458613793038746e-19 -1.5728278231965856e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.854261542060634 2.378822289433945e-19 -7.160443110529563e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8823847528288686 -6.224231367072708e-19 2.355974231319551e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.909169192439375 3.7176731787946437e-19 -3.0705202771249276e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9345778074528672 -2.809499953671749e-19 1.2399665482896128e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9585859834386703 2.090724713636861e-20 9.194715388403889e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9811794021343614 1.9168903632537383e-19 -2.042568591124577e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 3.002352143090754 -3.5726657945829336e-19 -4.352713589832338e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0221050845855286 5.402523046309122e-19 -2.1093295320455642e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0404444802240986 -4.992189225456046e-19 1.243713330573259e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.05738069334046 1.066171311909805e-18 -3.580588586493431e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0729270815007035 -7.391901245212495e-19 3.0903456362466613e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.087099021210521 6.482583804228898e-19 -1.5139554108725306e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.099913061714251 -9.80685033443872e-19 -3.0171770703061235e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1113861963360527 6.670425371609362e-19 -2.2833392370223716e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.121535245294919 -6.281693158081014e-19 2.1600999218439759e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1303763215184026 5.834331410351728e-19 7.271653504769241e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.137924365449716 -4.755754249422687e-19 8.716144125332354e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.144192771989401 2.9360502745278936e-19 -1.2053473395263049e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.149193097011349 -2.2299214678317457e-19 1.1613723140089775e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1529348310353877 2.3762954993171736e-19 -1.4241430848595206e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.155425229934803 -6.566991541911426e-20 1.2085685013997288e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.156669194747217 -5.461125389136238e-22 -3.1104405605022144e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener deleted file mode 100644 index e02e5d375..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_6.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.04693910738858697 -1 0.04702980456583738 -2 0.04721378114324349 -3 0.047496236149067006 -4 0.04788505188615871 -5 0.048390886643731375 -6 0.049027284553195195 -7 0.04981078927928397 -8 0.05076104303212698 -9 0.051900845974555625 -10 0.05325614332999277 -11 0.0548558983281081 -12 0.05673179869928445 -13 0.058917733174138856 -14 0.06144896321853982 -15 0.06436090549595162 -16 0.06768743456102094 -17 0.0714586163225178 -18 0.07569779531578565 -19 0.08041798845364473 -20 0.0856175913478734 -21 0.09127546878457823 -22 0.09734126485078005 -23 0.10372214926914533 -24 0.11028378600873942 -25 0.1168482676905463 -26 0.1231932662941457 -27 0.12905698275767444 -28 0.1342298517128384 -29 0.13859503984688984 -30 0.14205339733960604 -31 0.14451604283399902 -32 0.14589946756435343 -33 0.14614055258610756 -34 0.14524679948428623 -35 0.143366245376424 -36 0.14068134036882401 -37 0.13737678259985578 -38 0.13354505983282428 -39 0.1291997293147799 -40 0.12436544553922278 -41 0.11908620949231671 -42 0.11349294779449233 -43 0.1077565678390871 -44 0.10202209593826703 -45 0.09640768491548528 -46 0.09100612688308532 -47 0.08588494968779788 -48 0.08108204125881675 -49 0.07661932604473261 -50 0.07250888910228245 -51 0.0687548199003612 -52 0.0653549236989942 -53 0.06230227046440701 -54 0.059586566577641775 -55 0.057195346925673636 -56 0.05511483131692187 -57 0.05332995526609639 -58 0.0518265643965543 -59 0.05059245897813065 -60 0.049617440637068785 -61 0.048893336120786966 -62 0.04841400988906687 -63 0.04817536992595923 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz deleted file mode 100644 index a7ecdf5e5..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_6.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9570812373194448 3.4613998125189112e-18 2.7569970655419043e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9578426571265128 5.641312302922459e-18 -8.639118321937047e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.959370913686764 3.0363227196505125e-18 -1.3791760913524557e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.96167682715805 3.761014146766771e-18 -3.2599330918637953e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.9647765912510777 2.6350467923621485e-18 -3.410845604165115e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9686917232051742 3.747910229164567e-18 -2.280962388146549e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9734489865884228 2.934832414924557e-19 -4.26634485998336e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9790802775663097 1.7143211691380835e-18 -3.4335483817050715e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9856224625109657 -5.805213526974288e-19 -4.580902186768157e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.993117151784829 -2.8827692391488186e-18 -3.4597063951901553e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.001610391196647 -4.6164543411878645e-18 -3.470312281081654e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.0111522489912974 -2.245300019369533e-18 -1.2941067318404066e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.021796272321911 -3.984065126395423e-18 -1.7256126871142437e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.0335987830331232 -5.9741061095624735e-18 -1.0957432233051892e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0466179783964202 -1.4060557706871595e-18 -1.1014032872449696e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.0609127983994746 -2.8220124883946853e-18 -2.0556464579657143e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.076541517644615 7.733777915892759e-20 -3.553867491188848e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.093560017341825 1.6207185380534471e-18 -4.569901837850818e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.112019691967707 3.6403359674448875e-18 -4.266397913289836e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1319649468024684 5.496707726977625e-18 -1.5459564542601485e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1534302479166163 4.1289337473667774e-18 8.736587099996707e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.1764366966794237 2.443491691602077e-18 -3.055098961424749e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.2009881098366715 1.1449722559888372e-18 -3.6418634790138536e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2270673627144797 4.971643553439287e-19 -3.8783937647586044e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.254634456798141 5.568840902533679e-19 -9.975513339989968e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.283625496143147 3.789734413963083e-19 -2.923970748221835e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3139526113377813 3.939113650491096e-19 1.7819229063500376e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.345505001302656 2.817131210797504e-20 -1.2483238024697495e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.378151188444916 1.0149812832337465e-19 1.2987361626195926e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4117411600672436 1.3468250823667386e-19 1.324606693001994e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4461078734445723 1.2932618429225422e-19 1.2699329380899498e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4810693381889166 1.4106346156819812e-19 3.159296387774661e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.516431945160656 -1.7536011267159122e-19 -1.0615519771067498e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.551995833853758 -2.2554345134429535e-20 1.411134985540963e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.5875608830388437 -1.7305661938966297e-19 -2.9489952346896916e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6229319671022213 1.2295518070333714e-19 -6.524094257958254e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.6579217620954987 5.69159786327443e-20 -1.918814321765516e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.6923529998543083 7.527783238820891e-20 -6.685787892949857e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7260604398034323 4.421125355248132e-20 2.0748331592498523e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7588935365277623 -1.4133533790042903e-19 -1.3769533583622606e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.7907194837433695 8.470574435904066e-20 2.1782413614092067e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.821425503709742 -7.133798828723469e-20 -1.0524735169828038e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.850920230829894 1.6829324999843436e-19 2.210525323325204e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8791324867785155 -1.6266636563477185e-19 -2.1046300299295986e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.906008642436634 -3.2587839633490265e-20 8.399028328520588e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.931510088341715 -9.935198919415627e-20 -9.787309897059742e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.955610877027743 -2.6618533165392198e-20 -3.297340751362329e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.978295565243762 6.607015330341073e-20 -1.0587938975691151e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9995572849847876 -7.672756342019721e-20 -2.873928612209421e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.019396111296506 1.9919619053666685e-19 1.9539815016664438e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.037817622782657 -1.1754534909696447e-19 -2.213897559031275e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.0548316204469166 2.0732676516955801e-19 3.954677797519834e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.07045099750202 -2.0161074861931864e-19 -2.3692067984317944e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0846907504602603 1.564595013088054e-19 3.245609280486287e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.097567120515525 -1.7455686147516119e-19 -2.860929615362772e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.1090968537001777 1.3733492790560464e-19 2.571447505517765e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1192965685834397 -1.2692590729804976e-19 -1.98221903047547e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1281822196936773 1.2111016584959142e-19 1.798108910238904e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1357686298979393 -5.419754090004404e-20 -1.4461922865961387e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.142069108403626 4.9340771466658974e-20 6.963662744266813e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1470951499852076 -5.446893206820623e-20 -1.2091966777226828e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1508562028522267 1.7652615054588938e-20 5.188389475084607e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1533594948926074 -8.215723139761796e-21 1.0541554084006846e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.1546099102411356 1.1743560519040893e-20 2.9762549237258776e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener deleted file mode 100644 index 2500df79b..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_7.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.046892856495516666 -1 0.046982837939309005 -2 0.047165365471269594 -3 0.04744560302999105 -4 0.047831380497831574 -5 0.04833328679943668 -6 0.048964780496905405 -7 0.049742304778124906 -8 0.05068538859593769 -9 0.051816709378514694 -10 0.05316208504162121 -11 0.05475035394450371 -12 0.05661309107464164 -13 0.058784097536286176 -14 0.06129858918781147 -15 0.06419200044821873 -16 0.06749831309270628 -17 0.0712478204964421 -18 0.0754642496458234 -19 0.08016119191035755 -20 0.08533784567085377 -21 0.09097414882467499 -22 0.09702162652488346 -23 0.1033895766196234 -24 0.10994581487520075 -25 0.11651474370418288 -26 0.12287638323024674 -27 0.12877028427973788 -28 0.13398088556707574 -29 0.13838948382953603 -30 0.1418963620724326 -31 0.14441264078366234 -32 0.1458543400846629 -33 0.14615723518902515 -34 0.14532173446256647 -35 0.14349102880392256 -36 0.14084682250493796 -37 0.1375747876803251 -38 0.1337750799815571 -39 0.12946196017531197 -40 0.12465941554690191 -41 0.11940930658670187 -42 0.11383633778859738 -43 0.10811190162229885 -44 0.10238230505455916 -45 0.09676695991912386 -46 0.0913598456347534 -47 0.08623001697449988 -48 0.0814168247104995 -49 0.07694276862594737 -50 0.0728204172619373 -51 0.06905426428547713 -52 0.06564244649996731 -53 0.06257830068259038 -54 0.05985174375919278 -55 0.05745047335995536 -56 0.05536089797915914 -57 0.053568176567279184 -58 0.05205813490274401 -59 0.050818541516791056 -60 0.04983916959518793 -61 0.04911182190049014 -62 0.04863034421783403 -63 0.04839063176652785 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz deleted file mode 100644 index 631c22a0b..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_7.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9566908547471318 1.3270148201500092e-18 -1.3658261339670626e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.957449038142771 -1.5279056755579428e-19 -1.8980182626182348e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9589708042761471 -2.2257753379654846e-19 -1.6469712142104544e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9612669384759813 -1.2598659764499453e-18 -1.2817918745317667e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.964353583176818 -1.3462573176986951e-18 1.333542352728821e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.968252189112954 -2.094385825212704e-18 6.9992985166327795e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.972989439838959 -1.226062754408062e-18 -1.8284408258882989e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9785971403051106 -1.5028791101875017e-18 -3.2024243569837923e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.985112057467045 -2.0679266408338403e-18 -8.818672903492848e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.9925756978943763 -2.6272911108753343e-18 -2.8186669228508543e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0010340040313586 -2.0617627400151947e-18 9.053793162589453e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.0105369471498165 -1.067030245779205e-18 6.295038814467923e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0211379911435214 -2.7783399054658263e-19 -1.8421985795063552e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.0328933972111667 -5.000145413524618e-19 1.284733982472238e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0458613352979396 -8.831365859871112e-20 -9.241452918357839e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.06010076412527 5.599991675407429e-19 1.656378393724355e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0756700380727575 1.1881515713627643e-19 1.0374729568680148e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0926251965615386 -4.780907328754561e-19 -9.853860338101394e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.111017890593853 -5.001479027584727e-19 4.522208001386865e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1308929026150905 -7.239353060840805e-19 5.377856590143728e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1522852210331793 -8.085742267683841e-19 -7.863386600348849e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.1752166409618394 -7.18368789414544e-19 -2.833789840704206e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.199691878951898 -5.437793929010782e-19 -1.4910359537454398e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2256948650663633 -3.7658829406267235e-19 -6.87298308264175e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.253186733943231 -1.6630000773385772e-19 -4.438476408145894e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.282104764506107 1.0383064947861717e-19 -1.5351720668345353e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3123622569749633 1.8727897178887516e-19 -2.959257671190708e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.3438495191159325 1.545794643804289e-19 2.054137690077618e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.376436054026389 3.277091755101114e-20 1.13113686996481e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.409972762302373 -1.0407886939290028e-19 1.550726258402408e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4442934485507495 -5.501013830039914e-20 8.488511833744991e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4792168800365006 1.2288501202090663e-19 -8.32632099445811e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.514550015490968 2.2362129090260996e-19 2.1421119053851698e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.5500932844380015 1.4017802873180892e-19 -6.309153037492794e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.58564654198128 -2.2684284674630273e-21 2.758113230281882e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.621014416899657 -1.0213818861670205e-19 -7.133164384951394e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.6560092215325186 -5.877241218094842e-20 1.0987073814104286e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.6904532157843857 5.475243669575857e-20 3.2350085492278005e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.724180596962584 1.4207466159004384e-19 -1.755305161762538e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7570400849729735 7.31949969097352e-20 1.327137098166742e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.788897972989133 -1.0982793155180968e-19 -2.716361342631266e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8196404519699647 -1.806361870145589e-19 1.1566729586680891e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.8491750273679655 -1.0657362317347546e-19 -2.387985212952573e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8774294962210876 9.52033126585427e-20 1.8470553761824525e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.904349331308226 1.5065823742800477e-19 -1.9661693998391334e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.92989514495213 3.90765327608637e-20 -7.447634146999935e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9540403225814837 -1.1503087669390111e-19 -1.242450908554121e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.976768855301224 -1.7626402180437e-19 -2.063609059227559e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.9980733985953716 -1.171233794899945e-19 1.31078530376537e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0179536228771986 -1.7872855954159816e-20 -2.418193598078979e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0364147660399157 9.728931316087653e-20 2.2548657622086383e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.05346634461535 1.042206704839422e-19 -4.442031316486179e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.069121016318706 6.092089588416818e-20 2.565109679207636e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.083393584400338 -5.0828775279216396e-20 -3.4511888433616e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.096300132876587 -5.2512887698873054e-20 3.861560850034923e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.107857281151254 -1.8218512730271168e-20 -1.9584802225719488e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.118081546569734 2.163266715682127e-20 2.1296159691566633e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1269888031072175 2.0678440778340384e-20 -2.3650116900554497e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1345938136673186 3.8457002353436175e-20 1.4133423717535013e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1409098436947183 2.4296982115559543e-20 -8.857012671706477e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1459483567186157 5.4653214611257706e-21 1.0430370721501559e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.1497187792833 -1.1399642539869383e-20 -4.8755956170048943e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1522283249293204 -1.5075363976053877e-20 3.5997819363002793e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.153481869117152 -1.0794290931167938e-20 -2.516565386940169e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener deleted file mode 100644 index b9f1d6719..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_8.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0468675862599136 -1 0.04695718403016402 -2 0.04713893499638353 -3 0.04741798470122928 -4 0.047802135560618735 -5 0.04830194018370214 -6 0.04893081238110813 -7 0.04970514286594315 -8 0.050644401548013994 -9 0.051771202023001936 -10 0.05311129620966222 -11 0.05469345803989541 -12 0.05654920478537778 -13 0.05871229341582533 -14 0.06121791814977299 -15 0.0641015254862787 -16 0.06739715669094927 -17 0.07113522813838814 -18 0.07533967143336269 -19 0.08002438340353833 -20 0.08518898746585474 -21 0.09081398541841777 -22 0.09685188039493388 -23 0.10321309743973481 -24 0.10976657529697155 -25 0.11633791766763717 -26 0.12270836098740698 -27 0.12861822480753152 -28 0.13384882831041867 -29 0.13828036194236445 -30 0.1418127967438358 -31 0.1443572267707269 -32 0.1458294352457013 -33 0.14616463312868416 -34 0.14535968397161714 -35 0.14355507472074472 -36 0.14093213364843651 -37 0.1376769436640077 -38 0.13389365055365746 -39 0.1295970066095933 -40 0.12481065365439488 -41 0.11957546273717595 -42 0.11401288156719806 -43 0.10829448161877818 -44 0.10256724734521462 -45 0.09695125420077028 -46 0.09154110548516632 -47 0.08640662522590538 -48 0.08158794796378174 -49 0.07710787751879086 -50 0.07297923349859223 -51 0.06920671872246592 -52 0.06578864085574675 -53 0.06271847352390512 -54 0.05998624102713974 -55 0.05757972341514071 -56 0.05548541601328643 -57 0.053688595647025265 -58 0.052175081004713 -59 0.05093262316019239 -60 0.049950979727129065 -61 0.04922194037713555 -62 0.04873934072494175 -63 0.048499069047973055 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz deleted file mode 100644 index 68ce56e03..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9564769528235888 -4.081266917441785e-20 2.7908590995563204e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9572334263205735 5.793139237674196e-19 2.4185003162589166e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.958751763695091 -1.1359567387731722e-19 3.155591492681714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9610427325580506 4.263983379745125e-19 5.047032241637723e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.964122449291171 -3.0677902327976046e-19 -4.650172702221773e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9680123308996569 -7.45538526892937e-20 -6.970257247008592e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9727390204616129 -3.808551907426885e-19 -1.0826990762924036e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9783342769467933 -3.0348861952035195e-19 -1.2358742897106272e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9848348174402097 -4.584095695768042e-19 -9.271971209596813e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.992282096803991 -1.5086226825266906e-19 -6.183559315633063e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0007220065116598 -6.156031683827155e-19 -4.634132022778111e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.010204470788343 -1.0480581203642447e-18 4.266881407114594e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0207829143103897 -1.3140177167600518e-18 7.245521823821627e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.032513571624667 -5.258368060764154e-19 9.405987362224346e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0454546042753683 -5.640551456381032e-19 1.6491301631013408e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.059664987584168 4.983155605782578e-19 -3.4250313702765564e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0752031254526586 4.67436026454736e-19 -2.845095461161012e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0921251489161405 9.110050220091565e-19 -6.180607952836432e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.110482853138887 6.3557012491399515e-19 -5.077314010018871e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1303212289824893 3.306162067628708e-19 -8.972585851203428e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1516755503443252 3.06529810397258e-19 1.0230296390897176e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.174567988550856 3.1634112764565127e-20 3.211158236815306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.1990037421619237 7.938725892671158e-20 4.764275669257918e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2249673020424345 -6.359958136967343e-20 -1.3487347900221808e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.2524204022209573 4.0368983843111056e-20 4.247511852849374e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.2813009397482813 -8.223640698136658e-20 -2.385478682073356e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3115228265771175 7.151344222945072e-20 2.265934918916512e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.342976946334549 -2.2465718725286376e-20 -6.026096826208427e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.3755333115441912 1.365798958746426e-19 -1.0922892997824771e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4090432941993125 1.5421807062298458e-20 -7.603164867851816e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4433411330757084 1.2263465489498636e-19 -1.4644186229431397e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4782459771560252 -1.3111974826278987e-20 -5.459195156603685e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5135650638013027 8.593769432463794e-20 1.8351203506167365e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.5490989536591657 -1.376732419270732e-20 -1.17665121469279e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.5846474722769193 6.89376852033929e-20 4.485389457303741e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6200151047052884 -2.974868320905954e-20 -7.041753229592538e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.6550139581737247 1.7207084550365028e-20 8.204738077442038e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.689466031649674 -5.0994329962374406e-20 -1.3743625254957537e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7232052107021776 -1.915821745618279e-20 9.992582484315834e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7560798156790374 -3.508406739959154e-20 -1.232616938052844e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.7879556560926417 -2.6694536815958284e-21 -1.3907961273724353e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8187183738450803 1.0055554470722832e-21 -1.6001873827387636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.848274886621655 1.2119052308771354e-20 1.1243050791743687e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8765524574110763 1.2822923481728442e-20 3.1870319452721283e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9034960916674586 -1.1583124770536357e-20 2.3594503082335707e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9290659974092295 -7.968957792852064e-21 1.5564002084628535e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9532352140127287 -3.729091858099146e-21 -1.6708185489246323e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9759874394174197 -1.5155235662274669e-21 -2.0160886778735562e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.997315082213753 1.2243512419222811e-20 -7.785392353887547e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0172176036086396 3.3528726826537933e-21 3.079652244187743e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0357000656683986 8.646308670597711e-21 9.952897799961877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.052771838413057 -9.995445386668589e-21 -7.35603676816985e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0684454585289456 8.897607318654096e-21 -2.2618389133440714e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0827356301736373 -1.7577403791920215e-20 -2.6072419043289368e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0956583569753633 9.135256775001372e-21 1.7420561007689692e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.107230193751229 -7.915614285908413e-21 8.11223834059773e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1174676064867515 1.0705356297191669e-20 5.7106549073573374e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1263864287271423 -4.738709226491207e-21 -1.3325369170643531e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1340013932700996 8.819486705005479e-21 -5.913187693657786e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1403257436809935 -5.116068399802934e-21 -6.03541893106877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1453709279398856 4.66690879611828e-21 1.4256347447713127e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.149146361861662 -4.713953894693887e-21 -5.082605521005283e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1516592519153455 -2.4143343021733654e-21 4.162980272149272e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.15291446930372 1.702097554911546e-22 4.571800149560974e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 deleted file mode 100644 index b7c4a075c..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL.hess_8 +++ /dev/null @@ -1 +0,0 @@ -1.378510022033408410e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.374149649158943470e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.365386164323188767e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.352133750286003099e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.334262841121765589e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.311599136371373493e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.283922326557654890e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.250964570367895864e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.212408781770814986e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.167886809118204652e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.116977619527808295e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.059205642513455330e-02 0.000000000000000000e+00 0.000000000000000000e+00 9.940394789238792342e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.208912470912980139e-03 0.000000000000000000e+00 0.000000000000000000e+00 8.391169197007053437e-03 0.000000000000000000e+00 0.000000000000000000e+00 7.480181041022698069e-03 0.000000000000000000e+00 0.000000000000000000e+00 6.468458364070799396e-03 0.000000000000000000e+00 0.000000000000000000e+00 5.348070950090709139e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.110748886856484957e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.748029305969009600e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.251460587409648079e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.856572806540479320e-04 0.000000000000000000e+00 0.000000000000000000e+00 -2.045253061764250313e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.624265238991826107e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.087272944572949693e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.397147251201249635e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.516221353232781580e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.419755849999087730e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.205605456844467155e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.891765945738735868e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.046411621116077016e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.083438326205651663e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094271005320850837e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.078186079621248905e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.045852056796305746e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.005739908480898434e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.582470944891540929e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.027644602088387427e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.311261768819506665e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.429950574283877666e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.402668266896000340e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.280878871200076624e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.235299504634637557e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.285322439935869226e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.425974145285831121e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.651787645496867810e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.570280415647277467e-04 0.000000000000000000e+00 0.000000000000000000e+00 -3.319806470703911411e-04 0.000000000000000000e+00 0.000000000000000000e+00 2.354599461292655738e-04 0.000000000000000000e+00 0.000000000000000000e+00 7.490319701981655587e-04 0.000000000000000000e+00 0.000000000000000000e+00 1.212168733365171988e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.628156766571992042e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.000098758112630465e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.330887030369986276e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.623185465408864325e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.879418048553359158e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.100817716734189863e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.286142250638482767e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.438452727564343669e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.560803084098245266e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.655709148902988939e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.725163518119613271e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.770648486958304985e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.793146312772643566e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -3.761581922631320025e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -1.504632769052528010e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.513898307157584031e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.394689268473244043e-33 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.770847460736376046e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.197344634236622022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.385423730368188023e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener deleted file mode 100644 index b9f1d6719..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.ener +++ /dev/null @@ -1,65 +0,0 @@ -#Bead Energy (eV) -0 0.0468675862599136 -1 0.04695718403016402 -2 0.04713893499638353 -3 0.04741798470122928 -4 0.047802135560618735 -5 0.04830194018370214 -6 0.04893081238110813 -7 0.04970514286594315 -8 0.050644401548013994 -9 0.051771202023001936 -10 0.05311129620966222 -11 0.05469345803989541 -12 0.05654920478537778 -13 0.05871229341582533 -14 0.06121791814977299 -15 0.0641015254862787 -16 0.06739715669094927 -17 0.07113522813838814 -18 0.07533967143336269 -19 0.08002438340353833 -20 0.08518898746585474 -21 0.09081398541841777 -22 0.09685188039493388 -23 0.10321309743973481 -24 0.10976657529697155 -25 0.11633791766763717 -26 0.12270836098740698 -27 0.12861822480753152 -28 0.13384882831041867 -29 0.13828036194236445 -30 0.1418127967438358 -31 0.1443572267707269 -32 0.1458294352457013 -33 0.14616463312868416 -34 0.14535968397161714 -35 0.14355507472074472 -36 0.14093213364843651 -37 0.1376769436640077 -38 0.13389365055365746 -39 0.1295970066095933 -40 0.12481065365439488 -41 0.11957546273717595 -42 0.11401288156719806 -43 0.10829448161877818 -44 0.10256724734521462 -45 0.09695125420077028 -46 0.09154110548516632 -47 0.08640662522590538 -48 0.08158794796378174 -49 0.07710787751879086 -50 0.07297923349859223 -51 0.06920671872246592 -52 0.06578864085574675 -53 0.06271847352390512 -54 0.05998624102713974 -55 0.05757972341514071 -56 0.05548541601328643 -57 0.053688595647025265 -58 0.052175081004713 -59 0.05093262316019239 -60 0.049950979727129065 -61 0.04922194037713555 -62 0.04873934072494175 -63 0.048499069047973055 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz deleted file mode 100644 index 68ce56e03..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9564769528235888 -4.081266917441785e-20 2.7908590995563204e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9572334263205735 5.793139237674196e-19 2.4185003162589166e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.958751763695091 -1.1359567387731722e-19 3.155591492681714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 1.9610427325580506 4.263983379745125e-19 5.047032241637723e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 1.964122449291171 -3.0677902327976046e-19 -4.650172702221773e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 1.9680123308996569 -7.45538526892937e-20 -6.970257247008592e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 1.9727390204616129 -3.808551907426885e-19 -1.0826990762924036e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 1.9783342769467933 -3.0348861952035195e-19 -1.2358742897106272e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 1.9848348174402097 -4.584095695768042e-19 -9.271971209596813e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 1.992282096803991 -1.5086226825266906e-19 -6.183559315633063e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.0007220065116598 -6.156031683827155e-19 -4.634132022778111e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.010204470788343 -1.0480581203642447e-18 4.266881407114594e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.0207829143103897 -1.3140177167600518e-18 7.245521823821627e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.032513571624667 -5.258368060764154e-19 9.405987362224346e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.0454546042753683 -5.640551456381032e-19 1.6491301631013408e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.059664987584168 4.983155605782578e-19 -3.4250313702765564e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H 2.0752031254526586 4.67436026454736e-19 -2.845095461161012e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H 2.0921251489161405 9.110050220091565e-19 -6.180607952836432e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H 2.110482853138887 6.3557012491399515e-19 -5.077314010018871e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H 2.1303212289824893 3.306162067628708e-19 -8.972585851203428e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H 2.1516755503443252 3.06529810397258e-19 1.0230296390897176e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H 2.174567988550856 3.1634112764565127e-20 3.211158236815306e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H 2.1990037421619237 7.938725892671158e-20 4.764275669257918e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H 2.2249673020424345 -6.359958136967343e-20 -1.3487347900221808e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H 2.2524204022209573 4.0368983843111056e-20 4.247511852849374e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H 2.2813009397482813 -8.223640698136658e-20 -2.385478682073356e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H 2.3115228265771175 7.151344222945072e-20 2.265934918916512e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H 2.342976946334549 -2.2465718725286376e-20 -6.026096826208427e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H 2.3755333115441912 1.365798958746426e-19 -1.0922892997824771e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H 2.4090432941993125 1.5421807062298458e-20 -7.603164867851816e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 2.4433411330757084 1.2263465489498636e-19 -1.4644186229431397e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 2.4782459771560252 -1.3111974826278987e-20 -5.459195156603685e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 2.5135650638013027 8.593769432463794e-20 1.8351203506167365e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 2.5490989536591657 -1.376732419270732e-20 -1.17665121469279e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 2.5846474722769193 6.89376852033929e-20 4.485389457303741e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 2.6200151047052884 -2.974868320905954e-20 -7.041753229592538e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 2.6550139581737247 1.7207084550365028e-20 8.204738077442038e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 2.689466031649674 -5.0994329962374406e-20 -1.3743625254957537e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 2.7232052107021776 -1.915821745618279e-20 9.992582484315834e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 2.7560798156790374 -3.508406739959154e-20 -1.232616938052844e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 2.7879556560926417 -2.6694536815958284e-21 -1.3907961273724353e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 2.8187183738450803 1.0055554470722832e-21 -1.6001873827387636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 2.848274886621655 1.2119052308771354e-20 1.1243050791743687e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 2.8765524574110763 1.2822923481728442e-20 3.1870319452721283e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 2.9034960916674586 -1.1583124770536357e-20 2.3594503082335707e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 2.9290659974092295 -7.968957792852064e-21 1.5564002084628535e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 2.9532352140127287 -3.729091858099146e-21 -1.6708185489246323e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 2.9759874394174197 -1.5155235662274669e-21 -2.0160886778735562e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 2.997315082213753 1.2243512419222811e-20 -7.785392353887547e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 3.0172176036086396 3.3528726826537933e-21 3.079652244187743e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 3.0357000656683986 8.646308670597711e-21 9.952897799961877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 3.052771838413057 -9.995445386668589e-21 -7.35603676816985e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 3.0684454585289456 8.897607318654096e-21 -2.2618389133440714e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 3.0827356301736373 -1.7577403791920215e-20 -2.6072419043289368e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 3.0956583569753633 9.135256775001372e-21 1.7420561007689692e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 3.107230193751229 -7.915614285908413e-21 8.11223834059773e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 3.1174676064867515 1.0705356297191669e-20 5.7106549073573374e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 3.1263864287271423 -4.738709226491207e-21 -1.3325369170643531e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 3.1340013932700996 8.819486705005479e-21 -5.913187693657786e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 3.1403257436809935 -5.116068399802934e-21 -6.03541893106877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 3.1453709279398856 4.66690879611828e-21 1.4256347447713127e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 3.149146361861662 -4.713953894693887e-21 -5.082605521005283e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 3.1516592519153455 -2.4143343021733654e-21 4.162980272149272e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 3.15291446930372 1.702097554911546e-22 4.571800149560974e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz deleted file mode 100644 index 8820085f7..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_FINAL_forces_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014611936430597623 2.2493990815306725e-20 -1.5381880240164548e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014716052244532903 -3.192901210335874e-19 -1.332961675901475e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0014924029593322138 6.260850114788895e-20 -1.7392110707068206e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0015235318203782654 -2.3501036545957663e-19 -2.781682727066459e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0015648987221995733 1.6908192165753224e-19 2.562952734268418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0016163595466335936 4.109051702724425e-20 3.841672345037767e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0016777013154903107 2.0990916143994459e-19 5.967319357080445e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0017486190765485462 1.6726840851467758e-19 6.811547856088269e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.001828686987556224 2.526534249363127e-19 5.110266969727889e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0019173230282346844 8.314806517430583e-20 3.4080820800355915e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0020137467556785617 3.392910166276092e-19 2.5541118791277015e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.002116929563476926 5.776394979860374e-19 -2.351700908643346e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.002225537035612983 7.242237043020484e-19 -3.993385011419628e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0023378632373813497 2.8981609204935877e-19 -5.184130261869439e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0024517572016108137 3.1088021249203115e-19 -9.08921653311002e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002564542504158233 -2.7464769811717756e-19 1.8877134415268786e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0026729317428155724 -2.57628376151565e-19 1.5680805119245061e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002772939010492642 -5.021023866436339e-19 3.40645543005207e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002859795159836294 -3.502958478702019e-19 2.7983725891513367e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029278728541802888 -1.822198368485328e-19 4.9452600824508524e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002970631119575876 -1.6894456743876968e-19 -5.638449964427965e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0029805936552266933 -1.7435209614335524e-20 -1.769836801820751e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002950549355517977 -4.375445932042005e-20 -2.625840831137101e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028765367472441757 3.5053046716276013e-20 7.433580942571695e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0027564702782450746 -2.2249452686113325e-20 -2.3410253369507314e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.00259006520418934 4.5324773428006787e-20 1.3147617308573999e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023791715308467774 -3.941478823170301e-20 -1.2488749274487472e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0021279561042676334 1.2382029425867962e-20 3.3212962886986883e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0018407278857366192 -7.527630477267312e-20 6.0201760810992874e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0015204033673949903 -8.499762290289411e-21 4.1905007480354537e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0011709323311505221 -6.759035506982326e-20 8.071174887746598e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0007984595854487692 7.226693261653342e-21 3.008847208370852e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00041309628336367693 -4.73647459460636e-20 -1.0114305471015333e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -2.632158010756249e-05 7.58789048122888e-21 6.48513859826387e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0003514479392866044 -3.799515418035005e-20 -2.4721320927205225e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0007144815622053725 1.6396051040236813e-20 3.881077510348118e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0010583946671436592 -9.483721835981538e-21 -4.5220591225545855e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0013793310819489055 2.8105635162068076e-20 7.574828760472563e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0016723679995712852 1.0559092953595619e-20 -5.5074334310946574e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0019316075893473525 1.933665956709069e-20 6.793594892032116e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002152523445352028 1.4712751655395693e-21 7.665402912360721e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0023323328744871826 -5.542140577490966e-22 8.819467341444442e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0024728325817852145 -6.6794418703346916e-21 -6.196631741107309e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002579048706398306 -7.067381988438514e-21 -1.7565395440976557e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026558895881718626 6.384064249449157e-21 -1.3004161363659598e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.00270793751809628 4.3921083091605496e-21 -8.578133384142787e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027393913275684635 2.055297036492193e-21 9.208752540280499e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002754014849551081 8.352840887081676e-22 1.1111716317578613e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027550125591259086 -6.748038329179437e-21 4.290935820773934e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002745189951901616 -1.8479430249022187e-21 -1.697356989787864e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027270454674050365 -4.765431709245858e-21 -5.4855611315508225e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027027845406573134 5.509011325913366e-21 4.0542955618298244e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026743380144968504 -4.903935502200977e-21 1.2466174051256622e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002643383201947176 9.687824086257663e-21 1.43698701005371e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026113660634847326 -5.0349165136484965e-21 -9.601379846777734e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002579523353149828 4.36270792002847e-21 -4.471077692692645e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025489057197806944 -5.9002802584290984e-21 -3.147439793425727e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0025204179388653466 2.61174983095486e-21 7.344306015714114e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002494810582195423 -4.860879157162912e-21 3.2590661762866744e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0024726756271440243 2.8197321548325237e-21 3.326434186938368e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0024544702245190087 -2.572176868587673e-21 -7.857416705048298e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002440536745005933 2.5981058763362823e-21 2.8012890168669263e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0024311185055215356 1.3306655682350944e-21 -2.2944355735675678e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002426371366965546 -9.381147457744651e-23 -2.5197575324993267e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz deleted file mode 100644 index f7baf95d6..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0026355399409262463 7.281226727383812e-17 -2.5409005387429654e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0026446076540015554 1.0987182616680062e-16 1.128817428770933e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002660172499311446 4.6380974449808005e-17 4.66094003787824e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0026818437317423795 1.9374948224331323e-17 9.66402117666969e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0027090366619222516 3.67385704560455e-17 5.4705090950200755e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0027409604589312088 2.2286689372917813e-17 4.582482106182566e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002776589554789488 9.371721911897417e-18 5.837799118131893e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0028146424001432306 4.774771259503609e-18 4.934080686172595e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0028535511809479855 -4.787836400065832e-18 2.6640584337953218e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.00289142523004571 -7.02455810830397e-18 2.6453525753098815e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0029260110679633347 -1.2493895441512142e-17 2.6769605897187536e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.002954672729056098 -1.1303658625774205e-17 3.529046871819464e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0029743690174441678 -3.349829780823049e-17 4.091354770272915e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0029816280621087015 -7.156906212867277e-18 3.5557176668011836e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0029726689511456613 -1.5537844703191943e-17 2.1908076829292036e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002944330256715138 -4.7320688238834025e-17 -1.678778418139014e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.002893994269121237 -2.769039661336956e-17 1.647049535077062e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0028194481132226773 -5.918599082075604e-17 1.3982306472532055e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0027190463429294085 -7.956873907977161e-17 -2.9081245497719456e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.002591901805995665 -7.233582246374498e-17 -5.5243227617035364e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0024379992284310702 -3.543480588907693e-17 -5.800082124125445e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0022582735577981743 -3.288226614212594e-17 -4.405006074715507e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002054470988140502 -1.9247732994956387e-17 -2.35019973335619e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0018277658938875502 -1.0537150249427461e-17 -1.2693343957783423e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0015793438085661402 -7.204794102913561e-18 -7.719556112502169e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0013109582887076757 -2.6398777814169762e-18 -5.839315987712115e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0010250172914050533 -3.983018060147889e-18 -3.150192884796938e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.000725760446410476 -1.5636248903065155e-18 -2.2275830051055642e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.00041881592732740525 -4.327583968268283e-18 4.630072486605321e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.00011024031340721465 -4.044548356245156e-18 1.936753923159155e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 0.0001940327810420433 -2.1774684227353165e-18 1.6299278321627406e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 0.0004903057712242876 -1.1803954848519803e-18 1.1778958433152993e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 0.0007760012391585212 4.00821181803225e-18 3.064644452655979e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.001048770617166731 3.647448517275304e-18 1.3448845468619752e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0013065363673899978 5.9314205427011624e-18 7.793996384090136e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.001546952205283094 1.5387397567706622e-18 1.2429561344232743e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0017669495024581422 1.1537526976412505e-18 9.109241567568532e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.001963955268883572 -3.238588075326794e-19 8.930710353494864e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0021360876126270694 -2.3111225816625776e-19 2.7555434445513014e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.002282208262707771 2.372656428767415e-18 -2.0241246724360266e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.00240292880353722 8.022777023792641e-19 -2.9216850212096367e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.002500864541177828 4.38288711922005e-18 -3.122519102449274e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002578713799343934 5.552203187976084e-19 -1.7344059472188928e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0026390457266596014 2.159031732457124e-18 -1.3649367701283333e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026842808580573377 -5.702016365401373e-19 7.282754916396266e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027166455711104074 6.637166003560214e-19 8.868271397663553e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027381676411985926 -1.81644821078109e-19 1.303859054322254e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002750676474082126 -1.0075633955110675e-18 1.0822921073888494e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027557693581975982 2.451554374628453e-19 -9.582134820338015e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027548505483420372 -3.3152766162883606e-18 -7.823778305660084e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002749179057536834 1.1383723005871172e-18 -1.1226993381515351e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027398794504428186 -3.016164507199622e-18 -7.232887482992511e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0027279484296395913 2.09936253142976e-18 4.104124306337246e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0027142618754023686 -2.89565550204566e-18 1.3567114614003274e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026995855924574984 2.2388233732558e-18 -1.0513367326261986e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002684586162024586 -2.2698793999517594e-18 6.79210824349021e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0026698379152378187 1.98029401699161e-18 -3.1525156541374656e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002655830942588051 -1.0128431137769682e-18 8.435394457488346e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002642979033630866 1.6187260259166963e-18 2.7753553178154723e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002631626099976083 -8.345686213450697e-19 5.412891102822998e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0026220513510873036 2.54083243445228e-19 4.0420408929572456e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0026144742738465464 -5.983385850893643e-19 7.101490473360711e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0026090595909962332 7.287688049325184e-19 -2.653065734225007e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0026059177089612275 -6.546674098245806e-20 -4.709963730547034e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz deleted file mode 100644 index 5967ed44c..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0017040356077180907 -1.290437499680323e-18 -1.0602299614253574e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0017187621132378087 1.15079505682649e-17 -2.5928027138540892e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0017460397330079126 3.0267717965052924e-17 1.952496994072916e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0017856866034763699 2.0198420414667235e-17 -1.898159833191704e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0018373976522990066 -4.434094916951118e-18 1.0108611087375865e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0019007233740780487 1.960203127649731e-19 -2.9424278455031046e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.001975028767073319 -1.2432114549610934e-17 -2.8954898272767934e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.002059453668350271 -9.67649328165488e-18 5.7322513426991045e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0021528586050979285 9.024624804636823e-18 6.066106069010843e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0022537565911957087 -2.080198006648363e-18 1.3122135488890702e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.002360229289917847 -8.25147194190153e-18 1.2707218937599922e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0024698557976868874 -4.374138465447047e-18 2.011302355105192e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.002579632478589823 -1.6662129424473265e-17 1.515692612856549e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0026858840808502765 -2.0634561436418134e-17 1.3564267298764462e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0027841645247606043 -4.085339712517105e-17 -1.2168718177344511e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002869189636911521 -7.385123735956667e-17 -3.380266787062586e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.002934814403922884 -4.535072104529767e-17 -3.1928770521644364e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002974015260099788 -1.5718608829132548e-17 -2.914644896218094e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002978921343928923 -5.88783380637129e-17 -1.1257575718689688e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029425593968443763 -1.28386856395475e-16 1.0988549601175646e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002861423670647863 -1.2718970679900206e-16 -6.254071500208956e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0027338858806801713 -8.052147070209337e-17 -6.5223419736457995e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0025602227955980935 -4.3137901924772025e-17 -2.9282786812961563e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.002342893729954132 -2.2123008655789097e-17 -1.925112287525796e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0020865338610468946 -1.5630063405820873e-17 -1.6284563122415592e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0017952106337264433 -1.2441452868983412e-17 -3.515334168470137e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0014719134981196745 -1.1392237625623125e-17 -2.026206560535043e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0011207246624111225 -5.665665674168821e-18 -1.3200041472335445e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0007481925173778033 -2.4922883658768463e-18 1.1343340129681533e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0003644739508006735 -1.2361857079676202e-18 2.0759262230450714e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H 1.9246289748108995e-05 -2.047006978551582e-18 5.667976151037855e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H 0.00039339236157420184 -4.530797338797385e-18 7.092325097848898e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 0.0007528117376026694 -9.937001759782934e-19 1.3955368360539495e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.0010933308205277519 2.3558280332514925e-18 2.1716670106556385e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0014111866582478241 6.7910246707346586e-18 6.011335512984039e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0017012447810224938 2.7334407328792872e-18 1.1608723813303753e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.001957600495216532 -6.39964133259077e-19 4.45826477158937e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0021756311257432556 -2.5328315289370625e-18 -1.0081649825739456e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.002352470915719751 -3.0484729353579074e-19 -1.7522194410459077e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0024902468036651316 4.68166420938948e-18 -2.494093951932134e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0025938241675139313 1.6968221260025154e-18 9.959535025499953e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0026679183633578902 1.2284921057582048e-18 -2.5934725414152688e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0027169547694362623 -1.9530604555930606e-18 -4.966478229818212e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0027450119026566733 5.272856431028689e-19 -2.2593912933796543e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0027557242624618025 4.591258077793744e-20 1.3624047800180964e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027521705440829098 4.640751736081764e-19 1.2269435827540452e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002737091372190672 4.509915260890729e-19 8.349695584605107e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027129406098358585 -2.915767336477218e-19 1.1821374216693957e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0026818928597740857 1.2042407180641552e-18 -1.4580077302865402e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002645858711784296 -3.0167222177457646e-18 1.4910979758479527e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0026065075176801584 4.851231923956279e-19 -2.0808773205156463e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002565288673166457 -2.9806757463228907e-18 8.542503605063263e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0025234736336506346 2.6523915348321596e-18 -7.58340652021016e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002482216388323892 -1.194059300834343e-18 2.093934754425643e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002442476613695741 1.9244547800573167e-18 -1.0951275510994303e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0024050292339066943 -2.305915721627607e-18 1.2509272752147157e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0023704925753636192 9.492062073723253e-19 -6.680356122413402e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023393548732066646 -1.0660596203675025e-18 8.82131010957353e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0023119975114129707 1.4583229623406668e-18 1.0742186976721667e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0022887140061305243 -4.974036430726096e-19 1.7968854311727656e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.002269725419375324 1.6552948937000524e-19 -9.114849483773078e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002255193342441301 -3.90479787946729e-19 1.5939483060596448e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002245230740057281 3.62020087139663e-19 -2.3249301570818586e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0022399072221180364 -1.1249925047794747e-19 -2.1551206604335144e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz deleted file mode 100644 index bef6012c3..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015767615217615813 5.6616360233021385e-18 5.343296636738627e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0015878831372825902 6.409439573519663e-18 2.7131899876249473e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0016100901339404312 7.582102998414718e-18 3.266528564787154e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001643298970113794 3.062282236407016e-17 2.164770794617584e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0016873678742179632 4.177954110337668e-17 4.7104171614786075e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0017420800461406206 4.794654026308556e-17 3.570062219611515e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0018071205252277332 3.7196542671940794e-17 2.7864423817488193e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0018820461040286972 9.650758370763538e-18 5.765218775615829e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.001966247591316877 1.5500686218204455e-17 -1.1287578660597293e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.002058903648450959 -2.9429505311829116e-18 -4.503581389588023e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0021589254071171667 6.318446352217739e-18 -3.6795182170850673e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.002264891148273813 1.8454033103867986e-17 2.5957794522226054e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0023749706353666804 3.1570289228058976e-17 1.9888086090824815e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0024868391424786186 2.109336994506272e-17 1.8727588512036932e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.002597581936904036 8.663171646573396e-18 1.917191832772002e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0027035908925868335 8.795153598522228e-18 1.2076246077831372e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0028004560295166276 -4.186497631511921e-18 1.942801383814498e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002882859504851784 -1.5035749997606982e-17 1.2884382717400426e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002944484274817157 -6.828360188677846e-18 1.3649903264678332e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029779558575730143 -8.228832549775045e-18 8.219317819696395e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0029749244720921595 -1.8693635516581064e-18 6.2870154191048e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0029285977207323213 -3.047805632952247e-18 1.0708711626567424e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0028354450204368512 -2.594859908113062e-18 6.244939240080849e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0026938020314434177 -1.999588565441954e-18 6.85936622445599e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0025041735655045223 -1.1707888737355286e-18 1.7023240146606783e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002269543341910667 -5.318928193200276e-19 7.891283967954023e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0019949655247256328 -2.0565397891193528e-19 2.3645047950178487e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.001683987100373184 -4.322592192700476e-19 9.234698238706135e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0013401423751859076 -1.9881329130766935e-19 6.953036880148131e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0009685295733146603 4.217528081148711e-19 8.997510880329792e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0005781722309308463 7.6886945655722375e-19 8.308167482279437e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.00018098608387649576 9.547896163771036e-19 3.4539853216248905e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H 0.00021084975318314025 7.313163745694478e-19 1.3544699874372243e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.0005893946284363669 -5.422914251200839e-20 5.877512781090795e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0009497399484314434 -9.982502641745953e-19 1.567087040211069e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0012875735625377106 -1.1145931068655273e-18 1.5098406820827706e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0015981855860858704 -6.356518195855934e-19 1.980866880975076e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0018750088160655793 7.867615810335664e-21 1.2901767056632408e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.002112509452690515 4.837917441198271e-19 7.691199086548695e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0023068713330692326 6.995632727361137e-19 9.786729751232834e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0024586585266080673 6.137951505396521e-19 -2.698799439547664e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0025729907489399767 2.592824381537839e-19 6.321895147254109e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0026551039568063067 2.9567926756746428e-19 -3.2052038391297245e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0027099101310231397 3.581357782224682e-19 4.703849843623236e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.002741927906511207 3.8595968091358893e-19 -1.6090376306147457e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027552015699685265 2.3981395944307175e-19 2.770659330178038e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002753153262087851 -1.4056852346595895e-22 4.51543603862936e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002738800741322868 -3.163177947308016e-19 2.6836916847548675e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027148381243411015 -4.522981740612986e-19 9.275707550701215e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0026836489726233446 -1.854843558219034e-19 -2.796850318640599e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0026473249574448083 4.3422372940051e-20 7.265249081210539e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0026076878848335086 3.3100670942482695e-19 -1.3106147136970798e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0025663133638370505 4.529991677795415e-19 -7.732145611304797e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002524577343866377 5.840860598588886e-19 -1.4876410047654256e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0024837207370865884 1.593273846017186e-19 2.1003811559166352e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002444771507799964 -1.2687195191119553e-19 -9.105284229595923e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0024085544923971003 -1.1769384820926685e-19 4.1769065317098406e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0023757250106996915 -1.325736525961577e-19 -1.7755243161776625e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002346797795052037 -3.577993253543053e-19 7.573365920249572e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0023221714529145935 -2.690040857148673e-19 1.9011600338060158e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023021487349026287 -1.4612356191552667e-19 6.287186289795114e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0022869528947317523 -1.1450387439950962e-19 1.2402284093492013e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0022767404131783233 8.405627209780064e-20 -2.632135908085084e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002271610323431136 3.9740662780253934e-19 -2.440610973964339e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz deleted file mode 100644 index de5ff07e8..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015472019870115203 -3.0950868380725977e-18 4.3004740686948913e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0015579640991543135 -8.615565344812908e-18 1.9542623343688345e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001579450479108368 -1.2751297190547713e-17 1.603087579918763e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0016115806441290086 -1.1582769461431862e-17 8.979927785406021e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.001654221899564664 -2.9015308452006155e-17 1.3351588242381245e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0017071746683306169 -2.1916288446104426e-17 1.2343502356805905e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0017701523676223172 -1.4790800917692898e-17 7.4142052480465e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00184275537775613 -3.36962306365198e-18 1.6560996580889328e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0019244385713394583 -9.643992176384323e-18 8.300531362388747e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.002014471827563704 -1.8862578232855378e-17 1.6341064435241634e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0021118929636457567 -2.482153951199111e-17 1.9520260091482727e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.002215452596327338 -1.3670304817461486e-17 2.2072772505181393e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0023235506344377716 -1.4332899161573243e-17 2.3051500607622415e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.002434164436865787 -9.341713036268313e-18 9.945294345565358e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0025447692013757374 -8.731108921613499e-18 1.4558254780005074e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0026522519405060576 -5.695676204994062e-18 1.871464186560981e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.002752821530307497 -1.3838924926995584e-17 1.191290615969689e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0028419188659465034 -1.4468664730053435e-17 2.842886998453322e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0029141331982367393 -2.246843306122235e-17 -3.2207253379889103e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029631333272904957 -2.3806035429170945e-17 -3.042157560639207e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0029816255495970024 -1.5110862429352147e-17 -4.166798480425436e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.002961906175003916 -6.511795978309409e-18 -3.780682394198734e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0028991087711357963 -4.076739139105965e-18 -1.618315581742893e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0027905997506822984 -3.0153081667248117e-18 4.497221130241074e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002635464303306933 -3.965313273635874e-18 -2.715378355387205e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0024348773501266393 8.065643568941524e-20 -1.6723280753768624e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0021923757845175662 8.303773667484552e-19 -1.3841192241405657e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.001912606536981902 2.465868186270652e-18 1.415895616312954e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0015984840811887953 -6.54281732476899e-19 1.7026381594081842e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0012536518324158252 -2.164464093533771e-18 2.0090530602604076e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0008835241453577341 -1.0526882705214998e-18 1.6330168986750132e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0004976197891723839 -2.8167352496795407e-19 6.0336644291875165e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0001074789060270249 1.7959237361282775e-18 9.230338912509829e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.0002756106263102932 -1.0140253981784508e-18 -5.874571980306807e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0006449497574223665 6.0100234233238275e-19 3.8331186564578637e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0009959323266346208 -3.927261906985289e-19 -1.0106740434750614e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0013244966167842444 2.233536164868195e-19 -1.458656976618005e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0016259194888878414 -7.065029550179033e-19 2.1107686676827245e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0018939773313488408 -1.1387928976628045e-18 7.497917057120588e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.002123650198958841 1.3957178871052845e-18 6.713591574853779e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.00231161348999244 -3.8583700322853526e-19 -1.5539176464040583e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0024588162086068054 1.2170832318110582e-18 -2.180748135055363e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0025702609900481095 -1.4658680077547674e-18 -1.5915169728269708e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002650986126152824 9.198759483871636e-19 5.201080737696773e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0027057082293819594 -2.226869916890821e-19 -2.0733765190316052e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027387588221744917 4.1180645758124993e-19 3.0564031456617452e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027540285645266 8.900512781956289e-20 3.813563777259429e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002754827453338919 -1.484202551964936e-18 -8.005055468431271e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027440495225975027 9.421185839846095e-19 -5.091237639079016e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002724275727161085 -1.2463306768826055e-18 -2.074856904524641e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.00269778766742136 2.595729691021009e-18 5.929647863544485e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002666585974106742 -1.3280422843333624e-18 -1.0332210593385144e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.00263241169045787 1.8316362062178808e-18 2.2821486095210683e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002596768970751707 -2.7244733800140516e-18 -5.622820175331804e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002560947858883892 1.1978543248624063e-18 6.174793976110749e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025260665611373176 -1.0588559495693535e-18 -1.5681914245928298e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.00249310157874141 1.955221670135554e-18 8.2317416564533505e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002462845587963383 -8.787840895402104e-19 -2.9476761029796035e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024359279212715994 3.765004882208698e-19 7.361693093085441e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002412841215707965 -7.506710607439694e-19 -4.0914937961974585e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0023939636278156036 5.291330871761712e-19 9.544577140638902e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0023795768523545966 -1.60663767441315e-19 -9.637504675726731e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0023698801885218904 1.2196609367389849e-19 8.658906715196399e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002365000875167163 -7.559088169070024e-20 -1.1840769912748795e-19 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz deleted file mode 100644 index 5fa61646e..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001498004723636759 -1.1409591558589891e-18 3.738884501715156e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0015086099724527533 -8.629869578965402e-19 4.083553958610724e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001529789503587304 -1.460186952392329e-18 6.922557010069498e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0015614769325713684 -2.3565392142023744e-18 2.9700426929498125e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0016035614334734423 -4.079295626608952e-18 3.796142931767612e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0016558739060537717 -2.879492414733986e-18 6.423333856608498e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0017181679856933725 -3.0577061798955556e-18 6.555904562517117e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0017900954495346868 -1.1071791631708934e-18 5.917204441332888e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0018711754929809196 -3.475715479474428e-18 4.721936302503411e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.001960757301804675 -2.298517827062839e-18 2.3644451623271616e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0020579753421199882 -2.3654194825989898e-18 -1.3145440509954037e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0021616968549538545 -4.5817468408213395e-18 -5.36939142380683e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0022704612031086368 -7.341665010472152e-18 -7.707225683794779e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.002382411013452219 -4.5060199489424786e-18 -6.005842012078169e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.002495215536020697 -7.182971706285959e-18 -1.4589141332499293e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002605987361372238 -1.530860158581514e-18 -5.995687617851988e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.002711194668420134 3.580513075102675e-18 -6.019167014356874e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002806572591554353 1.0632984189042708e-17 -2.561437367391999e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002887039172189373 9.290412810985269e-18 -2.6110564957562076e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029466237541833674 6.829215955581023e-18 1.3673734578908321e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002978418614464766 2.698896692999304e-18 2.480601724045318e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0029746554866321184 1.5706998586140115e-18 1.5408679215158534e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0029291314253995747 1.0590110508385866e-18 1.030033447112888e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028386452430462132 2.0075955577393002e-19 5.513411649180866e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002701654469845306 3.3224209874987857e-19 7.601649769558112e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0025185602920289093 -5.328684083116833e-19 2.9572511033608097e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002292016956077984 -8.457192915329497e-20 5.423521446940024e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0020267408103642973 -5.363918110030541e-19 -1.2710685962410022e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0017262453112123152 1.3109013911705225e-20 1.1542940474263765e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0013937051880026261 1.2786824703399129e-19 3.02576938895115e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0010336070406796749 1.3267105719033664e-19 1.7614113533066217e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0006537121487424882 7.301782513074265e-19 2.942754890986986e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0002650071063964484 1.090594582416089e-19 -2.2854174987742333e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 0.00012081744400595359 5.754843202820801e-19 4.342730058955542e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0004950508170668607 -4.23584379185957e-19 2.739566105869616e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0008527725833816364 5.973362010620376e-20 4.2789937507204675e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0011897466542456275 -5.78459895367989e-20 -2.7564881291707963e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0015019612816959138 -5.522777193527708e-22 -6.165504609556085e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0017835855408659383 8.472332613053145e-20 -3.8976076463896383e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0020290496724759167 -6.822808157353842e-19 -3.892867577463814e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002234341327466293 9.255029039608618e-20 4.384610213627349e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.00239802067093716 -5.126360058976813e-19 -2.2306451059090046e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002524008022069715 6.13738719153972e-19 2.188612556409696e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0026174094176017026 4.144550335138637e-20 -3.766263903711449e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026830541293773507 4.347374007069442e-19 1.3601133267663014e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002725414581598514 -4.0897356158351636e-20 3.0268935031445936e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002748560033437357 -3.7136433096983837e-19 3.0751928641136146e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027560469343421694 2.0688429546660455e-19 2.701912408695958e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027509085501931426 -3.41497333145499e-19 -5.570886628810639e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027358467210110526 6.705910036523416e-19 2.715052951100467e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027132591102102285 -8.694240219012547e-19 -5.392251893753982e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.002685255341486825 4.379713075438041e-19 4.421949254428487e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026536769810497807 -7.12841976945623e-19 -2.6058266540938686e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002620119544580052 9.332628750692373e-19 4.652544152837966e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0025859551359443842 -3.9797537819769424e-19 -1.989698612009163e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025523556293887777 4.542721504388248e-19 3.4236924075683544e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025203386642577885 -5.140616299484378e-19 -2.4110200407923286e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0024907686771973437 3.7286215583833526e-19 1.4337756227601035e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002464336442922112 -2.0180098705149805e-19 -2.2953810346762476e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.002441584415193866 1.7454011009170573e-19 3.509766775520762e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0024229302188362037 -2.020405099140874e-19 -8.472541949469758e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002408685765458635 2.5364393473973627e-20 -3.2824579079860607e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002399072213307275 -9.91080359564916e-21 2.284966362980935e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.0023942309797528125 3.612278286454814e-20 6.482156962255841e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz deleted file mode 100644 index e822a3a9d..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014807743308649837 -1.0505887058092435e-18 2.441198244947668e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001491277907657113 -5.090599962350335e-18 3.2486026935260745e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0015122568333512942 -3.535156847777973e-18 1.7871848137910728e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0015436503450411978 -5.80842142927906e-19 2.270607471764644e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.001585356412891211 -1.0103104697600718e-18 5.464383118939204e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0016372183508290353 -3.829893030941696e-18 3.97789341832621e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0016990064284137661 -2.520006009951136e-18 3.4611115957703676e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0017703940445564785 -1.9043574985716695e-18 7.610464623067518e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0018509279438980774 1.0451390562422918e-18 6.870605256551332e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0019399919051437552 1.0315464938836838e-18 -2.995378786231616e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.002036763322180707 -7.746745970371519e-19 -5.4436009439766935e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.00214016215384005 -6.658568461958768e-19 -1.4741858476288841e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.002248791864308612 -1.01984055498659e-18 -4.0714129824112367e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0023608722497397133 -1.3301747453421489e-18 -4.5229864375197436e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.002474164493851269 -3.8459646920005905e-18 -1.6057024284282678e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002585889473015419 -5.298224585167183e-18 -4.641836963367452e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0026926413062906404 -4.5596790013182304e-18 -3.905139535572519e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0027902994913835103 -3.2128190817000078e-18 -3.6165350399349546e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002873944756646831 -7.569525908693894e-19 -5.685428129717458e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.002937786051255617 -2.625052021454353e-18 -7.512155271314056e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0029751089146787396 -2.996637713148432e-18 -3.6121299800996703e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0029782799400507372 -1.6949305667364648e-18 -1.5675838577865686e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0029405549586621056 -6.745129422905802e-19 -3.1534861359580254e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028583983704381184 -2.830443429332456e-19 -1.5120563411989394e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002729992794480249 -6.053854374928701e-19 2.766046349275849e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.0025553890162547713 -2.661378814698771e-19 2.811615963229614e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.002336827153079211 -5.284424186870134e-19 2.508408860783945e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002078789016114934 -1.2795105299802182e-21 7.297112102365087e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.001785190920051589 -3.3835844071434177e-19 2.2301765559868664e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0014590334696496976 -2.9729370729384573e-19 2.5194562813216424e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0011044990232914565 -1.1370356691015064e-19 1.6722615091944026e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.000728474045527725 1.8297068174516436e-20 8.288037542475059e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00034153060121826516 5.433584867859928e-19 -9.428248628290457e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 4.4729928613702004e-05 -6.436560218847456e-20 -2.515706810059038e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0004206576385423998 1.6228366822293045e-19 1.945448495986563e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0007810092548342092 -3.7763795537506564e-19 2.9283719728321277e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0011214761084325387 5.0955562077699595e-20 1.2964658726738278e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0014381870586274454 -6.915124523003794e-20 -9.195823463038295e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0017257679959563953 -2.5872417899555723e-19 -1.8967685132155614e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0019784520254129546 -1.906619167113079e-19 -2.6955352029756163e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002191961800823003 -4.2426530625664714e-19 2.726981686454879e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0023640404835000932 3.5596789496750467e-19 8.66867453776319e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0024975723795376565 -1.3110930456691292e-19 3.9464936947260026e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0025976550899817646 3.4304985690824906e-19 -1.2985002890626848e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026691543067650296 -2.0490036067167298e-19 1.6923238864061963e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002716595567977665 1.5484619710467253e-19 -6.834102427683714e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002744112826027325 -1.1523074441639517e-20 -5.0676872569206734e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027553751654994644 -1.0564982662787236e-19 1.1257660931716211e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027534950663157982 1.9690824735345263e-19 2.3990075016392493e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002741226217730074 -2.9776122523085073e-19 1.1625615300365842e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027210171183558703 2.7514558801772675e-19 -6.854752899211345e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0026950259351253758 -5.87622622650599e-19 1.9734491374178583e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026651396277085886 4.0740623458582193e-19 -1.703250675930513e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026329954258671622 -3.572890073143836e-19 8.344197964953706e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026000031993246514 5.405066755306106e-19 1.662923662688574e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025673676362961673 -3.6764193589479966e-19 1.2584673549850789e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002536118332888804 3.4621687593767855e-19 -1.1905437400933294e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0025071454620700095 -3.215604365327064e-19 -4.007787543846804e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024811713600440513 2.6211442321793636e-19 -4.803921671043517e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0024587643220408645 -1.618210453873145e-19 6.643297910432695e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0024403626283037117 1.229026036055091e-19 -6.400928606954336e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0024262941279157868 -1.309700399835651e-19 7.849195389208352e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002416791585373269 3.6194115801802275e-20 -6.661051413710259e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002412003988990305 3.0099110602025726e-22 1.7143260368608886e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz deleted file mode 100644 index 7c352c65c..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001469513250334811 -1.9077579870642073e-18 -1.519524890790527e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014799662699669614 -3.1092214671358762e-18 4.761468733042548e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0015008456791890858 -1.6734758287001937e-18 7.601358832717238e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0015320939868741657 -2.072891074878274e-18 1.796719168587548e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0015736142621623583 -1.4523117341820631e-18 1.879894925877849e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0016252569776441324 -2.065668822373082e-18 1.2571573495905862e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00168680193561582 -1.617539227920863e-19 2.3514051895324394e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0017579348408543025 -9.448518171717444e-19 1.8924076107817274e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0018382180027824004 3.1995559809772377e-19 2.5247741399763817e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0019270545965308244 1.5888444960788877e-18 1.906824656443837e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.002023645900443283 2.5443687867161873e-18 1.912670113373204e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0021269409768929406 1.2375019579695672e-18 7.132497219341677e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0022355784007285604 2.195826104333711e-18 9.510751617062847e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0023478199006256007 3.292641492862685e-18 6.03921245523709e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0024614762083283712 7.749506766264357e-19 6.070408019960232e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0025738260648993454 1.5553582815999777e-18 1.132973987743553e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0026815302773517467 -4.2624884117296916e-20 1.958721747994062e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0027805440260846755 -8.93262524765794e-19 2.518711273897853e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0028660323664113003 -2.0063790355486845e-18 2.351434429976957e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029322961069643974 -3.0295223426004665e-18 8.520572407155714e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0029727180116830856 -2.2756707578561126e-18 -4.8151888607088714e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.002979748597363763 -1.3467357264304537e-18 1.683824394931201e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0029463641546814694 -6.310539332756418e-19 2.0072209268510097e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028687998643541113 -2.7401320886441965e-19 2.1375851050023198e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0027450860458521457 -3.069278698194426e-19 5.49802573531151e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002575083608944631 -2.088720312210586e-19 1.611552796844625e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.00236081255281684 -2.1710510012448834e-19 -9.821106607295098e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.002106587850051324 -1.5526679549034137e-20 6.880163614705272e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.001816552497616313 -5.594091277195617e-20 -7.158012427127298e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0014936492637529376 -7.423055547558235e-20 -7.30059841441519e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0011419265506866884 -7.127840595812063e-20 -6.999262832668743e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0007678435737205471 -7.77474316940625e-20 -1.7412530316439076e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0003817285543659254 9.66501050678264e-20 5.850766662910998e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H 4.878511036097551e-06 1.2430876062796804e-20 -7.777500968697467e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.00038187429561860125 9.538052976743676e-20 1.625345096641536e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0007437643685096538 -6.776701356178071e-20 3.595768649424572e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0010861963306547985 -3.1369364623954565e-20 1.0575586601703361e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0014053162978807977 -4.1489540002886215e-20 3.684886445784592e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.001695999926795101 -2.4367127939921048e-20 -1.1435487796204823e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0019523958406140983 7.789727692212061e-20 7.589108191806531e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002170085526198702 -4.6685754060170665e-20 -1.200542433714979e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0023464961143062797 3.9318086412278984e-20 5.800730533744231e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.002483915977636879 -9.275518843339408e-20 -1.2183358090935084e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.00258741617017359 8.965391895616138e-20 1.1599713892893256e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026618870542830827 1.7960858239232632e-20 -4.6291426143151284e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.002711886681986388 5.475806355288895e-20 5.394297001016051e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.002741586000131436 1.4670862079135512e-20 1.8173364809614602e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002754709192323633 -3.6414707776682117e-20 5.835565447934759e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002754418830742935 4.2288562394164914e-20 1.5839719654358535e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027434979185450904 -1.097874108950578e-19 -1.076941127372152e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027244233032035913 6.478537318079874e-20 1.2201944240906124e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0026993799489194773 -1.1426859467487435e-19 -2.1796292145152853e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002670279666386048 1.111181998003872e-19 1.3057934470233581e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026387823626486677 -8.623299226931632e-20 -1.7888245689917968e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.002606318308355086 9.620739143501636e-20 1.5768075402318288e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.0025741103034123618 -7.569244230822956e-20 -1.417258849794037e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025431990534028085 6.99554881055517e-20 1.0925043023990706e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.002514483948458246 -6.675012963789674e-20 -9.910316117522598e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002488703407097418 2.987109179278987e-20 7.970720041082682e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0024664389571649446 -2.71942728236668e-20 -3.838037770600325e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0024481394139077763 3.0020669621623035e-20 6.664513621089672e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002434140727385383 -9.729276936215794e-21 -2.8595920717663266e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0024246815451951214 4.528113563391822e-21 -5.810000314641057e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002419914685433458 -6.472488758953425e-21 -1.6403693331644548e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz deleted file mode 100644 index 75829badd..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014641409867470743 -7.313870859233257e-19 7.527780254083132e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001474566715457001 8.421085150245046e-20 1.0460968672291696e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0014953923256271356 1.226740887619144e-19 9.077317439641083e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001526561930799192 6.943778556033818e-19 7.064623617150034e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0015679811054285613 7.419926300320412e-19 -7.349847496107192e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.001619503847654326 1.1543252737209672e-18 -3.857678503551918e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0016809146674556146 6.757471367232133e-19 1.0077491126124049e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00175190536523897 8.283150694359409e-19 1.765023105076917e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.0018320459850228092 1.1397422370698937e-18 4.860430628700528e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0019207493721286164 1.4480371735698845e-18 1.553514365920429e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0020172287516125593 1.1363449898129566e-18 -4.990017667617521e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.0021204477901374777 5.880960259089517e-19 -3.4695242467355865e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.0022290627370541724 1.5312880431383814e-19 1.015331728250732e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.002341356495030327 2.7558409504252944e-19 -7.080839108645524e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0024551648913380794 4.8674263790390215e-20 5.093446747558772e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.0025677960629525553 -3.086447513983398e-19 -9.129165312829506e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.002675944797077883 -6.548523062583422e-20 -5.718054622496059e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.0027756049558465136 2.6350074062111787e-19 5.430976420417609e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.0028619848327576967 2.7565759746965823e-19 -2.4924247128601015e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.002929432500402341 3.9899850843714993e-19 -2.964017281686533e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.0029713809438389367 4.456474324845773e-19 4.333922518263619e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.002980328467868274 3.959305107449948e-19 1.5618493947772814e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.0029491266593209896 2.997051875533057e-19 8.217876881687788e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028738847213551993 2.0755745211360853e-19 3.7880594791288175e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.002752557212400065 9.165660865169794e-20 2.446275864293882e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.002584909667264986 -5.722648684745478e-20 8.461134022799195e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023728506286044082 -1.0321921002803744e-19 1.6310012606971138e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0021205993745061743 -8.519680585331376e-20 -1.1321424270614465e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0018324084911967777 -1.806176202912201e-20 -6.234285303689933e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0015112012415662568 5.736329378963735e-20 -8.546861285765509e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0011609606783859953 3.0318956606091205e-20 -4.678461641601412e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0007879372163655696 -6.772833994081835e-20 4.589069810019545e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.0004023185934962377 -1.232493577465726e-19 -1.180629605948347e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -1.5604783895120383e-05 -7.725942347278707e-20 3.477303331257842e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.00036189162912327635 1.2502492521189403e-21 -1.5201400673990977e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.000724525821591206 5.629368338585106e-20 3.9314589661718296e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.001067924479747515 3.2392541985966105e-20 -6.055549476692223e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0013882340600252937 -3.017692380977735e-20 -1.7829819530495543e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0016804632478722506 -7.830475677139641e-20 9.67440233276784e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.001938728716055943 -4.034158072773177e-20 -7.314544797165016e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.0021585412978674936 6.05319018227575e-20 1.4971284242908992e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0023371868303834896 9.955802484402133e-20 -6.37502800843576e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0024766309828081266 5.873828272718727e-20 1.3161432107683175e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.0025819174740124794 -5.247151151462468e-20 -1.0180085622347348e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026579482152969095 -8.303561314436324e-20 1.0836585137891672e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.0027092969541693307 -2.1537115479030374e-20 4.10477965512215e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027401527608871385 6.339951628185074e-20 6.847795032970798e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.0027542660130321505 9.714829653978589e-20 1.137362592636912e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.002754826473340431 6.45528037200032e-20 -7.224421528944962e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.0027446317631218643 9.850663183974554e-21 1.332792627513757e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.002726172819643158 -5.362121519951952e-20 -1.2427741378077653e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027016479768145513 -5.744144776740994e-20 2.448235159708105e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.002672981484317526 -3.3576683422061017e-20 -1.4137657431266002e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.0026418446322668274 2.8014389340667076e-20 1.9021301893463377e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026096779574539195 2.894259154027833e-20 -2.1283076076749293e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002577713394439793 1.0041172663123516e-20 1.079420607121359e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.002546998002406411 -1.1922891253609511e-20 -1.1737424436911705e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0025184347511586864 -1.1396967322941268e-20 1.3034813039757315e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.0024927701196040815 -2.11956599561161e-20 -7.789667025511462e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0024705925065677706 -1.3391334200940898e-20 4.881561674807136e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.00245235621031585 -3.0122237343476905e-21 -5.748721364119083e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.0024384014056686425 6.282937621495552e-21 2.687195060910205e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.002428969813430238 8.308819434611232e-21 -1.9840275936424475e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002424216254766057 5.949296774140813e-21 1.3870104515348308e-20 diff --git a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz deleted file mode 100644 index 8820085f7..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst.instanton_forces_8.xyz +++ /dev/null @@ -1,192 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014611936430597623 2.2493990815306725e-20 -1.5381880240164548e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014716052244532903 -3.192901210335874e-19 -1.332961675901475e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0014924029593322138 6.260850114788895e-20 -1.7392110707068206e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0015235318203782654 -2.3501036545957663e-19 -2.781682727066459e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0015648987221995733 1.6908192165753224e-19 2.562952734268418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0016163595466335936 4.109051702724425e-20 3.841672345037767e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0016777013154903107 2.0990916143994459e-19 5.967319357080445e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0017486190765485462 1.6726840851467758e-19 6.811547856088269e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H -0.001828686987556224 2.526534249363127e-19 5.110266969727889e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H -0.0019173230282346844 8.314806517430583e-20 3.4080820800355915e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H -0.0020137467556785617 3.392910166276092e-19 2.5541118791277015e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H -0.002116929563476926 5.776394979860374e-19 -2.351700908643346e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H -0.002225537035612983 7.242237043020484e-19 -3.993385011419628e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H -0.0023378632373813497 2.8981609204935877e-19 -5.184130261869439e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H -0.0024517572016108137 3.1088021249203115e-19 -9.08921653311002e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H -0.002564542504158233 -2.7464769811717756e-19 1.8877134415268786e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 -H -0.0026729317428155724 -2.57628376151565e-19 1.5680805119245061e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 -H -0.002772939010492642 -5.021023866436339e-19 3.40645543005207e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 -H -0.002859795159836294 -3.502958478702019e-19 2.7983725891513367e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 -H -0.0029278728541802888 -1.822198368485328e-19 4.9452600824508524e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 -H -0.002970631119575876 -1.6894456743876968e-19 -5.638449964427965e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 -H -0.0029805936552266933 -1.7435209614335524e-20 -1.769836801820751e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 -H -0.002950549355517977 -4.375445932042005e-20 -2.625840831137101e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 -H -0.0028765367472441757 3.5053046716276013e-20 7.433580942571695e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 -H -0.0027564702782450746 -2.2249452686113325e-20 -2.3410253369507314e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 -H -0.00259006520418934 4.5324773428006787e-20 1.3147617308573999e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 -H -0.0023791715308467774 -3.941478823170301e-20 -1.2488749274487472e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 -H -0.0021279561042676334 1.2382029425867962e-20 3.3212962886986883e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 -H -0.0018407278857366192 -7.527630477267312e-20 6.0201760810992874e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 -H -0.0015204033673949903 -8.499762290289411e-21 4.1905007480354537e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 -H -0.0011709323311505221 -6.759035506982326e-20 8.071174887746598e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 -H -0.0007984595854487692 7.226693261653342e-21 3.008847208370852e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 32 -H -0.00041309628336367693 -4.73647459460636e-20 -1.0114305471015333e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 33 -H -2.632158010756249e-05 7.58789048122888e-21 6.48513859826387e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 34 -H 0.0003514479392866044 -3.799515418035005e-20 -2.4721320927205225e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 35 -H 0.0007144815622053725 1.6396051040236813e-20 3.881077510348118e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 36 -H 0.0010583946671436592 -9.483721835981538e-21 -4.5220591225545855e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 37 -H 0.0013793310819489055 2.8105635162068076e-20 7.574828760472563e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 38 -H 0.0016723679995712852 1.0559092953595619e-20 -5.5074334310946574e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 39 -H 0.0019316075893473525 1.933665956709069e-20 6.793594892032116e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 40 -H 0.002152523445352028 1.4712751655395693e-21 7.665402912360721e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 41 -H 0.0023323328744871826 -5.542140577490966e-22 8.819467341444442e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 42 -H 0.0024728325817852145 -6.6794418703346916e-21 -6.196631741107309e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 43 -H 0.002579048706398306 -7.067381988438514e-21 -1.7565395440976557e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 44 -H 0.0026558895881718626 6.384064249449157e-21 -1.3004161363659598e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 45 -H 0.00270793751809628 4.3921083091605496e-21 -8.578133384142787e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 46 -H 0.0027393913275684635 2.055297036492193e-21 9.208752540280499e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 47 -H 0.002754014849551081 8.352840887081676e-22 1.1111716317578613e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 48 -H 0.0027550125591259086 -6.748038329179437e-21 4.290935820773934e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 49 -H 0.002745189951901616 -1.8479430249022187e-21 -1.697356989787864e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 50 -H 0.0027270454674050365 -4.765431709245858e-21 -5.4855611315508225e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 51 -H 0.0027027845406573134 5.509011325913366e-21 4.0542955618298244e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 52 -H 0.0026743380144968504 -4.903935502200977e-21 1.2466174051256622e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 53 -H 0.002643383201947176 9.687824086257663e-21 1.43698701005371e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 54 -H 0.0026113660634847326 -5.0349165136484965e-21 -9.601379846777734e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 55 -H 0.002579523353149828 4.36270792002847e-21 -4.471077692692645e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 56 -H 0.0025489057197806944 -5.9002802584290984e-21 -3.147439793425727e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 57 -H 0.0025204179388653466 2.61174983095486e-21 7.344306015714114e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 58 -H 0.002494810582195423 -4.860879157162912e-21 3.2590661762866744e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 59 -H 0.0024726756271440243 2.8197321548325237e-21 3.326434186938368e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 60 -H 0.0024544702245190087 -2.572176868587673e-21 -7.857416705048298e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 61 -H 0.002440536745005933 2.5981058763362823e-21 2.8012890168669263e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 62 -H 0.0024311185055215356 1.3306655682350944e-21 -2.2944355735675678e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 63 -H 0.002426371366965546 -9.381147457744651e-23 -2.5197575324993267e-21 diff --git a/drivers/py/pes/friction/onheH/080K/inst1D.dat b/drivers/py/pes/friction/onheH/080K/inst1D.dat deleted file mode 100644 index cf099ac41..000000000 --- a/drivers/py/pes/friction/onheH/080K/inst1D.dat +++ /dev/null @@ -1,64 +0,0 @@ -1.9564769528235888 0.0468675862599136 -1.9572334263205735 0.04695718403016402 -1.958751763695091 0.04713893499638353 -1.9610427325580506 0.04741798470122928 -1.964122449291171 0.047802135560618735 -1.9680123308996569 0.04830194018370214 -1.9727390204616129 0.04893081238110813 -1.9783342769467933 0.04970514286594315 -1.9848348174402097 0.050644401548013994 -1.992282096803991 0.051771202023001936 -2.0007220065116598 0.05311129620966222 -2.010204470788343 0.05469345803989541 -2.0207829143103897 0.05654920478537778 -2.032513571624667 0.05871229341582533 -2.0454546042753683 0.06121791814977299 -2.059664987584168 0.0641015254862787 -2.0752031254526586 0.06739715669094927 -2.0921251489161405 0.07113522813838814 -2.110482853138887 0.07533967143336269 -2.1303212289824893 0.08002438340353833 -2.1516755503443252 0.08518898746585474 -2.174567988550856 0.09081398541841777 -2.1990037421619237 0.09685188039493388 -2.2249673020424345 0.10321309743973481 -2.2524204022209573 0.10976657529697155 -2.2813009397482813 0.11633791766763717 -2.3115228265771175 0.12270836098740698 -2.342976946334549 0.12861822480753152 -2.3755333115441912 0.13384882831041867 -2.4090432941993125 0.13828036194236445 -2.4433411330757084 0.1418127967438358 -2.4782459771560252 0.1443572267707269 -2.5135650638013027 0.1458294352457013 -2.5490989536591657 0.14616463312868416 -2.5846474722769193 0.14535968397161714 -2.6200151047052884 0.14355507472074472 -2.6550139581737247 0.14093213364843651 -2.689466031649674 0.1376769436640077 -2.7232052107021776 0.13389365055365746 -2.7560798156790374 0.1295970066095933 -2.7879556560926417 0.12481065365439488 -2.8187183738450803 0.11957546273717595 -2.848274886621655 0.11401288156719806 -2.8765524574110763 0.10829448161877818 -2.9034960916674586 0.10256724734521462 -2.9290659974092295 0.09695125420077028 -2.9532352140127287 0.09154110548516632 -2.9759874394174197 0.08640662522590538 -2.997315082213753 0.08158794796378174 -3.0172176036086396 0.07710787751879086 -3.0357000656683986 0.07297923349859223 -3.052771838413057 0.06920671872246592 -3.0684454585289456 0.06578864085574675 -3.0827356301736373 0.06271847352390512 -3.0956583569753633 0.05998624102713974 -3.107230193751229 0.05757972341514071 -3.1174676064867515 0.05548541601328643 -3.1263864287271423 0.053688595647025265 -3.1340013932700996 0.052175081004713 -3.1403257436809935 0.05093262316019239 -3.1453709279398856 0.049950979727129065 -3.149146361861662 0.04922194037713555 -3.1516592519153455 0.04873934072494175 -3.15291446930372 0.048499069047973055 diff --git a/drivers/py/pes/friction/onheH/100K/RESTART b/drivers/py/pes/friction/onheH/100K/RESTART deleted file mode 100644 index 0624e1b48..000000000 --- a/drivers/py/pes/friction/onheH/100K/RESTART +++ /dev/null @@ -1,117 +0,0 @@ - - - [ step, potential{electronvolt} ] - - 3 - 30 - - - - - - - - - 3.16681520e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 2.79915077e-03, 2.93159032e-03, 3.20556392e-03, 3.62736154e-03, 4.17095710e-03, - 4.73835527e-03, 5.17352631e-03, 5.36853225e-03, 5.27057363e-03, 4.96114929e-03, - 4.53120212e-03, 4.03844310e-03, 3.58057871e-03, 3.21975741e-03, 2.97766434e-03, - 2.85719331e-03 ] - - - [ -2.87396815e-03, -5.37414453e-20, -6.41607759e-21, -2.92494073e-03, -2.53298931e-20, - -1.14366358e-20, -2.97859217e-03, -2.60754711e-20, 2.50041085e-21, -2.93335423e-03, - -2.37109486e-20, -5.15399210e-20, -2.66789111e-03, -1.22007511e-19, -6.95833096e-20, - -2.11246435e-03, -1.30689373e-20, -6.30037116e-21, -1.28637073e-03, -2.44616489e-21, - -1.16182059e-21, -2.72269841e-04, -3.93318013e-22, -5.93092551e-22, 7.35590685e-04, - -1.21677978e-22, -5.13779713e-22, 1.59390638e-03, -1.90789800e-22, -1.19120265e-22, - 2.21026542e-03, -2.57606535e-22, -5.41705134e-23, 2.55266004e-03, -1.01489108e-22, - -5.06284095e-22, 2.70428771e-03, -5.49079385e-22, -1.04189815e-22, 2.75185424e-03, - -3.82201049e-22, 3.42997163e-22, 2.75434545e-03, 3.12271209e-22, 4.78006580e-22, - 2.74722290e-03, -8.71588324e-22, -3.21571256e-22 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00 ] - - - [ 3.86869172e-03, 0.00000000e+00, 0.00000000e+00, 2.82102908e-03, 0.00000000e+00, - 0.00000000e+00, 6.59392600e-04, 0.00000000e+00, 0.00000000e+00, -2.52241459e-03, - 0.00000000e+00, 0.00000000e+00, -5.85003384e-03, 0.00000000e+00, 0.00000000e+00, - -8.46716753e-03, 0.00000000e+00, 0.00000000e+00, -1.02935239e-02, 0.00000000e+00, - 0.00000000e+00, -1.09155442e-02, 0.00000000e+00, 0.00000000e+00, -1.00310700e-02, - 0.00000000e+00, 0.00000000e+00, -8.52814351e-03, 0.00000000e+00, 0.00000000e+00, - -6.07253176e-03, 0.00000000e+00, 0.00000000e+00, -3.54021984e-03, 0.00000000e+00, - 0.00000000e+00, -1.71585513e-03, 0.00000000e+00, 0.00000000e+00, -4.76917239e-04, - 0.00000000e+00, 0.00000000e+00, 3.00530116e-04, 0.00000000e+00, 0.00000000e+00, - 6.76375315e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, -3.00926554e-33, 5.51152161e-01, 0.00000000e+00, - -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -5.26621469e-33, 5.51152161e-01, 0.00000000e+00, - -6.58276836e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, - 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, - 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, - -3.32077154e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, 5.51152161e-01, - 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, - 5.51152161e-01, 0.00000000e+00, -3.29138418e-33, 5.51152161e-01 ] - - True - - - - - [ 2.11403516e+00, 9.75074564e-20, 1.16412092e-20, 2.12926823e+00, 4.59580763e-20, - 2.07504146e-20, 2.16000451e+00, 4.73108389e-20, -4.53669790e-21, 2.20652827e+00, - 4.30206943e-20, 9.35130526e-20, 2.26859970e+00, 2.21368107e-19, 1.26250634e-19, - 2.34481170e+00, 2.37120313e-20, 1.14312736e-20, 2.43222029e+00, 4.43827506e-21, - 2.10798518e-21, 2.52644695e+00, 7.13628723e-22, 1.07609585e-21, 2.62211671e+00, - 2.20770209e-22, 9.32192140e-22, 2.71388777e+00, 3.46165385e-22, 2.16129543e-22, - 2.79721092e+00, 4.67396398e-22, 9.82859495e-23, 2.86881941e+00, 1.84139907e-22, - 9.18592234e-22, 2.92689838e+00, 9.96239194e-22, 1.89040019e-22, 2.97064403e+00, - 6.93458315e-22, -6.22327531e-22, 2.99980410e+00, -5.66578943e-22, -8.67286048e-22, - 3.01436529e+00, 1.58139328e-21, 5.83452771e-22 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/onheH/100K/control.in b/drivers/py/pes/friction/onheH/100K/control.in deleted file mode 100644 index 687e6ee90..000000000 --- a/drivers/py/pes/friction/onheH/100K/control.in +++ /dev/null @@ -1,181 +0,0 @@ -# Physical settings -xc pbe -spin none -relativistic atomic_zora scalar -charge 0.0 -#vdw_correction_hirshfeld - -# k-grid settings (to be adjusted) -k_grid 12 12 12 - -# accuracy requirements -sc_iter_limit 200 -sc_init_iter 200 - -#Mixing settings - mixer pulay - n_max_pulay 10 - charge_mix_param 0.05 - - -# occupation gaussian broadening -occupation_type gaussian 0.1 - -final_forces_cleaned .true. -compute_forces .true. - - -# IPI - output_level MD_light -# use_pimd_wrapper localhost 41000 - use_pimd_wrapper drag092 41111 - -#=============================================================================== - -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for Pd atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species Pd -# global species definitions - nucleus 46 - mass 106.42 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 62 5.0 - radial_multiplier 2 - angular_grids specified - division 0.5211 50 - division 0.9161 110 - division 1.2296 194 - division 1.5678 302 -# division 1.9785 434 -# division 2.0474 590 -# division 2.1195 770 -# division 2.1568 974 -# division 2.7392 1202 -# outer_grid 974 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 5 s 1. - valence 4 p 6. - valence 4 d 9. -# ion occupancy - ion_occ 5 s 0. - ion_occ 4 p 6. - ion_occ 4 d 8. -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A -# -################################################################################ -# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV - ionic 5 p auto - hydro 4 f 8 -# hydro 5 g 10 - hydro 3 s 2.6 - hydro 3 d 2.5 -# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV -# hydro 5 f 17.2 -# hydro 6 h 14 -# hydro 4 d 4 -# hydro 5 f 7.6 -# hydro 3 p 3.3 -# hydro 4 s 9.4 -# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV -# hydro 4 f 20 -# hydro 5 g 12.8 -# hydro 5 d 9.8 -# hydro 6 h 15.2 -# hydro 5 s 10 -# hydro 6 p 9.8 -# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV -# hydro 5 f 9.2 -# hydro 2 s 5.6 -# hydro 5 f 43.2 -# hydro 5 d 13.2 -# hydro 5 g 14 -# hydro 4 p 4.7 -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for H atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species H -# global species definitions - nucleus 1 - mass 1.00794 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 24 5.0 - radial_multiplier 2 - angular_grids specified - division 0.2421 50 - division 0.3822 110 - division 0.4799 194 - division 0.5341 302 -# division 0.5626 434 -# division 0.5922 590 -# division 0.6542 770 -# division 0.6868 1202 -# outer_grid 770 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 1 s 1. -# ion occupancy - ion_occ 1 s 0.5 -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A -# -################################################################################ -# "First tier" - improvements: -1014.90 meV to -62.69 meV - hydro 2 s 2.1 - hydro 2 p 3.5 -# "Second tier" - improvements: -12.89 meV to -1.83 meV -# hydro 1 s 0.85 -# hydro 2 p 3.7 -# hydro 2 s 1.2 -# hydro 3 d 7 -# "Third tier" - improvements: -0.25 meV to -0.12 meV -# hydro 4 f 11.2 -# hydro 3 p 4.8 -# hydro 4 d 9 -# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/100K/geometry.in b/drivers/py/pes/friction/onheH/100K/geometry.in deleted file mode 100644 index cd6ad1f1f..000000000 --- a/drivers/py/pes/friction/onheH/100K/geometry.in +++ /dev/null @@ -1,11 +0,0 @@ -#=======================================# -# iterations/iteration0105/aims-chain-node-0.56500/geometry.in -#=======================================# -lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 -lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 -lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 -atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd -atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd -atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd -atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd -atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/100K/get1D.sh b/drivers/py/pes/friction/onheH/100K/get1D.sh deleted file mode 100755 index 5cd175503..000000000 --- a/drivers/py/pes/friction/onheH/100K/get1D.sh +++ /dev/null @@ -1,6 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 -xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/onheH/100K/hessian.dat b/drivers/py/pes/friction/onheH/100K/hessian.dat deleted file mode 100644 index 536cf2c98..000000000 --- a/drivers/py/pes/friction/onheH/100K/hessian.dat +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 diff --git a/drivers/py/pes/friction/onheH/100K/init.xyz b/drivers/py/pes/friction/onheH/100K/init.xyz deleted file mode 100644 index 223399063..000000000 --- a/drivers/py/pes/friction/onheH/100K/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/onheH/100K/input.xml b/drivers/py/pes/friction/onheH/100K/input.xml deleted file mode 100644 index bb0d37e40..000000000 --- a/drivers/py/pes/friction/onheH/100K/input.xml +++ /dev/null @@ -1,37 +0,0 @@ - - - [ step, potential{electronvolt}] - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - - - 100 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - true - 0.1 - - - -
diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 deleted file mode 100644 index 1733d1ce7..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -2.323982344186707391e-03 3.527994179292482739e-35 8.819985448231206847e-36 1.365079083143116252e-03 0.000000000000000000e+00 2.071054543382666004e-35 -7.191903135960085128e-04 -3.847557903766458361e-37 0.000000000000000000e+00 -3.620808285761435881e-03 -9.321541887042361518e-37 -2.982893403853555686e-35 -6.599159614588017038e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.895670439563999402e-03 -7.444103960595957545e-37 0.000000000000000000e+00 -1.053646522664873283e-02 6.225071440410660378e-38 -8.866991759720944843e-34 -1.082883742452135818e-02 -2.266974622120167170e-38 9.067898488480668681e-38 -9.843690630716179363e-03 0.000000000000000000e+00 9.738388466915072345e-39 -8.244750383091021054e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.731049368633099085e-03 6.631144365552691460e-34 -2.653015219475852029e-33 -3.335517703435208602e-03 -7.428786968842975345e-34 0.000000000000000000e+00 -1.623403739839834187e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.713952810114227857e-04 0.000000000000000000e+00 1.393447426386403838e-38 2.370765132173587660e-04 1.531525652046075765e-34 -4.763687875726518946e-37 5.573111738564566877e-04 0.000000000000000000e+00 -1.584654554123033909e-37 3.527994179292482739e-35 5.511521610893899137e-01 -6.757307989119387383e-36 0.000000000000000000e+00 5.511521610893899137e-01 -1.955924989020113250e-35 -3.847557903766458361e-37 5.511521610893899137e-01 1.331353186255454648e-37 -9.321541887042361518e-37 5.511521610893899137e-01 -6.412958209326077841e-37 0.000000000000000000e+00 5.511521610893899137e-01 4.997986953781574199e-35 -7.444103960595957545e-37 5.511521610893899137e-01 1.038915404592981723e-37 6.225071440410660378e-38 5.511521610893899137e-01 4.559131623307001418e-39 -2.266974622120167170e-38 5.511521610893899137e-01 -5.718641564800994941e-40 0.000000000000000000e+00 5.511521610893899137e-01 1.148042823678469121e-40 0.000000000000000000e+00 5.511521610893899137e-01 3.505248973832915832e-40 6.631144365552691460e-34 5.511521610893899137e-01 -1.920649576964299505e-38 -7.428786968842975345e-34 5.511521610893899137e-01 -9.675741736153982565e-39 0.000000000000000000e+00 5.511521610893899137e-01 -2.830887319619275506e-39 0.000000000000000000e+00 5.511521610893899137e-01 1.986584622925215256e-40 1.531525652046075765e-34 5.511521610893899137e-01 -7.690496624136721897e-39 0.000000000000000000e+00 5.511521610893899137e-01 -2.597914167207186500e-39 8.819985448231206847e-36 -6.641010126462829524e-33 5.511521610893899137e-01 2.071054543382666004e-35 -6.653812068363911227e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634119683155083895e-33 5.511521610893899137e-01 -2.982893403853555686e-35 -6.634894114294641858e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.584272948935894259e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634148926933250339e-33 5.511521610893899137e-01 -8.866991759720944843e-34 -6.634248259342086451e-33 5.511521610893899137e-01 9.067898488480668681e-38 -6.634253390337866719e-33 5.511521610893899137e-01 9.738388466915072345e-39 -6.634252703669427652e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252467948811814e-33 5.511521610893899137e-01 -2.653015219475852029e-33 -6.634272024969478722e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634262494215445877e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634255649361028698e-33 5.511521610893899137e-01 1.393447426386403838e-38 -6.634252619815247219e-33 5.511521610893899137e-01 -4.763687875726518946e-37 -6.634260508970333666e-33 5.511521610893899137e-01 -1.584654554123033909e-37 -6.634255416387877452e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 deleted file mode 100644 index c311a0108..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -3.964726446082260554e-03 -4.507098883084088552e-32 -7.201562167118422077e-35 2.904798445378655065e-03 0.000000000000000000e+00 2.071054543382666004e-35 7.188445207921641180e-04 -1.711404482112230359e-34 -6.830227696833855974e-34 -2.503634477509287127e-03 -9.321541887042361518e-37 2.275023201476989070e-31 -5.865553316661879790e-03 5.119578043412289853e-33 -1.023915608682457971e-32 -8.494028656009469658e-03 -2.234298728957662959e-35 0.000000000000000000e+00 -1.032114921615769412e-02 6.225071440410660378e-38 6.875599358897587131e-33 -1.090661791063039787e-02 -6.557019384149806738e-34 3.630841650546278385e-37 -9.995255263113346847e-03 1.704250490834644575e-37 1.296605944787125089e-34 -8.456377757354440611e-03 -6.400763224832467466e-38 1.280152644966493493e-37 -5.950231351785508979e-03 -1.637245688330365260e-34 2.308018812853982003e-33 -3.427819305695332681e-03 4.618597612920159235e-35 -1.973278332012501673e-37 -1.614983753456245485e-03 0.000000000000000000e+00 -1.537677698253533473e-33 -3.841376043916996637e-04 -4.549760815274697375e-38 3.668327834023752787e-38 3.892106891732055596e-04 5.289190910915635562e-34 2.398885884329825534e-37 7.630001130318074445e-04 -1.776319618418504809e-37 1.967984682713975918e-37 -4.507098883084088552e-32 5.511521610893899137e-01 -2.756839242978528887e-34 0.000000000000000000e+00 5.511521610893899137e-01 -1.244838884869908586e-33 -1.711404482112230359e-34 5.511521610893899137e-01 -1.489524580823529361e-33 -9.321541887042361518e-37 5.511521610893899137e-01 -3.148915379699196130e-33 5.119578043412289853e-33 5.511521610893899137e-01 2.419231148981757026e-30 -2.234298728957662959e-35 5.511521610893899137e-01 9.751053198461824091e-35 6.225071440410660378e-38 5.511521610893899137e-01 8.464288150576921194e-37 -6.557019384149806738e-34 5.511521610893899137e-01 -1.980638065000206113e-38 1.704250490834644575e-37 5.511521610893899137e-01 1.697807501951614750e-39 -6.400763224832467466e-38 5.511521610893899137e-01 1.999618410828042082e-39 -1.637245688330365260e-34 5.511521610893899137e-01 -4.168430555639474700e-38 4.618597612920159235e-35 5.511521610893899137e-01 -8.024547853602340285e-39 0.000000000000000000e+00 5.511521610893899137e-01 -2.967387558350777435e-39 -4.549760815274697375e-38 5.511521610893899137e-01 7.368411478388321833e-40 5.289190910915635562e-34 5.511521610893899137e-01 -2.759828427987090464e-38 -1.776319618418504809e-37 5.511521610893899137e-01 -1.754118053366753629e-38 -7.201562167118422077e-35 -6.909936742771563360e-33 5.511521610893899137e-01 2.071054543382666004e-35 -7.879091703343619014e-33 5.511521610893899137e-01 -6.830227696833855974e-34 -8.123777399297238250e-33 5.511521610893899137e-01 2.275023201476989070e-31 -9.783168198172905019e-33 5.511521610893899137e-01 -1.023915608682457971e-32 2.412596896163283396e-30 5.511521610893899137e-01 0.000000000000000000e+00 -6.536742286489091973e-33 5.511521610893899137e-01 6.875599358897587131e-33 -6.633406389658652478e-33 5.511521610893899137e-01 3.630841650546278385e-37 -6.634272624854359864e-33 5.511521610893899137e-01 1.296605944787125089e-34 -6.634251120666207604e-33 5.511521610893899137e-01 1.280152644966493493e-37 -6.634250818855298377e-33 5.511521610893899137e-01 2.308018812853982003e-33 -6.634294502779264823e-33 5.511521610893899137e-01 -1.973278332012501673e-37 -6.634260843021563942e-33 5.511521610893899137e-01 -1.537677698253533473e-33 -6.634255785861267154e-33 5.511521610893899137e-01 3.668327834023752787e-38 -6.634252081632561747e-33 5.511521610893899137e-01 2.398885884329825534e-37 -6.634280416757989064e-33 5.511521610893899137e-01 1.967984682713975918e-37 -6.634270359654244149e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 deleted file mode 100644 index 62c897f78..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -3.844010724974936122e-03 -4.515875968214880805e-32 -8.298697808467432324e-35 2.797043896882088487e-03 2.780749780104256225e-31 1.391060774738578121e-31 6.368058476286238105e-04 3.040114182730749323e-31 1.513939394226116981e-31 -2.539512766159894921e-03 -1.759317311544811775e-31 5.157152114740642549e-32 -5.859941045523098767e-03 1.145596502561510285e-31 -1.024286271574577431e-32 -8.471258306207396852e-03 7.602143579118029893e-32 4.752736173654367060e-33 -1.029501419982028522e-02 6.225071440410660378e-38 2.262838224170177394e-33 -1.091549545464691635e-02 3.045775685312478879e-32 -7.778001613719888408e-33 -1.003161068998537769e-02 5.658233454695210541e-37 6.881545100256363342e-34 -8.530502626867756191e-03 2.266791127423502213e-34 -9.069748345652900767e-34 -6.078339722733646679e-03 -1.637245688330365260e-34 -6.248605527877912460e-35 -3.547069841625597689e-03 4.618597612920159235e-35 3.280512313334996993e-37 -1.723130633169183334e-03 1.530175809955914616e-33 -7.780068362451346796e-36 -4.844238294980786168e-04 -1.704911233983017143e-34 3.668327834023752787e-38 2.928034064822703777e-04 5.284082135940964089e-34 7.507660859001154124e-37 6.685482535697628804e-04 1.226145692801611834e-33 1.967984682713975918e-37 -4.515875968214880805e-32 5.511521610893899137e-01 5.667959160145914721e-35 2.780749780104256225e-31 5.511521610893899137e-01 -6.404961486201141219e-34 3.040114182730749323e-31 5.511521610893899137e-01 -1.016399360798333807e-33 -1.759317311544811775e-31 5.511521610893899137e-01 -3.027569273706007140e-33 1.145596502561510285e-31 5.511521610893899137e-01 2.419266634082155738e-30 7.602143579118029893e-32 5.511521610893899137e-01 9.684555902679981271e-35 6.225071440410660378e-38 5.511521610893899137e-01 8.016584457975148506e-37 3.045775685312478879e-32 5.511521610893899137e-01 -2.272037214615348434e-37 5.658233454695210541e-37 5.511521610893899137e-01 5.756735514881372416e-41 2.266791127423502213e-34 5.511521610893899137e-01 -3.847902738474696566e-40 -1.637245688330365260e-34 5.511521610893899137e-01 -6.823693024797313431e-38 4.618597612920159235e-35 5.511521610893899137e-01 -3.011147319032063144e-38 1.530175809955914616e-33 5.511521610893899137e-01 -1.174717736219976340e-38 -1.704911233983017143e-34 5.511521610893899137e-01 3.420570303464206679e-39 5.284082135940964089e-34 5.511521610893899137e-01 -9.060455265737533392e-38 1.226145692801611834e-33 5.511521610893899137e-01 -4.229313988286238627e-38 -8.298697808467432324e-35 -6.577573226872251409e-33 5.511521610893899137e-01 1.391060774738578121e-31 -7.274748967093824978e-33 5.511521610893899137e-01 1.513939394226116981e-31 -7.650652179272043380e-33 5.511521610893899137e-01 5.157152114740642549e-32 -9.661822092179716713e-33 5.511521610893899137e-01 -1.024286271574577431e-32 2.412632381263682107e-30 5.511521610893899137e-01 4.752736173654367060e-33 -6.537407259446910124e-33 5.511521610893899137e-01 2.262838224170177394e-33 -6.633451160027912889e-33 5.511521610893899137e-01 -7.778001613719888408e-33 -6.634480022195171308e-33 5.511521610893899137e-01 6.881545100256363342e-34 -6.634252760906354292e-33 5.511521610893899137e-01 -9.069748345652900767e-34 -6.634253203263982560e-33 5.511521610893899137e-01 -6.248605527877912460e-35 -6.634321055403956282e-33 5.511521610893899137e-01 3.280512313334996993e-37 -6.634282929946901194e-33 5.511521610893899137e-01 -7.780068362451346796e-36 -6.634264565651071176e-33 5.511521610893899137e-01 3.668327834023752787e-38 -6.634249397903405505e-33 5.511521610893899137e-01 7.507660859001154124e-37 -6.634343423026366683e-33 5.511521610893899137e-01 1.967984682713975918e-37 -6.634295111613593346e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener deleted file mode 100644 index 9bcf3e815..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_0.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.07534249265191222 -1 0.07903029912539845 -2 0.08666367678379965 -3 0.09842268087661127 -4 0.11355434606037879 -5 0.12924298041403828 -6 0.14109517869918695 -7 0.146140043383778 -8 0.14303598618102292 -9 0.13423453145300682 -10 0.12212727591480516 -11 0.10840238888887122 -12 0.09580063281316811 -13 0.08594397358858961 -14 0.07935544881777104 -15 0.07608283680265102 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz deleted file mode 100644 index e3d52ef16..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.110494974775892 5.058669140865308e-18 1.9606891733268663e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.126155541613857 7.801381380050172e-18 3.355966630510679e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.157704226665703 4.3298416648170244e-20 -3.967470566801518e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.205378520917434 -1.7837992996077455e-19 -5.169917424945932e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.2688502454488075 -8.861818192669872e-18 1.0538814065371978e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.346586337943941 -2.9659072207340265e-19 9.478529014219023e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.435503246905292 -6.33556523929927e-20 3.2181073634091064e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.531085569707033 -2.937344635272306e-20 1.1821375471170196e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6278358705896463 -2.600367617345723e-20 -1.1078025012559222e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7203764018785046 -1.5647105147559552e-20 -1.9975808226574186e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.804172276380411 -4.7441934416986817e-20 9.932786887499549e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.8760334676810873 1.637783975177227e-20 7.285184485641294e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.9342346319581067 -1.3759115625467283e-20 -1.170783605563105e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.978034425752113 3.064612126372387e-20 -6.811846768202467e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.0072183105726227 4.3231314000195417e-20 2.6547104460322904e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.0217907296879614 -4.893692094788283e-20 -9.882285136444108e-20 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener deleted file mode 100644 index 849997f3a..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_1.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.07633813908845237 -1 0.07993815435275359 -2 0.0873832447059137 -3 0.09884012387294204 -4 0.11359729072786186 -5 0.12899194663969443 -6 0.14079673546292057 -7 0.14608586326175726 -8 0.14342508415573038 -9 0.13502380813500559 -10 0.12335299140664559 -11 0.10997629362632595 -12 0.09754155731894167 -13 0.0877386892032888 -14 0.08116002983587733 -15 0.07788600094393765 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz deleted file mode 100644 index 69bb35902..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.1147584518052622 3.0103876675006253e-18 5.06130803055962e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1299607126443263 2.0830878459365805e-18 1.3409642544856974e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.1606376698723784 1.7078210554274936e-18 1.3878163871833735e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.207075636123037 1.1320317308081352e-18 1.0240182279487162e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.2690396555788586 9.855198069255856e-19 -1.4753318395096646e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.3451282701340035 2.613441947735528e-19 2.3747347183564723e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4324037719447276 5.455806573085085e-20 3.2586333684400432e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5264953062128064 1.3549272166282897e-20 -3.180639543779679e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6220325230017405 3.5224712846901064e-21 8.353361943577026e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.713680417711326 -2.178250929842398e-22 2.6683725915310473e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7968935733616647 4.746469169016884e-21 -4.779897132401548e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.8684062503516645 3.5718627346856325e-21 -8.414056287571892e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.926406653572097 -5.500711929380195e-21 3.210427358056133e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.9700923135882906 1.8090598442687e-21 6.6792453101594045e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.9992115703737214 1.354611426904172e-20 -1.712606242435436e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.0137517720767093 -6.7391613152366666e-21 1.2438590283385887e-20 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener deleted file mode 100644 index 5cec63935..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.07616876475967577 -1 0.07977262815370123 -2 0.08722782891656054 -3 0.0987055255809182 -4 0.11349751279157776 -5 0.12893720191932592 -6 0.1407788079506119 -7 0.14608518936328682 -8 0.14341959972447607 -9 0.1349997355984417 -10 0.12330027818100008 -11 0.1098916237176952 -12 0.09743250000501565 -13 0.08761405341172465 -14 0.08102636597965586 -15 0.07774818265397825 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz deleted file mode 100644 index 22e17c2f9..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.114035157351104 9.750745638242172e-20 1.1641209164344636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1292682319969654 4.595807627492749e-20 2.0750414587060597e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.1600045051184527 4.731083888923977e-20 -4.536697897238496e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.2065282692947035 4.302069425091302e-20 9.351305263315544e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.2685996980556125 2.2136810724253764e-19 1.2625063374363074e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.344811698784781 2.371203134878708e-20 1.1431273613249786e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4322202905834622 4.438275058440399e-21 2.1079851772798616e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5264469455800507 7.136287229651099e-22 1.0760958457380333e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6221167134697954 2.207702091513337e-22 9.32192140065788e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.71388777020622 3.4616538460897865e-22 2.1612954272935584e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7972109236591995 4.673963977601391e-22 9.828594945432954e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.8688194109793805 1.8413990671180204e-22 9.185922344926029e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.9268983793088643 9.962391940347706e-22 1.8904001945221255e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.9706440276607315 6.934583146904018e-22 -6.223275306221227e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.9998041025256246 -5.665789427174645e-22 -8.672860482793619e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.014365293736699 1.5813932809068404e-21 5.834527710486858e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 deleted file mode 100644 index f2a95dfe9..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL.hess_2 +++ /dev/null @@ -1 +0,0 @@ -3.868691719503261281e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.821029077693668410e-03 0.000000000000000000e+00 0.000000000000000000e+00 6.593926001579718948e-04 0.000000000000000000e+00 0.000000000000000000e+00 -2.522414591955846053e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.850033844056849730e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.467167532291274695e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.029352393377242977e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.091554418500154458e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.003107003647626429e-02 0.000000000000000000e+00 0.000000000000000000e+00 -8.528143509325784855e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.072531757908734840e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.540219842558230481e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.715855127579213324e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.769172385684240095e-04 0.000000000000000000e+00 0.000000000000000000e+00 3.005301162559669004e-04 0.000000000000000000e+00 0.000000000000000000e+00 6.763753154811862067e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 -3.009265538105056020e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -5.266214691683848036e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.582768364604810045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.320771541072962210e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener deleted file mode 100644 index 5cec63935..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.07616876475967577 -1 0.07977262815370123 -2 0.08722782891656054 -3 0.0987055255809182 -4 0.11349751279157776 -5 0.12893720191932592 -6 0.1407788079506119 -7 0.14608518936328682 -8 0.14341959972447607 -9 0.1349997355984417 -10 0.12330027818100008 -11 0.1098916237176952 -12 0.09743250000501565 -13 0.08761405341172465 -14 0.08102636597965586 -15 0.07774818265397825 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz deleted file mode 100644 index 22e17c2f9..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.114035157351104 9.750745638242172e-20 1.1641209164344636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.1292682319969654 4.595807627492749e-20 2.0750414587060597e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.1600045051184527 4.731083888923977e-20 -4.536697897238496e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.2065282692947035 4.302069425091302e-20 9.351305263315544e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.2685996980556125 2.2136810724253764e-19 1.2625063374363074e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.344811698784781 2.371203134878708e-20 1.1431273613249786e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4322202905834622 4.438275058440399e-21 2.1079851772798616e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5264469455800507 7.136287229651099e-22 1.0760958457380333e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6221167134697954 2.207702091513337e-22 9.32192140065788e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.71388777020622 3.4616538460897865e-22 2.1612954272935584e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7972109236591995 4.673963977601391e-22 9.828594945432954e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.8688194109793805 1.8413990671180204e-22 9.185922344926029e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.9268983793088643 9.962391940347706e-22 1.8904001945221255e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.9706440276607315 6.934583146904018e-22 -6.223275306221227e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.9998041025256246 -5.665789427174645e-22 -8.672860482793619e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.014365293736699 1.5813932809068404e-21 5.834527710486858e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz deleted file mode 100644 index dfdbd6fef..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_FINAL_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0028739681524728193 -5.3741445307501155e-20 -6.416077588622157e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002924940734903256 -2.5329893058437305e-20 -1.1436635843159249e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0029785921715432036 -2.6075471096756448e-20 2.5004108502726884e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0029333542294848348 -2.371094860795661e-20 -5.1539921048829485e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0026678911141586933 -1.2200751070299244e-19 -6.958330962670714e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0021124643512878106 -1.3068937321703359e-20 -6.300371155946738e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0012863707334477366 -2.4461648899685643e-21 -1.1618205860021964e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00027226984101747013 -3.933180128776819e-22 -5.930925509178318e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0007355906847663502 -1.2167797787791417e-22 -5.137797125478023e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.001593906377818842 -1.907897998215784e-22 -1.1912026455054611e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0022102654197531614 -2.5760653471089673e-22 -5.417051344647627e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002552660041369951 -1.0148910752700834e-22 -5.062840952005297e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027042877108995745 -5.490793847542158e-22 -1.0418981525346726e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0027518542412458074 -3.8220104876702117e-22 3.429971634078064e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027543454479608148 3.1227120870647223e-22 4.780065797918473e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0027472228972053887 -8.715883243040457e-22 -3.215712556570762e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz deleted file mode 100644 index 871f37ff0..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00285984498398131 -2.788096429224122e-18 -1.0806380751036718e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0029158243787779595 -4.29974820709718e-18 -1.849648260949839e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002976886684984842 -2.3864015907387848e-20 2.1866799769512033e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0029362131405775618 9.83144838928549e-20 2.8494111614126444e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0026664239842264675 4.884210248071271e-18 -5.8084901474490246e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0020973977238561863 1.6346661742981848e-19 -5.224111750135299e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0012524916466683767 3.49186047336261e-20 -1.773666827960608e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00022167771070979563 1.6189238435946575e-20 -6.515376637984559e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0007927520592887092 1.433198231926963e-20 6.105677426274331e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0016487613283913875 8.623935816870365e-21 1.1009709873583576e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0022516464237361125 2.6147724680183393e-20 -5.474476958685732e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0025773392545781625 -9.026681773165003e-21 -4.015245173196095e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027160824611352457 7.583366311655086e-21 6.452799143741332e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0027546378417424686 -1.6890675963508918e-20 3.7543640673045666e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002751402634522497 -2.3827032137941705e-20 -1.463149399397275e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002741499340473659 2.6971689737486256e-20 5.446642809452727e-20 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz deleted file mode 100644 index 8e6a3c8c3..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0028767485041119186 -1.6591816686598174e-18 -2.7895508589820186e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002926877633671666 -1.1480983680269885e-18 -7.390753468034148e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002978995374561016 -9.41269265452826e-19 -7.648980009913858e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0029319641844365095 -6.239217348566662e-19 -5.643898593288624e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002665312989009937 -5.431713713834349e-19 8.131323316697366e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0021097825936162015 -1.4404041773761006e-19 -1.3088401720361735e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0012844817902281074 -3.006979583241543e-20 -1.7960028232137282e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0002717419607504435 -7.467710635635139e-21 1.7530163582005415e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0007347461187670165 -1.9414176609322718e-21 -4.603973487564344e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.001592137556816463 1.200547707377611e-22 -1.4706793204140327e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0022083364568336334 -2.6160267400478163e-21 2.634450634308091e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0025511945317676326 -1.9686398653366444e-21 4.6374253064230176e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002703440403219433 3.0317292674080823e-21 -1.7694339764131384e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0027515869778020475 -9.970672427087293e-22 -3.681280487140528e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027545189433933422 -7.465970153746164e-21 9.439066316134703e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002747633066039702 3.7143033228227046e-21 -6.855555915593619e-21 diff --git a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz deleted file mode 100644 index dfdbd6fef..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0028739681524728193 -5.3741445307501155e-20 -6.416077588622157e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002924940734903256 -2.5329893058437305e-20 -1.1436635843159249e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0029785921715432036 -2.6075471096756448e-20 2.5004108502726884e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0029333542294848348 -2.371094860795661e-20 -5.1539921048829485e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0026678911141586933 -1.2200751070299244e-19 -6.958330962670714e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0021124643512878106 -1.3068937321703359e-20 -6.300371155946738e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0012863707334477366 -2.4461648899685643e-21 -1.1618205860021964e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00027226984101747013 -3.933180128776819e-22 -5.930925509178318e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0007355906847663502 -1.2167797787791417e-22 -5.137797125478023e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.001593906377818842 -1.907897998215784e-22 -1.1912026455054611e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0022102654197531614 -2.5760653471089673e-22 -5.417051344647627e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002552660041369951 -1.0148910752700834e-22 -5.062840952005297e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027042877108995745 -5.490793847542158e-22 -1.0418981525346726e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0027518542412458074 -3.8220104876702117e-22 3.429971634078064e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0027543454479608148 3.1227120870647223e-22 4.780065797918473e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0027472228972053887 -8.715883243040457e-22 -3.215712556570762e-22 diff --git a/drivers/py/pes/friction/onheH/100K/inst1D.dat b/drivers/py/pes/friction/onheH/100K/inst1D.dat deleted file mode 100644 index 882931acc..000000000 --- a/drivers/py/pes/friction/onheH/100K/inst1D.dat +++ /dev/null @@ -1,16 +0,0 @@ -2.114035157351104 0.07616876475967577 -2.1292682319969654 0.07977262815370123 -2.1600045051184527 0.08722782891656054 -2.2065282692947035 0.0987055255809182 -2.2685996980556125 0.11349751279157776 -2.344811698784781 0.12893720191932592 -2.4322202905834622 0.1407788079506119 -2.5264469455800507 0.14608518936328682 -2.6221167134697954 0.14341959972447607 -2.71388777020622 0.1349997355984417 -2.7972109236591995 0.12330027818100008 -2.8688194109793805 0.1098916237176952 -2.9268983793088643 0.09743250000501565 -2.9706440276607315 0.08761405341172465 -2.9998041025256246 0.08102636597965586 -3.014365293736699 0.07774818265397825 diff --git a/drivers/py/pes/friction/onheH/120K/RESTART b/drivers/py/pes/friction/onheH/120K/RESTART deleted file mode 100644 index 93d3fdee5..000000000 --- a/drivers/py/pes/friction/onheH/120K/RESTART +++ /dev/null @@ -1,117 +0,0 @@ - - - [ step, potential{electronvolt} ] - - 14 - 30 - - - - - - - - - 3.80017824e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 5.09653038e-03, 5.11916391e-03, 5.16082725e-03, 5.21482601e-03, 5.27230650e-03, - 5.32348663e-03, 5.35919650e-03, 5.37241437e-03, 5.35978776e-03, 5.32393395e-03, - 5.27156666e-03, 5.21107730e-03, 5.15103533e-03, 5.09904304e-03, 5.06096826e-03, - 5.04084489e-03 ] - - - [ -1.48599383e-03, 1.64164289e-19, 8.19075971e-20, -1.43119487e-03, -7.70735038e-22, - -4.54701995e-22, -1.32209699e-03, -5.75957152e-21, 4.10131505e-20, -1.16020840e-03, - -5.28009047e-20, 1.07917949e-19, -9.49148954e-04, 3.85694163e-20, 8.24277519e-20, - -6.96120076e-04, 5.23474386e-21, -1.22026449e-21, -4.12365953e-04, 1.41603696e-21, - -2.25412955e-22, -1.12626617e-04, 4.51869787e-22, -8.90261063e-23, 1.86769891e-04, - 1.53257608e-22, -1.22408190e-22, 4.71870632e-04, 2.08295855e-22, -3.41087647e-23, - 7.31421501e-04, 1.62779005e-22, -1.12473926e-22, 9.56625653e-04, -3.81140907e-23, - 3.11850559e-23, 1.14132565e-03, -2.36371954e-22, 2.31713988e-22, 1.28175179e-03, - 1.12629310e-22, 1.37900803e-22, 1.37591552e-03, 2.70876305e-22, -4.61846477e-23, - 1.42305306e-03, 8.31207096e-23, 1.05017290e-22 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00 ] - - - [ -9.95565823e-03, 0.00000000e+00, 0.00000000e+00, -1.00538687e-02, 0.00000000e+00, - 0.00000000e+00, -1.02369953e-02, 0.00000000e+00, 0.00000000e+00, -1.04787058e-02, - 0.00000000e+00, 0.00000000e+00, -1.07175044e-02, 0.00000000e+00, 0.00000000e+00, - -1.08894754e-02, 0.00000000e+00, 0.00000000e+00, -1.09426612e-02, 0.00000000e+00, - 0.00000000e+00, -1.08412047e-02, 0.00000000e+00, 0.00000000e+00, -1.06105486e-02, - 0.00000000e+00, 0.00000000e+00, -1.03358938e-02, 0.00000000e+00, 0.00000000e+00, - -1.00362979e-02, 0.00000000e+00, 0.00000000e+00, -9.73361271e-03, 0.00000000e+00, - 0.00000000e+00, -9.45217139e-03, 0.00000000e+00, 0.00000000e+00, -9.21497425e-03, - 0.00000000e+00, 0.00000000e+00, -9.03459492e-03, 0.00000000e+00, 0.00000000e+00, - -8.93605286e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - -3.33840396e-33, 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, - 0.00000000e+00, -6.01853108e-33, 5.51152161e-01, 0.00000000e+00, -9.02779661e-33, - 5.51152161e-01, 0.00000000e+00, -4.89005650e-33, 5.51152161e-01, 0.00000000e+00, - -6.67680791e-33, 5.51152161e-01, 0.00000000e+00, -3.29138418e-33, 5.51152161e-01, - 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, - 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, - -6.63272687e-33, 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, 5.51152161e-01, - 0.00000000e+00, -3.31489407e-33, 5.51152161e-01, 0.00000000e+00, -3.31489407e-33, - 5.51152161e-01, 0.00000000e+00, -6.62978814e-33, 5.51152161e-01 ] - - True - - - - - [ 2.41251065e+00, -2.97856563e-19, -1.48611587e-19, 2.41798778e+00, 1.39840700e-21, - 8.25002653e-22, 2.42874003e+00, 1.04500570e-20, -7.44134804e-20, 2.44436524e+00, - 9.58009574e-20, -1.95804275e-19, 2.46426669e+00, -6.99796155e-20, -1.49555346e-19, - 2.48766642e+00, -9.49781972e-21, 2.21402469e-21, 2.51363181e+00, -2.56923054e-21, - 4.08984979e-22, 2.54111699e+00, -8.19863949e-22, 1.61527274e-22, 2.56901719e+00, - -2.78067690e-22, 2.22095091e-22, 2.59622889e+00, -3.77928038e-22, 6.18862941e-23, - 2.62170120e+00, -2.95343130e-22, 2.04070552e-22, 2.64447738e+00, 6.91534814e-23, - -5.65815724e-23, 2.66372727e+00, 4.28868779e-22, -4.20417454e-22, 2.67876999e+00, - -2.04352478e-22, -2.50204594e-22, 2.68908783e+00, -4.91472816e-22, 8.37965466e-23, - 2.69433365e+00, -1.50812635e-22, -1.90541374e-22 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/onheH/120K/clean.sh b/drivers/py/pes/friction/onheH/120K/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/onheH/120K/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/onheH/120K/control.in b/drivers/py/pes/friction/onheH/120K/control.in deleted file mode 100644 index 687e6ee90..000000000 --- a/drivers/py/pes/friction/onheH/120K/control.in +++ /dev/null @@ -1,181 +0,0 @@ -# Physical settings -xc pbe -spin none -relativistic atomic_zora scalar -charge 0.0 -#vdw_correction_hirshfeld - -# k-grid settings (to be adjusted) -k_grid 12 12 12 - -# accuracy requirements -sc_iter_limit 200 -sc_init_iter 200 - -#Mixing settings - mixer pulay - n_max_pulay 10 - charge_mix_param 0.05 - - -# occupation gaussian broadening -occupation_type gaussian 0.1 - -final_forces_cleaned .true. -compute_forces .true. - - -# IPI - output_level MD_light -# use_pimd_wrapper localhost 41000 - use_pimd_wrapper drag092 41111 - -#=============================================================================== - -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for Pd atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species Pd -# global species definitions - nucleus 46 - mass 106.42 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 62 5.0 - radial_multiplier 2 - angular_grids specified - division 0.5211 50 - division 0.9161 110 - division 1.2296 194 - division 1.5678 302 -# division 1.9785 434 -# division 2.0474 590 -# division 2.1195 770 -# division 2.1568 974 -# division 2.7392 1202 -# outer_grid 974 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 5 s 1. - valence 4 p 6. - valence 4 d 9. -# ion occupancy - ion_occ 5 s 0. - ion_occ 4 p 6. - ion_occ 4 d 8. -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A -# -################################################################################ -# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV - ionic 5 p auto - hydro 4 f 8 -# hydro 5 g 10 - hydro 3 s 2.6 - hydro 3 d 2.5 -# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV -# hydro 5 f 17.2 -# hydro 6 h 14 -# hydro 4 d 4 -# hydro 5 f 7.6 -# hydro 3 p 3.3 -# hydro 4 s 9.4 -# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV -# hydro 4 f 20 -# hydro 5 g 12.8 -# hydro 5 d 9.8 -# hydro 6 h 15.2 -# hydro 5 s 10 -# hydro 6 p 9.8 -# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV -# hydro 5 f 9.2 -# hydro 2 s 5.6 -# hydro 5 f 43.2 -# hydro 5 d 13.2 -# hydro 5 g 14 -# hydro 4 p 4.7 -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for H atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species H -# global species definitions - nucleus 1 - mass 1.00794 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 24 5.0 - radial_multiplier 2 - angular_grids specified - division 0.2421 50 - division 0.3822 110 - division 0.4799 194 - division 0.5341 302 -# division 0.5626 434 -# division 0.5922 590 -# division 0.6542 770 -# division 0.6868 1202 -# outer_grid 770 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 1 s 1. -# ion occupancy - ion_occ 1 s 0.5 -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A -# -################################################################################ -# "First tier" - improvements: -1014.90 meV to -62.69 meV - hydro 2 s 2.1 - hydro 2 p 3.5 -# "Second tier" - improvements: -12.89 meV to -1.83 meV -# hydro 1 s 0.85 -# hydro 2 p 3.7 -# hydro 2 s 1.2 -# hydro 3 d 7 -# "Third tier" - improvements: -0.25 meV to -0.12 meV -# hydro 4 f 11.2 -# hydro 3 p 4.8 -# hydro 4 d 9 -# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/onheH/120K/geometry.in b/drivers/py/pes/friction/onheH/120K/geometry.in deleted file mode 100644 index cd6ad1f1f..000000000 --- a/drivers/py/pes/friction/onheH/120K/geometry.in +++ /dev/null @@ -1,11 +0,0 @@ -#=======================================# -# iterations/iteration0105/aims-chain-node-0.56500/geometry.in -#=======================================# -lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 -lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 -lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 -atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd -atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd -atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd -atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd -atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/onheH/120K/get1D.sh b/drivers/py/pes/friction/onheH/120K/get1D.sh deleted file mode 100755 index 5cd175503..000000000 --- a/drivers/py/pes/friction/onheH/120K/get1D.sh +++ /dev/null @@ -1,6 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 -xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/onheH/120K/init.xyz b/drivers/py/pes/friction/onheH/120K/init.xyz deleted file mode 100644 index 223399063..000000000 --- a/drivers/py/pes/friction/onheH/120K/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/onheH/120K/input.xml b/drivers/py/pes/friction/onheH/120K/input.xml deleted file mode 100644 index 0a64e3dd1..000000000 --- a/drivers/py/pes/friction/onheH/120K/input.xml +++ /dev/null @@ -1,37 +0,0 @@ - - - [ step, potential{electronvolt}] - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - - - 120 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - true - 0.1 - - - -
diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 deleted file mode 100644 index 6d4dbd7ca..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ --1.844793918450345679e-03 -1.567081242456171078e-34 -3.917703106140427695e-35 -2.570225761388031382e-03 0.000000000000000000e+00 1.590514041389915588e-34 -4.075415944452323407e-03 0.000000000000000000e+00 -5.922790753146902056e-33 -6.042250189395489621e-03 -5.687396467330943605e-35 0.000000000000000000e+00 -7.976676983024812845e-03 -4.523074012535564999e-35 9.046148025071129997e-35 -9.567185658640033757e-03 -6.872189503342208881e-36 2.748875801336883553e-35 -1.074537748060947970e-02 -2.092676769397021175e-32 -2.168576963105721394e-36 -1.079626042460744319e-02 1.877088961120179563e-33 1.675473633847229671e-36 -9.956807313834512008e-03 0.000000000000000000e+00 3.062093205163796203e-37 -8.715297745290527531e-03 0.000000000000000000e+00 2.495895880555952630e-37 -6.855665941515712118e-03 -8.540912010442597253e-35 0.000000000000000000e+00 -4.800640890364525279e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.193136728024198283e-03 3.502833213263491982e-37 8.757083033158729956e-38 -2.092590758752521825e-03 3.877766069386422763e-36 1.558900932416652391e-37 -1.424062368170926933e-03 5.904403259294428043e-37 -3.690252037059017527e-38 -1.135659604461088405e-03 7.346839692639293793e-38 0.000000000000000000e+00 -1.567081242456171078e-34 5.511521610893899137e-01 6.526926698720301987e-35 0.000000000000000000e+00 5.511521610893899137e-01 3.983397484861065938e-35 0.000000000000000000e+00 5.511521610893899137e-01 1.127472601085943167e-35 -5.687396467330943605e-35 5.511521610893899137e-01 -5.284942574926353738e-35 -4.523074012535564999e-35 5.511521610893899137e-01 -2.064856016153178020e-34 -6.872189503342208881e-36 5.511521610893899137e-01 -2.459798374890074132e-35 -2.092676769397021175e-32 5.511521610893899137e-01 -2.573034422499837086e-36 1.877088961120179563e-33 5.511521610893899137e-01 -1.005958140899873610e-37 0.000000000000000000e+00 5.511521610893899137e-01 -1.073317348486594660e-38 0.000000000000000000e+00 5.511521610893899137e-01 -4.882604914406672795e-39 -8.540912010442597253e-35 5.511521610893899137e-01 1.683457570236023556e-39 0.000000000000000000e+00 5.511521610893899137e-01 -4.302518470835672672e-40 3.502833213263491982e-37 5.511521610893899137e-01 8.377429489516783288e-40 3.877766069386422763e-36 5.511521610893899137e-01 5.298580927293940932e-41 5.904403259294428043e-37 5.511521610893899137e-01 -2.756084885677734129e-40 7.346839692639293793e-38 5.511521610893899137e-01 -2.967057124982023712e-40 -3.917703106140427695e-35 -6.568983551486505912e-33 5.511521610893899137e-01 1.590514041389915588e-34 -6.594418843625099245e-33 5.511521610893899137e-01 -5.922790753146902056e-33 -6.622978092462850400e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.687102244222972672e-33 5.511521610893899137e-01 9.046148025071129997e-35 -6.840738420089027717e-33 5.511521610893899137e-01 2.748875801336883553e-35 -6.658850802222610742e-33 5.511521610893899137e-01 -2.168576963105721394e-36 -6.636825852896209214e-33 5.511521610893899137e-01 1.675473633847229671e-36 -6.634353414287800141e-33 5.511521610893899137e-01 3.062093205163796203e-37 -6.634263551647194515e-33 5.511521610893899137e-01 2.495895880555952630e-37 -6.634257701078623401e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634251135016138842e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253248725555988e-33 5.511521610893899137e-01 8.757083033158729956e-38 -6.634251980730760317e-33 5.511521610893899137e-01 1.558900932416652391e-37 -6.634252765487899621e-33 5.511521610893899137e-01 -3.690252037059017527e-38 -6.634253094082198617e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253115179421646e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 deleted file mode 100644 index 8e3563e3a..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ --5.588390290769351676e-03 -4.778513800279664441e-32 -1.280360420288502258e-34 -6.063077975271012436e-03 0.000000000000000000e+00 4.844034999488235731e-32 -6.942625465958104578e-03 1.288405268714821519e-32 6.855654944762391513e-33 -8.011497376157403205e-03 -5.687396467330943605e-35 -7.372960950250175947e-33 -9.085523438151939940e-03 -7.511081608314641372e-32 1.044245727624339665e-34 -1.009517101919659744e-02 -1.450168842677023220e-32 2.748875801336883553e-35 -1.082180817044043133e-02 2.003708318577403735e-32 -2.168576963105721394e-36 -1.087084760805652299e-02 -3.333201850120244361e-33 1.137609402274975671e-36 -1.033115342074771362e-02 2.379920901475597774e-37 8.670734016379291138e-34 -9.580266204448264350e-03 1.832668450667747749e-37 -2.691526726601033275e-34 -8.619038565384082307e-03 -8.498981806694408055e-35 -2.021035820662732586e-34 -7.400538407583383618e-03 0.000000000000000000e+00 8.525398206091710987e-35 -6.129311879437550695e-03 -7.603312752195839482e-35 5.791888512844881668e-38 -5.084022199422479071e-03 -1.401250545444867159e-35 5.719429193773650986e-37 -4.389808817031836535e-03 1.368977683040576938e-36 6.041464926830159670e-38 -4.059981138815007932e-03 -6.861152144017795913e-35 -1.726717621603182061e-35 -4.778513800279664441e-32 5.511521610893899137e-01 3.186564605354679273e-34 0.000000000000000000e+00 5.511521610893899137e-01 3.815214333743800534e-34 1.288405268714821519e-32 5.511521610893899137e-01 1.027316827045447180e-34 -5.687396467330943605e-35 5.511521610893899137e-01 -5.499608519387215664e-36 -7.511081608314641372e-32 5.511521610893899137e-01 -3.420903972049480002e-34 -1.450168842677023220e-32 5.511521610893899137e-01 -5.519892177093527527e-35 2.003708318577403735e-32 5.511521610893899137e-01 -5.095259606690337328e-36 -3.333201850120244361e-33 5.511521610893899137e-01 -2.927493276716108073e-37 2.379920901475597774e-37 5.511521610893899137e-01 -2.443421671223132694e-38 1.832668450667747749e-37 5.511521610893899137e-01 -7.946927264339651014e-39 -8.498981806694408055e-35 5.511521610893899137e-01 1.269612685861984643e-38 0.000000000000000000e+00 5.511521610893899137e-01 8.254575165101612846e-40 -7.603312752195839482e-35 5.511521610893899137e-01 6.032203647050997826e-40 -1.401250545444867159e-35 5.511521610893899137e-01 -2.626615475226316841e-40 1.368977683040576938e-36 5.511521610893899137e-01 7.887136323419749746e-40 -6.861152144017795913e-35 5.511521610893899137e-01 2.018025521613015468e-40 -1.280360420288502258e-34 -6.315596357938240705e-33 5.511521610893899137e-01 4.844034999488235731e-32 -6.252731385099330503e-33 5.511521610893899137e-01 6.855654944762391513e-33 -6.531521135769165475e-33 5.511521610893899137e-01 -7.372960950250175947e-33 -6.639752426993095832e-33 5.511521610893899137e-01 1.044245727624339665e-34 -6.976343215678657274e-33 5.511521610893899137e-01 2.748875801336883553e-35 -6.689451740244644624e-33 5.511521610893899137e-01 -2.168576963105721394e-36 -6.639348078080399951e-33 5.511521610893899137e-01 1.137609402274975671e-36 -6.634545567801381471e-33 5.511521610893899137e-01 8.670734016379291138e-34 -6.634277252690421925e-33 5.511521610893899137e-01 -2.691526726601033275e-34 -6.634260765400973514e-33 5.511521610893899137e-01 -2.021035820662732586e-34 -6.634240122346850702e-33 5.511521610893899137e-01 8.525398206091710987e-35 -6.634251993016193013e-33 5.511521610893899137e-01 5.791888512844881668e-38 -6.634252215253343970e-33 5.511521610893899137e-01 5.719429193773650986e-37 -6.634253081135255886e-33 5.511521610893899137e-01 6.041464926830159670e-38 -6.634252029760077951e-33 5.511521610893899137e-01 -1.726717621603182061e-35 -6.634252616671156318e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 deleted file mode 100644 index ab5b2d082..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_10 +++ /dev/null @@ -1 +0,0 @@ --9.868424351732116295e-03 -3.548057813447413177e-35 1.057204235843220507e-35 -9.972850903232455960e-03 -3.666650222755512891e-33 4.220669574700557876e-33 -1.016753795575492218e-02 1.926904837446843288e-32 9.787059999616584956e-34 -1.042589833455151611e-02 -2.041559602436486337e-32 1.418125748222338838e-34 -1.068744477503295875e-02 -1.390106159976721131e-32 -8.009988745498082086e-33 -1.087860946893375036e-02 -3.921780115208360533e-33 2.644713646397102897e-33 -1.094345264966271707e-02 -6.279089046424808836e-33 1.611924869161138926e-33 -1.084323678100362030e-02 -2.160711591356828380e-33 7.931660293339623856e-33 -1.060443774369900297e-02 -2.566755108049649413e-34 -2.749160826401761437e-34 -1.031832066398938666e-02 1.586000964559292196e-34 -1.845197102313470686e-37 -1.000508510632024117e-02 2.436929091858534570e-35 -1.180874172115725650e-34 -9.687858797289929103e-03 2.570848761038722167e-35 -1.749003081274201022e-36 -9.392430431187341264e-03 -7.234286005944159204e-37 1.744655943962980417e-35 -9.140319920980683258e-03 -1.699053234513510460e-35 1.461401482440981960e-35 -8.945781037850016396e-03 -8.575384152753861906e-35 7.352467819174687019e-36 -8.839591082546980477e-03 -1.051599344710931691e-34 -2.056272651151197458e-35 -3.548057813447413177e-35 5.511521610893899137e-01 6.489376348244147693e-34 -3.666650222755512891e-33 5.511521610893899137e-01 4.364299210739124307e-34 1.926904837446843288e-32 5.511521610893899137e-01 7.872399146080112182e-35 -2.041559602436486337e-32 5.511521610893899137e-01 -2.168762090578114450e-34 -1.390106159976721131e-32 5.511521610893899137e-01 5.035195578982973858e-34 -3.921780115208360533e-33 5.511521610893899137e-01 -4.329942488997114095e-35 -6.279089046424808836e-33 5.511521610893899137e-01 -4.822466296116420288e-36 -2.160711591356828380e-33 5.511521610893899137e-01 -1.096253633029353021e-38 -2.566755108049649413e-34 5.511521610893899137e-01 -9.644405122985997766e-38 1.586000964559292196e-34 5.511521610893899137e-01 -1.907512028985034036e-38 2.436929091858534570e-35 5.511521610893899137e-01 2.237482371597695967e-38 2.570848761038722167e-35 5.511521610893899137e-01 2.228092124972535550e-39 -7.234286005944159204e-37 5.511521610893899137e-01 3.675539151339159917e-39 -1.699053234513510460e-35 5.511521610893899137e-01 -2.212782360892837514e-40 -8.575384152753861906e-35 5.511521610893899137e-01 -1.842227195882815748e-39 -1.051599344710931691e-34 5.511521610893899137e-01 -4.338619853977773670e-39 1.057204235843220507e-35 -5.985315183649293948e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.197822897399796971e-33 5.511521610893899137e-01 9.787059999616584956e-34 -6.555528827012909039e-33 5.511521610893899137e-01 1.418125748222338838e-34 -6.851129027531519222e-33 5.511521610893899137e-01 -8.009988745498082086e-33 -6.130733260575411503e-33 5.511521610893899137e-01 2.644713646397102897e-33 -6.677552243363678474e-33 5.511521610893899137e-01 1.611924869161138926e-33 -6.639075284769825143e-33 5.511521610893899137e-01 7.931660293339623856e-33 -6.634263781010041219e-33 5.511521610893899137e-01 -2.749160826401761437e-34 -6.634349262524938567e-33 5.511521610893899137e-01 -1.845197102313470686e-37 -6.634271893593999492e-33 5.511521610893899137e-01 -1.180874172115725650e-34 -6.634230443649994890e-33 5.511521610893899137e-01 -1.749003081274201022e-36 -6.634250590381583760e-33 5.511521610893899137e-01 1.744655943962980417e-35 -6.634249142934555330e-33 5.511521610893899137e-01 1.461401482440981960e-35 -6.634253039751945423e-33 5.511521610893899137e-01 7.352467819174687019e-36 -6.634254660700904691e-33 5.511521610893899137e-01 -2.056272651151197458e-35 -6.634257157093563315e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 deleted file mode 100644 index 87a7466c7..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_11 +++ /dev/null @@ -1 +0,0 @@ --9.902225311777477709e-03 -3.313619214813977840e-35 1.057204235843220507e-35 -1.000424263411727951e-02 -3.666650222755512891e-33 4.221304425127935075e-33 -1.019444909176740396e-02 -1.555230515475229183e-32 9.783307294203369453e-34 -1.044653067832154551e-02 -4.597429405224906494e-34 1.408265893441419145e-34 -1.069922636128692837e-02 4.515179624381203403e-33 -8.009988745498082086e-33 -1.088291440408851486e-02 -1.236002367509094764e-32 -5.793529913485485918e-33 -1.094320237598424631e-02 9.612867604888131957e-34 -2.008262020286574087e-33 -1.084247289875383755e-02 5.349677571661660807e-33 -3.333923451188110439e-33 -1.060679346043170469e-02 -2.566718766330127720e-34 -1.131599436920947112e-33 -1.032509547090884779e-02 2.555148544398688306e-35 -1.845197102313470686e-37 -1.001712566604915332e-02 2.436929091858534570e-35 -3.281438086179620585e-36 -9.705517438841501643e-03 -1.609499566480919435e-36 3.714564081674987251e-36 -9.415495349050248194e-03 -7.552091815329605462e-36 -7.640498037222970814e-37 -9.169388105667050301e-03 -8.681079483287195783e-37 -1.763215202221119121e-35 -8.980348698408916613e-03 -2.594007811748756996e-35 7.353034774278100313e-36 -8.877128641047032920e-03 3.908723177560353526e-35 8.286812241818128385e-36 -3.313619214813977840e-35 5.511521610893899137e-01 6.489454424063876771e-34 -3.666650222755512891e-33 5.511521610893899137e-01 4.346963640910233066e-34 -1.555230515475229183e-32 5.511521610893899137e-01 7.841310941351819464e-35 -4.597429405224906494e-34 5.511521610893899137e-01 -2.164953996824901285e-34 4.515179624381203403e-33 5.511521610893899137e-01 5.038810291345607107e-34 -1.236002367509094764e-32 5.511521610893899137e-01 -4.325958259240211516e-35 9.612867604888131957e-34 5.511521610893899137e-01 -4.823004916107075133e-36 5.349677571661660807e-33 5.511521610893899137e-01 -1.338110841226935728e-38 -2.566718766330127720e-34 5.511521610893899137e-01 -9.627062442468288483e-38 2.555148544398688306e-35 5.511521610893899137e-01 -1.907262634969884568e-38 2.436929091858534570e-35 5.511521610893899137e-01 2.237472591300034591e-38 -1.609499566480919435e-36 5.511521610893899137e-01 2.228063793142444568e-39 -7.552091815329605462e-36 5.511521610893899137e-01 3.675333325085929988e-39 -8.681079483287195783e-37 5.511521610893899137e-01 -2.205002509875821821e-40 -2.594007811748756996e-35 5.511521610893899137e-01 -1.843590006970669522e-39 3.908723177560353526e-35 5.511521610893899137e-01 -4.340247687646438361e-39 1.057204235843220507e-35 -5.985307376067321041e-33 5.511521610893899137e-01 4.221304425127935075e-33 -6.199556454382685497e-33 5.511521610893899137e-01 9.783307294203369453e-34 -6.555839709060191432e-33 5.511521610893899137e-01 1.408265893441419145e-34 -6.850748218156197264e-33 5.511521610893899137e-01 -8.009988745498082086e-33 -6.130371789339148092e-33 5.511521610893899137e-01 -5.793529913485485918e-33 -6.677512401066109555e-33 5.511521610893899137e-01 -2.008262020286574087e-33 -6.639075823389815632e-33 5.511521610893899137e-01 -3.333923451188110439e-33 -6.634266199582123324e-33 5.511521610893899137e-01 -1.131599436920947112e-33 -6.634349089098133200e-33 5.511521610893899137e-01 -1.845197102313470686e-37 -6.634271891100059076e-33 5.511521610893899137e-01 -3.281438086179620585e-36 -6.634230443747798406e-33 5.511521610893899137e-01 3.714564081674987251e-36 -6.634250590409916263e-33 5.511521610893899137e-01 -7.640498037222970814e-37 -6.634249143140381989e-33 5.511521610893899137e-01 -1.763215202221119121e-35 -6.634253038973960663e-33 5.511521610893899137e-01 7.353034774278100313e-36 -6.634254662063715343e-33 5.511521610893899137e-01 8.286812241818128385e-36 -6.634257158721397276e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 deleted file mode 100644 index 2d6466b57..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_12 +++ /dev/null @@ -1 +0,0 @@ --9.927765048111537177e-03 -2.011443977082432045e-32 1.057204235843220507e-35 -1.002796292767989088e-02 -3.668813239811254479e-33 -6.228501348291273059e-33 -1.021478570532052300e-02 7.173998783854400067e-33 9.776913982830087745e-34 -1.046198571121990419e-02 -4.589029963377228221e-34 1.399866451593740872e-34 -1.070802588159989327e-02 4.513907831831956221e-33 -8.009988745498082086e-33 -1.088609898280738265e-02 9.669381705138771170e-33 -5.793605008952298009e-33 -1.094297781330335825e-02 9.612902155313571246e-34 -2.008265475329118016e-33 -1.084188785224268758e-02 -4.446268509585000742e-33 -3.333916026608279781e-33 -1.060858654161535991e-02 8.622478687203358323e-34 1.106246253302304640e-33 -1.033024540530419998e-02 2.555361093407560977e-35 -2.318225550698562030e-34 -1.002626950122548384e-02 -5.057609226129689394e-35 -3.280993074047588057e-36 -9.718918835472604295e-03 -1.609499566480919435e-36 3.714693069388648126e-36 -9.432991884363148630e-03 -7.552091815329605462e-36 -7.640498037222970814e-37 -9.191237679210394196e-03 -8.669849802658733879e-37 3.413392443590057546e-36 -9.006341826282560775e-03 -6.420003605293732501e-36 4.639318379866577390e-35 -8.905359836724715400e-03 -1.739817698861146911e-35 8.287711018351045615e-36 -2.011443977082432045e-32 5.511521610893899137e-01 6.489497506316585527e-34 -3.668813239811254479e-33 5.511521610893899137e-01 4.336230070454203546e-34 7.173998783854400067e-33 5.511521610893899137e-01 7.754870471406684682e-35 -4.589029963377228221e-34 5.511521610893899137e-01 -2.186929582723609186e-34 4.513907831831956221e-33 5.511521610893899137e-01 5.002341631531596640e-34 9.669381705138771170e-33 5.511521610893899137e-01 -4.339732010458073995e-35 9.612902155313571246e-34 5.511521610893899137e-01 -4.820953346342914101e-36 -4.446268509585000742e-33 5.511521610893899137e-01 -6.520250876990983877e-39 8.622478687203358323e-34 5.511521610893899137e-01 -9.664527733186605890e-38 2.555361093407560977e-35 5.511521610893899137e-01 -1.909671807794442559e-38 -5.057609226129689394e-35 5.511521610893899137e-01 2.237348104706866034e-38 -1.609499566480919435e-36 5.511521610893899137e-01 2.227411979858108288e-39 -7.552091815329605462e-36 5.511521610893899137e-01 3.665744771525854780e-39 -8.669849802658733879e-37 5.511521610893899137e-01 -2.233203552044558186e-40 -6.420003605293732501e-36 5.511521610893899137e-01 -1.846928196204592839e-39 -1.739817698861146911e-35 5.511521610893899137e-01 -4.341200892215121563e-39 1.057204235843220507e-35 -5.985303067842050422e-33 5.511521610893899137e-01 -6.228501348291273059e-33 -6.200629811428288876e-33 5.511521610893899137e-01 9.776913982830087745e-34 -6.556704113759642320e-33 5.511521610893899137e-01 1.399866451593740872e-34 -6.852945776746067541e-33 5.511521610893899137e-01 -8.009988745498082086e-33 -6.134018655320549139e-33 5.511521610893899137e-01 -5.793605008952298009e-33 -6.677650138578287533e-33 5.511521610893899137e-01 -2.008265475329118016e-33 -6.639073771820051074e-33 5.511521610893899137e-01 -3.333916026608279781e-33 -6.634259338724587569e-33 5.511521610893899137e-01 1.106246253302304640e-33 -6.634349463751040877e-33 5.511521610893899137e-01 -2.318225550698562030e-34 -6.634271915191787133e-33 5.511521610893899137e-01 -3.280993074047588057e-36 -6.634230444992664614e-33 5.511521610893899137e-01 3.714693069388648126e-36 -6.634250591061729423e-33 5.511521610893899137e-01 -7.640498037222970814e-37 -6.634249152728935052e-33 5.511521610893899137e-01 3.413392443590057546e-36 -6.634253041794064243e-33 5.511521610893899137e-01 4.639318379866577390e-35 -6.634254665401905240e-33 5.511521610893899137e-01 8.287711018351045615e-36 -6.634257159674601819e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 deleted file mode 100644 index 4d6a187bf..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_13 +++ /dev/null @@ -1 +0,0 @@ --9.947237777778353274e-03 5.942941363318341162e-33 -1.301895911251038061e-32 -1.004604899092387607e-02 -3.669723799009453785e-33 1.411202530068950833e-32 -1.023029296949770801e-02 -2.231557415983261837e-32 8.350219208675602801e-33 -1.047368956605003627e-02 -4.589029963377228221e-34 -3.366285101580438693e-32 -1.071467427217841391e-02 8.770422656780930550e-32 -2.810526891852891199e-33 -1.088848664192529347e-02 -4.624854170692089522e-33 -5.793620817872429769e-33 -1.094278556624544117e-02 7.093149863425347645e-33 1.057664348617876903e-33 -1.084143706669317246e-02 8.259577284912190470e-33 -1.574561393229840796e-34 -1.060996135469805327e-02 -2.043096127988904558e-33 -1.648423983509208477e-34 -1.033419017538862381e-02 2.555361093407560977e-35 -6.320827581804725141e-36 -1.003326835710795749e-02 4.669842643405745424e-35 -2.759981016748212965e-35 -9.729171297781105329e-03 1.690523431433361121e-35 -9.139666366609560198e-37 -9.446372711405734424e-03 7.873352822768833946e-36 -8.476621312824330679e-36 -9.207828972218895167e-03 -8.669849802658733879e-37 3.072633107337287694e-35 -9.026085339755495970e-03 -6.420003605293732501e-36 -2.960122463394963572e-35 -8.926806212912368962e-03 -6.626416797158785423e-35 -1.614604124063672952e-35 5.942941363318341162e-33 5.511521610893899137e-01 6.499518141831884914e-34 -3.669723799009453785e-33 5.511521610893899137e-01 4.327658922299856640e-34 -2.231557415983261837e-32 5.511521610893899137e-01 7.721335999416937925e-35 -4.589029963377228221e-34 5.511521610893899137e-01 -2.175416811628642725e-34 8.770422656780930550e-32 5.511521610893899137e-01 4.998345527272736732e-34 -4.624854170692089522e-33 5.511521610893899137e-01 -4.337124101218126969e-35 7.093149863425347645e-33 5.511521610893899137e-01 -4.821435788287172786e-36 8.259577284912190470e-33 5.511521610893899137e-01 -8.262803156480014818e-39 -2.043096127988904558e-33 5.511521610893899137e-01 -9.661981138638058929e-38 2.555361093407560977e-35 5.511521610893899137e-01 -1.910060411491565170e-38 4.669842643405745424e-35 5.511521610893899137e-01 2.237279115575144408e-38 1.690523431433361121e-35 5.511521610893899137e-01 2.227404581589329578e-39 7.873352822768833946e-36 5.511521610893899137e-01 3.665831794595633924e-39 -8.669849802658733879e-37 5.511521610893899137e-01 -2.251777149969329604e-40 -6.420003605293732501e-36 5.511521610893899137e-01 -1.839271603128838281e-39 -6.626416797158785423e-35 5.511521610893899137e-01 -4.342829140066460901e-39 -1.301895911251038061e-32 -5.984301004290520226e-33 5.511521610893899137e-01 1.411202530068950833e-32 -6.201486926243723310e-33 5.511521610893899137e-01 8.350219208675602801e-33 -6.557039458479539499e-33 5.511521610893899137e-01 -3.366285101580438693e-32 -6.851794499636571536e-33 5.511521610893899137e-01 -2.810526891852891199e-33 -6.134418265746435216e-33 5.511521610893899137e-01 -5.793620817872429769e-33 -6.677624059485888015e-33 5.511521610893899137e-01 1.057664348617876903e-33 -6.639074254261995709e-33 5.511521610893899137e-01 -1.574561393229840796e-34 -6.634261081276867327e-33 5.511521610893899137e-01 -1.648423983509208477e-34 -6.634349438285094723e-33 5.511521610893899137e-01 -6.320827581804725141e-36 -6.634271919077824517e-33 5.511521610893899137e-01 -2.759981016748212965e-35 -6.634230445682556417e-33 5.511521610893899137e-01 -9.139666366609560198e-37 -6.634250591069127293e-33 5.511521610893899137e-01 -8.476621312824330679e-36 -6.634249152641912227e-33 5.511521610893899137e-01 3.072633107337287694e-35 -6.634253043651423777e-33 5.511521610893899137e-01 -2.960122463394963572e-35 -6.634254657745311697e-33 5.511521610893899137e-01 -1.614604124063672952e-35 -6.634257161302849054e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 deleted file mode 100644 index 896386303..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ --7.683657746373033677e-03 -1.094945353551483560e-32 -1.280360420288502258e-34 -7.962467496073178178e-03 3.812607808704935272e-32 -8.922594239432022975e-33 -8.458554478949668193e-03 -3.946520307165209774e-33 -1.387981493967323468e-32 -9.099575968968671297e-03 -1.448628551933536654e-34 -7.284972059730131856e-33 -9.804278265406802043e-03 3.902233661171743658e-32 5.710651891302211812e-32 -1.047008730431828703e-02 4.423339771679886227e-33 -3.776590587781366374e-32 -1.088852913870834264e-02 1.542681171952462410e-33 -1.479769018802036493e-32 -1.088220466351342425e-02 -1.016292372329106661e-33 9.249513501601398014e-37 -1.049362424202665567e-02 -4.822490262525445139e-37 -3.396033766334288079e-33 -9.967819292644321261e-03 -6.145479154705127814e-37 1.147866935888757052e-35 -9.354944348125910497e-03 -8.498981806694408055e-35 1.288075658851413165e-34 -8.648136870087103772e-03 7.467320170963018569e-38 -1.572845770919617473e-34 -7.865510929246021313e-03 1.237449874791266767e-34 5.791888512844881668e-38 -7.137952698451108073e-03 -1.369913730645784263e-35 8.853110673681947254e-37 -6.581917083017876924e-03 8.286100351770668826e-35 1.139779229859905753e-36 -6.282451551294998895e-03 8.942045094506440456e-35 -1.726717621603182061e-35 -1.094945353551483560e-32 5.511521610893899137e-01 5.539548097867806985e-34 3.812607808704935272e-32 5.511521610893899137e-01 5.057060334819437823e-34 -3.946520307165209774e-33 5.511521610893899137e-01 1.001990968931475965e-34 -1.448628551933536654e-34 5.511521610893899137e-01 -1.936608545986047418e-34 3.902233661171743658e-32 5.511521610893899137e-01 5.356394824785680908e-34 4.423339771679886227e-33 5.511521610893899137e-01 -3.867990610953107801e-35 1.542681171952462410e-33 5.511521610893899137e-01 -4.611181636514234458e-36 -1.016292372329106661e-33 5.511521610893899137e-01 -2.554483517429373363e-37 -4.822490262525445139e-37 5.511521610893899137e-01 -9.098647707496867706e-38 -6.145479154705127814e-37 5.511521610893899137e-01 -1.910753757336841326e-38 -8.498981806694408055e-35 5.511521610893899137e-01 2.234961981161564830e-38 7.467320170963018569e-38 5.511521610893899137e-01 2.247744037615646491e-39 1.237449874791266767e-34 5.511521610893899137e-01 3.829313839379017580e-39 -1.369913730645784263e-35 5.511521610893899137e-01 6.068960590942114352e-40 8.286100351770668826e-35 5.511521610893899137e-01 -2.100266994217835838e-39 8.942045094506440456e-35 5.511521610893899137e-01 -5.210747280761544654e-39 -1.280360420288502258e-34 -6.080298008686928105e-33 5.511521610893899137e-01 -8.922594239432022975e-33 -6.128546784991766646e-33 5.511521610893899137e-01 -1.387981493967323468e-32 -6.534053721580562661e-33 5.511521610893899137e-01 -7.284972059730131856e-33 -6.827913673072313802e-33 5.511521610893899137e-01 5.710651891302211812e-32 -6.098613335995141311e-33 5.511521610893899137e-01 -3.776590587781366374e-32 -6.672932724583239785e-33 5.511521610893899137e-01 -1.479769018802036493e-32 -6.638864000110223981e-33 5.511521610893899137e-01 9.249513501601398014e-37 -6.634508266825452658e-33 5.511521610893899137e-01 -3.396033766334288079e-33 -6.634343804950784516e-33 5.511521610893899137e-01 1.147866935888757052e-35 -6.634271926011282367e-33 5.511521610893899137e-01 1.288075658851413165e-34 -6.634230468853898231e-33 5.511521610893899137e-01 -1.572845770919617473e-34 -6.634250570729671462e-33 5.511521610893899137e-01 5.791888512844881668e-38 -6.634248989159868898e-33 5.511521610893899137e-01 8.853110673681947254e-37 -6.634252211577649148e-33 5.511521610893899137e-01 1.139779229859905753e-36 -6.634254918740704556e-33 5.511521610893899137e-01 -1.726717621603182061e-35 -6.634258029220988589e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 deleted file mode 100644 index caf73a56a..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ --8.607620007990621908e-03 -1.094945353551483560e-32 -8.801392983525031840e-35 -8.803611330394513212e-03 -4.362219561358649930e-33 1.595458035601567978e-32 -9.168216954730351934e-03 -3.946520307165209774e-33 1.329042368203254227e-32 -9.650342484902834153e-03 2.858342955172657378e-32 2.405026697192608925e-32 -1.018237501028397898e-02 3.896906606343959799e-32 1.821901867020004546e-32 -1.066735212525686712e-02 4.410419393623789935e-33 -1.067510318869429580e-32 -1.092581521299340608e-02 1.751268505101788635e-32 -8.232263563212553530e-34 -1.086506618421353466e-02 2.005693642144614116e-32 9.249513501601398014e-37 -1.052638568155694031e-02 -4.822490262525445139e-37 5.622328503261207836e-34 -1.008976858099529250e-02 -5.758285667671030088e-37 5.516377453350961148e-35 -9.592150790658303394e-03 -2.760591546153103335e-35 -7.216985524453955627e-35 -9.065241372394693131e-03 1.531045243189696841e-37 -3.382714301785297943e-36 -8.497863276321937151e-03 1.351183689514408751e-35 5.791888512844881668e-38 -7.965690107146381274e-03 -1.378534355504053636e-35 8.853110673681947254e-37 -7.556174453969249916e-03 -8.016935091118023348e-36 -1.200308055819063675e-34 -7.334239346563627832e-03 -1.448963511156928913e-34 -1.726717621603182061e-35 -1.094945353551483560e-32 5.511521610893899137e-01 6.444573335237415048e-34 -4.362219561358649930e-33 5.511521610893899137e-01 5.051404972309055377e-34 -3.946520307165209774e-33 5.511521610893899137e-01 8.740274420353453862e-35 2.858342955172657378e-32 5.511521610893899137e-01 -1.948918230574975244e-34 3.896906606343959799e-32 5.511521610893899137e-01 4.705336735613113510e-34 4.410419393623789935e-33 5.511521610893899137e-01 -4.110785565369038095e-35 1.751268505101788635e-32 5.511521610893899137e-01 -4.743568074250794867e-36 2.005693642144614116e-32 5.511521610893899137e-01 -5.842808582389982516e-38 -4.822490262525445139e-37 5.511521610893899137e-01 -9.395047090619620727e-38 -5.758285667671030088e-37 5.511521610893899137e-01 -1.898898373541692040e-38 -2.760591546153103335e-35 5.511521610893899137e-01 2.230068039787943873e-38 1.531045243189696841e-37 5.511521610893899137e-01 2.214395134855836464e-39 1.351183689514408751e-35 5.511521610893899137e-01 3.895248133874028789e-39 -1.378534355504053636e-35 5.511521610893899137e-01 1.598451939997100758e-40 -8.016935091118023348e-36 5.511521610893899137e-01 -1.671030369686858874e-39 -1.448963511156928913e-34 5.511521610893899137e-01 -4.100999843812265794e-39 -8.801392983525031840e-35 -5.989795484949967384e-33 5.511521610893899137e-01 1.595458035601567978e-32 -6.129112321242804634e-33 5.511521610893899137e-01 1.329042368203254227e-32 -6.546850074270176274e-33 5.511521610893899137e-01 2.405026697192608925e-32 -6.829144641531206242e-33 5.511521610893899137e-01 1.821901867020004546e-32 -6.163719144912397623e-33 5.511521610893899137e-01 -1.067510318869429580e-32 -6.675360674127399334e-33 5.511521610893899137e-01 -8.232263563212553530e-34 -6.638996386547960276e-33 5.511521610893899137e-01 9.249513501601398014e-37 -6.634311246559533651e-33 5.511521610893899137e-01 5.622328503261207836e-34 -6.634346768944616169e-33 5.511521610893899137e-01 5.516377453350961148e-35 -6.634271807457444605e-33 5.511521610893899137e-01 -7.216985524453955627e-35 -6.634230517793312442e-33 5.511521610893899137e-01 -3.382714301785297943e-36 -6.634250604078574231e-33 5.511521610893899137e-01 5.791888512844881668e-38 -6.634248923225573966e-33 5.511521610893899137e-01 8.853110673681947254e-37 -6.634252658628514718e-33 5.511521610893899137e-01 -1.200308055819063675e-34 -6.634254489504079720e-33 5.511521610893899137e-01 -1.726717621603182061e-35 -6.634256919473551726e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 deleted file mode 100644 index 537f1d14f..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ --9.086077053294748518e-03 3.280508577441292417e-34 3.007597648259515112e-34 -9.246680607691263806e-03 -5.614275836456797716e-32 -9.962270431011574462e-33 -9.545795766419363018e-03 -3.938665219294184879e-33 -7.937488707153012805e-34 -9.942147027570933521e-03 -3.667836341889934025e-33 7.914323518118598763e-33 -1.038078477738539444e-02 -4.036061275108907966e-32 -2.143803262801122709e-32 -1.075601370660111793e-02 -9.183456427301159067e-33 3.702641030586628948e-34 -1.093729447168807246e-02 3.028562236622764671e-33 2.797783570786699195e-33 -1.085854873774397093e-02 -1.138183708133174051e-32 4.288027900952963527e-33 -1.055498419606750241e-02 -4.822490262525445139e-37 -9.669756109447400492e-34 -1.017295308595549640e-02 7.251029725829586714e-35 -9.104912568492838343e-35 -9.743245562094398141e-03 -2.761715234916612875e-35 3.375466604770666261e-35 -9.300261471325137544e-03 1.531045243189696841e-37 -3.914772531501313417e-35 -8.852677378349259676e-03 -4.598084298829680887e-35 9.380108047431184401e-38 -8.430800244879084471e-03 -1.378534355504053636e-35 5.349316749885212737e-35 -8.104918681414894147e-03 -8.065179494806608274e-36 2.629447080557124472e-35 -7.927897784512999424e-03 4.317616698614554330e-35 -1.722231158862203099e-35 3.280508577441292417e-34 5.511521610893899137e-01 6.444586021620585211e-34 -5.614275836456797716e-32 5.511521610893899137e-01 4.473082730082651198e-34 -3.938665219294184879e-33 5.511521610893899137e-01 8.559425618313060533e-35 -3.667836341889934025e-33 5.511521610893899137e-01 -2.134001213973662245e-34 -4.036061275108907966e-32 5.511521610893899137e-01 4.952920114455928441e-34 -9.183456427301159067e-33 5.511521610893899137e-01 -4.121487496508556945e-35 3.028562236622764671e-33 5.511521610893899137e-01 -4.747176326028734115e-36 -1.138183708133174051e-32 5.511521610893899137e-01 -5.743299189525879091e-38 -4.822490262525445139e-37 5.511521610893899137e-01 -9.415543327697148624e-38 7.251029725829586714e-35 5.511521610893899137e-01 -1.907694018287814270e-38 -2.761715234916612875e-35 5.511521610893899137e-01 2.228642707909145308e-38 1.531045243189696841e-37 5.511521610893899137e-01 2.232931740499949373e-39 -4.598084298829680887e-35 5.511521610893899137e-01 3.679050850107518655e-39 -1.378534355504053636e-35 5.511521610893899137e-01 -2.397448533929844929e-40 -8.065179494806608274e-36 5.511521610893899137e-01 -1.882297546228780559e-39 4.317616698614554330e-35 5.511521610893899137e-01 -4.404971737055055346e-39 3.007597648259515112e-34 -5.989794216311650025e-33 5.511521610893899137e-01 -9.962270431011574462e-33 -6.186944545465444453e-33 5.511521610893899137e-01 -7.937488707153012805e-34 -6.548658562290580432e-33 5.511521610893899137e-01 7.914323518118598763e-33 -6.847652939871074301e-33 5.511521610893899137e-01 -2.143803262801122709e-32 -6.138960807028116216e-33 5.511521610893899137e-01 3.702641030586628948e-34 -6.675467693438794458e-33 5.511521610893899137e-01 2.797783570786699195e-33 -6.638999994799738652e-33 5.511521610893899137e-01 4.288027900952963527e-33 -6.634310251465605014e-33 5.511521610893899137e-01 -9.669756109447400492e-34 -6.634346973906986617e-33 5.511521610893899137e-01 -9.104912568492838343e-35 -6.634271895413892081e-33 5.511521610893899137e-01 3.375466604770666261e-35 -6.634230532046630720e-33 5.511521610893899137e-01 -3.914772531501313417e-35 -6.634250585541968244e-33 5.511521610893899137e-01 9.380108047431184401e-38 -6.634249139422857588e-33 5.511521610893899137e-01 5.349316749885212737e-35 -6.634253058218561751e-33 5.511521610893899137e-01 2.629447080557124472e-35 -6.634254700771255968e-33 5.511521610893899137e-01 -1.722231158862203099e-35 -6.634257223445445190e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 deleted file mode 100644 index 828fe741b..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ --9.371858484379335524e-03 -1.852889974128036437e-32 -1.413101194175751078e-34 -9.511839615010377058e-03 2.743675540454953152e-33 -9.962270431011574462e-33 -9.772647453376257301e-03 -3.929645200666078991e-33 -7.937488707153012805e-34 -1.011849586029082114e-02 -3.667836341889934025e-33 -4.310261054838937576e-33 -1.049917340334565082e-02 4.769304901532531838e-33 -2.142906805182756210e-32 -1.080524779499867499e-02 -9.183456427301159067e-33 2.105009780875418151e-32 -1.094186384529378248e-02 3.028659871111240576e-33 2.797734753542461414e-33 -1.085332768490145441e-02 7.208817435389728047e-33 -5.007192395309128500e-33 -1.057186835357476658e-02 -4.392462018071927464e-37 1.116812253203671448e-33 -1.022352380055014873e-02 -3.572261486948745331e-35 -9.881864971267005870e-36 -9.835199408554314709e-03 -2.761715234916612875e-35 -3.633124608876359252e-35 -9.437286601298005770e-03 1.512974561806539015e-37 6.762831684178967506e-35 -9.054221486334102648e-03 -1.480842556865533425e-36 4.459380151190558909e-35 -8.696291322380049829e-03 -1.376959549320059187e-35 -6.919762769329016876e-37 -8.419120682922996354e-03 -8.038075651905559881e-36 -1.114290328114514210e-36 -8.268358297383593403e-03 -9.791981235189324550e-35 -1.717186611871211465e-35 -1.852889974128036437e-32 5.511521610893899137e-01 6.445232484160883299e-34 2.743675540454953152e-33 5.511521610893899137e-01 4.289167000832361793e-34 -3.929645200666078991e-33 5.511521610893899137e-01 7.891130626148302022e-35 -3.667836341889934025e-33 5.511521610893899137e-01 -2.142119279263547776e-34 4.769304901532531838e-33 5.511521610893899137e-01 5.074267034631560581e-34 -9.183456427301159067e-33 5.511521610893899137e-01 -4.500376817632599210e-35 3.028659871111240576e-33 5.511521610893899137e-01 -4.822002265240567423e-36 7.208817435389728047e-33 5.511521610893899137e-01 5.425157647933234206e-38 -4.392462018071927464e-37 5.511521610893899137e-01 -9.931351087080197144e-38 -3.572261486948745331e-35 5.511521610893899137e-01 -1.909233122530658661e-38 -2.761715234916612875e-35 5.511521610893899137e-01 2.222961148690479262e-38 1.512974561806539015e-37 5.511521610893899137e-01 2.223335777034155559e-39 -1.480842556865533425e-36 5.511521610893899137e-01 3.681830753002855573e-39 -1.376959549320059187e-35 5.511521610893899137e-01 -2.316020346714874476e-40 -8.038075651905559881e-36 5.511521610893899137e-01 -1.856914268606710023e-39 -9.791981235189324550e-35 5.511521610893899137e-01 -4.235986828191193432e-39 -1.413101194175751078e-34 -5.989729570057620131e-33 5.511521610893899137e-01 -9.962270431011574462e-33 -6.205336118390473052e-33 5.511521610893899137e-01 -7.937488707153012805e-34 -6.555341512212227761e-33 5.511521610893899137e-01 -4.310261054838937576e-33 -6.848464746400062383e-33 5.511521610893899137e-01 -2.142906805182756210e-32 -6.126826115010552916e-33 5.511521610893899137e-01 2.105009780875418151e-32 -6.679256586650035004e-33 5.511521610893899137e-01 2.797734753542461414e-33 -6.639074820738949858e-33 5.511521610893899137e-01 -5.007192395309128500e-33 -6.634198566897230464e-33 5.511521610893899137e-01 1.116812253203671448e-33 -6.634352131984579857e-33 5.511521610893899137e-01 -9.881864971267005870e-36 -6.634271910804934709e-33 5.511521610893899137e-01 -3.633124608876359252e-35 -6.634230588862223586e-33 5.511521610893899137e-01 6.762831684178967506e-35 -6.634250595137931493e-33 5.511521610893899137e-01 4.459380151190558909e-35 -6.634249136642955126e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253050075743641e-33 5.511521610893899137e-01 -1.114290328114514210e-36 -6.634254675387978213e-33 5.511521610893899137e-01 -1.717186611871211465e-35 -6.634257054460537002e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 deleted file mode 100644 index 034ddf354..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ --9.553630321826211969e-03 8.721535201734810339e-33 1.835321613649817518e-35 -9.680559196989051846e-03 2.751639046152152281e-33 4.216751462851557953e-33 -9.917096654661851016e-03 -3.929645200666078991e-33 -2.720947173642478541e-33 -1.023090766060057687e-02 1.398925429899489530e-32 -4.308717063002554098e-33 -1.057106606169064614e-02 4.769304901532531838e-33 -2.143023579452411139e-32 -1.083408663833263647e-02 5.735690802932153798e-33 -8.788747743143823605e-33 -1.094348213546939529e-02 -9.765938184179825558e-33 2.797709421843075081e-33 -1.084985912194225133e-02 7.208817435389728047e-33 -5.007246670725276420e-33 -1.058338802230642146e-02 -4.278560452653223183e-37 1.116778082734045801e-33 -1.025728877465494245e-02 -3.572261486948745331e-35 -3.237516199746703272e-34 -9.896005928326649312e-03 -2.761715234916612875e-35 -3.631816879968349363e-35 -9.527274981629625314e-03 1.512974561806539015e-37 2.362825692489420443e-36 -9.179959720420032346e-03 -2.968433122342335515e-35 -3.598608957408384762e-35 -8.862237342780986127e-03 -1.376959549320059187e-35 -6.919762769329016876e-37 -8.615703610758895445e-03 5.200257219755122757e-36 -1.434906737574305550e-35 -8.481459242568314613e-03 4.270173642693946453e-36 3.392312687858148133e-35 8.721535201734810339e-33 5.511521610893899137e-01 6.445155346308582710e-34 2.751639046152152281e-33 5.511521610893899137e-01 4.335006249794280957e-34 -3.929645200666078991e-33 5.511521610893899137e-01 7.833162807595248057e-35 1.398925429899489530e-32 5.511521610893899137e-01 -2.118924417524417287e-34 4.769304901532531838e-33 5.511521610893899137e-01 5.097191741483386808e-34 5.735690802932153798e-33 5.511521610893899137e-01 -4.562140702455634110e-35 -9.765938184179825558e-33 5.511521610893899137e-01 -4.829023698641043760e-36 7.208817435389728047e-33 5.511521610893899137e-01 7.184529163198608359e-38 -4.278560452653223183e-37 5.511521610893899137e-01 -1.001037806687179133e-37 -3.572261486948745331e-35 5.511521610893899137e-01 -1.901484066976878335e-38 -2.761715234916612875e-35 5.511521610893899137e-01 2.231927541084822217e-38 1.512974561806539015e-37 5.511521610893899137e-01 2.221701661625430430e-39 -2.968433122342335515e-35 5.511521610893899137e-01 3.681165906354641304e-39 -1.376959549320059187e-35 5.511521610893899137e-01 -2.249470688975192070e-40 5.200257219755122757e-36 5.511521610893899137e-01 -1.861230274418028611e-39 4.270173642693946453e-36 5.511521610893899137e-01 -4.231639208890335665e-39 1.835321613649817518e-35 -5.989737283842850361e-33 5.511521610893899137e-01 4.216751462851557953e-33 -6.200752193494281392e-33 5.511521610893899137e-01 -2.720947173642478541e-33 -6.555921190397758375e-33 5.511521610893899137e-01 -4.308717063002554098e-33 -6.846145260226149548e-33 5.511521610893899137e-01 -2.143023579452411139e-32 -6.124533644325370636e-33 5.511521610893899137e-01 -8.788747743143823605e-33 -6.679874225498265470e-33 5.511521610893899137e-01 2.797709421843075081e-33 -6.639081842172350878e-33 5.511521610893899137e-01 -5.007246670725276420e-33 -6.634180973182078041e-33 5.511521610893899137e-01 1.116778082734045801e-33 -6.634352922254378055e-33 5.511521610893899137e-01 -3.237516199746703272e-34 -6.634271833314379032e-33 5.511521610893899137e-01 -3.631816879968349363e-35 -6.634230499198299405e-33 5.511521610893899137e-01 2.362825692489420443e-36 -6.634250596772046665e-33 5.511521610893899137e-01 -3.598608957408384762e-35 -6.634249137307801456e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253043420777440e-33 5.511521610893899137e-01 -1.434906737574305550e-35 -6.634254679703984325e-33 5.511521610893899137e-01 3.392312687858148133e-35 -6.634257050112918199e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 deleted file mode 100644 index 2dddda7e7..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ --9.675994700830898784e-03 8.725153104000310727e-33 1.835321613649817518e-35 -9.794163419385508787e-03 5.237681014342732527e-33 4.220669574700557876e-33 -1.001440857753501182e-02 1.476134084230946998e-33 -2.723262437473258206e-33 -1.030670572822080071e-02 -1.078878790396505221e-32 -4.308717063002554098e-33 -1.061764264784230416e-02 4.769304901532531838e-33 9.050328248238460216e-33 -1.085228552049427760e-02 5.736777425983735391e-33 1.216134469134623593e-32 -1.094393325567382877e-02 -7.743453337211273130e-34 1.178930227230177333e-32 -1.084737814788290511e-02 -2.160723073086249598e-33 1.373205170417753286e-32 -1.059138057924124444e-02 -1.059772494183510065e-33 -1.001933421597295691e-33 -1.028058222311836745e-02 -3.573026705062310408e-35 3.355143935862735681e-34 -9.937772244992140389e-03 7.960028006841248327e-36 3.483940082189706412e-35 -9.588895240323785235e-03 1.475732557662078691e-37 2.362825692489420443e-36 -9.262800022019075652e-03 -1.243238793526867021e-37 4.307879652875249860e-35 -8.971788132543154909e-03 -1.376147720670687359e-35 -6.919762769329016876e-37 -8.745622053529260656e-03 5.203750921988232234e-36 -1.433509256681061759e-35 -8.622362921700278335e-03 4.270173642693946453e-36 3.393613299020143254e-35 8.725153104000310727e-33 5.511521610893899137e-01 6.489660406808336632e-34 5.237681014342732527e-33 5.511521610893899137e-01 4.344934883254713123e-34 1.476134084230946998e-33 5.511521610893899137e-01 7.826217910763135596e-35 -1.078878790396505221e-32 5.511521610893899137e-01 -2.130797690980879791e-34 4.769304901532531838e-33 5.511521610893899137e-01 5.007527201593661052e-34 5.736777425983735391e-33 5.511521610893899137e-01 -4.409242883156549477e-35 -7.743453337211273130e-34 5.511521610893899137e-01 -4.821165950706719759e-36 -2.160723073086249598e-33 5.511521610893899137e-01 1.970778879727482225e-38 -1.059772494183510065e-33 5.511521610893899137e-01 -9.783961764716394357e-38 -3.573026705062310408e-35 5.511521610893899137e-01 -1.908132521111938316e-38 7.960028006841248327e-36 5.511521610893899137e-01 2.233080335705438867e-38 1.475732557662078691e-37 5.511521610893899137e-01 2.212535364741841454e-39 -1.243238793526867021e-37 5.511521610893899137e-01 3.681172664484861473e-39 -1.376147720670687359e-35 5.511521610893899137e-01 -2.179126760025143967e-40 5.203750921988232234e-36 5.511521610893899137e-01 -1.848992929809236915e-39 4.270173642693946453e-36 5.511521610893899137e-01 -4.290757406275453805e-39 1.835321613649817518e-35 -5.985286777792875054e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.199759330148238175e-33 5.511521610893899137e-01 -2.723262437473258206e-33 -6.555990639366079318e-33 5.511521610893899137e-01 -4.308717063002554098e-33 -6.847332587571795970e-33 5.511521610893899137e-01 9.050328248238460216e-33 -6.133500098314343468e-33 5.511521610893899137e-01 1.216134469134623593e-32 -6.678345247305274191e-33 5.511521610893899137e-01 1.178930227230177333e-32 -6.639073984424416382e-33 5.511521610893899137e-01 1.373205170417753286e-32 -6.634233110684913248e-33 5.511521610893899137e-01 -1.001933421597295691e-33 -6.634350658091355943e-33 5.511521610893899137e-01 3.355143935862735681e-34 -6.634271899798920354e-33 5.511521610893899137e-01 3.483940082189706412e-35 -6.634230487670353373e-33 5.511521610893899137e-01 2.362825692489420443e-36 -6.634250605938343615e-33 5.511521610893899137e-01 4.307879652875249860e-35 -6.634249137301042654e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253036386385047e-33 5.511521610893899137e-01 -1.433509256681061759e-35 -6.634254667466639157e-33 5.511521610893899137e-01 3.393613299020143254e-35 -6.634257109231115396e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 deleted file mode 100644 index bf6967518..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_8 +++ /dev/null @@ -1 +0,0 @@ --9.761566529290667885e-03 3.468444610366646860e-35 2.174547694704099639e-35 -9.873618727809820028e-03 -2.200076546241211121e-32 4.220669574700557876e-33 -1.008248808191321635e-02 -2.225129075007191590e-33 9.782721151626834629e-34 -1.035976222799318142e-02 6.179135442191293317e-33 2.962427835669273619e-32 -1.064923218181832755e-02 4.767147172568817375e-33 1.222357284003711593e-33 -1.086435699964922313e-02 5.736267905118815280e-33 -2.184215260472968458e-33 -1.094390967556694259e-02 -7.743449672981820209e-34 -6.676482019585860112e-33 -1.084557834102142966e-02 -2.160723073086249598e-33 1.373202637753849358e-32 -1.059711561127673826e-02 3.942621837307290288e-34 -2.749160826401761437e-34 -1.029719673283884321e-02 -1.110605340996019837e-34 1.095199955206983212e-34 -9.967457139994665913e-03 7.953998141874483841e-36 3.483940082189706412e-35 -9.632588378195217418e-03 -7.414083595345841188e-35 2.362825692489420443e-36 -9.320164164231193454e-03 6.178632241741609018e-35 -4.978717291640066673e-35 -9.047349137447497497e-03 1.365375818171412813e-35 -6.919762769329016876e-37 -8.835312553158072846e-03 5.203750921988232234e-36 1.108771528341890199e-35 -8.719677068908847709e-03 4.264069739138928570e-36 -1.513925159214408198e-35 3.468444610366646860e-35 5.511521610893899137e-01 6.489366001378982617e-34 -2.200076546241211121e-32 5.511521610893899137e-01 4.371226880393788960e-34 -2.225129075007191590e-33 5.511521610893899137e-01 7.822235702157035972e-35 6.179135442191293317e-33 5.511521610893899137e-01 -2.159951811081868561e-34 4.767147172568817375e-33 5.511521610893899137e-01 5.001843964221268940e-34 5.736267905118815280e-33 5.511521610893899137e-01 -4.344985535380994505e-35 -7.743449672981820209e-34 5.511521610893899137e-01 -4.821418746832991481e-36 -2.160723073086249598e-33 5.511521610893899137e-01 -2.967796250072596161e-39 3.942621837307290288e-34 5.511521610893899137e-01 -9.709761495844309539e-38 -1.110605340996019837e-34 5.511521610893899137e-01 -1.905830572756574118e-38 7.953998141874483841e-36 5.511521610893899137e-01 2.237494597622734718e-38 -7.414083595345841188e-35 5.511521610893899137e-01 2.229448834505853501e-39 6.178632241741609018e-35 5.511521610893899137e-01 3.676245823515707394e-39 1.365375818171412813e-35 5.511521610893899137e-01 -2.212085880431606416e-40 5.203750921988232234e-36 5.511521610893899137e-01 -1.814485657454794019e-39 4.264069739138928570e-36 5.511521610893899137e-01 -4.322018856888928386e-39 2.174547694704099639e-35 -5.985316218335810456e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.197130130434330506e-33 5.511521610893899137e-01 9.782721151626834629e-34 -6.556030461452140261e-33 5.511521610893899137e-01 2.962427835669273619e-32 -6.850247999581895061e-33 5.511521610893899137e-01 1.222357284003711593e-33 -6.134068422051582593e-33 5.511521610893899137e-01 -2.184215260472968458e-33 -6.677702673827518059e-33 5.511521610893899137e-01 -6.676482019585860112e-33 -6.639074237220542341e-33 5.511521610893899137e-01 1.373202637753849358e-32 -6.634255786269960504e-33 5.511521610893899137e-01 -2.749160826401761437e-34 -6.634349916088667544e-33 5.511521610893899137e-01 1.095199955206983212e-34 -6.634271876779437419e-33 5.511521610893899137e-01 3.483940082189706412e-35 -6.634230443527734335e-33 5.511521610893899137e-01 2.362825692489420443e-36 -6.634250589024873682e-33 5.511521610893899137e-01 -4.978717291640066673e-35 -6.634249142227883525e-33 5.511521610893899137e-01 -6.919762769329016876e-37 -6.634253039682296510e-33 5.511521610893899137e-01 1.108771528341890199e-35 -6.634254632959366149e-33 5.511521610893899137e-01 -1.513925159214408198e-35 -6.634257140492566518e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 b/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 deleted file mode 100644 index e08716fab..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton.hess_9 +++ /dev/null @@ -1 +0,0 @@ --9.823156452711789485e-03 -3.412515338615880321e-35 9.054607347997894087e-35 -9.930811794884558674e-03 -3.668118341954914236e-33 4.220669574700557876e-33 -1.013150373698043331e-02 -7.207469828588667671e-33 9.782721151626834629e-34 -1.039796929762655878e-02 -5.242541807784502411e-33 6.779631957945763150e-33 -1.067143203180545043e-02 4.767147172568817375e-33 2.932729164998733533e-32 -1.087268828496573518e-02 -3.921678222871888738e-33 2.644815538733574351e-33 -1.094370675954036386e-02 -7.743449672981820209e-34 1.611924869161138926e-33 -1.084424169137210292e-02 -2.160711591356828380e-33 -3.495723050610696676e-33 -1.060131263806711813e-02 3.942621837307290288e-34 -2.749160826401761437e-34 -1.030931796982789868e-02 -1.110540127309965361e-34 5.880249670497912543e-35 -9.989064740979903059e-03 2.437049758294346058e-35 -3.082386416124920706e-35 -9.664342998821663644e-03 -2.413089103496522391e-35 1.486412313384328262e-35 -9.361697357595046010e-03 -7.253720111570022379e-37 2.305538843889616761e-36 -9.101128238756774763e-03 1.365332659165783395e-35 -5.304379208551471537e-36 -8.899196952880215547e-03 5.203750921988232234e-36 -3.812108468412848647e-35 -8.789015791726152368e-03 7.031686243789819521e-35 1.371873102111947292e-36 -3.412515338615880321e-35 5.511521610893899137e-01 6.489366124813236225e-34 -3.668118341954914236e-33 5.511521610893899137e-01 4.349507292650420647e-34 -7.207469828588667671e-33 5.511521610893899137e-01 7.833017348681447167e-35 -5.242541807784502411e-33 5.511521610893899137e-01 -2.169312630531359094e-34 4.767147172568817375e-33 5.511521610893899137e-01 5.021130803352440524e-34 -3.921678222871888738e-33 5.511521610893899137e-01 -4.338274731066182737e-35 -7.743449672981820209e-34 5.511521610893899137e-01 -4.821770916639442773e-36 -2.160711591356828380e-33 5.511521610893899137e-01 -7.189427832043905682e-39 3.942621837307290288e-34 5.511521610893899137e-01 -9.667755907171409761e-38 -1.110540127309965361e-34 5.511521610893899137e-01 -1.907426303618680688e-38 2.437049758294346058e-35 5.511521610893899137e-01 2.237844055071614868e-38 -2.413089103496522391e-35 5.511521610893899137e-01 2.227881652008690740e-39 -7.253720111570022379e-37 5.511521610893899137e-01 3.675639730684902685e-39 1.365332659165783395e-35 5.511521610893899137e-01 -2.213090800425620216e-40 5.203750921988232234e-36 5.511521610893899137e-01 -1.815012434537468510e-39 7.031686243789819521e-35 5.511521610893899137e-01 -4.325154764052979677e-39 9.054607347997894087e-35 -5.985316205992385352e-33 5.511521610893899137e-01 4.220669574700557876e-33 -6.199302089208666995e-33 5.511521610893899137e-01 9.782721151626834629e-34 -6.555922644986895807e-33 5.511521610893899137e-01 6.779631957945763150e-33 -6.851184081526843472e-33 5.511521610893899137e-01 2.932729164998733533e-32 -6.132139738138465093e-33 5.511521610893899137e-01 2.644815538733574351e-33 -6.677635565784369289e-33 5.511521610893899137e-01 1.611924869161138926e-33 -6.639074589390348281e-33 5.511521610893899137e-01 -3.495723050610696676e-33 -6.634260007901542982e-33 5.511521610893899137e-01 -2.749160826401761437e-34 -6.634349496032780969e-33 5.511521610893899137e-01 5.880249670497912543e-35 -6.634271892736745577e-33 5.511521610893899137e-01 -3.082386416124920706e-35 -6.634230440033160077e-33 5.511521610893899137e-01 1.486412313384328262e-35 -6.634250590592056326e-33 5.511521610893899137e-01 2.305538843889616761e-36 -6.634249142833976585e-33 5.511521610893899137e-01 -5.304379208551471537e-36 -6.634253039782789042e-33 5.511521610893899137e-01 -3.812108468412848647e-35 -6.634254633486143527e-33 5.511521610893899137e-01 1.371873102111947292e-36 -6.634257143628474055e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener deleted file mode 100644 index c07edf1a8..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_0.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.10477158290065992 -1 0.10744501822385662 -2 0.11300882313036195 -3 0.12088811927480793 -4 0.12983177509709246 -5 0.13806731035276731 -6 0.14397224775558426 -7 0.1461906211205283 -8 0.1441380352245253 -9 0.1389060169711805 -10 0.1320037780160444 -11 0.12429404670839665 -12 0.1167128725071067 -13 0.11034615568268052 -14 0.10592987924526506 -15 0.10381457027019807 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz deleted file mode 100644 index bab9eda60..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.2314111304138016 -2.0720960222545002e-17 -6.4272290331349665e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.2425786660405866 4.3444895621471185e-18 1.936798892363187e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.2664508462922726 -7.634272735525148e-18 -3.33045863292617e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.3025873919086854 -1.6810159972323087e-17 7.844861033290449e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.3500486627389208 -1.9267629798484935e-17 3.1865025342351917e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4072465809637817 -4.5258203105397435e-18 1.5151694593895694e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.471865591640838 -1.2397896353034163e-18 3.997688274709011e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.540765170017398 -2.9230785062510994e-19 1.1135500180399448e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6103666995696186 -1.8676051583342008e-19 2.990254333197622e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6771892705994413 -1.5826011466070713e-19 1.4938669827476168e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.7382592849745993 5.859635932227071e-20 1.1798877684079438e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.7911598920265517 6.135684446945961e-20 -3.361445839340712e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.8342411546326534 -1.59591820690246e-19 -3.046079789258153e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.866597463100933 -3.79809465527035e-21 -9.226324605050476e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.887810832437855 2.2797099367376865e-19 -8.579071844326224e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.89771729893857 4.0733571376581154e-20 -5.2719959947984444e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener deleted file mode 100644 index d49fe4ca2..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_1.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.11961083636815938 -1 0.12168664029273195 -2 0.1255549427255412 -3 0.13060817863957394 -4 0.13602533286215157 -5 0.1409345190007944 -6 0.14452697809661688 -7 0.1461442184491367 -8 0.1454354510180322 -9 0.14271315839304216 -10 0.1387234297430708 -11 0.13420235556590562 -12 0.12967299880986025 -13 0.12566666393990525 -14 0.12267865294765164 -15 0.12108534451897582 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz deleted file mode 100644 index f8a2aa2f0..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.2964741963960535 1.1250224008516622e-17 2.5347922334140933e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.3064728657055276 -8.124071803199816e-18 -1.266189391009803e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.3261322365883506 3.0603483018393216e-18 7.293094119523713e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.354709755510847 -5.415863801687177e-18 1.3577819196099127e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.3910817754629496 2.786845573832564e-17 2.7496659030031324e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4338240116241874 7.825591421541225e-19 7.439519406333787e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4812685029863206 2.0716522369086573e-19 1.981246070282136e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.531525553248844 9.526933753475788e-20 5.460918763637898e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.582586265674274 -4.144040823026011e-20 1.046539029799044e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.632418627555133 -1.0016624547477843e-19 2.7153116076340105e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.679061999371246 -6.086076974973631e-20 -6.521735990999064e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.720644998937365 -2.4242593982606744e-20 -6.167032521851262e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.7555377188627794 -7.876887222783042e-20 -3.658226338929138e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.782553593684067 -1.646780009415375e-20 -3.3437334762005515e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.800923683435276 3.2929345873575937e-20 -2.246972944912625e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.810203633592583 9.4802234997972e-20 -2.857350647107775e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener deleted file mode 100644 index 336697e7e..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_10.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13825442026320256 -1 0.1389040946390757 -2 0.1401002315596406 -3 0.1416510227482043 -4 0.1433029796649878 -5 0.14477564076741753 -6 0.1458055693283537 -7 0.1461907015533089 -8 0.14583437327466642 -9 0.1448127891709189 -10 0.1433201379712033 -11 0.14159759293629584 -12 0.13988999449203338 -13 0.13841295304625958 -14 0.13733071104703284 -15 0.13675839994459582 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz deleted file mode 100644 index 8d38e1c22..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_10.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4088232600045867 3.3127263357103638e-19 1.5374143858766957e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.414444841795172 4.986533594282553e-19 -1.6849869755890178e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4254816369464045 2.491535207100146e-19 -8.510857558665978e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4415224583815425 -1.6826019027073732e-19 1.8591772284305991e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.461956418296231 -1.9209653375056683e-19 -3.3205594473582895e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.485985722618923 -1.1150361721468898e-19 6.341470062460917e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5126523765235573 -3.047443325100038e-20 1.6824057234217925e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5408808070446716 -8.518964416085272e-21 4.480900082625935e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5695342948146234 -2.401227490059242e-21 1.0774640730245576e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.597477740454726 -6.615923628952089e-22 4.682587442088025e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6236310715347564 -2.7952003732255252e-22 2.29405520041107e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6470120336207694 -4.0118102924512483e-22 -6.79365227747363e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6667694147167564 -9.678030446416557e-22 -3.8041341749135715e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.682206027915257 1.2571670915357352e-22 3.291863834166481e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.692792493590954 1.533251316624766e-21 -3.41748871084566e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.6981743499688213 1.0335153354004477e-21 -2.1512629149732395e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener deleted file mode 100644 index e572b0eb5..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_11.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13843798807718916 -1 0.13907321886927496 -2 0.14024266827316792 -3 0.14175865144134214 -4 0.14337305405007456 -5 0.14481150965902675 -6 0.14581653147666265 -7 0.14619076120971633 -8 0.14583986374121108 -9 0.1448379005798483 -10 0.14337412761413224 -11 0.14168422613012305 -12 0.14000806203932517 -13 0.13855756708960315 -14 0.13749505653531466 -15 0.13693331300523848 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz deleted file mode 100644 index 8639f1232..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_11.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4103879587655714 -2.5175179673562646e-19 -8.162373584587352e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.415948259267538 -2.5297643475351457e-19 -2.433717157371553e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.426864337276964 1.5985022249506033e-20 9.387069832978715e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4427288270300047 -9.715659845896502e-20 3.7795604375818335e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.462936832705059 -1.4142552698113295e-19 2.4995320827281956e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4866989669250428 -4.4780277169957704e-20 1.3397763118436336e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.51306799936174 -1.1517243462947556e-20 3.643471410087461e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5409809772224903 -3.0715311991177423e-21 1.0312901107394793e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5693147528261733 -6.047340805757477e-22 3.0526260448239648e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.596947636307444 -4.198540453629936e-22 8.961821225788733e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6228119540715324 -3.6908631552091693e-22 2.902544910135212e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.645936282702593 -4.687240213536109e-22 -4.044742456895848e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6654783370728565 -1.0094110163805668e-21 -2.2912605714156402e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6807478386977954 -3.6264218950599274e-23 -2.2145247384420802e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.69122035442006 7.448216526723192e-22 -2.1815848443854905e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.696544506572592 3.04402827808409e-22 -5.71320673253198e-23 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener deleted file mode 100644 index 8fa917134..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_12.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13857720350738936 -1 0.13920147528547158 -2 0.14035067732942832 -3 0.14184025371377681 -4 0.1434261657376552 -5 0.1448386808264598 -6 0.14582482368880598 -7 0.14619080064837642 -8 0.1458440396815485 -9 0.14485698814815814 -10 0.14341517595541123 -11 0.14175012343604315 -12 0.14009791466568178 -13 0.13866763008996588 -14 0.1376200995624207 -15 0.13706637744723488 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz deleted file mode 100644 index c992c1b83..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_12.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4115867892485627 -2.616637259673376e-21 1.5687396676687763e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.41710012093894 3.847946797998936e-19 -9.657063191477644e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4279236821653103 2.1609875818739528e-19 -1.4449092476558132e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4436530464497332 2.885450801374802e-19 6.305856797634129e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.463687923025897 3.854916929837994e-19 -1.9376039604903876e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4872453766920484 7.411947453185423e-20 2.537103429475601e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5133864254396627 2.004923837199771e-20 7.08933128129098e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.541057776015262 5.548989709995593e-21 2.289411685300011e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5691466630040836 1.6096087038406888e-21 3.865831204243368e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.59654165523611 3.8245224399855923e-22 -6.484939965479694e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6221845686771514 -1.573268895579877e-22 3.719638703383037e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.645112275212686 7.568609077159702e-23 -1.0110838494181428e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6644893330112693 2.651377220310474e-22 -4.434849814321756e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6796307655291547 4.0635141055499034e-22 -3.8602566835267076e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6900159412156204 4.596091999015609e-22 4.350246188219603e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.695295860197247 5.263190431668783e-22 -2.9434956885943397e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener deleted file mode 100644 index fa95db28a..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_13.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13868364218205256 -1 0.13929953199849185 -2 0.14043324893922068 -3 0.14190263010814 -4 0.1434667535392989 -5 0.14485943590355374 -6 0.14583115071922406 -7 0.1461908273222357 -8 0.14584723976488212 -9 0.14487160785265998 -10 0.14344662157500512 -11 0.14180062236336408 -12 0.14016679741347038 -13 0.13875201523568115 -14 0.13771594786456398 -15 0.13716836312327987 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz deleted file mode 100644 index b191b4464..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_13.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4125106547770754 -2.978565633872773e-19 -1.4861158650795324e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4179877800408174 1.3984069957626917e-21 8.250026531755031e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.428740027602391 1.0450057043818443e-20 -7.441348036137495e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4443652431526677 9.58009574165853e-20 -1.958042752424339e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.464266693430515 -6.997961547142052e-20 -1.495553455235778e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4876664223743847 -9.497819715326151e-21 2.214024686735877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.513631805015641 -2.569230535404628e-21 4.0898497914854945e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.541116986243635 -8.198639490299509e-22 1.61527274274553e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.569017191901633 -2.780676899773558e-22 2.2209509148251033e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5962288872597017 -3.779280375630499e-22 6.188629412074027e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.621701195179552 -2.953431302606707e-22 2.0407055173296035e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6444773783435984 6.915348144068967e-23 -5.658157235236707e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.663727270955861 4.288687788250292e-22 -4.2041745363635273e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6787699878040856 -2.04352477993163e-22 -2.5020459406651618e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6890878342505045 -4.914728160451446e-22 8.37965465766285e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.694333651918987 -1.5081263476245136e-22 -1.9054137367354605e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener deleted file mode 100644 index 64e8cf537..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.12779616982302405 -1 0.12927261128951345 -2 0.13199397848856598 -3 0.1355289962813415 -4 0.13931026693386392 -5 0.14271834751259405 -6 0.14516485858535155 -7 0.1461800180989455 -8 0.1455336484410895 -9 0.14344736417476336 -10 0.1404219679841424 -11 0.13700769126672943 -12 0.13363368660354177 -13 0.13066864482140672 -14 0.12846247921255227 -15 0.12728607542923076 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz deleted file mode 100644 index 61a11af99..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.3383229909201058 -7.245283369895973e-18 -8.09877712631356e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.3467591438588884 1.0183585989727869e-17 -6.865802668587907e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.3633241263303937 3.3016675200365894e-18 -2.2830326410253755e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.387401744643219 4.934393604054129e-18 -4.278891219416674e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4180853337302946 -8.618164562264624e-18 3.091116786537841e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.454193505435375 -1.5645579657138974e-18 -3.4937066288575346e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.494285819702685 -3.930485679856878e-19 -6.703688606352345e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.536720778489076 -7.245204808472365e-20 1.7555638506085636e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.579763295160865 -2.263646841743886e-21 2.1329619693337123e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.621689750840832 1.8221478563758953e-20 -8.469193349575455e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6608738833057255 1.7683302548866813e-20 -9.96837697137709e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6958474986376935 -1.2555855816039059e-20 -1.6864171197535938e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.7253380509903704 -1.1518150784407953e-20 -1.1383175670446963e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.748315635392064 3.389057298464379e-21 -8.444367808311736e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7640275209327925 5.192706921920604e-21 4.2213425287676253e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.771996661108405 2.189683156615292e-20 2.0189609982788494e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener deleted file mode 100644 index 4ef16b492..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_3.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13187359656973582 -1 0.13302276355392886 -2 0.13514219636313662 -3 0.1378982595231344 -4 0.1408489747603094 -5 0.14350789443825132 -6 0.14540880473620935 -7 0.14618454715952503 -8 0.14565557531940132 -9 0.14398063812620526 -10 0.14153591997260637 -11 0.13875511794245843 -12 0.13602615366862078 -13 0.1336461309861989 -14 0.131882765111852 -15 0.13094428756242057 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz deleted file mode 100644 index 15c98ee10..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.362559790325972 -6.143274580653494e-20 -8.938234665209195e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.3699913434136475 9.82603488830841e-18 -5.850880540578698e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.3845920731376613 -2.2261138853682223e-19 3.1243721204822144e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.405837369664595 4.4925748978777975e-18 -2.5595937323623892e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4329401296541517 3.771700831972277e-18 2.4329937312982053e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4648576903962214 1.7470954650836736e-18 -7.720397361248471e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.500315421199589 4.630643587483599e-19 -2.178166299630976e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.537863216109959 1.2349080203039983e-19 -5.901710155457842e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5759620968205703 2.8841116624621814e-20 -2.069738881470252e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6130804818461972 4.5787407506831465e-21 -6.128541988228817e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6477727490121725 8.634682005023885e-21 -6.0548556645327875e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6787382663232036 2.7108313857655273e-21 -3.2194550875133427e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.7048609705440354 -9.084070125445272e-21 6.578768249638381e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.7252364265376077 -1.0290104769424924e-20 1.2585991662258684e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7391893913324643 -3.680747935643482e-21 1.1581936589932861e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.7462755459549046 -2.0162188575810158e-20 3.593111885221937e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener deleted file mode 100644 index bedbf041c..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_4.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13421326823764756 -1 0.1351795392085013 -2 0.13696105552450846 -3 0.1392761105466777 -4 0.1417518970955967 -5 0.14397701268094557 -6 0.1455578347640275 -7 0.14618765218496788 -8 0.14571754153674715 -9 0.14427461526220658 -10 0.14216655784301252 -11 0.1397565709764386 -12 0.13739139176528584 -13 0.1353400505811195 -14 0.13382579035928036 -15 0.13302155143351582 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz deleted file mode 100644 index 0acf82211..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.378036400008956 -5.2677393387650104e-20 -1.6843123827553497e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.384861189353958 1.183269274760024e-18 -2.5115572893812397e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.398269038777232 1.0950147412485515e-18 -6.487350180881853e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4177751963363625 3.529902437536716e-19 -3.760182337779692e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.442652702068164 -9.671645957208038e-19 -2.459675841651522e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4719410673011186 1.1002398303393508e-18 -6.784129715598233e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5044706908063903 2.928347479808325e-19 -1.859345754684388e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.538916117261639 7.441958539783295e-20 -5.556776969643256e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5738712487118307 1.5158028612680962e-20 -1.8407620671769603e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6079350325127546 -1.3998458567492364e-21 -1.4460900230008096e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.639782187769053 4.0136897677432984e-21 -4.751431126824183e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6682171464200013 3.4806004621151892e-22 -6.914565770728537e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.692213438339977 9.234116692420712e-22 -3.160720044593336e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.7109374554792636 4.719047356248118e-21 8.82585647211388e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7237639775230047 6.775178464953001e-21 2.8205429549215483e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.730279661360899 -5.499082653432982e-21 -5.341739555557236e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener deleted file mode 100644 index cb4711f2b..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_5.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13564405043411262 -1 0.13649841426965775 -2 0.13807297203647503 -3 0.14011772609588732 -4 0.1423022840552975 -5 0.14426122133649408 -6 0.14564664125016716 -7 0.14618905209117888 -8 0.14575820657043093 -9 0.14446243010868962 -10 0.14256825314380392 -11 0.14039548084490452 -12 0.1382576361339662 -13 0.13640900160779257 -14 0.13504775007123526 -15 0.13432577976813345 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz deleted file mode 100644 index a487443eb..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.3882471491078743 1.6367392899796402e-18 -2.8830476351521246e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.3946727651671735 -8.239366989732026e-19 8.15023507249094e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.407294025353667 -8.116983152407859e-19 6.097092365289808e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.425650604577382 3.5602527716738367e-20 5.235538878845954e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4490540348157928 5.3698220048514165e-20 1.6545885658021632e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.476597495314023 -7.866401491471966e-19 2.0590402857540293e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5071814982899006 -2.0552797061145034e-19 5.552660170944418e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5395635957654803 -5.4101153935503534e-20 1.4209275570418195e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.572427116951356 -1.446792411027231e-20 3.097891471934784e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6044592355440788 -4.692416801937402e-21 -3.2937437013317725e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.634415951321537 -1.3037402837486014e-21 -1.4053577480625311e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.661172356516093 -1.2458288722219286e-22 4.388866292579513e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.68376025727045 1.5317323205262155e-21 -1.5405249873293975e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.701391888142795 8.579889941855248e-22 1.5878000986070268e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7134739896370617 4.414010018826434e-22 1.4700084667312025e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.7196128599165963 2.3240131895773706e-21 1.8771590843858792e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener deleted file mode 100644 index 03f5c3e84..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_6.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.1365818193223151 -1 0.13736278574418653 -2 0.13880161156750337 -3 0.140669111785199 -4 0.14266260690530444 -5 0.14444690811922556 -6 0.14570436670541514 -7 0.1461898028223269 -8 0.14578512548453018 -9 0.1445867977651491 -10 0.14283492868599137 -11 0.1408209840856736 -12 0.13883448387904088 -13 0.13711867560507696 -14 0.13585742980979526 -15 0.13518915267680912 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz deleted file mode 100644 index 7db3b5e82..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.3953147492954914 1.1354138442716729e-18 1.3452460467240761e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4014645377655004 5.6836250058901005e-19 1.7151544728192184e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.41354215900941 7.365178259583208e-20 4.327564544552418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.431104010062697 -9.56669745136322e-19 -9.486765531133864e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.453488096319528 -9.452686839195054e-19 1.0270049837485955e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.479824751692141 -3.142916432380436e-19 -2.6633421647022933e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.509063080278922 -8.430946493667463e-20 -7.119386152706069e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.540018069444007 -2.1865425096716667e-20 -1.8291067959852063e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5714350397483274 -5.704122469353905e-21 -4.606419343160747e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.6020623714203284 -1.5908183187371046e-21 3.9215522448598815e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.630712459023694 2.7941631180428607e-21 3.530115113280738e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6563093955288153 2.510864230083157e-21 2.759406851715817e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.677925094093369 1.2671536823366167e-21 -8.600606627875617e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6948030081598775 -6.377396447727068e-22 -1.0052103108530288e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.7063716705919854 1.2663436426667167e-21 1.2751301173514087e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.712250707845954 3.928031607670342e-23 1.3931647594680634e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener deleted file mode 100644 index 5581bbec5..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_7.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13722404023181523 -1 0.13795465417635913 -2 0.13930038643648315 -3 0.14104636184684624 -4 0.1429088409727804 -5 0.14457349627604588 -6 0.1457434810510513 -7 0.1461902179764247 -8 0.14580388429634314 -9 0.14467301295294807 -10 0.14301988083095427 -11 0.14111659274354277 -12 0.1392356597507 -13 0.13761113034787423 -14 0.13641849551656487 -15 0.13578702216633456 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz deleted file mode 100644 index b35875c8e..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.400352966342781 3.705080054085656e-21 -8.144355022852245e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4063058921463854 4.114950196243128e-19 4.092968478922562e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.417995542008848 1.0022567725176017e-19 -9.987232519488031e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4349903036030343 -1.5102726919082078e-19 -3.8852521284262793e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4566471379055352 8.061840740291998e-19 -6.989070419138168e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4821230470510693 3.6347165881749154e-19 3.884379480972989e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.510401783923569 9.683469658065607e-20 1.0113196308500409e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.540339241349826 2.5064216374269038e-20 2.78997724888931e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.570724874221731 6.33311973195195e-21 7.262580626347625e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.600350651544698 1.8512660042995024e-21 1.491974668551002e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.6280691582966282 1.455041320960942e-21 2.0899946020014155e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.65283944094868 1.0134187889831264e-21 1.4720392640817571e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6737620505765087 1.2649770909650768e-21 -1.5096365306430996e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.690102572405443 9.699893585515925e-22 -1.22792014188941e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.701305120202562 2.2403020914494856e-21 2.610078347465771e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.706998866870694 3.2355534073305635e-21 -2.2274148903523467e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener deleted file mode 100644 index fc9f82209..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_8.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13767919451611116 -1 0.13837408163317105 -2 0.13965377385530112 -3 0.1413135670178166 -4 0.14308310727487317 -5 0.14466295487892517 -6 0.14577102141725787 -7 0.14619046139930714 -8 0.14581728208356529 -9 0.14473451003171922 -10 0.14315193341478116 -11 0.1413279729791101 -12 0.13952296903138908 -13 0.13796334126038326 -14 0.13681940341969137 -15 0.13621403614864838 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz deleted file mode 100644 index 2bfdbbc41..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.404032100911285 -2.0282268050288074e-21 -2.1641022585014107e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.409841185153556 -5.944729732524944e-19 -1.8219398345405767e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4212473931737875 3.672027788892918e-20 -2.4724748214074044e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.437827934609895 -6.578309138290831e-19 4.845134072227357e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.4589536824660145 -6.053038753015063e-19 -2.079867907569171e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.483801210720456 -3.344281511517376e-20 1.0749240083830885e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.5113795703334794 -9.06623628448783e-21 4.345892880759563e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5405744625939253 -2.5780238874519974e-21 2.6816676615101177e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5702074755603874 1.4481409558617227e-22 1.6656686440302081e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.599102319808863 3.585863503906688e-22 4.5531230166272615e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.626140871972916 -8.473309097270604e-22 -3.1154683554961573e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6503076864328157 -1.0705880315334471e-21 2.814457103399993e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.670724249013737 4.280971053617609e-22 -5.625630823545308e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.686672292656817 1.2946157625539998e-22 4.878474857866354e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6976073881595712 -1.2067249806578498e-21 1.0839524312384036e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.703165755140378 1.4123473722349123e-21 3.6139615439771107e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener deleted file mode 100644 index f90b21968..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_9.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13800978452383972 -1 0.13867869566020163 -2 0.1399103802922583 -3 0.14150754045133687 -4 0.14320952161738285 -5 0.14472776790822098 -6 0.1457909115617625 -7 0.1461906089910128 -8 0.14582708477455458 -9 0.14477942528250837 -10 0.14324842740350557 -11 0.14148259255038342 -12 0.13973336916861442 -13 0.13822110782060923 -14 0.13711260487553908 -15 0.13652622588053687 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz deleted file mode 100644 index 95bb43bcc..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_9.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.406765439020562 -1.2907325287685857e-21 -1.3383089635469271e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.412467577892283 -1.4623024628474392e-21 -4.43560204294263e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.4236630750642565 -8.303654609684162e-20 -1.0965636010836057e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.439935742618978 -4.412161354489423e-19 -1.7995954259846706e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.46066684080276 2.862394284404205e-21 4.171803897747424e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.485047546120633 -2.126119427439803e-19 -5.908513472885527e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.512105708833543 -5.607450195676556e-20 -1.5121171601660274e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.5407491379645237 -1.5590650796075587e-20 -4.7239469921762226e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5698232312525535 -5.416107817654631e-21 -9.915875156784967e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.598175221167789 -2.1325580904562842e-21 4.997506326941626e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.624708707508375 -6.022273437012621e-22 1.0418461090635023e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6484271848863394 -2.658991505306806e-22 6.45594534864603e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.6684677093581595 -3.0024536118282338e-24 -3.9019685168415576e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6841240275599705 2.2348815873479076e-22 3.587979321349706e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6948602791935357 -3.082722539359822e-22 1.0146914570043515e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.700317978159024 -5.736908401162131e-22 5.460726860644675e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 deleted file mode 100644 index 572ae78a4..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL.hess_13 +++ /dev/null @@ -1 +0,0 @@ --9.955658228090165721e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.005386865121865592e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.023699533760124084e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.047870577647010658e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.071750438255832799e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.088947539896496959e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.094266115035419547e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.084120473908624024e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.061054858418189993e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.033589383703061026e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.003629785448136372e-02 0.000000000000000000e+00 0.000000000000000000e+00 -9.733612707468091915e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.452171390866088291e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.214974249881300455e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.034594917525935395e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.936052858402520824e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -3.338403956335296523e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.018531076210112041e-33 5.511521610893899137e-01 0.000000000000000000e+00 -9.027796614315168061e-33 5.511521610893899137e-01 0.000000000000000000e+00 -4.890056499420716033e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.676807912670593045e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.291384182302405022e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.632726874514757264e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -3.314894069318850772e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.629788138637701545e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener deleted file mode 100644 index fa95db28a..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.13868364218205256 -1 0.13929953199849185 -2 0.14043324893922068 -3 0.14190263010814 -4 0.1434667535392989 -5 0.14485943590355374 -6 0.14583115071922406 -7 0.1461908273222357 -8 0.14584723976488212 -9 0.14487160785265998 -10 0.14344662157500512 -11 0.14180062236336408 -12 0.14016679741347038 -13 0.13875201523568115 -14 0.13771594786456398 -15 0.13716836312327987 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz deleted file mode 100644 index b191b4464..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_13.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.4125106547770754 -2.978565633872773e-19 -1.4861158650795324e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.4179877800408174 1.3984069957626917e-21 8.250026531755031e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.428740027602391 1.0450057043818443e-20 -7.441348036137495e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.4443652431526677 9.58009574165853e-20 -1.958042752424339e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.464266693430515 -6.997961547142052e-20 -1.495553455235778e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.4876664223743847 -9.497819715326151e-21 2.214024686735877e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.513631805015641 -2.569230535404628e-21 4.0898497914854945e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.541116986243635 -8.198639490299509e-22 1.61527274274553e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.569017191901633 -2.780676899773558e-22 2.2209509148251033e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.5962288872597017 -3.779280375630499e-22 6.188629412074027e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.621701195179552 -2.953431302606707e-22 2.0407055173296035e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.6444773783435984 6.915348144068967e-23 -5.658157235236707e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 2.663727270955861 4.288687788250292e-22 -4.2041745363635273e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 2.6787699878040856 -2.04352477993163e-22 -2.5020459406651618e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 2.6890878342505045 -4.914728160451446e-22 8.37965465766285e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 2.694333651918987 -1.5081263476245136e-22 -1.9054137367354605e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz deleted file mode 100644 index ea129efa5..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_FINAL_forces_13.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001485993830167969 1.6416428860555675e-19 8.190759706678125e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014311948685495474 -7.70735037797129e-22 -4.547019952021589e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0013220969902539678 -5.759571523207936e-21 4.101315051535468e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001160208397751648 -5.2800904714583604e-20 1.0791794945040917e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0009491489537623587 3.8569416299277926e-20 8.242775188779033e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0006961200758143405 5.234743861739422e-21 -1.220264490799738e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0004123659528442293 1.416036961925111e-21 -2.254129551108221e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011262661668046895 4.518697873071388e-22 -8.902610629129851e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00018676989113939298 1.5325760826015415e-22 -1.2240818963793133e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0004718706315723419 2.082958546391471e-22 -3.410876474645961e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.000731421500803685 1.6277900450607386e-22 -1.1247392560232525e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0009566256532785221 -3.811409074289113e-23 3.118505587984279e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.001141325646813254 -2.363719542731824e-22 2.317139881313742e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0012817517884265895 1.126293098699038e-22 1.3790080273425396e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00137591552463838 2.7087630467996967e-22 -4.618464773753651e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0014230530554878943 8.31207095689099e-23 1.0501728987711588e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz deleted file mode 100644 index 6b6e5529a..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0028520081672789646 1.1420402006502963e-17 3.542381171428807e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0028040999945881215 -2.3944748110076815e-18 -1.0674708951215072e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0026803580213167737 4.207645916530494e-18 1.8355894729560742e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002444990903897951 9.264955997004228e-18 -4.323712111943975e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002067771697709855 1.0619395802505298e-17 -1.7562477580605434e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0015381459075631484 2.4944156448562332e-18 -8.350889219592038e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0008674384310822318 6.833127367937046e-19 -2.203334531967586e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011644115055508473 1.6110610357542393e-19 -6.137354989238447e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0006168730496398377 1.029334619077587e-19 -1.648085137948782e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0012671648238777183 8.722540420950337e-20 -8.233480159214353e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.001794665653987321 -3.229551007243993e-20 -6.502976934009758e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002172859138419669 -3.3816957426968244e-20 1.8526681387375716e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0024099733865889593 8.795937686561949e-20 1.6788534587003444e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0025447118120052064 2.0933280772743152e-21 5.0851087449857815e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002613976732072058 -1.2564670582899322e-19 4.7283739871415364e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0026413497719772455 -2.245039589309162e-20 2.905671985787771e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz deleted file mode 100644 index 6e6a2732b..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0024884103610560617 -6.200585275033675e-18 -1.3970562173587787e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.002416704479852049 4.477599731178956e-18 6.978630192035114e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0022660124812034364 -1.6867175802449868e-18 -4.019604585003816e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0020274127246601137 2.9849650384656863e-18 -7.483444392811037e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0016949643903153597 -1.5359759606402185e-17 -1.515484304713985e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0012698421997955126 -4.3130916237850372e-19 -4.100307198267322e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0007656819282577569 -1.1417956073978754e-19 -1.0919680532858607e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00021688361640288107 -5.2507901267836336e-20 -3.009797178112627e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00032986912497209495 2.2839970552534398e-20 -5.768022479381364e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0008382501453689153 5.520684266163445e-20 -1.4965498605785906e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0012844419664059658 3.3543544773130936e-20 3.594468885493588e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.001651010963806505 1.3361358063926347e-20 3.3989733019268737e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0019275754827721213 4.341363415494276e-20 2.0162393524549216e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002117430914164494 9.076263610280899e-21 1.842905931514872e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002232558759293777 -1.8149080141481365e-20 1.238423994497984e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002286045941283969 -5.2250456695236464e-20 1.574834984143617e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz deleted file mode 100644 index c0f4e08b5..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_10.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015225794472987595 -1.8258162790245027e-19 -8.473492612658581e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014667037146868078 -2.7483387668336725e-19 9.286842130033623e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0013553652923911572 -1.3732150138235464e-19 4.690777536182723e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0011899392623869072 9.273696749302881e-20 -1.024689547297707e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0009738826604090946 1.0587441971440585e-19 1.8301335154373117e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007144150736436023 6.145545959715992e-20 -3.495114929409003e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.000423083863262697 1.6796049744263222e-20 -9.272615502930793e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011518727698175578 4.6952456481690104e-21 -2.4696577641649102e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00019225540648472875 1.3234417204134027e-21 -5.938466523436612e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0004847700953483179 3.646380605699303e-22 -2.5808181881968534e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0007507668544313775 1.5405807263811176e-22 -1.2643734813649147e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0009812518548847388 2.211117912565163e-22 3.744336134419447e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0011700097718558122 5.334067395631399e-22 2.0966567715776183e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.001313315670366571 -6.928903593503833e-23 -1.814317866212861e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.001409258412286268 -8.450547766508923e-22 1.8835562884811786e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0014572304770987356 -5.696242106249825e-22 1.1856732046589614e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz deleted file mode 100644 index b30b0560f..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_11.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00150708544762243 1.3875354682897734e-19 4.498709840764269e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014516631615128857 1.394285087190886e-19 1.3413484707656584e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0013412694242621015 -8.810179557877231e-21 -5.1737038247432375e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0011773368952913798 5.354806920475266e-20 -2.0831129031411877e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0009633929847211708 7.794698482885725e-20 -1.3776225091079087e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007066528969108947 2.468074653640406e-20 -7.38420609648991e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00041853561843238347 6.347753624396195e-21 -2.0081071415371107e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011410118454349398 1.6928810582472289e-21 -5.6839777324418025e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0001899267699573457 3.3330049539372864e-22 -1.6824614416024853e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00047929671941810797 2.314034644439367e-22 -4.939327135890225e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00074256165186701 2.0342272042787383e-22 -1.5997438998800313e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0009708111355885283 2.5833825732355204e-22 2.229268546168155e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.001157853636304411 5.56339063105587e-22 1.2628332155546406e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0012999449675001645 1.9987102644841597e-23 1.2205400953782684e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0013951400543292102 -4.105100634965197e-22 1.2023852015829236e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0014427621476056501 -1.6777227638832607e-22 3.1488462373854535e-23 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz deleted file mode 100644 index 1fd1330e7..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_12.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014951837402547787 1.4421652804560004e-21 -8.646142580222974e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014401123353742459 -2.1208041934741117e-19 5.322511247759705e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001330448443239614 -1.1910329758371642e-19 7.96364854423546e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0011676677249281464 -1.5903224448948341e-19 -3.4754866015362695e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0009553502901262226 -2.1246457967002865e-19 1.067914610159638e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.000700704626102099 -4.0851108567041455e-20 -1.3983300380627802e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00041505108892649577 -1.1050181056922858e-20 -3.9073002563621375e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011326854064507488 -3.058337670526858e-21 -1.2618141979764032e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00018814357453294432 -8.871393156300872e-22 -2.130661222625531e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.00047510283532131925 -2.107893807932926e-22 3.574188676509087e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0007362713168218143 8.67110551773567e-23 -2.050086909841297e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0009628026736743013 -4.171455249317344e-23 5.572610486493887e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0011485243690178587 -1.4613122848372971e-22 2.4442770592703154e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0012896776825021194 -2.2396145808910483e-22 2.127588813485506e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0013842926973099397 -2.5331460378231066e-22 -2.3976475879081147e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.00143164250232438 -2.9008187806392486e-22 1.6223140099260722e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz deleted file mode 100644 index ea129efa5..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_13.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001485993830167969 1.6416428860555675e-19 8.190759706678125e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014311948685495474 -7.70735037797129e-22 -4.547019952021589e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0013220969902539678 -5.759571523207936e-21 4.101315051535468e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001160208397751648 -5.2800904714583604e-20 1.0791794945040917e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0009491489537623587 3.8569416299277926e-20 8.242775188779033e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0006961200758143405 5.234743861739422e-21 -1.220264490799738e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0004123659528442293 1.416036961925111e-21 -2.254129551108221e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011262661668046895 4.518697873071388e-22 -8.902610629129851e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00018676989113939298 1.5325760826015415e-22 -1.2240818963793133e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0004718706315723419 2.082958546391471e-22 -3.410876474645961e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.000731421500803685 1.6277900450607386e-22 -1.1247392560232525e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0009566256532785221 -3.811409074289113e-23 3.118505587984279e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.001141325646813254 -2.363719542731824e-22 2.317139881313742e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0012817517884265895 1.126293098699038e-22 1.3790080273425396e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00137591552463838 2.7087630467996967e-22 -4.618464773753651e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0014230530554878943 8.31207095689099e-23 1.0501728987711588e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz deleted file mode 100644 index b8eab3e53..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.002166858546834956 3.993253587023183e-18 4.4636585153490375e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00209592629951815 -5.6127054258781484e-18 3.7841019784055255e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0019514228556452755 -1.819721188866813e-18 1.2582983739387532e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0017299294859733924 -2.7196016985400964e-18 2.3583201426479155e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0014302139909061825 4.7499200231161436e-18 -1.7036756970800215e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.001056571821247607 8.623095039528342e-19 1.9255639587071574e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0006239424958838306 2.1662956765840184e-19 3.6947524626614164e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00016034811206562042 3.993210287724784e-20 -9.675828101933207e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0003002459331580581 1.247613848770315e-21 -1.1755865989197566e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0007313066410677047 -1.0042807288659739e-20 4.667814217302401e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0011142931528157654 -9.74619041500546e-21 5.494092510328192e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0014365587871789187 6.920187067336713e-21 9.294724400503379e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0016900396650620874 6.3482536965798955e-21 6.273861870827008e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0018730419873846378 -1.867886254104412e-21 4.654131566584688e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.001989711277020876 -2.8619716419203746e-21 -2.3266020574288268e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002046012487730462 -1.2068486038695553e-20 -1.1127547173565799e-20 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz deleted file mode 100644 index 397c113f2..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0019582373873393696 3.385879061292689e-20 4.926327352054148e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0018913990442878878 -5.415640363630923e-18 3.2247254542158074e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0017564337051345822 1.2269274787517942e-19 -1.7220044462512123e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001552019390593871 -2.4760923638212936e-18 1.4107256171023883e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0012789568881082286 -2.0787810645241706e-18 -1.3409497529219445e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.000942813205141391 -9.629154412103394e-19 4.255113690120919e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0005580641841206654 -2.552189220476311e-19 1.2005010632536922e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0001479354517033912 -6.80622224137169e-20 3.252740306303789e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00026023305337602123 -1.5895843755891443e-20 1.1407410574130662e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0006444411092603016 -2.523582859807072e-21 3.3777591611393794e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0009886250971433402 -4.7590236473885805e-21 3.3371467845915798e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0012814594665516929 -1.494080576613616e-21 1.77440962901321e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0015160282351308857 5.006704881126728e-21 -3.625902338094457e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0016892001617319285 5.6714134815047854e-21 -6.936796504106917e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0018020300366504995 2.0286521791552157e-21 -6.383409381141777e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0018573676729341658 1.1112433805849577e-20 -1.9803513805760424e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz deleted file mode 100644 index c75830fbb..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001817615719236009 2.903325920615929e-20 9.283124097052306e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0017539023281922604 -6.521614179346622e-19 1.3842502277422805e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0016258761844349056 -6.035197410638782e-19 3.575517071936678e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0014333317626334986 -1.9455133568830664e-19 2.0724326215574317e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0011781327642435997 5.330548570606671e-19 1.3556556557056004e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0008666243060632932 -6.063995602081569e-19 3.739087753862715e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.000512616776821824 -1.6139650419170269e-19 1.024782430906683e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0001365024732318459 -4.101651531939204e-20 3.0626296355106314e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0002381641846318971 -8.354380227733919e-21 1.0145399913759543e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0005920966945850301 7.715280691393701e-22 7.970156413067018e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0009107710967726742 -2.2121537894340906e-21 2.6187615338165436e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.001183610300480748 -1.9183404665835156e-22 3.810977867531756e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0014040637128960743 -5.089403370779285e-22 1.74203768317617e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0015686483930317224 -2.6009131486793223e-21 -4.864389868070343e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0016770083120976565 -3.7341542527251414e-21 -1.554548345050465e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0017305539349000204 3.030831288448765e-21 2.9441113000220476e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz deleted file mode 100644 index 73393b131..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001721922023661441 -9.020923968121923e-19 1.5889979346377484e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0016605761926864401 4.541144922399388e-19 -4.492019673589922e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001537678172351954 4.473692805975761e-19 -3.3604256334910973e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001353644476948642 -1.962241009132525e-20 -2.885578567543469e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0011109240617137276 -2.959589002639219e-20 -9.119300637556566e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0008163104475442856 4.3355841820215737e-19 -1.1348445032634484e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00048295549042645235 1.1327718516681746e-19 -3.0603606530109977e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00012947517686072796 2.981796790898253e-20 -7.831472938150661e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00022289701377494405 7.974027639853873e-21 -1.7074095795772475e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0005565618015498926 2.5862356611199628e-21 1.8153539590635725e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0008579930912378993 7.18559274887336e-22 7.745659599483824e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0011171265991116372 6.866412752726734e-23 -2.418933141887577e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0013275267392284945 -8.442175786684897e-22 8.490636759788026e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0014856373586363963 -4.72882488336264e-22 -8.751194557252092e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0015903756622600868 -2.432791160946408e-22 -8.101983432586028e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0016423569986714764 -1.2808848918358138e-21 -1.034600286067858e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz deleted file mode 100644 index a212b10b1..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0016544007842064763 -6.257857940011445e-19 -7.414352658489329e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0015948280359958493 -3.1325422048180257e-19 -9.453110942964455e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0014757148269767028 -4.059333914577877e-20 -2.3851465509838864e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.001297851188992573 5.272705974807197e-19 5.2286513242327634e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.001064051304636144 5.2098687795235885e-19 -5.660360162426122e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007813460723396459 1.7322251838298325e-19 1.4679067897961629e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00046236443154317646 4.646734380013837e-20 3.9238650636938275e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00012454420147408297 1.2051176295193574e-20 1.0081161634705365e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00021239747578720731 3.143839426102952e-21 2.538837975867014e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0005319764740789759 8.767829542725452e-22 -2.1613719945794727e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.000821343309502934 -1.5400090409455907e-21 -1.9456305735789955e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0010707958325609042 -1.383868246612379e-21 -1.5208530496480423e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0012739601763008114 -6.983944904522047e-22 4.740242929633377e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0014272451404046813 3.514915834288572e-22 5.540238351759843e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0015291841864186614 -6.979480353375711e-22 -7.027907198483962e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0015799152059467324 -2.1649431093949397e-23 -7.678457679344032e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz deleted file mode 100644 index ca65acb9a..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001605651022755263 -2.0420628788185028e-21 4.488778871524242e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0015474110200183054 -2.2679636934346094e-19 -2.2558484224289233e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0014311168300680853 -5.523959861395533e-20 5.504484786418061e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0012577963050988286 8.323900579794991e-20 2.1413651069592957e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0010305097299662478 -4.443300946370421e-19 3.852041265513929e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007564043148941275 -2.0032819025200587e-19 -2.1408841454295456e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0004477137482070312 -5.337065228886395e-20 -5.573910000951241e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00012106032836118718 -1.3814197020690454e-20 -1.537701990115574e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00020487584242076583 -3.490512626703175e-21 -4.002787007297428e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0005143789971546132 -1.0203292590209905e-21 -8.22305062862511e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0007950747889023309 -8.019491685219838e-22 -1.1519050415582396e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0010375228016033051 -5.585479556366425e-22 -8.1131762160709555e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0012353987367211688 -6.971948574139719e-22 8.320394363234335e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0013850738266852631 -5.346117311994213e-22 6.767708398475387e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0014848740515976064 -1.234747339195464e-21 -1.4385503218183832e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0015346319270509831 -1.7832822527703793e-21 1.2276445304603824e-21 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz deleted file mode 100644 index da7a4d466..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015697369058946 1.117861586771056e-21 1.1927496365914823e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001512504884774409 3.276450639173474e-19 1.0041660771818843e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0013983300794534273 -2.0238460514286258e-20 1.3627098410577945e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0012283991225769688 3.625649297883074e-19 -2.670406114675944e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0010059468014039933 3.3361453898820777e-19 1.1463236920372164e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007381721456860701 1.843207982364093e-20 -5.924466902272087e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0004370129420549762 4.996875721142508e-21 -2.3952482530936272e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011850921793083539 1.4208834369092385e-21 -1.4780069269648319e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00019939290898938987 -7.981460173852433e-23 -9.180368728160828e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0005015246796828759 -1.976356419549743e-22 -2.5094635903199573e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0007758546776170932 4.670082620539081e-22 1.7170971169373149e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.001013135452477347 5.900569072160953e-22 -1.5511941148322908e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.001207085927457777 -2.3594664477624673e-22 3.1005785858880805e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0013540388881603301 -7.135302753120254e-23 -2.688781960733295e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0014522034332599529 6.650890809301261e-22 -5.974227249951444e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0015012084305935827 -7.78418306416193e-22 -1.991842715056933e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz b/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz deleted file mode 100644 index 08d0f1ebe..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst.instanton_forces_9.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015428868980090107 7.113900226191793e-22 7.376118774641905e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0014864226727866637 8.059511625647034e-22 2.4446916517003435e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001373855589352785 4.5765771830673006e-20 6.04373398509193e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0012064821996132322 2.431772265601935e-19 9.918509081180324e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0009876649486536898 -1.5776147957392954e-21 -2.299298733884633e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0007246211293814278 1.1718153171675837e-19 3.256489969406634e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.00042906629524346745 3.090558293548256e-20 8.33406640645857e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00011661499599453697 8.592820879047078e-21 2.6036135936096485e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00019531941495264636 2.9850995283934894e-21 5.465156021754627e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0004919669250026473 1.1753640002036437e-21 -2.754386412151776e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0007615486940610629 3.3191890194807336e-22 -5.742157345329215e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0009949616405223872 1.4655089144681762e-22 -3.558208230781254e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0011859608861268486 1.6548087967297755e-24 2.150578380559986e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0013308468007275807 -1.231759816645685e-22 -1.9775225569059333e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0014277563695201808 1.6990491896071378e-22 -5.592493893668901e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0014761792737331475 3.161909463272385e-22 -3.0096914103631925e-22 diff --git a/drivers/py/pes/friction/onheH/120K/inst1D.dat b/drivers/py/pes/friction/onheH/120K/inst1D.dat deleted file mode 100644 index 98a44396c..000000000 --- a/drivers/py/pes/friction/onheH/120K/inst1D.dat +++ /dev/null @@ -1,16 +0,0 @@ -2.4125106547770754 0.13868364218205256 -2.4179877800408174 0.13929953199849185 -2.428740027602391 0.14043324893922068 -2.4443652431526677 0.14190263010814 -2.464266693430515 0.1434667535392989 -2.4876664223743847 0.14485943590355374 -2.513631805015641 0.14583115071922406 -2.541116986243635 0.1461908273222357 -2.569017191901633 0.14584723976488212 -2.5962288872597017 0.14487160785265998 -2.621701195179552 0.14344662157500512 -2.6444773783435984 0.14180062236336408 -2.663727270955861 0.14016679741347038 -2.6787699878040856 0.13875201523568115 -2.6890878342505045 0.13771594786456398 -2.694333651918987 0.13716836312327987 diff --git a/drivers/py/pes/friction/template.agr b/drivers/py/pes/friction/template.agr deleted file mode 100644 index 6d0383c1a..000000000 --- a/drivers/py/pes/friction/template.agr +++ /dev/null @@ -1,1502 +0,0 @@ -# Grace project file -# -@version 50125 -@page size 792, 612 -@page scroll 5% -@page inout 5% -@link page off -@map font 8 to "Courier", "Courier" -@map font 10 to "Courier-Bold", "Courier-Bold" -@map font 11 to "Courier-BoldOblique", "Courier-BoldOblique" -@map font 9 to "Courier-Oblique", "Courier-Oblique" -@map font 14 to "Courier-Regular", "Courier-Regular" -@map font 15 to "Dingbats-Regular", "Dingbats-Regular" -@map font 4 to "Helvetica", "Helvetica" -@map font 6 to "Helvetica-Bold", "Helvetica-Bold" -@map font 7 to "Helvetica-BoldOblique", "Helvetica-BoldOblique" -@map font 5 to "Helvetica-Oblique", "Helvetica-Oblique" -@map font 20 to "NimbusMonoL-Bold", "NimbusMonoL-Bold" -@map font 21 to "NimbusMonoL-BoldOblique", "NimbusMonoL-BoldOblique" -@map font 22 to "NimbusMonoL-Regular", "NimbusMonoL-Regular" -@map font 23 to "NimbusMonoL-RegularOblique", "NimbusMonoL-RegularOblique" -@map font 24 to "NimbusRomanNo9L-Medium", "NimbusRomanNo9L-Medium" -@map font 25 to "NimbusRomanNo9L-MediumItalic", "NimbusRomanNo9L-MediumItalic" -@map font 26 to "NimbusRomanNo9L-Regular", "NimbusRomanNo9L-Regular" -@map font 27 to "NimbusRomanNo9L-RegularItalic", "NimbusRomanNo9L-RegularItalic" -@map font 28 to "NimbusSansL-Bold", "NimbusSansL-Bold" -@map font 29 to "NimbusSansL-BoldCondensed", "NimbusSansL-BoldCondensed" -@map font 30 to "NimbusSansL-BoldCondensedItalic", "NimbusSansL-BoldCondensedItalic" -@map font 31 to "NimbusSansL-BoldItalic", "NimbusSansL-BoldItalic" -@map font 32 to "NimbusSansL-Regular", "NimbusSansL-Regular" -@map font 33 to "NimbusSansL-RegularCondensed", "NimbusSansL-RegularCondensed" -@map font 34 to "NimbusSansL-RegularCondensedItalic", "NimbusSansL-RegularCondensedItalic" -@map font 35 to "NimbusSansL-RegularItalic", "NimbusSansL-RegularItalic" -@map font 36 to "StandardSymbolsL-Regular", "StandardSymbolsL-Regular" -@map font 12 to "Symbol", "Symbol" -@map font 2 to "Times-Bold", "Times-Bold" -@map font 3 to "Times-BoldItalic", "Times-BoldItalic" -@map font 1 to "Times-Italic", "Times-Italic" -@map font 0 to "Times-Roman", "Times-Roman" -@map font 42 to "URWBookmanL-DemiBold", "URWBookmanL-DemiBold" -@map font 43 to "URWBookmanL-DemiBoldItalic", "URWBookmanL-DemiBoldItalic" -@map font 44 to "URWBookmanL-Light", "URWBookmanL-Light" -@map font 45 to "URWBookmanL-LightItalic", "URWBookmanL-LightItalic" -@map font 46 to "URWChanceryL-MediumItalic", "URWChanceryL-MediumItalic" -@map font 47 to "URWGothicL-Book", "URWGothicL-Book" -@map font 48 to "URWGothicL-BookOblique", "URWGothicL-BookOblique" -@map font 49 to "URWGothicL-Demi", "URWGothicL-Demi" -@map font 50 to "URWGothicL-DemiOblique", "URWGothicL-DemiOblique" -@map font 51 to "URWPalladioL-Bold", "URWPalladioL-Bold" -@map font 52 to "URWPalladioL-BoldItalic", "URWPalladioL-BoldItalic" -@map font 53 to "URWPalladioL-Italic", "URWPalladioL-Italic" -@map font 54 to "URWPalladioL-Roman", "URWPalladioL-Roman" -@map font 55 to "Utopia-Bold", "Utopia-Bold" -@map font 56 to "Utopia-BoldItalic", "Utopia-BoldItalic" -@map font 57 to "Utopia-Italic", "Utopia-Italic" -@map font 58 to "Utopia-Regular", "Utopia-Regular" -@map font 13 to "ZapfDingbats", "ZapfDingbats" -@map color 0 to (255, 255, 255), "white" -@map color 1 to (0, 0, 0), "black" -@map color 2 to (255, 0, 0), "red" -@map color 3 to (0, 0, 255), "blue" -@map color 4 to (0, 255, 0), "green" -@map color 5 to (114, 33, 188), "indigo" -@map color 6 to (255, 0, 255), "magenta" -@map color 7 to (255, 165, 0), "orange" -@map color 8 to (0, 139, 0), "green4" -@map color 9 to (103, 7, 72), "maroon" -@map color 10 to (176, 23, 31), "indianred" -@map color 11 to (220, 20, 60), "crimson" -@map color 12 to (135, 38, 87), "raspberry" -@map color 13 to (139, 102, 139), "plum" -@map color 14 to (100, 149, 237), "blue2" -@map color 15 to (16, 78, 139), "blue3" -@map color 16 to (46, 139, 87), "seagreen" -@map color 17 to (238, 201, 0), "gold" -@map color 18 to (139, 105, 20), "goldenrod" -@map color 19 to (238, 118, 0), "darkorange" -@map color 20 to (139, 69, 19), "chocolate" -@map color 21 to (250, 128, 114), "salmon" -@map color 22 to (120, 120, 120), "darkgrey" -@map color 23 to (127, 127, 127), "grey" -@map color 24 to (255, 127, 127), "lightred" -@map color 25 to (127, 127, 255), "lightblue" -@map color 26 to (127, 255, 127), "lightgreen" -@map color 27 to (204, 149, 255), "lightindigo" -@map color 28 to (255, 127, 255), "lightmagenta" -@map color 29 to (255, 210, 127), "lightorange" -@map color 30 to (127, 255, 127), "lightgreen4" -@map color 31 to (206, 110, 174), "lightmaroon" -@map color 32 to (255, 144, 149), "lightindianred" -@map color 33 to (255, 139, 162), "lightcrimson" -@map color 34 to (255, 163, 209), "lightraspberry" -@map color 35 to (255, 221, 255), "lightplum" -@map color 36 to (181, 207, 255), "lightblue2" -@map color 37 to (142, 199, 255), "lightblue3" -@map color 38 to (169, 255, 207), "lightseagreen" -@map color 39 to (255, 235, 127), "lightgold" -@map color 40 to (255, 223, 145), "lightgoldenrod" -@map color 41 to (255, 190, 127), "lightdarkorange" -@map color 42 to (255, 190, 144), "lightchocolate" -@map color 43 to (255, 192, 185), "lightsalmon" -@map color 44 to (240, 240, 240), "lightgrey" -@map color 45 to (200, 200, 200), "lightdarkgrey" -@reference date 0 -@date wrap off -@date wrap year 1950 -@default linewidth 1.0 -@default linestyle 1 -@default color 1 -@default pattern 1 -@default font 0 -@default char size 1.000000 -@default symbol size 1.000000 -@default sformat "%.8g" -@background color 0 -@page background fill on -@timestamp off -@timestamp 0.03, 0.03 -@timestamp color 1 -@timestamp rot 0 -@timestamp font 0 -@timestamp char size 1.000000 -@timestamp def "Fri Feb 19 11:06:55 2021" -@with string -@ string on -@ string loctype view -@ string 0.497549019608, 0.803921568627 -@ string color 1 -@ string rot 0 -@ string font 4 -@ string just 0 -@ string char size 1.000000 -@ string def "120 K" -@with string -@ string on -@ string loctype view -@ string 1.02450980392, 0.79044117647 -@ string color 1 -@ string rot 0 -@ string font 4 -@ string just 0 -@ string char size 1.000000 -@ string def "100 K" -@with string -@ string on -@ string loctype view -@ string 0.490196078432, 0.411764705882 -@ string color 1 -@ string rot 0 -@ string font 4 -@ string just 0 -@ string char size 1.000000 -@ string def "080 K" -@with string -@ string on -@ string loctype view -@ string 1.02450980392, 0.405637254902 -@ string color 1 -@ string rot 0 -@ string font 4 -@ string just 0 -@ string char size 1.000000 -@ string def "060 K" -@r0 off -@link r0 to g0 -@r0 type above -@r0 linestyle 1 -@r0 linewidth 1.0 -@r0 color 1 -@r0 line 0, 0, 0, 0 -@r1 off -@link r1 to g0 -@r1 type above -@r1 linestyle 1 -@r1 linewidth 1.0 -@r1 color 1 -@r1 line 0, 0, 0, 0 -@r2 off -@link r2 to g0 -@r2 type above -@r2 linestyle 1 -@r2 linewidth 1.0 -@r2 color 1 -@r2 line 0, 0, 0, 0 -@r3 off -@link r3 to g0 -@r3 type above -@r3 linestyle 1 -@r3 linewidth 1.0 -@r3 color 1 -@r3 line 0, 0, 0, 0 -@r4 off -@link r4 to g0 -@r4 type above -@r4 linestyle 1 -@r4 linewidth 1.0 -@r4 color 1 -@r4 line 0, 0, 0, 0 -@g0 on -@g0 hidden false -@g0 type XY -@g0 stacked false -@g0 bar hgap 0.000000 -@g0 fixedpoint off -@g0 fixedpoint type 0 -@g0 fixedpoint xy 0.000000, 0.000000 -@g0 fixedpoint format general general -@g0 fixedpoint prec 6, 6 -@with g0 -@ world 1.5, 0, 3.5, 0.2 -@ stack world 0, 0, 0, 0 -@ znorm 1 -@ view 0.150000, 0.531818, 0.601872, 0.850000 -@ title "" -@ title font 0 -@ title size 1.500000 -@ title color 1 -@ subtitle "" -@ subtitle font 0 -@ subtitle size 1.000000 -@ subtitle color 1 -@ xaxes scale Normal -@ yaxes scale Normal -@ xaxes invert off -@ yaxes invert off -@ xaxis on -@ xaxis type zero false -@ xaxis offset 0.000000 , 0.000000 -@ xaxis bar on -@ xaxis bar color 1 -@ xaxis bar linestyle 1 -@ xaxis bar linewidth 2.0 -@ xaxis label "" -@ xaxis label layout para -@ xaxis label place auto -@ xaxis label char size 1.350000 -@ xaxis label font 4 -@ xaxis label color 1 -@ xaxis label place normal -@ xaxis tick on -@ xaxis tick major 0.5 -@ xaxis tick minor ticks 1 -@ xaxis tick default 6 -@ xaxis tick place rounded true -@ xaxis tick in -@ xaxis tick major size 0.500000 -@ xaxis tick major color 1 -@ xaxis tick major linewidth 1.5 -@ xaxis tick major linestyle 1 -@ xaxis tick major grid off -@ xaxis tick minor color 1 -@ xaxis tick minor linewidth 1.5 -@ xaxis tick minor linestyle 1 -@ xaxis tick minor grid off -@ xaxis tick minor size 0.500000 -@ xaxis ticklabel on -@ xaxis ticklabel format general -@ xaxis ticklabel prec 5 -@ xaxis ticklabel formula "" -@ xaxis ticklabel append "" -@ xaxis ticklabel prepend "" -@ xaxis ticklabel angle 0 -@ xaxis ticklabel skip 0 -@ xaxis ticklabel stagger 0 -@ xaxis ticklabel place normal -@ xaxis ticklabel offset auto -@ xaxis ticklabel offset 0.000000 , 0.010000 -@ xaxis ticklabel start type auto -@ xaxis ticklabel start 0.000000 -@ xaxis ticklabel stop type auto -@ xaxis ticklabel stop 0.000000 -@ xaxis ticklabel char size 1.000000 -@ xaxis ticklabel font 4 -@ xaxis ticklabel color 1 -@ xaxis tick place normal -@ xaxis tick spec type none -@ yaxis on -@ yaxis type zero false -@ yaxis offset 0.000000 , 0.000000 -@ yaxis bar on -@ yaxis bar color 1 -@ yaxis bar linestyle 1 -@ yaxis bar linewidth 2.0 -@ yaxis label "Energy(eV)" -@ yaxis label layout para -@ yaxis label place auto -@ yaxis label char size 1.250000 -@ yaxis label font 4 -@ yaxis label color 1 -@ yaxis label place normal -@ yaxis tick on -@ yaxis tick major 0.05 -@ yaxis tick minor ticks 1 -@ yaxis tick default 6 -@ yaxis tick place rounded true -@ yaxis tick in -@ yaxis tick major size 1.000000 -@ yaxis tick major color 1 -@ yaxis tick major linewidth 1.5 -@ yaxis tick major linestyle 1 -@ yaxis tick major grid off -@ yaxis tick minor color 1 -@ yaxis tick minor linewidth 1.5 -@ yaxis tick minor linestyle 1 -@ yaxis tick minor grid off -@ yaxis tick minor size 0.500000 -@ yaxis ticklabel on -@ yaxis ticklabel format general -@ yaxis ticklabel prec 5 -@ yaxis ticklabel formula "" -@ yaxis ticklabel append "" -@ yaxis ticklabel prepend "" -@ yaxis ticklabel angle 0 -@ yaxis ticklabel skip 0 -@ yaxis ticklabel stagger 0 -@ yaxis ticklabel place normal -@ yaxis ticklabel offset auto -@ yaxis ticklabel offset 0.000000 , 0.010000 -@ yaxis ticklabel start type auto -@ yaxis ticklabel start 0.000000 -@ yaxis ticklabel stop type auto -@ yaxis ticklabel stop 0.000000 -@ yaxis ticklabel char size 1.000000 -@ yaxis ticklabel font 4 -@ yaxis ticklabel color 1 -@ yaxis tick place normal -@ yaxis tick spec type none -@ altxaxis off -@ altyaxis off -@ legend on -@ legend loctype view -@ legend 0.85, 0.95 -@ legend box color 1 -@ legend box pattern 1 -@ legend box linewidth 2.0 -@ legend box linestyle 1 -@ legend box fill color 0 -@ legend box fill pattern 1 -@ legend font 0 -@ legend char size 1.000000 -@ legend color 1 -@ legend length 4 -@ legend vgap 1 -@ legend hgap 1 -@ legend invert false -@ frame type 0 -@ frame linestyle 1 -@ frame linewidth 2.0 -@ frame color 1 -@ frame pattern 1 -@ frame background color 0 -@ frame background pattern 0 -@ s0 hidden false -@ s0 type xy -@ s0 symbol 0 -@ s0 symbol size 1.000000 -@ s0 symbol color 1 -@ s0 symbol pattern 1 -@ s0 symbol fill color 1 -@ s0 symbol fill pattern 0 -@ s0 symbol linewidth 1.0 -@ s0 symbol linestyle 1 -@ s0 symbol char 65 -@ s0 symbol char font 0 -@ s0 symbol skip 0 -@ s0 line type 1 -@ s0 line linestyle 1 -@ s0 line linewidth 2.0 -@ s0 line color 1 -@ s0 line pattern 1 -@ s0 baseline type 0 -@ s0 baseline off -@ s0 dropline off -@ s0 fill type 0 -@ s0 fill rule 0 -@ s0 fill color 1 -@ s0 fill pattern 1 -@ s0 avalue off -@ s0 avalue type 2 -@ s0 avalue char size 1.000000 -@ s0 avalue font 0 -@ s0 avalue color 1 -@ s0 avalue rot 0 -@ s0 avalue format general -@ s0 avalue prec 3 -@ s0 avalue prepend "" -@ s0 avalue append "" -@ s0 avalue offset 0.000000 , 0.000000 -@ s0 errorbar on -@ s0 errorbar place both -@ s0 errorbar color 1 -@ s0 errorbar pattern 1 -@ s0 errorbar size 1.000000 -@ s0 errorbar linewidth 1.0 -@ s0 errorbar linestyle 1 -@ s0 errorbar riser linewidth 1.0 -@ s0 errorbar riser linestyle 1 -@ s0 errorbar riser clip off -@ s0 errorbar riser clip length 0.100000 -@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/120K/inst1D.dat" -@ s0 legend "Ohne Friction" -@ s1 hidden false -@ s1 type xy -@ s1 symbol 0 -@ s1 symbol size 1.000000 -@ s1 symbol color 2 -@ s1 symbol pattern 1 -@ s1 symbol fill color 2 -@ s1 symbol fill pattern 0 -@ s1 symbol linewidth 1.0 -@ s1 symbol linestyle 1 -@ s1 symbol char 65 -@ s1 symbol char font 0 -@ s1 symbol skip 0 -@ s1 line type 1 -@ s1 line linestyle 1 -@ s1 line linewidth 2.0 -@ s1 line color 2 -@ s1 line pattern 1 -@ s1 baseline type 0 -@ s1 baseline off -@ s1 dropline off -@ s1 fill type 0 -@ s1 fill rule 0 -@ s1 fill color 1 -@ s1 fill pattern 1 -@ s1 avalue off -@ s1 avalue type 2 -@ s1 avalue char size 1.000000 -@ s1 avalue font 0 -@ s1 avalue color 1 -@ s1 avalue rot 0 -@ s1 avalue format general -@ s1 avalue prec 3 -@ s1 avalue prepend "" -@ s1 avalue append "" -@ s1 avalue offset 0.000000 , 0.000000 -@ s1 errorbar on -@ s1 errorbar place both -@ s1 errorbar color 2 -@ s1 errorbar pattern 1 -@ s1 errorbar size 1.000000 -@ s1 errorbar linewidth 1.0 -@ s1 errorbar linestyle 1 -@ s1 errorbar riser linewidth 1.0 -@ s1 errorbar riser linestyle 1 -@ s1 errorbar riser clip off -@ s1 errorbar riser clip length 0.100000 -@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/120K/inst1D.dat" -@ s1 legend "Friction" -@g1 on -@g1 hidden false -@g1 type XY -@g1 stacked false -@g1 bar hgap 0.000000 -@g1 fixedpoint off -@g1 fixedpoint type 0 -@g1 fixedpoint xy 0.000000, 0.000000 -@g1 fixedpoint format general general -@g1 fixedpoint prec 6, 6 -@with g1 -@ world 1.5, 0, 3.5, 0.2 -@ stack world 0, 0, 0, 0 -@ znorm 1 -@ view 0.692246, 0.531818, 1.144118, 0.850000 -@ title "" -@ title font 0 -@ title size 1.500000 -@ title color 1 -@ subtitle "" -@ subtitle font 0 -@ subtitle size 1.000000 -@ subtitle color 1 -@ xaxes scale Normal -@ yaxes scale Normal -@ xaxes invert off -@ yaxes invert off -@ xaxis on -@ xaxis type zero false -@ xaxis offset 0.000000 , 0.000000 -@ xaxis bar on -@ xaxis bar color 1 -@ xaxis bar linestyle 1 -@ xaxis bar linewidth 1.0 -@ xaxis label "" -@ xaxis label layout para -@ xaxis label place auto -@ xaxis label char size 1.000000 -@ xaxis label font 4 -@ xaxis label color 1 -@ xaxis label place normal -@ xaxis tick on -@ xaxis tick major 0.5 -@ xaxis tick minor ticks 1 -@ xaxis tick default 6 -@ xaxis tick place rounded true -@ xaxis tick in -@ xaxis tick major size 1.000000 -@ xaxis tick major color 1 -@ xaxis tick major linewidth 1.0 -@ xaxis tick major linestyle 1 -@ xaxis tick major grid off -@ xaxis tick minor color 1 -@ xaxis tick minor linewidth 1.0 -@ xaxis tick minor linestyle 1 -@ xaxis tick minor grid off -@ xaxis tick minor size 0.500000 -@ xaxis ticklabel on -@ xaxis ticklabel format general -@ xaxis ticklabel prec 5 -@ xaxis ticklabel formula "" -@ xaxis ticklabel append "" -@ xaxis ticklabel prepend "" -@ xaxis ticklabel angle 0 -@ xaxis ticklabel skip 0 -@ xaxis ticklabel stagger 0 -@ xaxis ticklabel place normal -@ xaxis ticklabel offset auto -@ xaxis ticklabel offset 0.000000 , 0.010000 -@ xaxis ticklabel start type auto -@ xaxis ticklabel start 0.000000 -@ xaxis ticklabel stop type auto -@ xaxis ticklabel stop 0.000000 -@ xaxis ticklabel char size 1.000000 -@ xaxis ticklabel font 4 -@ xaxis ticklabel color 1 -@ xaxis tick place both -@ xaxis tick spec type none -@ yaxis on -@ yaxis type zero false -@ yaxis offset 0.000000 , 0.000000 -@ yaxis bar on -@ yaxis bar color 1 -@ yaxis bar linestyle 1 -@ yaxis bar linewidth 1.0 -@ yaxis label "" -@ yaxis label layout para -@ yaxis label place auto -@ yaxis label char size 1.000000 -@ yaxis label font 0 -@ yaxis label color 1 -@ yaxis label place normal -@ yaxis tick on -@ yaxis tick major 0.02 -@ yaxis tick minor ticks 1 -@ yaxis tick default 6 -@ yaxis tick place rounded true -@ yaxis tick in -@ yaxis tick major size 1.000000 -@ yaxis tick major color 1 -@ yaxis tick major linewidth 1.0 -@ yaxis tick major linestyle 1 -@ yaxis tick major grid off -@ yaxis tick minor color 1 -@ yaxis tick minor linewidth 1.0 -@ yaxis tick minor linestyle 1 -@ yaxis tick minor grid off -@ yaxis tick minor size 0.500000 -@ yaxis ticklabel off -@ yaxis ticklabel format general -@ yaxis ticklabel prec 5 -@ yaxis ticklabel formula "" -@ yaxis ticklabel append "" -@ yaxis ticklabel prepend "" -@ yaxis ticklabel angle 0 -@ yaxis ticklabel skip 0 -@ yaxis ticklabel stagger 0 -@ yaxis ticklabel place normal -@ yaxis ticklabel offset auto -@ yaxis ticklabel offset 0.000000 , 0.010000 -@ yaxis ticklabel start type auto -@ yaxis ticklabel start 0.000000 -@ yaxis ticklabel stop type auto -@ yaxis ticklabel stop 0.000000 -@ yaxis ticklabel char size 1.000000 -@ yaxis ticklabel font 0 -@ yaxis ticklabel color 1 -@ yaxis tick place both -@ yaxis tick spec type none -@ altxaxis off -@ altyaxis off -@ legend on -@ legend loctype view -@ legend 0.5, 0.8 -@ legend box color 1 -@ legend box pattern 1 -@ legend box linewidth 1.0 -@ legend box linestyle 1 -@ legend box fill color 0 -@ legend box fill pattern 1 -@ legend font 0 -@ legend char size 1.000000 -@ legend color 1 -@ legend length 4 -@ legend vgap 1 -@ legend hgap 1 -@ legend invert false -@ frame type 0 -@ frame linestyle 1 -@ frame linewidth 2.0 -@ frame color 1 -@ frame pattern 1 -@ frame background color 0 -@ frame background pattern 0 -@ s0 hidden false -@ s0 type xy -@ s0 symbol 0 -@ s0 symbol size 1.000000 -@ s0 symbol color 1 -@ s0 symbol pattern 1 -@ s0 symbol fill color 1 -@ s0 symbol fill pattern 0 -@ s0 symbol linewidth 1.0 -@ s0 symbol linestyle 1 -@ s0 symbol char 65 -@ s0 symbol char font 0 -@ s0 symbol skip 0 -@ s0 line type 1 -@ s0 line linestyle 1 -@ s0 line linewidth 2.0 -@ s0 line color 1 -@ s0 line pattern 1 -@ s0 baseline type 0 -@ s0 baseline off -@ s0 dropline off -@ s0 fill type 0 -@ s0 fill rule 0 -@ s0 fill color 1 -@ s0 fill pattern 1 -@ s0 avalue off -@ s0 avalue type 2 -@ s0 avalue char size 1.000000 -@ s0 avalue font 0 -@ s0 avalue color 1 -@ s0 avalue rot 0 -@ s0 avalue format general -@ s0 avalue prec 3 -@ s0 avalue prepend "" -@ s0 avalue append "" -@ s0 avalue offset 0.000000 , 0.000000 -@ s0 errorbar on -@ s0 errorbar place both -@ s0 errorbar color 1 -@ s0 errorbar pattern 1 -@ s0 errorbar size 1.000000 -@ s0 errorbar linewidth 1.0 -@ s0 errorbar linestyle 1 -@ s0 errorbar riser linewidth 1.0 -@ s0 errorbar riser linestyle 1 -@ s0 errorbar riser clip off -@ s0 errorbar riser clip length 0.100000 -@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/100K/inst1D.dat" -@ s0 legend "" -@ s1 hidden false -@ s1 type xy -@ s1 symbol 0 -@ s1 symbol size 1.000000 -@ s1 symbol color 2 -@ s1 symbol pattern 1 -@ s1 symbol fill color 2 -@ s1 symbol fill pattern 0 -@ s1 symbol linewidth 1.0 -@ s1 symbol linestyle 1 -@ s1 symbol char 65 -@ s1 symbol char font 0 -@ s1 symbol skip 0 -@ s1 line type 1 -@ s1 line linestyle 1 -@ s1 line linewidth 2.0 -@ s1 line color 2 -@ s1 line pattern 1 -@ s1 baseline type 0 -@ s1 baseline off -@ s1 dropline off -@ s1 fill type 0 -@ s1 fill rule 0 -@ s1 fill color 1 -@ s1 fill pattern 1 -@ s1 avalue off -@ s1 avalue type 2 -@ s1 avalue char size 1.000000 -@ s1 avalue font 0 -@ s1 avalue color 1 -@ s1 avalue rot 0 -@ s1 avalue format general -@ s1 avalue prec 3 -@ s1 avalue prepend "" -@ s1 avalue append "" -@ s1 avalue offset 0.000000 , 0.000000 -@ s1 errorbar on -@ s1 errorbar place both -@ s1 errorbar color 2 -@ s1 errorbar pattern 1 -@ s1 errorbar size 1.000000 -@ s1 errorbar linewidth 1.0 -@ s1 errorbar linestyle 1 -@ s1 errorbar riser linewidth 1.0 -@ s1 errorbar riser linestyle 1 -@ s1 errorbar riser clip off -@ s1 errorbar riser clip length 0.100000 -@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/100K/inst1D.dat" -@ s1 legend "" -@g2 on -@g2 hidden false -@g2 type XY -@g2 stacked false -@g2 bar hgap 0.000000 -@g2 fixedpoint off -@g2 fixedpoint type 0 -@g2 fixedpoint xy 0.000000, 0.000000 -@g2 fixedpoint format general general -@g2 fixedpoint prec 6, 6 -@with g2 -@ world 1.5, 0, 3.5, 0.2 -@ stack world 0, 0, 0, 0 -@ znorm 1 -@ view 0.150000, 0.150000, 0.601872, 0.468182 -@ title "" -@ title font 0 -@ title size 1.500000 -@ title color 1 -@ subtitle "" -@ subtitle font 0 -@ subtitle size 1.000000 -@ subtitle color 1 -@ xaxes scale Normal -@ yaxes scale Normal -@ xaxes invert off -@ yaxes invert off -@ xaxis on -@ xaxis type zero false -@ xaxis offset 0.000000 , 0.000000 -@ xaxis bar on -@ xaxis bar color 1 -@ xaxis bar linestyle 1 -@ xaxis bar linewidth 1.0 -@ xaxis label "" -@ xaxis label layout para -@ xaxis label place auto -@ xaxis label char size 1.000000 -@ xaxis label font 4 -@ xaxis label color 1 -@ xaxis label place normal -@ xaxis tick on -@ xaxis tick major 0.5 -@ xaxis tick minor ticks 1 -@ xaxis tick default 6 -@ xaxis tick place rounded true -@ xaxis tick in -@ xaxis tick major size 1.000000 -@ xaxis tick major color 1 -@ xaxis tick major linewidth 1.0 -@ xaxis tick major linestyle 1 -@ xaxis tick major grid off -@ xaxis tick minor color 1 -@ xaxis tick minor linewidth 1.0 -@ xaxis tick minor linestyle 1 -@ xaxis tick minor grid off -@ xaxis tick minor size 0.500000 -@ xaxis ticklabel on -@ xaxis ticklabel format general -@ xaxis ticklabel prec 5 -@ xaxis ticklabel formula "" -@ xaxis ticklabel append "" -@ xaxis ticklabel prepend "" -@ xaxis ticklabel angle 0 -@ xaxis ticklabel skip 0 -@ xaxis ticklabel stagger 0 -@ xaxis ticklabel place normal -@ xaxis ticklabel offset auto -@ xaxis ticklabel offset 0.000000 , 0.010000 -@ xaxis ticklabel start type auto -@ xaxis ticklabel start 0.000000 -@ xaxis ticklabel stop type auto -@ xaxis ticklabel stop 0.000000 -@ xaxis ticklabel char size 1.000000 -@ xaxis ticklabel font 4 -@ xaxis ticklabel color 1 -@ xaxis tick place both -@ xaxis tick spec type none -@ yaxis on -@ yaxis type zero false -@ yaxis offset 0.000000 , 0.000000 -@ yaxis bar on -@ yaxis bar color 1 -@ yaxis bar linestyle 1 -@ yaxis bar linewidth 1.0 -@ yaxis label "Energy (eV)" -@ yaxis label layout para -@ yaxis label place auto -@ yaxis label char size 1.250000 -@ yaxis label font 4 -@ yaxis label color 1 -@ yaxis label place normal -@ yaxis tick on -@ yaxis tick major 0.05 -@ yaxis tick minor ticks 1 -@ yaxis tick default 6 -@ yaxis tick place rounded true -@ yaxis tick in -@ yaxis tick major size 1.000000 -@ yaxis tick major color 1 -@ yaxis tick major linewidth 1.0 -@ yaxis tick major linestyle 1 -@ yaxis tick major grid off -@ yaxis tick minor color 1 -@ yaxis tick minor linewidth 1.0 -@ yaxis tick minor linestyle 1 -@ yaxis tick minor grid off -@ yaxis tick minor size 0.500000 -@ yaxis ticklabel on -@ yaxis ticklabel format general -@ yaxis ticklabel prec 5 -@ yaxis ticklabel formula "" -@ yaxis ticklabel append "" -@ yaxis ticklabel prepend "" -@ yaxis ticklabel angle 0 -@ yaxis ticklabel skip 0 -@ yaxis ticklabel stagger 0 -@ yaxis ticklabel place normal -@ yaxis ticklabel offset auto -@ yaxis ticklabel offset 0.000000 , 0.010000 -@ yaxis ticklabel start type auto -@ yaxis ticklabel start 0.000000 -@ yaxis ticklabel stop type auto -@ yaxis ticklabel stop 0.000000 -@ yaxis ticklabel char size 1.000000 -@ yaxis ticklabel font 4 -@ yaxis ticklabel color 1 -@ yaxis tick place both -@ yaxis tick spec type none -@ altxaxis off -@ altyaxis off -@ legend on -@ legend loctype view -@ legend 0.5, 0.8 -@ legend box color 1 -@ legend box pattern 1 -@ legend box linewidth 1.0 -@ legend box linestyle 1 -@ legend box fill color 0 -@ legend box fill pattern 1 -@ legend font 0 -@ legend char size 1.000000 -@ legend color 1 -@ legend length 4 -@ legend vgap 1 -@ legend hgap 1 -@ legend invert false -@ frame type 0 -@ frame linestyle 1 -@ frame linewidth 2.0 -@ frame color 1 -@ frame pattern 1 -@ frame background color 0 -@ frame background pattern 0 -@ s0 hidden false -@ s0 type xy -@ s0 symbol 0 -@ s0 symbol size 1.000000 -@ s0 symbol color 1 -@ s0 symbol pattern 1 -@ s0 symbol fill color 1 -@ s0 symbol fill pattern 0 -@ s0 symbol linewidth 1.0 -@ s0 symbol linestyle 1 -@ s0 symbol char 65 -@ s0 symbol char font 0 -@ s0 symbol skip 0 -@ s0 line type 1 -@ s0 line linestyle 1 -@ s0 line linewidth 2.0 -@ s0 line color 1 -@ s0 line pattern 1 -@ s0 baseline type 0 -@ s0 baseline off -@ s0 dropline off -@ s0 fill type 0 -@ s0 fill rule 0 -@ s0 fill color 1 -@ s0 fill pattern 1 -@ s0 avalue off -@ s0 avalue type 2 -@ s0 avalue char size 1.000000 -@ s0 avalue font 0 -@ s0 avalue color 1 -@ s0 avalue rot 0 -@ s0 avalue format general -@ s0 avalue prec 3 -@ s0 avalue prepend "" -@ s0 avalue append "" -@ s0 avalue offset 0.000000 , 0.000000 -@ s0 errorbar on -@ s0 errorbar place both -@ s0 errorbar color 1 -@ s0 errorbar pattern 1 -@ s0 errorbar size 1.000000 -@ s0 errorbar linewidth 1.0 -@ s0 errorbar linestyle 1 -@ s0 errorbar riser linewidth 1.0 -@ s0 errorbar riser linestyle 1 -@ s0 errorbar riser clip off -@ s0 errorbar riser clip length 0.100000 -@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/080K/inst1D.dat" -@ s0 legend "" -@ s1 hidden false -@ s1 type xy -@ s1 symbol 0 -@ s1 symbol size 1.000000 -@ s1 symbol color 2 -@ s1 symbol pattern 1 -@ s1 symbol fill color 2 -@ s1 symbol fill pattern 0 -@ s1 symbol linewidth 1.0 -@ s1 symbol linestyle 1 -@ s1 symbol char 65 -@ s1 symbol char font 0 -@ s1 symbol skip 0 -@ s1 line type 1 -@ s1 line linestyle 1 -@ s1 line linewidth 2.0 -@ s1 line color 2 -@ s1 line pattern 1 -@ s1 baseline type 0 -@ s1 baseline off -@ s1 dropline off -@ s1 fill type 0 -@ s1 fill rule 0 -@ s1 fill color 1 -@ s1 fill pattern 1 -@ s1 avalue off -@ s1 avalue type 2 -@ s1 avalue char size 1.000000 -@ s1 avalue font 0 -@ s1 avalue color 1 -@ s1 avalue rot 0 -@ s1 avalue format general -@ s1 avalue prec 3 -@ s1 avalue prepend "" -@ s1 avalue append "" -@ s1 avalue offset 0.000000 , 0.000000 -@ s1 errorbar on -@ s1 errorbar place both -@ s1 errorbar color 2 -@ s1 errorbar pattern 1 -@ s1 errorbar size 1.000000 -@ s1 errorbar linewidth 1.0 -@ s1 errorbar linestyle 1 -@ s1 errorbar riser linewidth 1.0 -@ s1 errorbar riser linestyle 1 -@ s1 errorbar riser clip off -@ s1 errorbar riser clip length 0.100000 -@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/080K/inst1D.dat" -@ s1 legend "" -@g3 on -@g3 hidden false -@g3 type XY -@g3 stacked false -@g3 bar hgap 0.000000 -@g3 fixedpoint off -@g3 fixedpoint type 0 -@g3 fixedpoint xy 0.000000, 0.000000 -@g3 fixedpoint format general general -@g3 fixedpoint prec 6, 6 -@with g3 -@ world 1.5, 0, 3.5, 0.2 -@ stack world 0, 0, 0, 0 -@ znorm 1 -@ view 0.692246, 0.150000, 1.144118, 0.468182 -@ title "" -@ title font 0 -@ title size 1.500000 -@ title color 1 -@ subtitle "" -@ subtitle font 0 -@ subtitle size 1.000000 -@ subtitle color 1 -@ xaxes scale Normal -@ yaxes scale Normal -@ xaxes invert off -@ yaxes invert off -@ xaxis on -@ xaxis type zero false -@ xaxis offset 0.000000 , 0.000000 -@ xaxis bar on -@ xaxis bar color 1 -@ xaxis bar linestyle 1 -@ xaxis bar linewidth 1.0 -@ xaxis label "" -@ xaxis label layout para -@ xaxis label place auto -@ xaxis label char size 1.000000 -@ xaxis label font 4 -@ xaxis label color 1 -@ xaxis label place normal -@ xaxis tick on -@ xaxis tick major 0.5 -@ xaxis tick minor ticks 1 -@ xaxis tick default 6 -@ xaxis tick place rounded true -@ xaxis tick in -@ xaxis tick major size 1.000000 -@ xaxis tick major color 1 -@ xaxis tick major linewidth 1.0 -@ xaxis tick major linestyle 1 -@ xaxis tick major grid off -@ xaxis tick minor color 1 -@ xaxis tick minor linewidth 1.0 -@ xaxis tick minor linestyle 1 -@ xaxis tick minor grid off -@ xaxis tick minor size 0.500000 -@ xaxis ticklabel on -@ xaxis ticklabel format general -@ xaxis ticklabel prec 5 -@ xaxis ticklabel formula "" -@ xaxis ticklabel append "" -@ xaxis ticklabel prepend "" -@ xaxis ticklabel angle 0 -@ xaxis ticklabel skip 0 -@ xaxis ticklabel stagger 0 -@ xaxis ticklabel place normal -@ xaxis ticklabel offset auto -@ xaxis ticklabel offset 0.000000 , 0.010000 -@ xaxis ticklabel start type auto -@ xaxis ticklabel start 0.000000 -@ xaxis ticklabel stop type auto -@ xaxis ticklabel stop 0.000000 -@ xaxis ticklabel char size 1.000000 -@ xaxis ticklabel font 4 -@ xaxis ticklabel color 1 -@ xaxis tick place both -@ xaxis tick spec type none -@ yaxis on -@ yaxis type zero false -@ yaxis offset 0.000000 , 0.000000 -@ yaxis bar on -@ yaxis bar color 1 -@ yaxis bar linestyle 1 -@ yaxis bar linewidth 1.0 -@ yaxis label "" -@ yaxis label layout para -@ yaxis label place auto -@ yaxis label char size 1.000000 -@ yaxis label font 0 -@ yaxis label color 1 -@ yaxis label place normal -@ yaxis tick on -@ yaxis tick major 0.05 -@ yaxis tick minor ticks 1 -@ yaxis tick default 6 -@ yaxis tick place rounded true -@ yaxis tick in -@ yaxis tick major size 1.000000 -@ yaxis tick major color 1 -@ yaxis tick major linewidth 1.0 -@ yaxis tick major linestyle 1 -@ yaxis tick major grid off -@ yaxis tick minor color 1 -@ yaxis tick minor linewidth 1.0 -@ yaxis tick minor linestyle 1 -@ yaxis tick minor grid off -@ yaxis tick minor size 0.500000 -@ yaxis ticklabel off -@ yaxis ticklabel format general -@ yaxis ticklabel prec 5 -@ yaxis ticklabel formula "" -@ yaxis ticklabel append "" -@ yaxis ticklabel prepend "" -@ yaxis ticklabel angle 0 -@ yaxis ticklabel skip 0 -@ yaxis ticklabel stagger 0 -@ yaxis ticklabel place normal -@ yaxis ticklabel offset auto -@ yaxis ticklabel offset 0.000000 , 0.010000 -@ yaxis ticklabel start type auto -@ yaxis ticklabel start 0.000000 -@ yaxis ticklabel stop type auto -@ yaxis ticklabel stop 0.000000 -@ yaxis ticklabel char size 1.000000 -@ yaxis ticklabel font 0 -@ yaxis ticklabel color 1 -@ yaxis tick place both -@ yaxis tick spec type none -@ altxaxis off -@ altyaxis off -@ legend on -@ legend loctype view -@ legend 0.5, 0.8 -@ legend box color 1 -@ legend box pattern 1 -@ legend box linewidth 1.0 -@ legend box linestyle 1 -@ legend box fill color 0 -@ legend box fill pattern 1 -@ legend font 0 -@ legend char size 1.000000 -@ legend color 1 -@ legend length 4 -@ legend vgap 1 -@ legend hgap 1 -@ legend invert false -@ frame type 0 -@ frame linestyle 1 -@ frame linewidth 2.0 -@ frame color 1 -@ frame pattern 1 -@ frame background color 0 -@ frame background pattern 0 -@ s0 hidden false -@ s0 type xy -@ s0 symbol 0 -@ s0 symbol size 1.000000 -@ s0 symbol color 1 -@ s0 symbol pattern 1 -@ s0 symbol fill color 1 -@ s0 symbol fill pattern 0 -@ s0 symbol linewidth 1.0 -@ s0 symbol linestyle 1 -@ s0 symbol char 65 -@ s0 symbol char font 0 -@ s0 symbol skip 0 -@ s0 line type 1 -@ s0 line linestyle 1 -@ s0 line linewidth 2.0 -@ s0 line color 1 -@ s0 line pattern 1 -@ s0 baseline type 0 -@ s0 baseline off -@ s0 dropline off -@ s0 fill type 0 -@ s0 fill rule 0 -@ s0 fill color 1 -@ s0 fill pattern 1 -@ s0 avalue off -@ s0 avalue type 2 -@ s0 avalue char size 1.000000 -@ s0 avalue font 0 -@ s0 avalue color 1 -@ s0 avalue rot 0 -@ s0 avalue format general -@ s0 avalue prec 3 -@ s0 avalue prepend "" -@ s0 avalue append "" -@ s0 avalue offset 0.000000 , 0.000000 -@ s0 errorbar on -@ s0 errorbar place both -@ s0 errorbar color 1 -@ s0 errorbar pattern 1 -@ s0 errorbar size 1.000000 -@ s0 errorbar linewidth 1.0 -@ s0 errorbar linestyle 1 -@ s0 errorbar riser linewidth 1.0 -@ s0 errorbar riser linestyle 1 -@ s0 errorbar riser clip off -@ s0 errorbar riser clip length 0.100000 -@ s0 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/onheH/060K/inst1D.dat" -@ s0 legend "" -@ s1 hidden false -@ s1 type xy -@ s1 symbol 0 -@ s1 symbol size 1.000000 -@ s1 symbol color 2 -@ s1 symbol pattern 1 -@ s1 symbol fill color 2 -@ s1 symbol fill pattern 0 -@ s1 symbol linewidth 1.0 -@ s1 symbol linestyle 1 -@ s1 symbol char 65 -@ s1 symbol char font 0 -@ s1 symbol skip 0 -@ s1 line type 1 -@ s1 line linestyle 1 -@ s1 line linewidth 2.0 -@ s1 line color 2 -@ s1 line pattern 1 -@ s1 baseline type 0 -@ s1 baseline off -@ s1 dropline off -@ s1 fill type 0 -@ s1 fill rule 0 -@ s1 fill color 1 -@ s1 fill pattern 1 -@ s1 avalue off -@ s1 avalue type 2 -@ s1 avalue char size 1.000000 -@ s1 avalue font 0 -@ s1 avalue color 1 -@ s1 avalue rot 0 -@ s1 avalue format general -@ s1 avalue prec 3 -@ s1 avalue prepend "" -@ s1 avalue append "" -@ s1 avalue offset 0.000000 , 0.000000 -@ s1 errorbar on -@ s1 errorbar place both -@ s1 errorbar color 2 -@ s1 errorbar pattern 1 -@ s1 errorbar size 1.000000 -@ s1 errorbar linewidth 1.0 -@ s1 errorbar linestyle 1 -@ s1 errorbar riser linewidth 1.0 -@ s1 errorbar riser linestyle 1 -@ s1 errorbar riser clip off -@ s1 errorbar riser clip length 0.100000 -@ s1 comment "/home/litmanya/Codes/i-pi/SABIA/i-pi/drivers/drivers/friction/frictionH/060K/inst1D.dat" -@ s1 legend "" -@target G0.S0 -@type xy -2.4125107 0.13868364 -2.4179878 0.13929953 -2.42874 0.14043325 -2.4443652 0.14190263 -2.4642667 0.14346675 -2.4876664 0.14485944 -2.5136318 0.14583115 -2.541117 0.14619083 -2.5690172 0.14584724 -2.5962289 0.14487161 -2.6217012 0.14344662 -2.6444774 0.14180062 -2.6637273 0.1401668 -2.67877 0.13875202 -2.6890878 0.13771595 -2.6943337 0.13716836 -& -@target G0.S1 -@type xy -2.5404617 0.14619035 -2.5408892 0.14619071 -2.5417277 0.14619091 -2.5429447 0.14619005 -2.544493 0.14618697 -2.546313 0.1461805 -2.5483342 0.1461697 -2.5504789 0.14615412 -2.5526643 0.14613391 -2.5548065 0.14610987 -2.5568234 0.14608347 -2.5586376 0.1460566 -2.5601798 0.14603146 -2.5613911 0.14601024 -2.5622252 0.14599487 -2.5626503 0.14598681 -& -@target G1.S0 -@type xy -2.1140352 0.076168765 -2.1292682 0.079772628 -2.1600045 0.087227829 -2.2065283 0.098705526 -2.2685997 0.11349751 -2.3448117 0.1289372 -2.4322203 0.14077881 -2.5264469 0.14608519 -2.6221167 0.1434196 -2.7138878 0.13499974 -2.7972109 0.12330028 -2.8688194 0.10989162 -2.9268984 0.0974325 -2.970644 0.087614053 -2.9998041 0.081026366 -3.0143653 0.077748183 -& -@target G1.S1 -@type xy -2.1481513 0.084329875 -2.1625478 0.087852471 -2.1914769 0.094993194 -2.234972 0.10562813 -2.2925299 0.11877371 -2.3626514 0.13188808 -2.4426064 0.14174779 -2.5285044 0.14611196 -2.6156591 0.14382628 -2.6994168 0.13662413 -2.7757577 0.1267172 -2.841669 0.11529636 -2.8953394 0.10432512 -2.9358895 0.095431447 -2.9629791 0.089344847 -2.9765244 0.086285344 -& -@target G2.S0 -@type xy -1.956477 0.046867586 -1.9572334 0.046957184 -1.9587518 0.047138935 -1.9610427 0.047417985 -1.9641224 0.047802136 -1.9680123 0.04830194 -1.972739 0.048930812 -1.9783343 0.049705143 -1.9848348 0.050644402 -1.9922821 0.051771202 -2.000722 0.053111296 -2.0102045 0.054693458 -2.0207829 0.056549205 -2.0325136 0.058712293 -2.0454546 0.061217918 -2.059665 0.064101525 -2.0752031 0.067397157 -2.0921251 0.071135228 -2.1104829 0.075339671 -2.1303212 0.080024383 -2.1516756 0.085188987 -2.174568 0.090813985 -2.1990037 0.09685188 -2.2249673 0.1032131 -2.2524204 0.10976658 -2.2813009 0.11633792 -2.3115228 0.12270836 -2.3429769 0.12861822 -2.3755333 0.13384883 -2.4090433 0.13828036 -2.4433411 0.1418128 -2.478246 0.14435723 -2.5135651 0.14582944 -2.549099 0.14616463 -2.5846475 0.14535968 -2.6200151 0.14355507 -2.655014 0.14093213 -2.689466 0.13767694 -2.7232052 0.13389365 -2.7560798 0.12959701 -2.7879557 0.12481065 -2.8187184 0.11957546 -2.8482749 0.11401288 -2.8765525 0.10829448 -2.9034961 0.10256725 -2.929066 0.096951254 -2.9532352 0.091541105 -2.9759874 0.086406625 -2.9973151 0.081587948 -3.0172176 0.077107878 -3.0357001 0.072979233 -3.0527718 0.069206719 -3.0684455 0.065788641 -3.0827356 0.062718474 -3.0956584 0.059986241 -3.1072302 0.057579723 -3.1174676 0.055485416 -3.1263864 0.053688596 -3.1340014 0.052175081 -3.1403257 0.050932623 -3.1453709 0.04995098 -3.1491464 0.04922194 -3.1516593 0.048739341 -3.1529145 0.048499069 -& -@target G2.S1 -@type xy -1.986685 0.05091937 -1.9994379 0.052903203 -2.0262721 0.057548082 -2.0697017 0.06621438 -2.1329715 0.080659415 -2.2189211 0.101742 -2.3276738 0.12584533 -2.4543702 0.14273224 -2.589553 0.14516575 -2.7216097 0.13408648 -2.8405658 0.11550857 -2.9403611 0.094431774 -3.0189906 0.076710307 -3.0766054 0.064029716 -3.1141674 0.056156934 -3.1326587 0.052440646 -& -@target G3.S0 -@type xy -1.8783333 0.04143116 -1.8785298 0.041434377 -1.8789259 0.041441038 -1.8795283 0.041451616 -1.880347 0.041466856 -1.8813956 0.041487822 -1.8826913 0.041515972 -1.8842555 0.04155324 -1.8861138 0.041602164 -1.8882966 0.041666035 -1.8908392 0.041749098 -1.8937826 0.041856794 -1.8971737 0.041996075 -1.9010661 0.042175779 -1.9055207 0.042407096 -1.9106062 0.042704131 -1.9163997 0.043084566 -1.9229876 0.04357044 -1.9304662 0.044189025 -1.9389418 0.044973801 -1.9485316 0.045965467 -1.9593638 0.047212921 -1.9715773 0.04877408 -1.9853211 0.050716343 -2.0007534 0.053116408 -2.0180395 0.056059049 -2.0373487 0.059634333 -2.05885 0.06393263 -2.0827061 0.069036704 -2.1090654 0.075010162 -2.1380517 0.081881749 -2.1697507 0.089625454 -2.2041943 0.098131184 -2.2413435 0.10715123 -2.2810793 0.11628911 -2.3232012 0.12499742 -2.367431 0.13263222 -2.4134242 0.13878817 -2.4607781 0.14321764 -2.5090414 0.14570372 -2.5577323 0.14607037 -2.6063639 0.1443606 -2.6544674 0.14097875 -2.7016038 0.1363858 -2.7473734 0.13079626 -2.7914281 0.12425051 -2.8334837 0.11685568 -2.873327 0.10896346 -2.9108089 0.10097612 -2.9458331 0.093205118 -2.9783456 0.085873647 -3.0083249 0.079106341 -3.0357747 0.072962653 -3.0607167 0.067468044 -3.0831858 0.06262255 -3.103225 0.058408112 -3.1208816 0.054794562 -3.1362039 0.051740885 -3.1492389 0.04920413 -3.1600298 0.04714707 -3.1686146 0.045538633 -3.1750246 0.044353979 -3.1792843 0.043574515 -3.18141 0.043187871 -& -@target G3.S1 -@type xy -1.8946271 0.041889967 -1.8948991 0.041900864 -1.8954468 0.041923123 -1.8962777 0.041957701 -1.8974032 0.042006086 -1.898839 0.042070378 -1.9006049 0.042153388 -1.9027257 0.042258777 -1.9052311 0.042391233 -1.9081565 0.042556696 -1.9115431 0.04276264 -1.915439 0.043018423 -1.9198995 0.043335705 -1.9249875 0.043728954 -1.9307747 0.044216051 -1.9373418 0.044818972 -1.9447791 0.045564569 -1.9531874 0.046485417 -1.9626779 0.047620672 -1.9733726 0.04901689 -1.9854041 0.05072866 -1.998915 0.05281888 -2.0140564 0.055358408 -2.0309865 0.05842472 -2.0498671 0.062099107 -2.0708593 0.066461841 -2.0941181 0.071584671 -2.1197841 0.077520041 -2.1479738 0.084286621 -2.1787667 0.091851139 -2.2121906 0.10009594 -2.2482068 0.10877698 -2.2867032 0.11751916 -2.3274929 0.12581136 -2.3703181 0.13307221 -2.4148594 0.13895093 -2.4607429 0.14321508 -2.5075487 0.14565816 -2.554827 0.14610963 -2.6021217 0.14458378 -2.648992 0.14143639 -2.6950236 0.13709531 -2.7398381 0.13179811 -2.7831028 0.12558053 -2.824544 0.11851734 -2.8639535 0.11088444 -2.9011862 0.10306702 -2.936149 0.095373505 -2.9687911 0.088032683 -2.9990946 0.081186502 -3.027067 0.074902943 -3.052735 0.069214895 -3.0761391 0.064129837 -3.0973288 0.05963651 -3.1163591 0.055710643 -3.1332873 0.052316292 -3.1481702 0.049410068 -3.1610622 0.046952418 -3.1720132 0.04490887 -3.1810679 0.043250076 -3.1882644 0.04195178 -3.1936341 0.040994736 -3.1972005 0.040364616 -3.1989797 0.040051921 -& diff --git a/drivers/py/pes/friction/test-ohne80/RESTART b/drivers/py/pes/friction/test-ohne80/RESTART deleted file mode 100644 index df3ffa6a3..000000000 --- a/drivers/py/pes/friction/test-ohne80/RESTART +++ /dev/null @@ -1,117 +0,0 @@ - - - [ step, potential{electronvolt} ] - - 9 - 30 - - - - - - - - - 2.53345216e-04 - [ 1.00000000e+00 ] - - - - - 1.00000000e-03 - 2.00000000e-04 - - 1.00000000e-01 - - [ 1.72723599e-03, 1.78383969e-03, 1.92188540e-03, 2.19375838e-03, 2.67508700e-03, - 3.42744998e-03, 4.37771723e-03, 5.14525767e-03, 5.36208621e-03, 4.99086344e-03, - 4.28675855e-03, 3.45354589e-03, 2.74792678e-03, 2.24637181e-03, 1.93846815e-03, - 1.79407991e-03 ] - - - [ -1.47659842e-03, -1.01710041e-19, 6.14390492e-20, -1.64007837e-03, -1.64201483e-19, - -8.12405107e-20, -1.95624952e-03, -2.46552617e-19, -8.15163089e-20, -2.38446595e-03, - -1.79715622e-19, 1.08511958e-19, -2.81025400e-03, -5.82622524e-20, -6.43310029e-20, - -2.97330106e-03, 1.47020953e-19, -7.19317832e-20, -2.50439628e-03, 3.77448738e-19, - -1.07375903e-19, -1.36423595e-03, 1.96370431e-19, -4.81220028e-20, 1.58525091e-04, - -3.42880551e-19, 8.34061212e-20, 1.53298828e-03, -4.23026760e-19, 9.21223603e-20, - 2.41157879e-03, 3.89313928e-19, -8.09693606e-20, 2.72736124e-03, 4.35468830e-19, - -8.00203360e-20, 2.73600998e-03, -8.50959899e-19, 1.44884979e-19, 2.62525620e-03, - 6.38415013e-19, -9.73003224e-20, 2.50468515e-03, -2.87741941e-19, 3.91395380e-20, - 2.43269161e-03, 7.03282316e-20, -8.43639446e-21 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00 ] - - - [ 1.37205221e-02, 0.00000000e+00, 0.00000000e+00, 1.30098510e-02, 0.00000000e+00, - 0.00000000e+00, 1.14766409e-02, 0.00000000e+00, 0.00000000e+00, 8.88476534e-03, - 0.00000000e+00, 0.00000000e+00, 4.85797340e-03, 0.00000000e+00, 0.00000000e+00, - -1.07975035e-03, 0.00000000e+00, 0.00000000e+00, -6.90526383e-03, 0.00000000e+00, - 0.00000000e+00, -1.01681686e-02, 0.00000000e+00, 0.00000000e+00, -1.06348704e-02, - 0.00000000e+00, 0.00000000e+00, -8.68319027e-03, 0.00000000e+00, 0.00000000e+00, - -4.71302762e-03, 0.00000000e+00, 0.00000000e+00, -1.26413120e-03, 0.00000000e+00, - 0.00000000e+00, 1.01183208e-03, 0.00000000e+00, 0.00000000e+00, 2.50136313e-03, - 0.00000000e+00, 0.00000000e+00, 3.38117402e-03, 0.00000000e+00, 0.00000000e+00, - 3.76313059e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, - 0.00000000e+00, 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, - 5.51152161e-01, 0.00000000e+00, -1.20370622e-32, 5.51152161e-01, 0.00000000e+00, - -4.81482486e-32, 5.51152161e-01, 0.00000000e+00, 1.20370622e-32, 5.51152161e-01, - 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, - 5.51152161e-01, 0.00000000e+00, -2.40741243e-32, 5.51152161e-01, 0.00000000e+00, - 0.00000000e+00, 5.51152161e-01, 0.00000000e+00, 4.81482486e-32, 5.51152161e-01, - 0.00000000e+00, 4.81482486e-32, 5.51152161e-01, 0.00000000e+00, -4.81482486e-32, - 5.51152161e-01, 0.00000000e+00, 0.00000000e+00, 5.51152161e-01 ] - - True - - - - - [ 1.95759707e+00, 1.84540764e-19, -1.11473842e-19, 1.96982806e+00, 2.97924049e-19, - 1.47401238e-19, 1.99564425e+00, 4.47340381e-19, 1.47901641e-19, 2.03766475e+00, - 3.26072607e-19, -1.96882033e-19, 2.09943703e+00, 1.05709923e-19, 1.16720948e-19, - 2.18448906e+00, -2.66752020e-19, 1.30511660e-19, 2.29417353e+00, -6.84835813e-19, - 1.94820796e-19, 2.42460987e+00, -3.56290776e-19, 8.73116468e-20, 2.56635830e+00, - 6.22115951e-19, -1.51330480e-19, 2.70680953e+00, 7.67531708e-19, -1.67145059e-19, - 2.83458135e+00, -7.06363788e-19, 1.46909268e-19, 2.94239697e+00, -7.90106363e-19, - 1.45187376e-19, 3.02764003e+00, 1.54396546e-18, -2.62876550e-19, 3.09023755e+00, - -1.15832806e-18, 1.76539855e-19, 3.13110554e+00, 5.22073507e-19, -7.10140334e-20, - 3.15124164e+00, -1.27602206e-19, 1.53068337e-20 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03 ] - [ H ] -
- - [ 7.44721588e+00, 4.56010455e-16, 4.56010455e-16, 0.00000000e+00, 7.44721588e+00, - 4.56010455e-16, 0.00000000e+00, 0.00000000e+00, 7.44721588e+00 ] - -
-
diff --git a/drivers/py/pes/friction/test-ohne80/control.in b/drivers/py/pes/friction/test-ohne80/control.in deleted file mode 100644 index 687e6ee90..000000000 --- a/drivers/py/pes/friction/test-ohne80/control.in +++ /dev/null @@ -1,181 +0,0 @@ -# Physical settings -xc pbe -spin none -relativistic atomic_zora scalar -charge 0.0 -#vdw_correction_hirshfeld - -# k-grid settings (to be adjusted) -k_grid 12 12 12 - -# accuracy requirements -sc_iter_limit 200 -sc_init_iter 200 - -#Mixing settings - mixer pulay - n_max_pulay 10 - charge_mix_param 0.05 - - -# occupation gaussian broadening -occupation_type gaussian 0.1 - -final_forces_cleaned .true. -compute_forces .true. - - -# IPI - output_level MD_light -# use_pimd_wrapper localhost 41000 - use_pimd_wrapper drag092 41111 - -#=============================================================================== - -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for Pd atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species Pd -# global species definitions - nucleus 46 - mass 106.42 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 62 5.0 - radial_multiplier 2 - angular_grids specified - division 0.5211 50 - division 0.9161 110 - division 1.2296 194 - division 1.5678 302 -# division 1.9785 434 -# division 2.0474 590 -# division 2.1195 770 -# division 2.1568 974 -# division 2.7392 1202 -# outer_grid 974 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 5 s 1. - valence 4 p 6. - valence 4 d 9. -# ion occupancy - ion_occ 5 s 0. - ion_occ 4 p 6. - ion_occ 4 d 8. -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Constructed for dimers: 2.0 A, 2.275 A, 2.75 A, 3.75 A -# -################################################################################ -# "First tier" - max. impr. -120.76 meV, min. impr. -5.71 meV - ionic 5 p auto - hydro 4 f 8 -# hydro 5 g 10 - hydro 3 s 2.6 - hydro 3 d 2.5 -# "Second tier" - max. impr. -5.00 meV, min. impr. -0.62 meV -# hydro 5 f 17.2 -# hydro 6 h 14 -# hydro 4 d 4 -# hydro 5 f 7.6 -# hydro 3 p 3.3 -# hydro 4 s 9.4 -# "Third tier" - max. impr. -0.54 meV, min. impr. -0.14 meV -# hydro 4 f 20 -# hydro 5 g 12.8 -# hydro 5 d 9.8 -# hydro 6 h 15.2 -# hydro 5 s 10 -# hydro 6 p 9.8 -# "Fourth tier" - max. impr. -0.15 meV, min. impr. -0.05 meV -# hydro 5 f 9.2 -# hydro 2 s 5.6 -# hydro 5 f 43.2 -# hydro 5 d 13.2 -# hydro 5 g 14 -# hydro 4 p 4.7 -################################################################################ -# -# FHI-aims code project -# VB, Fritz-Haber Institut, 2009 -# -# Suggested "light" defaults for H atom (to be pasted into control.in file) -# Be sure to double-check any results obtained with these settings for post-processing, -# e.g., with the "tight" defaults and larger basis sets. -# -################################################################################ - species H -# global species definitions - nucleus 1 - mass 1.00794 -# - l_hartree 4 -# - cut_pot 3.5 1.5 1.0 - basis_dep_cutoff 1e-4 -# - radial_base 24 5.0 - radial_multiplier 2 - angular_grids specified - division 0.2421 50 - division 0.3822 110 - division 0.4799 194 - division 0.5341 302 -# division 0.5626 434 -# division 0.5922 590 -# division 0.6542 770 -# division 0.6868 1202 -# outer_grid 770 - outer_grid 302 -################################################################################ -# -# Definition of "minimal" basis -# -################################################################################ -# valence basis states - valence 1 s 1. -# ion occupancy - ion_occ 1 s 0.5 -################################################################################ -# -# Suggested additional basis functions. For production calculations, -# uncomment them one after another (the most important basis functions are -# listed first). -# -# Basis constructed for dimers: 0.5 A, 0.7 A, 1.0 A, 1.5 A, 2.5 A -# -################################################################################ -# "First tier" - improvements: -1014.90 meV to -62.69 meV - hydro 2 s 2.1 - hydro 2 p 3.5 -# "Second tier" - improvements: -12.89 meV to -1.83 meV -# hydro 1 s 0.85 -# hydro 2 p 3.7 -# hydro 2 s 1.2 -# hydro 3 d 7 -# "Third tier" - improvements: -0.25 meV to -0.12 meV -# hydro 4 f 11.2 -# hydro 3 p 4.8 -# hydro 4 d 9 -# hydro 3 s 3.2 diff --git a/drivers/py/pes/friction/test-ohne80/geometry.in b/drivers/py/pes/friction/test-ohne80/geometry.in deleted file mode 100644 index cd6ad1f1f..000000000 --- a/drivers/py/pes/friction/test-ohne80/geometry.in +++ /dev/null @@ -1,11 +0,0 @@ -#=======================================# -# iterations/iteration0105/aims-chain-node-0.56500/geometry.in -#=======================================# -lattice_vector 3.9408969800000002 0.0000000000000000 0.0000000000000000 -lattice_vector 0.0000000000000000 3.9408994300000000 0.0000000000000000 -lattice_vector 0.0000000000000000 0.0000000000000000 3.9408994300000000 -atom 0.0247103780137420 0.0247118181215916 0.0247117808667154 Pd -atom -0.0423615210037601 2.0133997254004892 2.0133997242546435 Pd -atom 2.0133986622420208 -0.0423611346687766 2.0133998862206530 Pd -atom 2.0133989788407325 2.0133999460488869 -0.0423611180279472 Pd -atom 1.3585700937318070 1.3585696745192011 1.3585695196532610 H diff --git a/drivers/py/pes/friction/test-ohne80/get1D.sh b/drivers/py/pes/friction/test-ohne80/get1D.sh deleted file mode 100755 index 5cd175503..000000000 --- a/drivers/py/pes/friction/test-ohne80/get1D.sh +++ /dev/null @@ -1,6 +0,0 @@ -n=${1} -tail -n +2 inst.instanton_FINAL_${n}.ener |awk '{print $2}' > aux1 -grep H inst.instanton_FINAL_${n}.xyz |awk '{print $2}' >aux2 -paste aux2 aux1 >inst1D.dat -rm aux1 aux2 -xmgrace inst1D.dat ../REF/friction_data/MEP.dat diff --git a/drivers/py/pes/friction/test-ohne80/hessian.dat b/drivers/py/pes/friction/test-ohne80/hessian.dat deleted file mode 100644 index 536cf2c98..000000000 --- a/drivers/py/pes/friction/test-ohne80/hessian.dat +++ /dev/null @@ -1 +0,0 @@ -0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 6.057031816452968648e-03 6.058344276776983506e-03 6.058096466172481487e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.950615490911501798e-03 5.951964558164810071e-03 5.951759858394654878e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.736837991977567636e-03 5.738254398849999827e-03 5.738123666115466093e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 5.413775187290345570e-03 5.415277886910898480e-03 5.415227394594407384e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.978538988409993843e-03 4.980129157629385045e-03 4.980128086322279518e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 4.427432606333558257e-03 4.429085427329077645e-03 4.429055484546449289e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 3.760743272277714683e-03 3.762325924830129537e-03 3.762214099854201133e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.978849973373203647e-03 2.980099953745884295e-03 2.979882519707661992e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 2.080734091954548892e-03 2.081296763593865062e-03 2.080951478319967990e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 1.085196451651882638e-03 1.085418151828328875e-03 1.085116969755123978e-03 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 9.024235870722097097e-06 9.851954107555072060e-06 9.940701609090218938e-06 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -1.121195605943963586e-03 -1.119497578779774655e-03 -1.119041445103805682e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -2.266156410160331119e-03 -2.264675594446791118e-03 -2.264567064553385523e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -3.411187599114233471e-03 -3.410169909783423298e-03 -3.410667532095703475e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -4.543747755539860600e-03 -4.542105630118975501e-03 -4.542716569974538515e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -5.619371708372091628e-03 -5.617597104125553881e-03 -5.617977792073732685e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -6.605118515934718659e-03 -6.604307571261760351e-03 -6.604402805198382465e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -7.520861358152998791e-03 -7.518906691899055958e-03 -7.519953290353442038e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -8.460166932917640575e-03 -8.455599975421218897e-03 -8.457970527444994349e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -9.569325447339720875e-03 -9.562890475293614467e-03 -9.565055697628591438e-03 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.076851113630014449e-02 -1.076147156509727441e-02 -1.076160439452853931e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.202995218272046377e-02 -1.201962316299759817e-02 -1.202142522476758700e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.332340013572358081e-02 -1.330428026917506237e-02 -1.331622018720135005e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.443811172913904255e-02 -1.444167708987745789e-02 -1.442958988581580573e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.525762029519896028e-02 -1.528139534258572685e-02 -1.525348480147111462e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.575586368098686255e-02 -1.575855174356212765e-02 -1.576612582978003871e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.614142834462561904e-02 -1.612813661547275040e-02 -1.614507189215614452e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.634845701594062062e-02 -1.634833368163723932e-02 -1.634972863528180373e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.638014562894209505e-02 -1.640462533086432112e-02 -1.638657995542262130e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.635391822273863163e-02 -1.635824270434707919e-02 -1.634813420351845584e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.620212585916703391e-02 -1.619981390006814195e-02 -1.620797821061087038e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.587734915595382171e-02 -1.587839474091084363e-02 -1.589300889036891415e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.535488267166072729e-02 -1.535242028713652493e-02 -1.535442703992032781e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.464483961318796545e-02 -1.463667472632293638e-02 -1.464037557809543325e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.377721517703642609e-02 -1.378055466755994871e-02 -1.378040033751240165e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.283357333228352104e-02 -1.285211066311576014e-02 -1.284431467299699745e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.192695712425397882e-02 -1.193423819798923070e-02 -1.193148006340197242e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.105044169552203345e-02 -1.105732906830567130e-02 -1.105660688950908972e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -1.020412150412488943e-02 -1.020863105048188356e-02 -1.020754272564798441e-02 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -9.386055221108835153e-03 -9.376235642721006749e-03 -9.376115311076618428e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -8.581515992580170463e-03 -8.572195587593306812e-03 -8.576522119509242398e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -7.739792851959095832e-03 -7.735375828297553005e-03 -7.740181911635932166e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -6.842719622281428354e-03 -6.840859594173112970e-03 -6.840941839175371242e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -5.912012576437348718e-03 -5.912055248647732006e-03 -5.911061705712308476e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.993517470328967880e-03 -4.992428441985335627e-03 -4.992961431690657800e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -4.104629338865092500e-03 -4.100012077260786411e-03 -4.102889134705500415e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -3.212146422048580904e-03 -3.209703695359906322e-03 -3.212500028343433581e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -2.339849814692648161e-03 -2.339621916822368086e-03 -2.340282833599187026e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -1.516913543673234846e-03 -1.512207813311001667e-03 -1.509610007138133606e-03 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 -7.290563418310344601e-04 -7.245095043813005314e-04 -7.205959343175791232e-04 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 2.277870000001042117e-05 1.999293556837616892e-05 2.256240054553451668e-05 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 6.961797290071843752e-04 6.906351542920307479e-04 6.915212230687584061e-04 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.285685583819057287e-03 1.282979384270967541e-03 1.282479417329856000e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 1.786308351281072279e-03 1.784909818050009131e-03 1.784235887542255303e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.205285034988582749e-03 2.202554971648474150e-03 2.202860650679606611e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.549922757737752357e-03 2.545792351901169509e-03 2.546986674315139532e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 2.828414396105396328e-03 2.824150019552565394e-03 2.825508070282596595e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.050911783488222118e-03 3.047372761227863311e-03 3.048407286890698203e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.231045650436796535e-03 3.228512756771806033e-03 3.229248911626111940e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.375866341890710123e-03 3.374341415423708773e-03 3.374950397838768698e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.488269935435607885e-03 3.487661860652807241e-03 3.488248289190481674e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.570563379805095916e-03 3.570707157422511879e-03 3.571322706045435696e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.624470659973266437e-03 3.625146103271997822e-03 3.625802907206805356e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 3.651129761104120186e-03 3.652075172197498734e-03 3.652757319648220619e-03 diff --git a/drivers/py/pes/friction/test-ohne80/init.xyz b/drivers/py/pes/friction/test-ohne80/init.xyz deleted file mode 100644 index 223399063..000000000 --- a/drivers/py/pes/friction/test-ohne80/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 0.0 0.0 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 0.0 0.0 diff --git a/drivers/py/pes/friction/test-ohne80/input.xml b/drivers/py/pes/friction/test-ohne80/input.xml deleted file mode 100644 index afcec152d..000000000 --- a/drivers/py/pes/friction/test-ohne80/input.xml +++ /dev/null @@ -1,37 +0,0 @@ - - - [ step, potential{electronvolt}] - - 30 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - - - 80 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - true - 0.1 - - - -
diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 deleted file mode 100644 index f2f2eab70..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_0 +++ /dev/null @@ -1 +0,0 @@ -3.734818280233287088e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.845782312592117815e-03 0.000000000000000000e+00 4.597851281863155766e-35 7.664769565135540023e-04 -5.641672198402295020e-34 -5.099816676521848316e-35 -2.421625395738981248e-03 -4.924659551023193814e-33 -6.175121694072970245e-35 -5.934054372920137717e-03 -1.745698724309905664e-34 0.000000000000000000e+00 -8.687218023080303317e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.054397414683942019e-02 -1.845462876222226530e-33 6.748072532624786352e-38 -1.075144957901948313e-02 0.000000000000000000e+00 5.269410684734435833e-39 -9.558332897562037828e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.476186931212857809e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.524595410098533436e-03 -1.848189503563817759e-37 0.000000000000000000e+00 -2.170742788691551548e-03 1.254472657255384445e-37 6.272363286276922225e-38 -5.363218365243636442e-04 -9.877504856835469417e-38 0.000000000000000000e+00 5.550899951789409204e-04 -8.497088663121496587e-38 0.000000000000000000e+00 1.211414114240429900e-03 0.000000000000000000e+00 -3.096516590406364803e-35 1.489980234621267417e-03 0.000000000000000000e+00 9.183549615799117241e-39 0.000000000000000000e+00 5.511521610893899137e-01 -8.224399241397367023e-38 0.000000000000000000e+00 5.511521610893899137e-01 -5.897911703110076037e-35 -5.641672198402295020e-34 5.511521610893899137e-01 -1.595782179766953557e-36 -4.924659551023193814e-33 5.511521610893899137e-01 -2.736468729736113066e-35 -1.745698724309905664e-34 5.511521610893899137e-01 3.230513701848005415e-34 0.000000000000000000e+00 5.511521610893899137e-01 -3.746640196012831775e-37 -1.845462876222226530e-33 5.511521610893899137e-01 -8.251348517995317136e-39 0.000000000000000000e+00 5.511521610893899137e-01 -6.305912822656329130e-40 0.000000000000000000e+00 5.511521610893899137e-01 5.212108934203943390e-40 0.000000000000000000e+00 5.511521610893899137e-01 4.104049214484437078e-42 -1.848189503563817759e-37 5.511521610893899137e-01 -3.614198904941168172e-40 1.254472657255384445e-37 5.511521610893899137e-01 -2.142468746332492301e-40 -9.877504856835469417e-38 5.511521610893899137e-01 -2.117846475705540036e-40 -8.497088663121496587e-38 5.511521610893899137e-01 -8.278898936108957144e-41 0.000000000000000000e+00 5.511521610893899137e-01 1.728296928676643158e-41 0.000000000000000000e+00 5.511521610893899137e-01 2.824111339950594965e-42 0.000000000000000000e+00 -6.634335062466123784e-33 5.511521610893899137e-01 4.597851281863155766e-35 -6.693231935504809852e-33 5.511521610893899137e-01 -5.099816676521848316e-35 -6.635848600653475924e-33 5.511521610893899137e-01 -6.175121694072970245e-35 -6.661617505771071078e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.311201448288908775e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634627482493310683e-33 5.511521610893899137e-01 6.748072532624786352e-38 -6.634261069822228090e-33 5.511521610893899137e-01 5.269410684734435833e-39 -6.634253449064992168e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252297262816241e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252814369660801e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253179893600258e-33 5.511521610893899137e-01 6.272363286276922225e-38 -6.634253032720584159e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634253030258357700e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.634252901262699273e-33 5.511521610893899137e-01 -3.096516590406364803e-35 -6.634252801190740225e-33 5.511521610893899137e-01 9.183549615799117241e-39 -6.634252815649597786e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 deleted file mode 100644 index 25072c3fb..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_1 +++ /dev/null @@ -1 +0,0 @@ -9.892913615669208030e-03 0.000000000000000000e+00 0.000000000000000000e+00 8.967960163997572981e-03 1.614951759475882236e-32 8.246251695649536416e-33 6.858333381143919688e-03 2.136792064844772747e-34 -7.260501194090478013e-35 3.294098717232307478e-03 3.733952422943596913e-33 -1.700656174663918155e-32 -1.883111251835540081e-03 4.662873566019753647e-32 1.868795087220818113e-32 -6.909399291245864327e-03 0.000000000000000000e+00 -1.415159042963247631e-33 -9.947480542244835702e-03 2.181281584841297074e-33 -5.737206219768610313e-37 -1.083839149683370195e-02 3.428520116758796274e-32 2.142830342384932400e-33 -9.348424149405528891e-03 1.653711061776393223e-31 6.459808835064036028e-34 -6.265511515632433970e-03 5.174352847145581049e-35 8.084926323664970389e-37 -2.617943301605032795e-03 -1.489092802103321111e-32 -2.205382583246868412e-36 -1.034614635909382116e-04 2.245169974936651202e-32 -9.960300609146510793e-36 1.614442208560950198e-03 -5.724717697437056580e-35 2.371658679920791783e-33 2.741523544600115922e-03 2.303101426121082228e-35 0.000000000000000000e+00 3.387531636094563356e-03 -5.066406213847528809e-36 -3.096516590406364803e-35 3.660104868431911414e-03 5.877471754111438375e-37 -1.505183782029476225e-35 0.000000000000000000e+00 5.511521610893899137e-01 -4.455683826064147910e-35 1.614951759475882236e-32 5.511521610893899137e-01 -1.488126295331421371e-34 2.136792064844772747e-34 5.511521610893899137e-01 -1.282562250654161197e-36 3.733952422943596913e-33 5.511521610893899137e-01 -1.506062012919669114e-34 4.662873566019753647e-32 5.511521610893899137e-01 3.498214094918402662e-34 0.000000000000000000e+00 5.511521610893899137e-01 2.830290147970561428e-36 2.181281584841297074e-33 5.511521610893899137e-01 1.119598608131650601e-37 3.428520116758796274e-32 5.511521610893899137e-01 -1.260610132146908431e-36 1.653711061776393223e-31 5.511521610893899137e-01 2.670266514641765167e-36 5.174352847145581049e-35 5.511521610893899137e-01 -2.292532857939595301e-36 -1.489092802103321111e-32 5.511521610893899137e-01 -3.524462513891821374e-36 2.245169974936651202e-32 5.511521610893899137e-01 -1.746952636438934422e-35 -5.724717697437056580e-35 5.511521610893899137e-01 -8.500574790556673181e-36 2.303101426121082228e-35 5.511521610893899137e-01 -1.280196201750088239e-36 -5.066406213847528809e-36 5.511521610893899137e-01 -6.521311212262208397e-38 5.877471754111438375e-37 5.511521610893899137e-01 -9.243186767302303250e-40 0.000000000000000000e+00 -6.678809656734351228e-33 5.511521610893899137e-01 8.246251695649536416e-33 -6.783065448006851496e-33 5.511521610893899137e-01 -7.260501194090478013e-35 -6.635535380724362458e-33 5.511521610893899137e-01 -1.700656174663918155e-32 -6.784859019765677040e-33 5.511521610893899137e-01 1.868795087220818113e-32 -6.284431408981868494e-33 5.511521610893899137e-01 -1.415159042963247631e-33 -6.631422528325739353e-33 5.511521610893899137e-01 -5.737206219768610313e-37 -6.634140858612896258e-33 5.511521610893899137e-01 2.142830342384932400e-33 -6.635513428605857417e-33 5.511521610893899137e-01 6.459808835064036028e-34 -6.631582551959068371e-33 5.511521610893899137e-01 8.084926323664970389e-37 -6.636545351331649433e-33 5.511521610893899137e-01 -2.205382583246868412e-36 -6.637777280987601198e-33 5.511521610893899137e-01 -9.960300609146510793e-36 -6.651722344838098642e-33 5.511521610893899137e-01 2.371658679920791783e-33 -6.642753393264267358e-33 5.511521610893899137e-01 0.000000000000000000e+00 -6.635533014675460649e-33 5.511521610893899137e-01 -3.096516590406364803e-35 -6.634318031585831746e-33 5.511521610893899137e-01 -1.505183782029476225e-35 -6.634253742792385306e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 deleted file mode 100644 index 09a85d0b5..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_2 +++ /dev/null @@ -1 +0,0 @@ -1.297717861181817839e-02 0.000000000000000000e+00 -1.587057591239417484e-33 1.212179150376219844e-02 -4.044133410817390068e-31 8.246251695649536416e-33 1.023495068474918057e-02 1.374874082278548983e-34 -3.773722049673942213e-34 7.019420557719971074e-03 3.733952422943596913e-33 1.621044803035586025e-33 2.021911683957246242e-03 -5.045942251219761709e-32 -2.948271222101864843e-32 -4.439556615543967244e-03 0.000000000000000000e+00 3.073542592520248260e-33 -8.914059996526576754e-03 2.805409072116473415e-34 8.586475414792535202e-36 -1.091285399369415834e-02 -8.997482023453314094e-33 -5.071637379789344971e-33 -9.687061940582898309e-03 1.418825435015178791e-32 6.459808835064036028e-34 -6.517554089700547393e-03 5.174352847145581049e-35 -1.709872188738425000e-32 -2.397908563780358580e-03 5.537434216832573317e-33 -2.205382583246868412e-36 4.017945734196125968e-04 2.245169974936651202e-32 5.045201353242628595e-32 2.291926566506841557e-03 -9.716694092551321802e-35 2.371658679920791783e-33 3.500670581460030295e-03 5.489651641268065512e-35 3.186550215146982750e-35 4.141755059447818632e-03 1.080596682216596700e-36 -6.377154319807145998e-36 4.407491885433248782e-03 1.668367199494600138e-36 -1.505183782029476225e-35 0.000000000000000000e+00 5.511521610893899137e-01 -2.977087589350948246e-32 -4.044133410817390068e-31 5.511521610893899137e-01 -5.159600047764989871e-32 1.374874082278548983e-34 5.511521610893899137e-01 -4.107018409596793783e-34 3.733952422943596913e-33 5.511521610893899137e-01 6.112425622025477091e-34 -5.045942251219761709e-32 5.511521610893899137e-01 3.397576558955371873e-33 0.000000000000000000e+00 5.511521610893899137e-01 1.928754867416306195e-35 2.805409072116473415e-34 5.511521610893899137e-01 -6.942168761099936106e-37 -8.997482023453314094e-33 5.511521610893899137e-01 -5.527639458564507626e-37 1.418825435015178791e-32 5.511521610893899137e-01 5.772437820439283762e-37 5.174352847145581049e-35 5.511521610893899137e-01 4.769986070774829629e-36 5.537434216832573317e-33 5.511521610893899137e-01 -1.341596888461318830e-36 2.245169974936651202e-32 5.511521610893899137e-01 -1.105795406506512485e-34 -9.716694092551321802e-35 5.511521610893899137e-01 -1.656595602864174550e-34 5.489651641268065512e-35 5.511521610893899137e-01 -6.247933186764104648e-35 1.080596682216596700e-36 5.511521610893899137e-01 -8.168673189436548443e-36 1.668367199494600138e-36 5.511521610893899137e-01 -3.076868209282457878e-37 -1.587057591239417484e-33 -3.640512871198318930e-32 5.511521610893899137e-01 8.246251695649536416e-33 -5.823025329612360554e-32 5.511521610893899137e-01 -3.773722049673942213e-34 -7.044954659433387925e-33 5.511521610893899137e-01 1.621044803035586025e-33 -6.023010256271162377e-33 5.511521610893899137e-01 -2.948271222101864843e-32 -3.236676259518337016e-33 5.511521610893899137e-01 3.073542592520248260e-33 -6.614965269799547059e-33 5.511521610893899137e-01 8.586475414792535202e-36 -6.634947035349819908e-33 5.511521610893899137e-01 -5.071637379789344971e-33 -6.634805582419566918e-33 5.511521610893899137e-01 6.459808835064036028e-34 -6.633675574691665839e-33 5.511521610893899137e-01 -1.709872188738425000e-32 -6.629482832402935437e-33 5.511521610893899137e-01 -2.205382583246868412e-36 -6.635594415362170712e-33 5.511521610893899137e-01 5.045201353242628595e-32 -6.744832359124360864e-33 5.511521610893899137e-01 2.371658679920791783e-33 -6.799912378760128033e-33 5.511521610893899137e-01 3.186550215146982750e-35 -6.696732150341351817e-33 5.511521610893899137e-01 -6.377154319807145998e-36 -6.642421491663145735e-33 5.511521610893899137e-01 -1.505183782029476225e-35 -6.634560505294636607e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 deleted file mode 100644 index ac0c928b3..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_3 +++ /dev/null @@ -1 +0,0 @@ -1.326697938691712500e-02 -3.436519449523465765e-31 -1.587057591239417484e-33 1.249014660394636746e-02 -2.603507112345384461e-32 8.246251695649536416e-33 1.081221990719443207e-02 1.374874082278548983e-34 -3.773722049673942213e-34 7.969590343063824231e-03 -8.525426525301300832e-32 1.621044803035586025e-33 3.543078470445989309e-03 1.343866176434485623e-32 -2.948271222101864843e-32 -2.753180329516431105e-03 1.428692175075599036e-33 2.315757838267004947e-34 -7.983070269410200842e-03 2.685972510287069034e-34 3.247378778067339144e-35 -1.069905429420435136e-02 -1.713928353924731256e-33 -5.067434521353379181e-33 -1.020509664259706441e-02 -1.053401809279171042e-33 6.459808835064036028e-34 -7.667299694980426322e-03 5.174352847145581049e-35 2.403274999540800712e-32 -3.417865289183932842e-03 1.687104178334103572e-35 -1.079101738114614049e-35 -3.165902434181564569e-04 -1.846981759237531628e-33 -4.672192218626060397e-32 1.756568002332469739e-03 -9.083643985619460307e-35 2.371658679920791783e-33 3.105885213102797630e-03 4.923643007017172544e-33 -1.945063685778190305e-32 3.856753230101362534e-03 1.080596682216596700e-36 -6.377154319807145998e-36 4.174254122014324497e-03 3.361789095746924865e-34 -1.618625254645058275e-35 -3.436519449523465765e-31 5.511521610893899137e-01 -2.868431779549579768e-32 -2.603507112345384461e-32 5.511521610893899137e-01 -5.041893450685493515e-32 1.374874082278548983e-34 5.511521610893899137e-01 3.481182583062192475e-34 -8.525426525301300832e-32 5.511521610893899137e-01 1.728675260320496180e-33 1.343866176434485623e-32 5.511521610893899137e-01 3.770304158716389006e-33 1.428692175075599036e-33 5.511521610893899137e-01 1.857284814810217619e-35 2.685972510287069034e-34 5.511521610893899137e-01 6.594467567311686729e-36 -1.713928353924731256e-33 5.511521610893899137e-01 4.412910800665558469e-37 -1.053401809279171042e-33 5.511521610893899137e-01 -2.175537723334330594e-37 5.174352847145581049e-35 5.511521610893899137e-01 -6.808445727137127657e-36 1.687104178334103572e-35 5.511521610893899137e-01 -2.488040964095655123e-36 -1.846981759237531628e-33 5.511521610893899137e-01 -1.226032696205281228e-34 -9.083643985619460307e-35 5.511521610893899137e-01 -1.811470434051900345e-34 4.923643007017172544e-33 5.511521610893899137e-01 -6.704322957372316328e-35 1.080596682216596700e-36 5.511521610893899137e-01 -8.565583050657174589e-36 3.361789095746924865e-34 5.511521610893899137e-01 -3.309997228519980292e-37 -1.587057591239417484e-33 -3.531857061396950452e-32 5.511521610893899137e-01 8.246251695649536416e-33 -5.705318732532864198e-32 5.511521610893899137e-01 -3.773722049673942213e-34 -6.286134560167488700e-33 5.511521610893899137e-01 1.621044803035586025e-33 -4.905577558153213393e-33 5.511521610893899137e-01 -2.948271222101864843e-32 -2.863948659757319882e-33 5.511521610893899137e-01 2.315757838267004947e-34 -6.615679970325608463e-33 5.511521610893899137e-01 3.247378778067339144e-35 -6.627658350906397590e-33 5.511521610893899137e-01 -5.067434521353379181e-33 -6.633811527393643560e-33 5.511521610893899137e-01 6.459808835064036028e-34 -6.634470372246043809e-33 5.511521610893899137e-01 2.403274999540800712e-32 -6.641061264200847041e-33 5.511521610893899137e-01 -1.079101738114614049e-35 -6.636740859437805120e-33 5.511521610893899137e-01 -4.672192218626060397e-32 -6.756856088094237696e-33 5.511521610893899137e-01 2.371658679920791783e-33 -6.815399861878900035e-33 5.511521610893899137e-01 -1.945063685778190305e-32 -6.701296048047434094e-33 5.511521610893899137e-01 -6.377154319807145998e-36 -6.642818401524365864e-33 5.511521610893899137e-01 -1.618625254645058275e-35 -6.634583818196560018e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 deleted file mode 100644 index 090642728..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_4 +++ /dev/null @@ -1 +0,0 @@ -1.348105139917538976e-02 -7.668023353324523642e-32 -1.609114077642185327e-33 1.273577563624147223e-02 -2.600004614777261509e-32 -1.106985657178011861e-31 1.112760490112172512e-02 1.374874082278548983e-34 -3.773722049673942213e-34 8.408668957458507662e-03 -1.019357468449447682e-32 1.509264176723570327e-33 4.185844418960517517e-03 -4.367502943423001401e-32 -8.087280827715933084e-33 -1.944617064427021924e-03 1.428692175075599036e-33 2.315757838267004947e-34 -7.476395676433939506e-03 1.363370024116781492e-33 5.806172785937895930e-34 -1.046348102422013822e-02 4.248529999262566016e-35 8.466121371840540561e-35 -1.043918224155719783e-02 -7.285884269289415537e-35 -7.764585254068245071e-36 -8.223274073844119222e-03 -3.131656052681589212e-36 4.469322681809003052e-36 -4.068932357432573921e-03 2.065607638125683916e-36 -6.994165944030183254e-35 -7.958502629903999297e-04 1.167302409597223206e-35 1.037807328735401565e-35 1.376699260233349735e-03 -9.072132492384225864e-35 -3.896311846960215919e-35 2.796265930116329911e-03 -2.620185217536552828e-35 -3.278804338353152372e-35 3.615787880010486437e-03 -9.184370456139274847e-35 1.685939485426929459e-35 3.965528479983848956e-03 -5.760036400186170059e-36 8.146564404981491779e-35 -7.668023353324523642e-32 5.511521610893899137e-01 -2.889399000560562656e-32 -2.600004614777261509e-32 5.511521610893899137e-01 -5.011971054253917440e-32 1.374874082278548983e-34 5.511521610893899137e-01 1.587566408653974462e-33 -1.019357468449447682e-32 5.511521610893899137e-01 1.282009624467491290e-33 -4.367502943423001401e-32 5.511521610893899137e-01 3.759655391411658788e-33 1.428692175075599036e-33 5.511521610893899137e-01 1.414718507821078149e-35 1.363370024116781492e-33 5.511521610893899137e-01 6.543457904602231167e-36 4.248529999262566016e-35 5.511521610893899137e-01 4.405066880151662215e-37 -7.285884269289415537e-35 5.511521610893899137e-01 -2.176732055564081971e-37 -3.131656052681589212e-36 5.511521610893899137e-01 -6.808317154894128754e-36 2.065607638125683916e-36 5.511521610893899137e-01 -2.487960018241296235e-36 1.167302409597223206e-35 5.511521610893899137e-01 -1.226040309290718825e-34 -9.072132492384225864e-35 5.511521610893899137e-01 -1.811451563154299911e-34 -2.620185217536552828e-35 5.511521610893899137e-01 -6.704326603291460263e-35 -9.184370456139274847e-35 5.511521610893899137e-01 -8.565634144754383328e-36 -5.760036400186170059e-36 5.511521610893899137e-01 -3.311424048846644951e-37 -1.609114077642185327e-33 -3.552824282407933339e-32 5.511521610893899137e-01 -1.106985657178011861e-31 -5.675396336101288124e-32 5.511521610893899137e-01 -3.773722049673942213e-34 -5.046686409819733058e-33 5.511521610893899137e-01 1.509264176723570327e-33 -5.352243194006218625e-33 5.511521610893899137e-01 -8.087280827715933084e-33 -2.874597427062050443e-33 5.511521610893899137e-01 2.315757838267004947e-34 -6.620105633395500416e-33 5.511521610893899137e-01 5.806172785937895930e-34 -6.627709360569107342e-33 5.511521610893899137e-01 8.466121371840540561e-35 -6.633812311785695350e-33 5.511521610893899137e-01 -7.764585254068245071e-36 -6.634470491679266148e-33 5.511521610893899137e-01 4.469322681809003052e-36 -6.641061135628603809e-33 5.511521610893899137e-01 -6.994165944030183254e-35 -6.636740778491951227e-33 5.511521610893899137e-01 1.037807328735401565e-35 -6.756856849402781990e-33 5.511521610893899137e-01 -3.896311846960215919e-35 -6.815397974789140056e-33 5.511521610893899137e-01 -3.278804338353152372e-35 -6.701296084506625544e-33 5.511521610893899137e-01 1.685939485426929459e-35 -6.642818452618462574e-33 5.511521610893899137e-01 8.146564404981491779e-35 -6.634583960878592438e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 deleted file mode 100644 index 370c0d527..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_5 +++ /dev/null @@ -1 +0,0 @@ -1.360375687276000473e-02 -7.657979022920952359e-32 -1.609114077642185327e-33 1.287598181939019967e-02 9.961203632580170862e-32 1.487446434399835321e-32 1.130571931044606175e-02 -3.012150813830570144e-33 -2.018536311680979037e-31 8.651096302266212540e-03 -1.017898391336952743e-32 1.567627261223366707e-33 4.527806611753107044e-03 7.154088979381308404e-32 -6.571167637885988801e-32 -1.511366485664991394e-03 -9.735002489462927825e-34 1.120893236429363067e-32 -7.194792770197902185e-03 1.363370024116781492e-33 1.813767879151036843e-32 -1.031822635219253187e-02 4.023388603664965418e-35 1.516463189084567755e-32 -1.054303883615845608e-02 -7.285884269289415537e-35 7.007136270331468784e-33 -8.468719134442789787e-03 -7.047632079618085285e-33 4.469322681809003052e-36 -4.397682515011993101e-03 9.414002177613127567e-37 7.462248057000984626e-33 -1.034336174624523024e-03 -8.337491946789278611e-33 -1.171697129322223296e-35 1.190752488224667291e-03 9.260946725418910840e-33 -3.896311846960215919e-35 2.646391717116255808e-03 -2.620464666280672182e-33 4.146688848322069556e-32 3.497952884983801004e-03 -9.184370456139274847e-35 1.125322248437168041e-32 3.864119454702644955e-03 -5.802615748856883069e-36 8.146564404981491779e-35 -7.657979022920952359e-32 5.511521610893899137e-01 -2.870661510083477607e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.996742580915486787e-32 -3.012150813830570144e-33 5.511521610893899137e-01 1.602454791917423650e-33 -1.017898391336952743e-32 5.511521610893899137e-01 1.068118438990721255e-33 7.154088979381308404e-32 5.511521610893899137e-01 3.730573311342456885e-33 -9.735002489462927825e-34 5.511521610893899137e-01 1.408377631237783680e-35 1.363370024116781492e-33 5.511521610893899137e-01 1.334699197107296041e-35 4.023388603664965418e-35 5.511521610893899137e-01 3.913978032308525530e-36 -7.285884269289415537e-35 5.511521610893899137e-01 -3.893514546687561292e-37 -7.047632079618085285e-33 5.511521610893899137e-01 -1.466466518516152849e-35 9.414002177613127567e-37 5.511521610893899137e-01 -2.829366413850706120e-36 -8.337491946789278611e-33 5.511521610893899137e-01 -1.323969003624028343e-34 9.260946725418910840e-33 5.511521610893899137e-01 -1.900937608591865503e-34 -2.620464666280672182e-33 5.511521610893899137e-01 -6.883210420820293459e-35 -9.184370456139274847e-35 5.511521610893899137e-01 -8.640760521213921962e-36 -5.802615748856883069e-36 5.511521610893899137e-01 -3.384771269619072764e-37 -1.609114077642185327e-33 -3.534086791930848291e-32 5.511521610893899137e-01 1.487446434399835321e-32 -5.660167862762857471e-32 5.511521610893899137e-01 -2.018536311680979037e-31 -5.031798026556283870e-33 5.511521610893899137e-01 1.567627261223366707e-33 -5.566134379482988489e-33 5.511521610893899137e-01 -6.571167637885988801e-32 -2.903679507131252346e-33 5.511521610893899137e-01 1.120893236429363067e-32 -6.620169042161333375e-33 5.511521610893899137e-01 1.813767879151036843e-32 -6.620905826502636302e-33 5.511521610893899137e-01 1.516463189084567755e-32 -6.630338840441402481e-33 5.511521610893899137e-01 7.007136270331468784e-33 -6.634642169928378633e-33 5.511521610893899137e-01 4.469322681809003052e-36 -6.648917483658871743e-33 5.511521610893899137e-01 7.462248057000984626e-33 -6.637082184887560367e-33 5.511521610893899137e-01 -1.171697129322223296e-35 -6.766649718836112300e-33 5.511521610893899137e-01 -3.896311846960215919e-35 -6.824346579332895952e-33 5.511521610893899137e-01 4.146688848322069556e-32 -6.703084922681913929e-33 5.511521610893899137e-01 1.125322248437168041e-32 -6.642893578994921871e-33 5.511521610893899137e-01 8.146564404981491779e-35 -6.634591295600670189e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 deleted file mode 100644 index 4fe6289ca..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_6 +++ /dev/null @@ -1 +0,0 @@ -1.366465157692338568e-02 -7.657979022920952359e-32 -1.609114077642185327e-33 1.294589312243548014e-02 9.961203632580170862e-32 1.485861783160527517e-32 1.139517976401576912e-02 -1.485914064781893706e-34 -6.440148024901372194e-32 8.773710783513129913e-03 -1.016667612948965393e-32 1.579935045103240198e-33 4.701522253474878753e-03 -3.531460210140193439e-32 -1.229806849580585810e-32 -1.285427269787913808e-03 -9.735002489462927825e-34 -3.627872011334522073e-34 -7.044040333093151696e-03 1.368834827201453768e-33 -1.509925356946595944e-32 -1.023984552103838520e-02 4.023388603664965418e-35 -4.251438650362712214e-32 -1.059269568676834104e-02 3.316781942255381255e-33 -6.551426869461634226e-33 -8.585246694615597182e-03 6.704038665259261726e-33 4.469322681809003052e-36 -4.565780607357744145e-03 9.414002177613127567e-37 -2.220447320094047286e-32 -1.157007561320025010e-03 8.230988922638532594e-33 -3.346395192577719490e-35 1.094942590077343332e-03 9.262675794400551567e-33 -3.896311846960215919e-35 2.568628275175905817e-03 2.598082218247164722e-33 4.147552042265545903e-32 3.435543887882049237e-03 -8.019293383041284214e-34 1.125577933598412232e-32 3.810143648551499174e-03 -2.903608437706601180e-35 6.029146023327594799e-33 -7.657979022920952359e-32 5.511521610893899137e-01 -2.881259161470650433e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.986782753913350173e-32 -1.485914064781893706e-34 5.511521610893899137e-01 1.602192257140373909e-33 -1.016667612948965393e-32 5.511521610893899137e-01 1.095866609511388656e-33 -3.531460210140193439e-32 5.511521610893899137e-01 3.608111524840095247e-33 -9.735002489462927825e-34 5.511521610893899137e-01 1.377237119795542082e-35 1.368834827201453768e-33 5.511521610893899137e-01 2.811192404646573690e-35 4.023388603664965418e-35 5.511521610893899137e-01 1.093604204382866207e-35 3.316781942255381255e-33 5.511521610893899137e-01 -6.957235078644786856e-37 6.704038665259261726e-33 5.511521610893899137e-01 -2.893621720240826099e-35 9.414002177613127567e-37 5.511521610893899137e-01 -3.487242871257896993e-36 8.230988922638532594e-33 5.511521610893899137e-01 -1.524456900591711166e-34 9.262675794400551567e-33 5.511521610893899137e-01 -2.085498743775719342e-34 2.598082218247164722e-33 5.511521610893899137e-01 -7.254184999924371844e-35 -8.019293383041284214e-34 5.511521610893899137e-01 -8.869622913848486991e-36 -2.903608437706601180e-35 5.511521610893899137e-01 -3.386538384238352919e-37 -1.609114077642185327e-33 -3.544684443318021117e-32 5.511521610893899137e-01 1.485861783160527517e-32 -5.650208035760720857e-32 5.511521610893899137e-01 -6.440148024901372194e-32 -5.032060561333333269e-33 5.511521610893899137e-01 1.579935045103240198e-33 -5.538386208962321430e-33 5.511521610893899137e-01 -1.229806849580585810e-32 -3.026141293633613641e-33 5.511521610893899137e-01 -3.627872011334522073e-34 -6.620480447275756079e-33 5.511521610893899137e-01 -1.509925356946595944e-32 -6.606140894427243601e-33 5.511521610893899137e-01 -4.251438650362712214e-32 -6.623316776429881721e-33 5.511521610893899137e-01 -6.551426869461634226e-33 -6.634948541981574370e-33 5.511521610893899137e-01 4.469322681809003052e-36 -6.663189035676118989e-33 5.511521610893899137e-01 -2.220447320094047286e-32 -6.637740061344967514e-33 5.511521610893899137e-01 -3.346395192577719490e-35 -6.786698508532880732e-33 5.511521610893899137e-01 -3.896311846960215919e-35 -6.842802692851281849e-33 5.511521610893899137e-01 4.147552042265545903e-32 -6.706794668472955034e-33 5.511521610893899137e-01 1.125577933598412232e-32 -6.643122441387555831e-33 5.511521610893899137e-01 6.029146023327594799e-33 -6.634591472312131472e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 deleted file mode 100644 index 88d10bdb9..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_7 +++ /dev/null @@ -1 +0,0 @@ -1.369758266412592074e-02 4.825185487074058229e-32 -1.604290971039142556e-33 1.298357942468922506e-02 9.961203632580170862e-32 1.485483871072945402e-32 1.144315861247862005e-02 -4.475605252991051122e-32 2.481344199785092107e-32 8.839095082846614923e-03 1.549119830347482346e-32 1.868759936676362329e-32 4.793616472341798163e-03 -3.531460210140193439e-32 6.307924018424626325e-34 -1.164774845174188162e-03 3.996215470964709319e-33 -3.627872011334522073e-34 -6.962895567908617030e-03 1.162020186535016265e-34 -5.681401035523279279e-34 -1.019791857588655051e-02 1.306153937362450189e-35 3.119876382022624995e-34 -1.061770515280208160e-02 4.728193374929779168e-35 -1.242519830963587598e-35 -8.643387785283668592e-03 -2.720568866158413905e-35 4.496511554422271141e-36 -4.652389889329083296e-03 -1.105898490725019044e-34 -2.525686824038393369e-35 -1.219989260686054440e-03 -3.116791056096124471e-35 2.149307491690853733e-34 1.046068524069051434e-03 4.262624617086682794e-35 -3.898785726354743826e-35 2.529092011222609359e-03 -4.648788402235605810e-35 9.587842473898067174e-35 3.403660923273767527e-03 -4.204567699734799393e-35 1.108159579225518693e-34 3.782587691776719691e-03 5.922165653919295338e-35 2.757273743400747263e-35 4.825185487074058229e-32 5.511521610893899137e-01 -2.878266593887413063e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.976202111790506191e-32 -4.475605252991051122e-32 5.511521610893899137e-01 1.577893771636058623e-33 1.549119830347482346e-32 5.511521610893899137e-01 1.094784704348111891e-33 -3.531460210140193439e-32 5.511521610893899137e-01 3.606005983904457369e-33 3.996215470964709319e-33 5.511521610893899137e-01 1.363706487769884367e-35 1.162020186535016265e-34 5.511521610893899137e-01 2.810997366000843055e-35 1.306153937362450189e-35 5.511521610893899137e-01 1.093607731081430692e-35 4.728193374929779168e-35 5.511521610893899137e-01 -6.957448491854272665e-37 -2.720568866158413905e-35 5.511521610893899137e-01 -2.893645886900312774e-35 -1.105898490725019044e-34 5.511521610893899137e-01 -3.487268435354157757e-36 -3.116791056096124471e-35 5.511521610893899137e-01 -1.524459086742857623e-34 4.262624617086682794e-35 5.511521610893899137e-01 -2.085495411105424993e-34 -4.648788402235605810e-35 5.511521610893899137e-01 -7.254206021856046591e-35 -4.204567699734799393e-35 5.511521610893899137e-01 -8.869677000963140768e-36 5.922165653919295338e-35 5.511521610893899137e-01 -3.386385280977337131e-37 -1.604290971039142556e-33 -3.541691875734783746e-32 5.511521610893899137e-01 1.485483871072945402e-32 -5.639627393637876875e-32 5.511521610893899137e-01 2.481344199785092107e-32 -5.056359046837648555e-33 5.511521610893899137e-01 1.868759936676362329e-32 -5.539468114125598366e-33 5.511521610893899137e-01 6.307924018424626325e-34 -3.028246834569251861e-33 5.511521610893899137e-01 -3.627872011334522073e-34 -6.620615753596012515e-33 5.511521610893899137e-01 -5.681401035523279279e-34 -6.606142844813700373e-33 5.511521610893899137e-01 3.119876382022624995e-34 -6.623316741162895572e-33 5.511521610893899137e-01 -1.242519830963587598e-35 -6.634948563322895654e-33 5.511521610893899137e-01 4.496511554422271141e-36 -6.663189277342713796e-33 5.511521610893899137e-01 -2.525686824038393369e-35 -6.637740086909063404e-33 5.511521610893899137e-01 2.149307491690853733e-34 -6.786698727147995378e-33 5.511521610893899137e-01 -3.898785726354743826e-35 -6.842802359584251858e-33 5.511521610893899137e-01 9.587842473898067174e-35 -6.706794878692272038e-33 5.511521610893899137e-01 1.108159579225518693e-34 -6.643122495474670057e-33 5.511521610893899137e-01 2.757273743400747263e-35 -6.634591457001805825e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 b/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 deleted file mode 100644 index 01a1b9aac..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton.hess_8 +++ /dev/null @@ -1 +0,0 @@ -1.371462307946609040e-02 4.825399148373140098e-32 1.159008770720961249e-31 1.300309815256473628e-02 9.961203632580170862e-32 1.486155206499155570e-32 1.146804094136671774e-02 -4.476483847801318358e-32 -1.731078618042207662e-32 8.873044980785255165e-03 1.549119830347482346e-32 1.868759936676362329e-32 4.841472570197069558e-03 1.373343108816398238e-32 6.307924018424626325e-34 -1.101621874151874911e-03 -3.378613067619615589e-32 -3.592528376023801112e-34 -6.920118425194711313e-03 1.069572785787056687e-34 -5.658289185336289224e-34 -1.017582381339245286e-02 2.658694324792213893e-32 3.124247661419346537e-34 -1.063051470790147592e-02 4.728193374929779168e-35 -1.281334564643944056e-35 -8.673110154630736535e-03 -2.400031823969091892e-35 1.272500903083766671e-32 -4.697548986309914125e-03 -1.031208111894393683e-34 -2.525686824038393369e-35 -1.252871607725007923e-03 -3.116791056096124471e-35 2.160943939651569028e-34 1.020551431061371894e-03 3.080945368840777810e-35 -4.046495632385481682e-35 2.508419661346137589e-03 -4.648788402235605810e-35 9.587842473898067174e-35 3.386907159852666025e-03 -8.382068632558372584e-32 1.102728576979402544e-34 3.768091454515344954e-03 5.981605770802224096e-35 -5.450502734642837584e-33 4.825399148373140098e-32 5.511521610893899137e-01 -2.875759932920306299e-32 9.961203632580170862e-32 5.511521610893899137e-01 -4.983058881884260848e-32 -4.476483847801318358e-32 5.511521610893899137e-01 1.545800228738392917e-33 1.549119830347482346e-32 5.511521610893899137e-01 1.182984821847473832e-33 1.373343108816398238e-32 5.511521610893899137e-01 3.603044902570189134e-33 -3.378613067619615589e-32 5.511521610893899137e-01 1.759073494943684232e-35 1.069572785787056687e-34 5.511521610893899137e-01 3.713963678364259903e-35 2.658694324792213893e-32 5.511521610893899137e-01 1.177534796676072218e-35 4.728193374929779168e-35 5.511521610893899137e-01 -2.003657854201122279e-36 -2.400031823969091892e-35 5.511521610893899137e-01 -3.317441395374082417e-35 -1.031208111894393683e-34 5.511521610893899137e-01 -9.602379224875355249e-36 -3.116791056096124471e-35 5.511521610893899137e-01 -1.585921050007451623e-34 3.080945368840777810e-35 5.511521610893899137e-01 -2.298543943609470604e-34 -4.648788402235605810e-35 5.511521610893899137e-01 -8.332415973520049580e-35 -8.382068632558372584e-32 5.511521610893899137e-01 -1.076209880849181303e-35 5.981605770802224096e-35 5.511521610893899137e-01 -4.335414906141147984e-37 1.159008770720961249e-31 -3.539185214767676982e-32 5.511521610893899137e-01 1.486155206499155570e-32 -5.646484163731631532e-32 5.511521610893899137e-01 -1.731078618042207662e-32 -5.088452589735314261e-33 5.511521610893899137e-01 1.868759936676362329e-32 -5.451267996626236083e-33 5.511521610893899137e-01 6.307924018424626325e-34 -3.031207915903520096e-33 5.511521610893899137e-01 -3.592528376023801112e-34 -6.616662083524274019e-33 5.511521610893899137e-01 -5.658289185336289224e-34 -6.597113181690066076e-33 5.511521610893899137e-01 3.124247661419346537e-34 -6.622477470506948792e-33 5.511521610893899137e-01 -1.281334564643944056e-35 -6.636256476327910788e-33 5.511521610893899137e-01 1.272500903083766671e-32 -6.667427232427450830e-33 5.511521610893899137e-01 -2.525686824038393369e-35 -6.643855197698585217e-33 5.511521610893899137e-01 2.160943939651569028e-34 -6.792844923474455056e-33 5.511521610893899137e-01 -4.046495632385481682e-35 -6.864107212834655821e-33 5.511521610893899137e-01 9.587842473898067174e-35 -6.717576978208911972e-33 5.511521610893899137e-01 1.102728576979402544e-34 -6.645014917282198824e-33 5.511521610893899137e-01 -5.450502734642837584e-33 -6.634686359964322724e-33 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener deleted file mode 100644 index d3a8fe1a0..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_0.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.06609749183902248 -1 0.06917958687928251 -2 0.07651636325411229 -3 0.08895589010071343 -4 0.10654574807957333 -5 0.12626279217180666 -6 0.14119662586930817 -7 0.14613925312163503 -8 0.13976616621533475 -9 0.1265881070980252 -10 0.109287250786556 -11 0.09214845045953049 -12 0.07826181720228342 -13 0.06835240828788859 -14 0.06223621123522454 -15 0.05955516525759201 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz deleted file mode 100644 index 88ba37b02..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 2.0691538559413805 -4.2868688864203186e-19 -5.138942451019324e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 2.0833536824672327 -1.636309764493738e-17 -9.282345172384641e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.1155186852509167 4.946417445169928e-19 8.024088785907777e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.167033215236072 -4.077755212220506e-18 -1.7809342412626963e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.238804326863034 3.948381363608722e-17 -2.6247191849036978e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.3299088281683242 2.4265296708308084e-18 6.230582052024254e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.4365769433400213 3.8315878303015453e-19 9.30785729539914e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.552129813940306 2.7069444044935072e-20 -8.249062057539133e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6681134225744096 4.8519803421942683e-20 -3.416982927206734e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7766029399681456 7.553456352036286e-21 -1.7554601333758717e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.871758937004375 6.107170284695514e-20 2.0957043455293886e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9505359604533554 4.063355158901011e-20 2.577492161510732e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.012079453709823 3.741574729491395e-20 3.476434351595815e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.056668826777411 3.6694052049529836e-20 1.5957571228168472e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.0850014875038165 3.755109185292569e-21 -3.5434321439519996e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.09771729893857 -4.362068518178427e-21 5.2044260034031155e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener deleted file mode 100644 index 94b04377e..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_1.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.04898068445015675 -1 0.05119741959945367 -2 0.05680842959524242 -3 0.0678179688713372 -4 0.08638481797601462 -5 0.11189406234581419 -6 0.13570629787935032 -7 0.14612527912448361 -8 0.13932984992953926 -9 0.12168522800329801 -10 0.09821116521257958 -11 0.07670181968081968 -12 0.060500459691730915 -13 0.049660862830592574 -14 0.043200961486597814 -15 0.04027358936215093 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz deleted file mode 100644 index c564fa6fa..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9731065225143827 -3.985014930050983e-18 -1.9248061644795873e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9885338600363707 -2.737417786433003e-17 -2.1263558139668283e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0222202017852005 2.2892173629593923e-19 9.708408917705893e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.077141928812368 6.1864317459886246e-18 -8.348653355671235e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.156566039173988 3.610216131589014e-17 -1.3030826742946108e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.2615844314806313 -5.282518839530046e-18 1.7147126262879487e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.3887064319962747 1.7917091088420308e-18 -2.347923771840515e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.529658863708937 1.0507374674367432e-17 -7.064866459527254e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.6727715170618134 7.064710970042742e-18 -7.350259329970387e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.8067477289810148 -1.0861847316478021e-17 -1.6006515714906315e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.9233831334955056 -9.708332657947795e-18 -4.83257565699322e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 3.0190281229640163 2.035738589766852e-17 1.9769834836040175e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0932097789661555 -1.4148446507339516e-17 -1.7990501488726383e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.1468703893864154 5.537065329784149e-18 8.820181721652334e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.181337854649266 -1.3521108721628223e-18 -2.406126221680295e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1977172989385703 2.1308558230822185e-19 2.4851922836926145e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener deleted file mode 100644 index 5eda4ce9d..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_2.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.04825645474156761 -1 0.05011521281190444 -2 0.054624235348314294 -3 0.06342044555206088 -4 0.07871442411019267 -5 0.10170489616039473 -6 0.12774657424813082 -7 0.1442415299315078 -8 0.14343918260365737 -9 0.12879765847746547 -10 0.1063865812260448 -11 0.08358316189393798 -12 0.06568119212236621 -13 0.053433377899566765 -14 0.04604882916038747 -15 0.042596090568175496 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz deleted file mode 100644 index 731b4e383..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9676634524402903 1.2691883678552141e-17 -2.1257651817839068e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9812082224492942 -3.678369833467928e-18 1.5680322509625736e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0097992132398375 -1.7762527882450108e-18 3.7916192174971166e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0563660312204806 -1.3908043834327753e-17 3.5579999355101055e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.1248273632289782 -2.91764374380476e-18 7.117964611917471e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.218769138145316 7.226491048441428e-19 -3.1933393924204427e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.338045533615313 1.214689630085618e-18 -3.704624554881775e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4762644125316084 9.433038636320541e-19 -3.540166435251642e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.621815763577319 -5.970135692395523e-19 2.0210846034916955e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7617072721938243 -1.367898422424243e-18 5.8274193351755465e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.885652565274277 4.0275193425279097e-19 -1.880026924669266e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.98848006340828 1.3302424088005805e-18 -7.06114572836146e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.068941929703719 -1.5088660892039283e-18 9.009560284472286e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.127663816007621 8.256944461237921e-19 -5.430052798721378e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1658769973828838 -2.3020057008746675e-19 2.0485649726740926e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1846801153652597 5.933096706093729e-20 -4.288766435340115e-19 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener deleted file mode 100644 index a0ed90892..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_3.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.04768356085140438 -1 0.04939461365412743 -2 0.05355048513773009 -3 0.06167311746295977 -4 0.07586808144503333 -5 0.09755620906576387 -6 0.12357123059665635 -7 0.14236588438419132 -8 0.1450010725927133 -9 0.1325996741109535 -10 0.11178658068515497 -11 0.08895596564707188 -12 0.07038959870944665 -13 0.05744359155335994 -14 0.04957909050081842 -15 0.04589793710632664 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz deleted file mode 100644 index 22c5e8858..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.963180596264626 -5.758479667304717e-19 3.553162555337343e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9761180768527646 6.556621873230681e-19 -3.422714236851307e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 2.0034024579983583 3.9818096772923815e-18 -8.962056298561226e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.047742240346857 -2.0094899479834505e-18 -3.792593633909826e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.112749142893046 2.0318540336091786e-18 -1.0406858769630795e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.201860121775764 1.0462147427369784e-18 5.515923843836488e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.315862209285933 1.7813948607820626e-19 1.2158399685867374e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.449821584750394 2.734748231954091e-20 9.146855579724638e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.593385896152681 1.3171791433828178e-20 -1.120480541939179e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7336220613414843 -3.991640723165517e-21 3.455463331628317e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8594882683093066 -3.7309199558855136e-21 1.2957481904435053e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.964701822060645 -6.380874001868044e-21 1.8841479057808342e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0473961986581792 -2.0827849495408548e-20 -1.5382725592391947e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.107890686659913 -5.283858850810538e-21 9.159154621637666e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1472937293941343 5.192662682707128e-21 5.442277951767934e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1666852187356698 -1.421488700463162e-20 1.1209794419264826e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener deleted file mode 100644 index d183d19c5..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_4.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.047326260866351076 -1 0.04894986765132139 -2 0.052902171650412215 -3 0.060657866260543356 -4 0.07430107173527616 -5 0.09538501517105737 -6 0.12135412977459256 -7 0.14123367696811998 -8 0.1455399452109994 -9 0.13429049423312447 -10 0.1143049536886203 -11 0.09151109415922248 -12 0.07259935096992415 -13 0.05928338595076988 -14 0.051153140720327596 -15 0.0473445083172125 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz deleted file mode 100644 index 75040010c..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.960294890009016 -3.692070348819142e-18 9.35842813872747e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9728795584981598 -2.5557826932313724e-18 5.556901801076555e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.999431606720305 -6.166669894915221e-20 6.362915042525495e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.042614842600379 1.6111425915301633e-18 3.594095503667428e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.106003898381913 9.926070084731194e-19 -8.2937761054037185e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.1930627416011648 1.4715679825093765e-19 -4.160169976303156e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.304848656419043 3.1123617886362306e-20 -7.09058206976107e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4369717379796625 4.7915582680618834e-21 -1.5228022266993677e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5795756680368913 1.6047458795096228e-21 -2.7922155991346283e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.719908440306673 4.572677807267683e-21 8.533594544676464e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8467812918182096 -5.5038453206985205e-21 1.6344460637231293e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.953368530718814 2.074293314075208e-21 -5.289747818873409e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.037410131934603 -1.0960412960415687e-21 9.723477701699874e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.099018407154604 -4.329901017776546e-21 -5.5757871134169095e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1391983289374874 -5.3281537856874535e-21 6.763097117399336e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.158985112277123 -8.664145208306943e-21 3.907893837353662e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener deleted file mode 100644 index 0793d605c..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_5.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.04716196301854047 -1 0.04874305405774195 -2 0.05259525136155942 -3 0.06016778552483738 -4 0.07353106531182262 -5 0.0943013453205325 -6 0.12021725056134766 -7 0.14061774433201396 -8 0.1457503361134273 -9 0.13509418710270654 -10 0.11554222394137909 -11 0.09280787692836757 -12 0.07374463359257678 -13 0.06025497749370654 -14 0.05199519333324893 -15 0.04812384900505698 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz deleted file mode 100644 index 238b4d772..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9589426312876965 2.054505958206617e-18 4.499305129565119e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.971346067050039 -9.72764293060044e-19 -1.0577986177837286e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9975205929365543 -4.0926635108043654e-21 1.0607962544935101e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0401060418793335 2.529544907393278e-19 -4.945898734221825e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.1026610009577045 1.4688312529387233e-18 1.1662613420205774e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.1886781271122118 1.5269089438716387e-19 9.240727829194017e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.2993615957057223 7.27037118209472e-19 -1.1161594898810347e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.430585021880612 6.903858631522325e-19 -1.437955213242034e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5727115389384214 -1.897338228842745e-19 4.042594743482909e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7130730362936046 -6.937044861115863e-19 2.150274622305578e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8403903175826954 9.475846370913777e-20 -4.2142569923854494e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9476021562676125 5.084513468459578e-19 -2.7016561048868935e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0322599444499696 -3.9723618191244144e-19 3.2320081062666723e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0943777019345684 1.3071571643328668e-19 -1.903964347582647e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.134912903508376 -2.2000265324888932e-20 7.090513949940993e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1548802291493576 -4.038353022886922e-22 -1.4363296461449258e-19 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener deleted file mode 100644 index 5ad0cb46c..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_6.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.04707110851815223 -1 0.048629325243244335 -2 0.05242790114762217 -3 0.05990286681175513 -4 0.07311785306411694 -5 0.09372267510917924 -6 0.11960845253011342 -7 0.14028170303204948 -8 0.14584369758232013 -9 0.13549596412035578 -10 0.11616264040153498 -11 0.09346028517031822 -12 0.0743189125241669 -13 0.06074011940717821 -14 0.052413780127769254 -15 0.04851015984559665 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz deleted file mode 100644 index 8af17b809..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9581876347857052 3.790886544373569e-19 -1.421721123096947e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9704949418533713 -1.9346301894498622e-18 1.514466808342032e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9964697216550698 -1.0397749321528743e-20 5.467954591357833e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0387402473718303 -3.872630304905376e-19 1.6479010778832037e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.100858832806455 -4.889655452317044e-19 -3.1967749050189758e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.186337516299244 -1.7524365574094355e-20 4.804702212162522e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.29646289729918 -3.9278060605536936e-21 9.680413869961679e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4272460911354603 -2.010691165908609e-21 4.541538990254332e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5691604697372648 2.3619822982963e-21 -7.548331775167822e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7095719344028035 2.1645046808533926e-21 -7.095040966578605e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.837144430629525 -3.1240442793450615e-21 -1.7246111293594936e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.9446959876927328 -1.6191438933680932e-21 4.521473485650961e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.029683302133993 -2.255627179391739e-21 -5.884414731537842e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0920712941337753 -2.278361135323538e-21 4.168337366472404e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1327940177953644 1.108746928938257e-21 -3.409304243020153e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1528564683764557 -4.975813467134529e-22 -6.017002628866389e-22 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener deleted file mode 100644 index 6e40c34fa..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_7.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.04702493896116645 -1 0.048571397421526434 -2 0.05234234949380354 -3 0.059766893903191225 -4 0.07290492312524598 -5 0.09342319302388279 -6 0.1192909504569416 -7 0.1401037681900495 -8 0.1458878705963857 -9 0.1357017751645486 -10 0.1164828056934044 -11 0.09379976928707788 -12 0.07461930400013642 -13 0.060995018830304386 -14 0.05263440467212523 -15 0.04871410326084989 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz deleted file mode 100644 index b8cc2e678..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.9578019461229983 -1.0898886132137001e-20 2.044537092349526e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.970059224444842 -1.3946418441665392e-19 -2.8177140404755867e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9959300174823171 -2.819041421490817e-19 3.4689725326655616e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.0380365383551955 -3.4090007299074405e-19 3.4152846698069692e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.0999278390155665 -1.1883555855063766e-19 5.0342269847588187e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.185126233659367 -5.886615886446936e-20 8.246964195114006e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.294961477410879 -9.921100397683706e-21 6.39779889003223e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4255157756092616 -1.5165232943180077e-21 -5.547168728425464e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.567319658702937 -7.644645063033909e-22 1.7004440326256178e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7077557509686394 -2.1901332478402847e-23 -8.242538790171847e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8354579764093533 -2.821222072579752e-22 -4.678559860486276e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.943182188059441 -9.297411963106498e-23 -6.904706704061733e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0283369735992 -7.180581034985084e-23 -2.2464360683834053e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.090862269093421 3.916511461260653e-23 8.146473170651664e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1316802216474313 5.73133327426157e-22 5.198125911465029e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.15179096682048 7.285984434432587e-22 -8.727419392668278e-23 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener deleted file mode 100644 index 477b4789a..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_8.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.047000480881081705 -1 0.048540745805408125 -2 0.05229716062457533 -3 0.05969520026890455 -4 0.0727928178949055 -5 0.0932656555395706 -6 0.11912374210959654 -7 0.14000957921110332 -8 0.1459097837493836 -9 0.13580829857132964 -10 0.11664863044981832 -11 0.09397576134328887 -12 0.07477488908450806 -13 0.061126884492198046 -14 0.05274840016111142 -15 0.048819396349009836 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz deleted file mode 100644 index 7187d7843..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.957597069513815 1.8454076374258458e-19 -1.1147384246216175e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9698280629346974 2.9792404869356036e-19 1.4740123764355072e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9956442544887898 4.473403805096716e-19 1.479016406775356e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.037664750295609 3.260726072789764e-19 -1.9688203320099592e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.0994370329353953 1.0570992286908351e-19 1.167209482268265e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.184489057243468 -2.667520203750863e-19 1.3051165961264418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.294173528708773 -6.848358127452143e-19 1.9482079588247094e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4246098740175857 -3.56290775542309e-19 8.731164675236389e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5663582965951695 6.221159505979333e-19 -1.5133048028005144e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7068095330095456 7.675317081630339e-19 -1.671450587034784e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8345813531977164 -7.063637883494281e-19 1.4690926815560342e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.942396970346781 -7.901063633389286e-19 1.451873759134359e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0276400334362035 1.5439654592257134e-18 -2.628765503513539e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0902375519586887 -1.1583280586923087e-18 1.7653985468521653e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1311055360453413 5.22073506681833e-19 -7.101403336840961e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1512416404087644 -1.2760220601906393e-19 1.5306833674839856e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 deleted file mode 100644 index a27b38170..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL.hess_8 +++ /dev/null @@ -1 +0,0 @@ -1.372052205055116804e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.300985096933852947e-02 0.000000000000000000e+00 0.000000000000000000e+00 1.147664087203107211e-02 0.000000000000000000e+00 0.000000000000000000e+00 8.884765340518626514e-03 0.000000000000000000e+00 0.000000000000000000e+00 4.857973401520016693e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.079750346441631439e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.905263832824703324e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.016816863896711706e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.063487038369620788e-02 0.000000000000000000e+00 0.000000000000000000e+00 -8.683190272443522956e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.713027617988564677e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.264131200286481779e-03 0.000000000000000000e+00 0.000000000000000000e+00 1.011832077725278306e-03 0.000000000000000000e+00 0.000000000000000000e+00 2.501363126292512409e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.381174021117178130e-03 0.000000000000000000e+00 0.000000000000000000e+00 3.763130593976765290e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 1.203706215242022408e-32 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 -2.407412430484044816e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 0.000000000000000000e+00 4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 -4.814824860968089633e-32 5.511521610893899137e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.511521610893899137e-01 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener deleted file mode 100644 index 477b4789a..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.ener +++ /dev/null @@ -1,17 +0,0 @@ -#Bead Energy (eV) -0 0.047000480881081705 -1 0.048540745805408125 -2 0.05229716062457533 -3 0.05969520026890455 -4 0.0727928178949055 -5 0.0932656555395706 -6 0.11912374210959654 -7 0.14000957921110332 -8 0.1459097837493836 -9 0.13580829857132964 -10 0.11664863044981832 -11 0.09397576134328887 -12 0.07477488908450806 -13 0.061126884492198046 -14 0.05274840016111142 -15 0.048819396349009836 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz deleted file mode 100644 index 7187d7843..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H 1.957597069513815 1.8454076374258458e-19 -1.1147384246216175e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H 1.9698280629346974 2.9792404869356036e-19 1.4740123764355072e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H 1.9956442544887898 4.473403805096716e-19 1.479016406775356e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H 2.037664750295609 3.260726072789764e-19 -1.9688203320099592e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H 2.0994370329353953 1.0570992286908351e-19 1.167209482268265e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 2.184489057243468 -2.667520203750863e-19 1.3051165961264418e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 2.294173528708773 -6.848358127452143e-19 1.9482079588247094e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 2.4246098740175857 -3.56290775542309e-19 8.731164675236389e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 2.5663582965951695 6.221159505979333e-19 -1.5133048028005144e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 2.7068095330095456 7.675317081630339e-19 -1.671450587034784e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 2.8345813531977164 -7.063637883494281e-19 1.4690926815560342e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 2.942396970346781 -7.901063633389286e-19 1.451873759134359e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 3.0276400334362035 1.5439654592257134e-18 -2.628765503513539e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 3.0902375519586887 -1.1583280586923087e-18 1.7653985468521653e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 3.1311055360453413 5.22073506681833e-19 -7.101403336840961e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 3.1512416404087644 -1.2760220601906393e-19 1.5306833674839856e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz deleted file mode 100644 index 2744e7b43..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_FINAL_forces_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001476598416876829 -1.0171004074581202e-19 6.143904917795865e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001640078365219887 -1.6420148327795642e-19 -8.124051067449371e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0019562495162948708 -2.465526174604555e-19 -8.151630888809017e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0023844659486092624 -1.7971562217385978e-19 1.085119580784019e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0028102540002227804 -5.82622524378881e-20 -6.433100285961822e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029733010561764648 1.4702095250468979e-19 -7.193178324287169e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002504396281231223 3.774487381859336e-19 -1.0737590267577877e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0013642359479591707 1.9637043091635838e-19 -4.812200279583877e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00015852509147107251 -3.4288055062023107e-19 8.340612124504565e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0015329882820110424 -4.230267596586871e-19 9.212236031983506e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002411578791966826 3.8931392846407573e-19 -8.096936062802152e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027273612402308233 4.354688296447292e-19 -8.002033599758783e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027360099752299473 -8.509598994996242e-19 1.4488497882587251e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026252562040650204 6.384150127987437e-19 -9.730032242816395e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002504685150634024 -2.8774194145520833e-19 3.9139537958673e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002432691609055136 7.032823160718064e-20 -8.436394459323836e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz deleted file mode 100644 index a673dd854..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_0.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.002632603767693688 2.362717051057425e-19 2.8323392375933067e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.00272346708611596 9.018556629123943e-18 5.1159846017374606e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0028796323283429436 -2.726228664555665e-19 -4.42249387512621e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002981460159024136 2.247463597608855e-18 9.81565755830028e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002821039559668824 -2.1761589213580196e-17 1.446619651012455e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002235730249099677 -1.337387072025926e-18 -3.4339987628179334e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.001241374556023047 -2.1117879130745037e-19 -5.13004566347088e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 6.319864928009974e-06 -1.491938258485428e-20 4.546488379973182e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0011826369593138807 -2.6741794511636085e-20 1.883277524735541e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.002077627536058465 -4.163103792119179e-21 9.675256462163803e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0025629234018341627 -3.3659801005508374e-20 -1.155051979042948e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027367058833866497 -2.2395269771020137e-20 -1.4205903750076026e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002748702226711721 -2.062176998036632e-20 -1.9160443057674253e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026962574858969933 -2.0224006086224927e-20 -8.795049868142923e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0026380430962335945 -2.069636542600618e-21 1.952970283812755e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0026059177089612275 2.4041634906140326e-21 -2.8684306390054437e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz deleted file mode 100644 index 9a667ca2e..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_1.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0016824157950850215 2.1963495906710832e-18 1.0608610772311043e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001873126695798665 1.508733728797084e-17 1.1719456021128061e-17 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002239760224779918 -1.2617070967984234e-19 -5.350810555733108e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0026853493877254503 -3.4096652262336386e-18 4.601378339164389e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002975903404547755 -1.9897784229250622e-17 7.181968320156164e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002707810787148424 2.9114716744024008e-18 -9.450675696258665e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0017175655361622774 -9.875043473818302e-19 1.2940632609230514e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.00023722909098543375 -5.7911622591535344e-18 3.8938164169763927e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0012261828023101397 -3.8937307186109784e-18 4.05111131428063e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.002266500058754907 5.986530621899852e-18 8.822025727781897e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0026980726212388604 5.350768525002628e-18 2.6634845169797917e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002743792182764511 -1.1220017231630674e-17 -1.0896187194263847e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002617722005223619 7.797946868577806e-18 9.915503774593433e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0024489677782446873 -3.051765522603669e-18 -4.861262217089819e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002311700604821963 7.452188292249994e-19 1.326141666932943e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0022399072221180364 -1.1744257918616755e-19 -1.3697190978798605e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz deleted file mode 100644 index 0a6bd4d58..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_2.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0016117801025368815 -6.995159117729168e-18 1.17162007390878e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0017843268443360006 2.027341483001868e-18 -8.64224363775883e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0021126320195622938 9.789855628822922e-19 -2.0897591257515973e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0025395146250638714 7.665448415815707e-18 -1.9609993536123045e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002911730604821207 1.6080656546869316e-18 -3.923081578416115e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.002897891705921677 -3.982896158441624e-19 1.7600159072244064e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0021691598238081054 -6.694788146745599e-19 2.0418118294479095e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0008199149407570549 -5.199039630047778e-19 1.951170381405064e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0007325712620767708 3.2904531888606936e-19 -1.1139251469589407e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0019729464454195725 7.539201716698888e-19 -3.2117947601560988e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002607598168584877 -2.2197759894635766e-19 1.0361809024377055e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002756066227322505 -7.331659783831956e-19 3.891765727953534e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.00267334213366018 8.316148058592413e-19 -4.965638621252039e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.002516203664642486 -4.550832783806349e-19 2.9927853348447778e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002375735688628403 1.2687554168771687e-19 -1.1290710118213531e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0022973685029263067 -3.2700390715158996e-20 2.3637628892453435e-19 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz deleted file mode 100644 index ec2e8b547..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_3.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.00155230614205983 3.173798513224306e-19 -1.9583332210760757e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0017207501795999155 -3.6136963148770534e-19 1.8864363484320202e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.002043468895198924 -2.1945830086863424e-18 4.939456696756798e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00247078654459684 1.1075347275184844e-18 2.090296177463263e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0028689365223876625 -1.1198607416418926e-18 5.735762701034082e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029444452771817996 -5.766235164230658e-19 -3.040113346934975e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002346250860738663 -9.818196272735668e-20 -6.701128262254362e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0011028281908805621 -1.5072623980768854e-20 -5.041309219937779e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0004424417174721176 -7.259661314173113e-21 6.175552721483892e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0017576087168179643 2.2000014108650898e-21 -1.9044860827920903e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0025181721261724036 2.056304596537832e-21 -7.141544153906043e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027485382681062018 3.516832495768676e-21 -1.038452190083155e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027111886754016368 1.1479314260238982e-20 8.478222453691886e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0025776167347003006 2.9122102245155283e-21 -5.048087863467473e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002447406767469851 -2.8619472593822625e-21 -2.9995232543660357e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0023724837743575944 7.834565692244203e-21 -6.1783024195455915e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz deleted file mode 100644 index 65553ed96..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_4.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0015134037877050283 2.034892551645728e-18 -5.157917893059402e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0016795051364418179 1.4086251546493321e-18 -3.062698436624866e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001999282831055633 3.398773439307406e-20 -3.506934376516114e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.002427671954333487 -8.879847211450097e-19 -1.9808935040079624e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002840701978296214 -5.470774978324343e-19 4.571132624084803e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029615528127915776 -8.110578737499964e-20 2.2928866729386803e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0024285925397748587 -1.7153849258988975e-20 3.9079896311304934e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0012372823187302472 -2.6408776944280414e-21 8.392957381570916e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00029827422937391256 -8.844591594910222e-22 1.538935661690556e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.001644837852503877 -2.5202412554410763e-21 -4.703309075159062e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0024664682983626444 3.0334562428047158e-21 -9.008284802050493e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027395186652112587 -1.1432512427858236e-21 2.915455941989966e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027249364860726247 6.040855289565263e-22 -5.35911574859638e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026024259876034662 2.3864343032506924e-21 3.073107117334101e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002476678018324827 2.936623473598254e-21 -3.7274955919120674e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002403018765817869 4.775262355550654e-21 -2.1538441337653794e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz deleted file mode 100644 index 8a846889e..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_5.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014950079888311277 -1.1323453988366049e-18 -2.479801745560393e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001659759928435622 5.361411423506359e-19 5.830079941888716e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.001977677445618153 2.2556803385915162e-21 -5.846601481396285e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0024059680776925244 -1.3941641422824659e-19 2.725942775895637e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.002825565985236469 -8.095495193328136e-19 -6.427874590496533e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029681795721827426 -8.415591642015716e-20 -5.093047113099149e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0024680708045246944 -4.0070807889335273e-19 6.1517371496836335e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0013031819010874387 -3.805076604619167e-19 7.925321233281016e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00022590544971233848 1.0457220651441943e-19 -2.228084829279213e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0015869507357467554 3.8233672667780545e-19 -1.185128505019391e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002438362822713231 -5.2226332054801806e-20 2.3226968487393133e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027335542955199505 -2.802340586229606e-19 1.4890236007287548e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027310690846347758 2.1893758012394014e-19 -1.781328252427303e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026147071114593465 -7.204424960055383e-20 1.0493740648073261e-18 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.00249166823456797 1.2125493778352504e-20 -3.9079520867444443e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002418880524571148 2.225746995805998e-22 7.916361885095345e-20 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz deleted file mode 100644 index bbf44a355..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_6.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0014846912246896204 -2.089355311376182e-19 7.835846694613169e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0016487413526057515 1.0662756098240674e-18 -8.34701654315862e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0019657025784567956 5.730742009026305e-21 -3.013674989765522e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0023939849916939804 2.1344085616488608e-19 -9.082442403368628e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0028170930515688665 2.6949441695270574e-19 1.7619093974175377e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029711882571496913 9.658591957882611e-21 -2.6481220076243463e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.0024884893530138508 2.1648187986141714e-21 -5.335381024669084e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0013373720361232412 1.1081967813738748e-21 -2.503079029150401e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.0001882900543018318 -1.3018116481608897e-21 4.160279370503456e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0015568929123112414 -1.1929714325404475e-21 3.9104471617475525e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.00242354281500877 1.7218237558999765e-21 9.505231509852985e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.002730191836504344 8.923946559445133e-22 -2.492019882924904e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002733890360045934 1.243193794533722e-21 3.243207896033324e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026206314157505503 1.2557236634756439e-21 -2.2973881476809218e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002498947759428428 -6.110882659855446e-22 1.879045401351784e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002426591343826207 2.7424303455888857e-22 3.3162840021802503e-22 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz deleted file mode 100644 index 68efcfeea..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_7.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001479408222349577 6.006944645194491e-21 -1.126851036875859e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.0016430841810253921 7.686598663580803e-20 1.5529891827400363e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0019595266580041707 1.5537207716551695e-19 -1.9119317081383585e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00238776484078529 1.8788781194437935e-19 -1.8823415264995745e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0028126302243972156 6.549647490944867e-20 -2.7746250820643463e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029725991286990165 3.2444210673183645e-20 -4.545332138563906e-21 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002498943582899671 5.46803592456818e-21 -3.5261606844565635e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0013550176529700067 8.358350910057709e-22 3.0573340325991775e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00016874486549731484 4.2133626472524747e-22 -9.372034033931663e-23 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.001541194934600551 1.2070966726208973e-23 4.542893067066339e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.0024156967724460266 1.5549226422154178e-22 2.5785983778930856e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027283450172088976 5.124288696004493e-23 3.805544021632023e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.002735298711949237 3.9575927553095173e-23 1.2381280938386664e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026236891513214786 -2.1585937558051732e-23 -4.4899462932614e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.0025027387438536415 -3.1588367200327935e-22 -2.8649583297187054e-22 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.0024306216968974096 -4.0156860667011765e-22 4.810136059002572e-23 diff --git a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz b/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz deleted file mode 100644 index 2744e7b43..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst.instanton_forces_8.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.001476598416876829 -1.0171004074581202e-19 6.143904917795865e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.001640078365219887 -1.6420148327795642e-19 -8.124051067449371e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.0019562495162948708 -2.465526174604555e-19 -8.151630888809017e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.0023844659486092624 -1.7971562217385978e-19 1.085119580784019e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0028102540002227804 -5.82622524378881e-20 -6.433100285961822e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H -0.0029733010561764648 1.4702095250468979e-19 -7.193178324287169e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H -0.002504396281231223 3.774487381859336e-19 -1.0737590267577877e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H -0.0013642359479591707 1.9637043091635838e-19 -4.812200279583877e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.00015852509147107251 -3.4288055062023107e-19 8.340612124504565e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0015329882820110424 -4.230267596586871e-19 9.212236031983506e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 -H 0.002411578791966826 3.8931392846407573e-19 -8.096936062802152e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 -H 0.0027273612402308233 4.354688296447292e-19 -8.002033599758783e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 -H 0.0027360099752299473 -8.509598994996242e-19 1.4488497882587251e-19 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 -H 0.0026252562040650204 6.384150127987437e-19 -9.730032242816395e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 -H 0.002504685150634024 -2.8774194145520833e-19 3.9139537958673e-20 -1 -CELL(abcABC): 7.447216 7.447216 7.447216 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 -H 0.002432691609055136 7.032823160718064e-20 -8.436394459323836e-21 diff --git a/drivers/py/pes/friction/test-ohne80/inst1D.dat b/drivers/py/pes/friction/test-ohne80/inst1D.dat deleted file mode 100644 index a1f44d19f..000000000 --- a/drivers/py/pes/friction/test-ohne80/inst1D.dat +++ /dev/null @@ -1,16 +0,0 @@ -1.957597069513815 0.047000480881081705 -1.9698280629346974 0.048540745805408125 -1.9956442544887898 0.05229716062457533 -2.037664750295609 0.05969520026890455 -2.0994370329353953 0.0727928178949055 -2.184489057243468 0.0932656555395706 -2.294173528708773 0.11912374210959654 -2.4246098740175857 0.14000957921110332 -2.5663582965951695 0.1459097837493836 -2.7068095330095456 0.13580829857132964 -2.8345813531977164 0.11664863044981832 -2.942396970346781 0.09397576134328887 -3.0276400334362035 0.07477488908450806 -3.0902375519586887 0.061126884492198046 -3.1311055360453413 0.05274840016111142 -3.1512416404087644 0.048819396349009836 diff --git a/drivers/py/pes/friction/test2/clean.sh b/drivers/py/pes/friction/test2/clean.sh deleted file mode 100755 index 21687e485..000000000 --- a/drivers/py/pes/friction/test2/clean.sh +++ /dev/null @@ -1,4 +0,0 @@ -rm inst* -rm \#inst* -rm *tmp -rm *RES* diff --git a/drivers/py/pes/friction/test2/init.xyz b/drivers/py/pes/friction/test2/init.xyz deleted file mode 100644 index e308c01de..000000000 --- a/drivers/py/pes/friction/test2/init.xyz +++ /dev/null @@ -1,48 +0,0 @@ -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1441466 1.1441364 1.1471352 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1503273 1.1503173 1.1503182 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1649317 1.1649216 1.1649205 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.1880459 1.1880352 1.1880343 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2194632 1.2194523 1.2194517 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.2583844 1.2583735 1.2583731 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3031849 1.3031754 1.3031744 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3513008 1.3512929 1.3512915 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.3996751 1.3996689 1.3996679 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4454179 1.4454138 1.4454129 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.4863054 1.4863029 1.4863018 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5208596 1.5208578 1.5208567 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5482857 1.5482846 1.5482833 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5683137 1.5683131 1.5683116 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5809606 1.5809607 1.5809623 -1 -CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} -H 1.5863237 1.5863240 1.5850224 diff --git a/drivers/py/pes/friction/test2/input.xml b/drivers/py/pes/friction/test2/input.xml deleted file mode 100644 index 33b8aff93..000000000 --- a/drivers/py/pes/friction/test2/input.xml +++ /dev/null @@ -1,45 +0,0 @@ - - - [ step, potential{electronvolt}] - extras - extras - - 100 - -
localhost
-
- - - init.xyz - [3.9408969800000002,3.9408969800000002,3.9408969800000002] - - - - ['friction'] - - - - 118 - - - - - 1e-3 - 2e-4 - 1e-3 - - nichols - 0.1 - 1 - powell - true - - z_friction.dat - true - true - crystal - 0.1 - - - -
diff --git a/drivers/py/pes/friction/test2/z_friction.dat b/drivers/py/pes/friction/test2/z_friction.dat deleted file mode 100644 index 88b85ef6d..000000000 --- a/drivers/py/pes/friction/test2/z_friction.dat +++ /dev/null @@ -1,1003 +0,0 @@ -#eta 1 -# bath_type Ohmic -# w_c 500 - # freq (cm^-1) Laplace transform -1 0.9915470158218098 -2 0.9848551497951816 -3 0.9788255643617454 -4 0.9732247078293326 -5 0.9679416696883935 -6 0.962911133018018 -7 0.9580899447435153 -8 0.9534474391977994 -9 0.9489606918318892 -10 0.9446119121776004 -11 0.9403868910489187 -12 0.9362740173481964 -13 0.9322636249598021 -14 0.928347541807527 -15 0.9245187684107862 -16 0.9207712425362906 -17 0.9170996629124359 -18 0.9134993545627568 -19 0.9099661641551429 -20 0.9064963774421086 -21 0.9030866532531712 -22 0.8997339700879358 -23 0.8964355824392188 -24 0.8931889847263488 -25 0.8899918812500051 -26 0.8868421609620551 -27 0.8837378761228457 -28 0.8806772241248969 -29 0.8776585319167312 -30 0.874680242577914 -31 0.8717409036863014 -32 0.8688391571880675 -33 0.8659737305354348 -34 0.8631434288998111 -35 0.8603471283020212 -36 0.857583769528487 -37 0.8548523527240882 -38 0.8521519325701771 -39 0.8494816139706848 -40 0.8468405481811211 -41 0.8442279293250585 -42 0.8416429912508109 -43 0.8390850046877706 -44 0.8365532746675381 -45 0.8340471381797273 -46 0.831565962036351 -47 0.8291091409221039 -48 0.8266760956107441 -49 0.824266271330268 -50 0.8218791362616757 -51 0.8195141801579645 -52 0.8171709130715548 -53 0.8148488641797111 -54 0.8125475806987108 -55 0.8102666268785352 -56 0.8080055830707606 -57 0.8057640448631033 -58 0.8035416222747761 -59 0.8013379390074006 -60 0.7991526317467734 -61 0.796985349511237 -62 0.7948357530428389 -63 0.7927035142377412 -64 0.7905883156132424 -65 0.7884898498073732 -66 0.7864078191101018 -67 0.7843419350226136 -68 0.7822919178430147 -69 0.7802574962764451 -70 0.7782384070678282 -71 0.7762343946556395 -72 0.7742452108452136 -73 0.7722706145002324 -74 0.770310371251143 -75 0.76836425321937 -76 0.7664320387562564 -77 0.7645135121957763 -78 0.7626084636201109 -79 0.7607166886372758 -80 0.7588379881700227 -81 0.7569721682553251 -82 0.7551190398537776 -83 0.7532784186683185 -84 0.7514501249717047 -85 0.7496339834422199 -86 0.7478298230071312 -87 0.7460374766934447 -88 0.744256781485537 -89 0.742487578189273 -90 0.740729711302249 -91 0.738983028889811 -92 0.7372473824665428 -93 0.7355226268829143 -94 0.7338086202168218 -95 0.7321052236697538 -96 0.7304123014673415 -97 0.7287297207640642 -98 0.7270573515518944 -99 0.7253950665726847 -100 0.7237427412341026 -101 0.7221002535289383 -102 0.7204674839576208 -103 0.7188443154537764 -104 0.7172306333126927 -105 0.7156263251225384 -106 0.7140312806982176 -107 0.712445392017719 -108 0.7108685531608633 -109 0.7093006602503189 -110 0.7077416113947941 -111 0.7061913066343006 -112 0.7046496478873963 -113 0.7031165389003207 -114 0.701591885197936 -115 0.7000755940363974 -116 0.6985675743574739 -117 0.6970677367444532 -118 0.6955759933795586 -119 0.694092258002813 -120 0.6926164458722978 -121 0.6911484737257331 -122 0.6896882597433415 -123 0.6882357235119293 -124 0.6867907859901439 -125 0.6853533694748546 -126 0.6839233975686164 -127 0.6825007951481693 -128 0.6810854883339358 -129 0.6796774044604751 -130 0.6782764720478581 -131 0.6768826207739282 -132 0.675495781447412 -133 0.6741158859818493 -134 0.6727428673703116 -135 0.6713766596608783 -136 0.6700171979328448 -137 0.6686644182736309 -138 0.6673182577563711 -139 0.665978654418155 -140 0.6646455472388978 -141 0.6633188761208197 -142 0.6619985818685072 -143 0.6606846061695424 -144 0.6593768915756765 -145 0.6580753814845278 -146 0.6567800201217898 -147 0.6554907525239279 -148 0.6542075245213498 -149 0.6529302827220361 -150 0.6516589744956094 -151 0.6503935479578326 -152 0.6491339519555221 -153 0.6478801360518566 -154 0.6466320505120773 -155 0.6453896462895573 -156 0.6441528750122365 -157 0.642921688969405 -158 0.6416960410988252 -159 0.640475884974183 -160 0.6392611747928573 -161 0.6380518653639957 -162 0.6368479120968908 -163 0.635649270989643 -164 0.6344558986181063 -165 0.6332677521251036 -166 0.6320847892099062 -167 0.6309069681179693 -168 0.6297342476309137 -169 0.6285665870567494 -170 0.6274039462203316 -171 0.626246285454043 -172 0.6250935655886968 -173 0.623945747944651 -174 0.6228027943231316 -175 0.6216646669977567 -176 0.6205313287062546 -177 0.6194027426423736 -178 0.6182788724479744 -179 0.6171596822053032 -180 0.6160451364294374 -181 0.6149352000609029 -182 0.6138298384584534 -183 0.6127290173920114 -184 0.6116327030357649 -185 0.610540861961415 -186 0.6094534611315701 -187 0.6083704678932862 -188 0.6072918499717428 -189 0.6062175754640584 -190 0.6051476128332351 -191 0.6040819309022343 -192 0.6030204988481755 -193 0.6019632861966588 -194 0.6009102628162061 -195 0.5998613989128165 -196 0.5988166650246367 -197 0.5977760320167395 -198 0.5967394710760106 -199 0.5957069537061387 -200 0.5946784517227086 -201 0.5936539372483923 -202 0.5926333827082372 -203 0.5916167608250495 -204 0.5906040446148677 -205 0.5895952073825281 -206 0.5885902227173152 -207 0.5875890644887002 -208 0.5865917068421604 -209 0.5855981241950815 -210 0.5846082912327386 -211 0.5836221829043546 -212 0.5826397744192342 -213 0.581661041242972 -214 0.5806859590937321 -215 0.5797145039385988 -216 0.5787466519899951 -217 0.5777823797021695 -218 0.5768216637677468 -219 0.5758644811143447 -220 0.5749108089012515 -221 0.5739606245161651 -222 0.5730139055719944 -223 0.5720706299037137 -224 0.5711307755652795 -225 0.5701943208266014 -226 0.5692612441705648 -227 0.5683315242901118 -228 0.5674051400853706 -229 0.5664820706608363 -230 0.565562295322604 -231 0.5646457935756481 -232 0.5637325451211503 -233 0.5628225298538745 -234 0.5619157278595864 -235 0.5610121194125203 -236 0.5601116849728858 -237 0.5592144051844212 -238 0.5583202608719857 -239 0.5574292330391953 -240 0.5565413028660963 -241 0.5556564517068797 -242 0.5547746610876346 -243 0.5538959127041372 -244 0.5530201884196781 -245 0.5521474702629271 -246 0.5512777404258298 -247 0.5504109812615423 -248 0.549547175282398 -249 0.548686305157909 -250 0.5478283537127981 -251 0.5469733039250656 -252 0.5461211389240842 -253 0.5452718419887275 -254 0.5444253965455269 -255 0.5435817861668577 -256 0.5427409945691563 -257 0.5419030056111626 -258 0.5410678032921926 -259 0.5402353717504378 -260 0.5394056952612899 -261 0.5385787582356935 -262 0.5377545452185236 -263 0.5369330408869883 -264 0.5361142300490556 -265 0.5352980976419066 -266 0.5344846287304097 -267 0.5336738085056196 -268 0.5328656222832998 -269 0.5320600555024659 -270 0.5312570937239519 -271 0.5304567226289982 -272 0.5296589280178607 -273 0.5288636958084402 -274 0.528071012034933 -275 0.527280862846501 -276 0.526493234505962 -277 0.5257081133884988 -278 0.5249254859803876 -279 0.5241453388777454 -280 0.5233676587852939 -281 0.5225924325151446 -282 0.5218196469855986 -283 0.5210492892199644 -284 0.5202813463453946 -285 0.5195158055917365 -286 0.5187526542904008 -287 0.5179918798732471 -288 0.5172334698714828 -289 0.5164774119145797 -290 0.5157236937292059 -291 0.5149723031381711 -292 0.5142232280593879 -293 0.5134764565048479 -294 0.5127319765796108 -295 0.5119897764808087 -296 0.5112498444966641 -297 0.5105121690055203 -298 0.5097767384748864 -299 0.5090435414604948 -300 0.5083125666053719 -301 0.507583802638921 -302 0.5068572383760178 -303 0.5061328627161186 -304 0.5054106646423798 -305 0.5046906332207897 -306 0.5039727575993115 -307 0.5032570270070392 -308 0.5025434307533622 -309 0.5018319582271428 -310 0.5011225988959046 -311 0.5004153423050312 -312 0.49971017807697427 -313 0.49900709591047493 -314 0.49830608557979217 -315 0.497607136933943 -316 0.4969102398959523 -317 0.4962153844621122 -318 0.4955225607012511 -319 0.4948317587540115 -320 0.4941429688321387 -321 0.4934561812177765 -322 0.49277138626277345 -323 0.4920885743879972 -324 0.4914077360826579 -325 0.49072886190364023 -326 0.4900519424748425 -327 0.48937696848652695 -328 0.4887039306946743 -329 0.4880328199203507 -330 0.48736362704907843 -331 0.48669634303021736 -332 0.4860309588763527 -333 0.48536746566269084 -334 0.48470585452646225 -335 0.4840461166663318 -336 0.48338824334181657 -337 0.4827322258727103 -338 0.48207805563851625 -339 0.4814257240778837 -340 0.4807752226880555 -341 0.4801265430243186 -342 0.4794796766994642 -343 0.4788346153832517 -344 0.478191350801881 -345 0.4775498747374702 -346 0.47691017902753985 -347 0.4762722555645029 -348 0.47563609629516157 -349 0.4750016932202088 -350 0.474369038393737 -351 0.4737381239227518 -352 0.4731089419666909 -353 0.4724814847369504 -354 0.4718557444964145 -355 0.471231713558992 -356 0.4706093842891585 -357 0.46998874910150146 -358 0.46936980046027404 -359 0.46875253087895113 -360 0.4681369329197923 -361 0.4675229991934086 -362 0.4669107223583348 -363 0.46630009512060633 -364 0.4656911102333418 -365 0.46508376049632844 -366 0.4644780387556143 -367 0.4638739379031033 -368 0.46327145087615657 -369 0.4626705706571957 -370 0.4620712902733141 -371 0.46147360279588856 -372 0.46087750134019834 -373 0.4602829790650468 -374 0.4596900291723878 -375 0.4590986449069562 -376 0.45850881955590195 -377 0.45792054644842906 -378 0.4573338189554377 -379 0.45674863048917047 -380 0.45616497450286275 -381 0.4555828444903966 -382 0.4550022339859583 -383 0.45442313656369987 -384 0.4538455458374046 -385 0.45326945546015474 -386 0.4526948591240039 -387 0.45212175055965415 -388 0.45155012353613266 -389 0.4509799718604769 -390 0.4504112893774181 -391 0.44984406996907317 -392 0.44927830755463477 -393 0.44871399609006835 -394 0.4481511295678115 -395 0.44758970201647463 -396 0.4470297075005478 -397 0.44647114012010813 -398 0.4459139940105313 -399 0.445358263342206 -400 0.4448039423202515 -401 0.4442510251842373 -402 0.4436995062079068 -403 0.4431493796989029 -404 0.44260063999849697 -405 0.4420532814813202 -406 0.4415072985550987 -407 0.44096268566038893 -408 0.4404194372703193 -409 0.4398775478903305 -410 0.4393370120579223 -411 0.4387978243423998 -412 0.43825997934462363 -413 0.4377234716967632 -414 0.43718829606205123 -415 0.43665444713454066 -416 0.4361219196388661 -417 0.4355907083300043 -418 0.4350608079930402 -419 0.43453221344293347 -420 0.4340049195242877 -421 0.43347892111112174 -422 0.43295421310664406 -423 0.43243079044302857 -424 0.43190864808119267 -425 0.43138778101057784 -426 0.43086818424893225 -427 0.43034985284209504 -428 0.4298327818637838 -429 0.42931696641538275 -430 0.4288024016257333 -431 0.4282890826509284 -432 0.4277770046741056 -433 0.4272661629052452 -434 0.4267565525809683 -435 0.426248168964338 -436 0.4257410073446616 -437 0.4252350630372958 -438 0.42473033138345195 -439 0.42422680775000515 -440 0.42372448752930386 -441 0.4232233661389823 -442 0.4227234390217727 -443 0.42222470164532216 -444 0.4217271495020085 -445 0.42123077810876014 -446 0.4207355830068754 -447 0.42024155976184563 -448 0.419748703963178 -449 0.4192570112242222 -450 0.4187664771819965 -451 0.41827709749701647 -452 0.4177888678531257 -453 0.41730178395732725 -454 0.4168158415396169 -455 0.4163310363528185 -456 0.4158473641724194 -457 0.41536482079640946 -458 0.4148834020451197 -459 0.41440310376106304 -460 0.41392392180877696 -461 0.4134458520746668 -462 0.41296889046685104 -463 0.4124930329150079 -464 0.4120182753702229 -465 0.41154461380483826 -466 0.41107204421230364 -467 0.4106005626070276 -468 0.41013016502423144 -469 0.4096608475198032 -470 0.4091926061701538 -471 0.4087254370720742 -472 0.40825933634259365 -473 0.40779430011883927 -474 0.407330324557897 -475 0.40686740583667413 -476 0.40640554015176156 -477 0.40594472371929935 -478 0.4054849527748419 -479 0.40502622357322515 -480 0.40456853238843427 -481 0.40411187551347244 -482 0.4036562492602327 -483 0.4032016499593676 -484 0.40274807396016254 -485 0.40229551763040994 -486 0.401843977356283 -487 0.4013934495422118 -488 0.40094393061076083 -489 0.40049541700250596 -490 0.4000479051759142 -491 0.39960139160722313 -492 0.3991558727903225 -493 0.39871134523663565 -494 0.39826780547500285 -495 0.3978252500515656 -496 0.3973836755296513 -497 0.3969430784896594 -498 0.39650345552894783 -499 0.39606480326172205 -500 0.39562711831892267 -501 0.3951903973481156 -502 0.39475463701338354 -503 0.3943198339952161 -504 0.39388598499040356 -505 0.39345308671192963 -506 0.39302113588886617 -507 0.3925901292662675 -508 0.39216006360506744 -509 0.39173093568197576 -510 0.39130274228937556 -511 0.39087548023522245 -512 0.3904491463429436 -513 0.3900237374513377 -514 0.38959925041447707 -515 0.389175682101608 -516 0.38875302939705453 -517 0.38833128920012144 -518 0.38791045842499833 -519 0.3874905340006655 -520 0.3870715128707984 -521 0.3866533919936748 -522 0.3862361683420825 -523 0.38581983890322674 -524 0.385404400678639 -525 0.38498985068408675 -526 0.3845761859494836 -527 0.38416340351880035 -528 0.38375150044997597 -529 0.38334047381483105 -530 0.3829303206989799 -531 0.3825210382017448 -532 0.38211262343607033 -533 0.38170507352843797 -534 0.38129838561878276 -535 0.3808925568604089 -536 0.38048758441990777 -537 0.38008346547707406 -538 0.3796801972248261 -539 0.37927777686912334 -540 0.3788762016288872 -541 0.37847546873592014 -542 0.3780755754348275 -543 0.37767651898293847 -544 0.3772782966502284 -545 0.3768809057192419 -546 0.3764843434850152 -547 0.37608860725500115 -548 0.37569369434899286 -549 0.3752996020990492 -550 0.3749063278494206 -551 0.37451386895647465 -552 0.37412222278862356 -553 0.373731386726251 -554 0.3733413581616405 -555 0.3729521344989033 -556 0.3725637131539079 -557 0.3721760915542089 -558 0.37178926713897814 -559 0.3714032373589341 -560 0.37101799967627386 -561 0.37063355156460415 -562 0.37024989050887425 -563 0.3698670140053074 -564 0.36948491956133556 -565 0.36910360469553166 -566 0.36872306693754475 -567 0.3683433038280338 -568 0.36796431291860365 -569 0.3675860917717399 -570 0.36720863796074577 -571 0.366831949069678 -572 0.36645602269328403 -573 0.3660808564369399 -574 0.36570644791658763 -575 0.36533279475867425 -576 0.36495989460009 -577 0.3645877450881084 -578 0.36421634388032514 -579 0.3638456886445993 -580 0.36347577705899325 -581 0.36310660681171375 -582 0.36273817560105387 -583 0.3623704811353349 -584 0.36200352113284795 -585 0.3616372933217977 -586 0.361271795440245 -587 0.3609070252360509 -588 0.36054298046682 -589 0.36017965889984516 -590 0.3598170583120531 -591 0.35945517648994796 -592 0.3590940112295585 -593 0.3587335603363829 -594 0.35837382162533604 -595 0.3580147929206956 -596 0.35765647205604956 -597 0.3572988568742431 -598 0.35694194522732786 -599 0.3565857349765085 -600 0.3562302239920924 -601 0.35587541015343827 -602 0.3555212913489055 -603 0.3551678654758042 -604 0.3548151304403445 -605 0.35446308415758787 -606 0.3541117245513971 -607 0.3537610495543878 -608 0.3534110571078797 -609 0.35306174516184863 -610 0.3527131116748783 -611 0.3523651546141128 -612 0.3520178719552097 -613 0.35167126168229296 -614 0.3513253217879061 -615 0.3509800502729663 -616 0.3506354451467184 -617 0.35029150442668927 -618 0.3499482261386421 -619 0.34960560831653265 -620 0.3492636490024624 -621 0.3489223462466368 -622 0.3485816981073192 -623 0.34824170265078774 -624 0.34790235795129204 -625 0.3475636620910101 -626 0.3472256131600049 -627 0.3468882092561822 -628 0.3465514484852485 -629 0.3462153289606681 -630 0.3458798488036226 -631 0.34554500614296846 -632 0.3452107991151962 -633 0.3448772258643897 -634 0.34454428454218505 -635 0.34421197330773123 -636 0.34388029032764894 -637 0.3435492337759909 -638 0.3432188018342032 -639 0.3428889926910855 -640 0.3425598045427515 -641 0.342231235592591 -642 0.34190328405123144 -643 0.3415759481364984 -644 0.3412492260733795 -645 0.3409231160939852 -646 0.3405976164375119 -647 0.3402727253502047 -648 0.33994844108532046 -649 0.3396247619030907 -650 0.3393016860706855 -651 0.33897921186217694 -652 0.33865733755850347 -653 0.33833606144743356 -654 0.3380153818235307 -655 0.3376952969881176 -656 0.33737580524924166 -657 0.3370569049216394 -658 0.33673859432670233 -659 0.3364208717924425 -660 0.3361037356534581 -661 0.33578718425089965 -662 0.33547121593243634 -663 0.3351558290522219 -664 0.33484102197086224 -665 0.33452679305538185 -666 0.3342131406791904 -667 0.3339000632220512 -668 0.33358755907004783 -669 0.3332756266155521 -670 0.3329642642571924 -671 0.33265347039982107 -672 0.33234324345448363 -673 0.3320335818383867 -674 0.3317244839748669 -675 0.3314159482933603 -676 0.3311079732293706 -677 0.3308005572244392 -678 0.33049369872611495 -679 0.33018739618792325 -680 0.32988164806933584 -681 0.32957645283574216 -682 0.329271808958418 -683 0.32896771491449733 -684 0.32866416918694225 -685 0.3283611702645137 -686 0.3280587166417438 -687 0.32775680681890496 -688 0.32745543930198334 -689 0.32715461260264894 -690 0.32685432523822827 -691 0.32655457573167584 -692 0.3262553626115465 -693 0.32595668441196735 -694 0.3256585396726107 -695 0.32536092693866625 -696 0.3250638447608144 -697 0.32476729169519847 -698 0.3244712663033984 -699 0.3241757671524041 -700 0.3238807928145882 -701 0.32358634186768065 -702 0.32329241289474187 -703 0.32299900448413643 -704 0.32270611522950815 -705 0.3224137437297533 -706 0.3221218885889956 -707 0.3218305484165607 -708 0.32153972182695095 -709 0.3212494074398199 -710 0.320959603879948 -711 0.32067030977721706 -712 0.32038152376658613 -713 0.3200932444880666 -714 0.3198054705866983 -715 0.31951820071252474 -716 0.3192314335205693 -717 0.3189451676708114 -718 0.3186594018281623 -719 0.31837413466244235 -720 0.3180893648483562 -721 0.3178050910654704 -722 0.3175213119981899 -723 0.31723802633573495 -724 0.316955232772118 -725 0.31667293000612123 -726 0.31639111674127374 -727 0.3161097916858287 -728 0.3158289535527413 -729 0.3155486010596463 -730 0.31526873292883634 -731 0.31498934788723887 -732 0.3147104446663956 -733 0.3144320220024395 -734 0.31415407863607436 -735 0.3138766133125523 -736 0.3135996247816527 -737 0.31332311179766137 -738 0.3130470731193488 -739 0.3127715075099498 -740 0.312496413737142 -741 0.3122217905730254 -742 0.31194763679410176 -743 0.3116739511812541 -744 0.3114007325197262 -745 0.3111279795991024 -746 0.3108556912132874 -747 0.310583866160486 -748 0.3103125032431839 -749 0.31004160126812674 -750 0.3097711590463018 -751 0.3095011753929171 -752 0.30923164912738277 -753 0.30896257907329133 -754 0.3086939640583986 -755 0.30842580291460436 -756 0.30815809447793374 -757 0.30789083758851776 -758 0.30762403109057496 -759 0.30735767383239243 -760 0.3070917646663073 -761 0.30682630244868847 -762 0.3065612860399177 -763 0.306296714304372 -764 0.3060325861104046 -765 0.305768900330328 -766 0.30550565584039485 -767 0.30524285152078096 -768 0.304980486255567 -769 0.30471855893272104 -770 0.30445706844408094 -771 0.30419601368533694 -772 0.30393539355601423 -773 0.30367520695945566 -774 0.30341545280280474 -775 0.30315612999698804 -776 0.3028972374566991 -777 0.30263877410038054 -778 0.30238073885020794 -779 0.30212313063207297 -780 0.30186594837556674 -781 0.3016091910139632 -782 0.30135285748420293 -783 0.30109694672687665 -784 0.30084145768620885 -785 0.30058638931004206 -786 0.3003317405498202 -787 0.30007751036057334 -788 0.29982369770090106 -789 0.2995703015329571 -790 0.2993173208224336 -791 0.29906475453854525 -792 0.2988126016540142 -793 0.29856086114505387 -794 0.29830953199135457 -795 0.29805861317606724 -796 0.29780810368578886 -797 0.2975580025105472 -798 0.2973083086437855 -799 0.297059021082348 -800 0.2968101388264648 -801 0.2965616608797368 -802 0.29631358624912163 -803 0.29606591394491844 -804 0.2958186429807536 -805 0.2955717723735663 -806 0.29532530114359384 -807 0.29507922831435773 -808 0.29483355291264907 -809 0.29458827396851467 -810 0.29434339051524283 -811 0.2940989015893491 -812 0.293854806230563 -813 0.2936111034818134 -814 0.2933677923892153 -815 0.2931248720020557 -816 0.2928823413727803 -817 0.2926401995569797 -818 0.292398445613376 -819 0.2921570786038094 -820 0.2919160975932247 -821 0.2916755016496583 -822 0.2914352898442247 -823 0.29119546125110335 -824 0.29095601494752615 -825 0.29071695001376363 -826 0.29047826553311235 -827 0.29023996059188234 -828 0.29000203427938387 -829 0.28976448568791496 -830 0.28952731391274866 -831 0.2892905180521204 -832 0.28905409720721553 -833 0.28881805048215686 -834 0.28858237698399214 -835 0.28834707582268215 -836 0.28811214611108754 -837 0.28787758696495763 -838 0.28764339750291784 -839 0.28740957684645724 -840 0.2871761241199174 -841 0.2869430384504794 -842 0.286710318968153 -843 0.28647796480576393 -844 0.2862459750989426 -845 0.2860143489861123 -846 0.2857830856084774 -847 0.2855521841100122 -848 0.2853216436374487 -849 0.2850914633402659 -850 0.28486164237067796 -851 0.28463217988362266 -852 0.2844030750367507 -853 0.2841743269904139 -854 0.28394593490765446 -855 0.2837178979541936 -856 0.28349021529842056 -857 0.28326288611138145 -858 0.2830359095667686 -859 0.2828092848409096 -860 0.28258301111275624 -861 0.2823570875638738 -862 0.28213151337843057 -863 0.28190628774318693 -864 0.28168140984748485 -865 0.28145687888323717 -866 0.2812326940449174 -867 0.28100885452954893 -868 0.28078535953669487 -869 0.28056220826844747 -870 0.2803393999294182 -871 0.2801169337267269 -872 0.27989480886999235 -873 0.27967302457132137 -874 0.27945158004529935 -875 0.2792304745089797 -876 0.27900970718187434 -877 0.2787892772859434 -878 0.27856918404558545 -879 0.27834942668762763 -880 0.27813000444131597 -881 0.2779109165383055 -882 0.27769216221265064 -883 0.2774737407007956 -884 0.27725565124156454 -885 0.2770378930761524 -886 0.27682046544811495 -887 0.27660336760335985 -888 0.2763865987901368 -889 0.2761701582590283 -890 0.27595404526294054 -891 0.27573825905709387 -892 0.2755227988990136 -893 0.2753076640485212 -894 0.2750928537677243 -895 0.2748783673210088 -896 0.2746642039750288 -897 0.27445036299869796 -898 0.27423684366318085 -899 0.2740236452418835 -900 0.27381076701044504 -901 0.27359820824672837 -902 0.27338596823081174 -903 0.2731740462449801 -904 0.2729624415737158 -905 0.27275115350369084 -906 0.2725401813237574 -907 0.2723295243249398 -908 0.27211918180042577 -909 0.2719091530455581 -910 0.271699437357826 -911 0.2714900340368568 -912 0.27128094238440764 -913 0.27107216170435705 -914 0.2708636913026968 -915 0.27065553048752344 -916 0.2704476785690303 -917 0.27024013485949927 -918 0.27003289867329255 -919 0.2698259693268448 -920 0.26961934613865485 -921 0.269413028429278 -922 0.2692070155213177 -923 0.26900130673941763 -924 0.26879590141025433 -925 0.2685907988625287 -926 0.26838599842695854 -927 0.2681814994362706 -928 0.2679773012251932 -929 0.2677734031304478 -930 0.267569804490742 -931 0.2673665046467618 -932 0.2671635029411637 -933 0.26696079871856737 -934 0.2667583913255481 -935 0.26655628011062926 -936 0.2663544644242748 -937 0.26615294361888214 -938 0.26595171704877413 -939 0.26575078407019265 -940 0.2655501440412903 -941 0.26534979632212374 -942 0.2651497402746465 -943 0.26494997526270114 -944 0.26475050065201294 -945 0.26455131581018193 -946 0.2643524201066763 -947 0.2641538129128253 -948 0.2639554936018118 -949 0.26375746154866575 -950 0.26355971613025697 -951 0.2633622567252881 -952 0.2631650827142882 -953 0.26296819347960493 -954 0.26277158840539866 -955 0.26257526687763516 -956 0.2623792282840789 -957 0.2621834720142861 -958 0.26198799745959866 -959 0.2617928040131365 -960 0.2615978910697918 -961 0.2614032580262219 -962 0.26120890428084254 -963 0.2610148292338218 -964 0.26082103228707326 -965 0.26062751284424945 -966 0.2604342703107354 -967 0.2602413040936423 -968 0.2600486136018011 -969 0.259856198245756 -970 0.25966405743775794 -971 0.25947219059175874 -972 0.2592805971234043 -973 0.25908927645002855 -974 0.2588982279906473 -975 0.2587074511659519 -976 0.25851694539830294 -977 0.2583267101117244 -978 0.2581367447318972 -979 0.2579470486861532 -980 0.25775762140346925 -981 0.25756846231446096 -982 0.25737957085137686 -983 0.2571909464480922 -984 0.2570025885401032 -985 0.2568144965645208 -986 0.2566266699600653 -987 0.25643910816705967 -988 0.2562518106274244 -989 0.25606477678467143 -990 0.25587800608389827 -991 0.2556914979717821 -992 0.25550525189657447 -993 0.255319267308095 -994 0.2551335436577262 -995 0.2549480803984073 -996 0.25476287698462907 -997 0.2545779328724277 -998 0.2543932475193798 -999 0.25420882038459613 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART deleted file mode 100644 index a97e77ead..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/RESTART +++ /dev/null @@ -1,417 +0,0 @@ - - - [ step, potential{electronvolt} ] - - 23 - 100 - - - - - - - - - 3.16681520e-04 - [ 1.00000000e+00 ] - - - - - 5.00000000e-06 - 5.00000000e-06 - - 5.00000000e-02 - - [ -4.08280679e-03, -3.46602968e-03, -2.33923783e-03, -1.03434556e-03, -1.28319037e-04, - -1.28319037e-04, -1.03434556e-03, -2.33923783e-03, -3.46602968e-03, -4.08280679e-03 ] - - - [ -6.74123475e-03, -3.31368158e-04, -2.56641258e-04, -1.73434050e-04, -3.45431088e-04, - -1.89782615e-04, -2.48082411e-04, -3.37915236e-04, -1.14210849e-04, -2.98352945e-04, - -3.07700533e-04, -3.71729651e-05, -6.51794608e-03, -3.04545678e-04, -2.33738518e-04, - -1.63672373e-04, -3.16318443e-04, -1.72718160e-04, -2.31014647e-04, -3.08655221e-04, - -1.03897424e-04, -2.75647312e-04, -2.80568315e-04, -3.38099648e-05, -5.76830191e-03, - -2.49099689e-04, -1.88418165e-04, -1.39532241e-04, -2.57230257e-04, -1.39061693e-04, - -1.92910729e-04, -2.49980840e-04, -8.35939892e-05, -2.27353814e-04, -2.26595684e-04, - -2.71947501e-05, -4.11584127e-03, -1.64858547e-04, -1.22908686e-04, -9.60811869e-05, - -1.69267439e-04, -9.06029088e-05, -1.30258416e-04, -1.63834838e-04, -5.44262891e-05, - -1.51698370e-04, -1.48092618e-04, -1.77005997e-05, -1.51160289e-03, -5.78861074e-05, - -4.27748591e-05, -3.45463100e-05, -5.92265764e-05, -3.15081132e-05, -4.62933337e-05, - -5.71837634e-05, -1.89191699e-05, -5.35291166e-05, -5.15998287e-05, -6.15176974e-06, - 1.51160289e-03, 5.78861074e-05, 4.27748591e-05, 3.45463100e-05, 5.92265764e-05, - 3.15081132e-05, 4.62933337e-05, 5.71837634e-05, 1.89191699e-05, 5.35291166e-05, - 5.15998287e-05, 6.15176974e-06, 4.11584127e-03, 1.64858547e-04, 1.22908686e-04, - 9.60811869e-05, 1.69267439e-04, 9.06029088e-05, 1.30258416e-04, 1.63834838e-04, - 5.44262891e-05, 1.51698370e-04, 1.48092618e-04, 1.77005997e-05, 5.76830191e-03, - 2.49099689e-04, 1.88418165e-04, 1.39532241e-04, 2.57230257e-04, 1.39061693e-04, - 1.92910729e-04, 2.49980840e-04, 8.35939892e-05, 2.27353814e-04, 2.26595684e-04, - 2.71947501e-05, 6.51794608e-03, 3.04545678e-04, 2.33738518e-04, 1.63672373e-04, - 3.16318443e-04, 1.72718160e-04, 2.31014647e-04, 3.08655221e-04, 1.03897424e-04, - 2.75647312e-04, 2.80568315e-04, 3.38099648e-05, 6.74123475e-03, 3.31368158e-04, - 2.56641258e-04, 1.73434050e-04, 3.45431088e-04, 1.89782615e-04, 2.48082411e-04, - 3.37915236e-04, 1.14210849e-04, 2.98352945e-04, 3.07700533e-04, 3.71729651e-05 ] - - nichols - - [ 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, 1.00000000e+00, - 1.00000000e+00 ] - - False - -1 - - [ -1.47785464e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, - -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, - -4.17125977e-04, -3.68845607e-05, -2.74457677e-03, -9.07946536e-04, -3.03664938e-04, - -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, - -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -4.88577796e-03, - -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, - -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, - -3.68845607e-05, -7.14701720e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, - -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, - -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -8.60821858e-03, -9.07946536e-04, - -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, - -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, - -8.60821858e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, - -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, - -4.17125977e-04, -3.68845607e-05, -7.14701720e-03, -9.07946536e-04, -3.03664938e-04, - -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, - -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -4.88577796e-03, - -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, - -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, - -3.68845607e-05, -2.74457677e-03, -9.07946536e-04, -3.03664938e-04, -2.45080969e-03, - -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, -5.49578928e-04, -1.16238192e-04, - -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, -1.47785464e-03, -9.07946536e-04, - -3.03664938e-04, -2.45080969e-03, -7.08685682e-04, -2.04426217e-04, -1.57974759e-03, - -5.49578928e-04, -1.16238192e-04, -1.17472692e-03, -4.17125977e-04, -3.68845607e-05, - -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, - 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, - 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -9.07946536e-04, 1.25048199e-02, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, - 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, - 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, - 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, 1.39876961e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -3.03664938e-04, 0.00000000e+00, - 1.39876961e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, - 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, - 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, - 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, - 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, - 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, 0.00000000e+00, 9.11121023e-02, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.45080969e-03, 0.00000000e+00, - 0.00000000e+00, 9.11121023e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, - 0.00000000e+00, 4.06575815e-17, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 4.06575815e-17, 7.61840764e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -7.08685682e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 7.61840764e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, -4.06575815e-17, 0.00000000e+00, - 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -2.04426217e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.33913609e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.57974759e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 3.78557883e-02, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -6.77626358e-17, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -6.77626358e-17, 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 4.58159857e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -5.49578928e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 4.58159857e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.04953142e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, -1.16238192e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.04953142e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, - 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, - 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, - -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, - 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, - 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, -1.17472692e-03, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.09329642e-02, 0.00000000e+00, 0.00000000e+00, - -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, - 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 6.77626358e-18, 2.63931583e-03, 0.00000000e+00, - -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 6.77626358e-18, - 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, - 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, -4.17125977e-04, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.63931583e-03, 0.00000000e+00, - -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, - -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 2.06369789e-05, -3.68845607e-05, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 2.06369789e-05 ] - - True - - - - - [ -1.01072780e+00, -4.68874120e-02, -3.59468317e-02, -2.52838796e-02, -4.86791004e-02, - -2.65598422e-02, -3.56249983e-02, -4.74854921e-02, -1.59759557e-02, -4.24677650e-02, - -4.31552318e-02, -5.19870877e-03, -9.19269284e-01, -4.23917888e-02, -3.24651981e-02, - -2.29308911e-02, -4.39927282e-02, -2.39852603e-02, -3.22592356e-02, -4.29011410e-02, - -1.44265930e-02, -3.84199320e-02, -3.89808531e-02, -4.69442999e-03, -7.39381375e-01, - -3.37645062e-02, -2.58127098e-02, -1.83570651e-02, -3.50150253e-02, -1.90676527e-02, - -2.57589463e-02, -3.41294814e-02, -1.14678155e-02, -3.06319441e-02, -3.10002665e-02, - -3.73150660e-03, -4.81234459e-01, -2.17577394e-02, -1.66041252e-02, -1.18901097e-02, - -2.25475638e-02, -1.22635502e-02, -1.66413273e-02, -2.19664552e-02, -7.37502356e-03, - -1.97592992e-02, -1.99456146e-02, -2.39966815e-03, -1.67247515e-01, -7.51435809e-03, - -5.72813931e-03, -4.11960115e-03, -7.78369258e-03, -4.23032996e-03, -5.75646515e-03, - -7.58074855e-03, -2.54389292e-03, -6.82851412e-03, -6.88187988e-03, -8.27707300e-04, - 1.67247515e-01, 7.51435809e-03, 5.72813931e-03, 4.11960115e-03, 7.78369258e-03, - 4.23032996e-03, 5.75646515e-03, 7.58074855e-03, 2.54389292e-03, 6.82851412e-03, - 6.88187988e-03, 8.27707300e-04, 4.81234459e-01, 2.17577394e-02, 1.66041252e-02, - 1.18901097e-02, 2.25475638e-02, 1.22635502e-02, 1.66413273e-02, 2.19664552e-02, - 7.37502356e-03, 1.97592992e-02, 1.99456146e-02, 2.39966815e-03, 7.39381375e-01, - 3.37645062e-02, 2.58127098e-02, 1.83570651e-02, 3.50150253e-02, 1.90676527e-02, - 2.57589463e-02, 3.41294814e-02, 1.14678155e-02, 3.06319441e-02, 3.10002665e-02, - 3.73150660e-03, 9.19269284e-01, 4.23917888e-02, 3.24651981e-02, 2.29308911e-02, - 4.39927282e-02, 2.39852603e-02, 3.22592356e-02, 4.29011410e-02, 1.44265930e-02, - 3.84199320e-02, 3.89808531e-02, 4.69442999e-03, 1.01072780e+00, 4.68874120e-02, - 3.59468317e-02, 2.52838796e-02, 4.86791004e-02, 2.65598422e-02, 3.56249983e-02, - 4.74854921e-02, 1.59759557e-02, 4.24677650e-02, 4.31552318e-02, 5.19870877e-03 ] - -

- [ 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, - 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00, 0.00000000e+00 ] -

- [ 1.83736223e+03, 1.83736223e+03, 1.83736223e+03, 1.83736223e+03 ] - [ H, H, H, H ] -
- - [ 3.00000000e+02, 1.83697020e-14, 1.83697020e-14, 0.00000000e+00, 3.00000000e+02, - 1.83697020e-14, 0.00000000e+00, 0.00000000e+00, 3.00000000e+02 ] - -
-
diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 deleted file mode 100644 index 134871b06..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL.hess_22 +++ /dev/null @@ -1 +0,0 @@ --1.477854642297198734e-03 -9.079465359124443830e-04 -3.036649378698210149e-04 -2.450809691770789930e-03 -7.086856821782530364e-04 -2.044262173923530991e-04 -1.579747592456479761e-03 -5.495789276197622555e-04 -1.162381917757483382e-04 -1.174726919036546803e-03 -4.171259769480094304e-04 -3.688456065309916334e-05 -2.744576773996022095e-03 -9.079465359126070133e-04 -3.036649378698210149e-04 -2.450809691771115191e-03 -7.086856821783614566e-04 -2.044262173923666517e-04 -1.579747592456642391e-03 -5.495789276197622555e-04 -1.162381917757754433e-04 -1.174726919036628119e-03 -4.171259769480365354e-04 -3.688456065310593960e-05 -4.885777959485072125e-03 -9.079465359125256981e-04 -3.036649378698481200e-04 -2.450809691771115191e-03 -7.086856821783885617e-04 -2.044262173923802042e-04 -1.579747592456696602e-03 -5.495789276197622555e-04 -1.162381917757686670e-04 -1.174726919036682329e-03 -4.171259769480771930e-04 -3.688456065310763367e-05 -7.147017201396439756e-03 -9.079465359126341183e-04 -3.036649378698481200e-04 -2.450809691771033659e-03 -7.086856821783479041e-04 -2.044262173923666517e-04 -1.579747592456764256e-03 -5.495789276198029131e-04 -1.162381917757754433e-04 -1.174726919036682329e-03 -4.171259769480636405e-04 -3.688456065310932773e-05 -8.608218578287314682e-03 -9.079465359125629947e-04 -3.036649378698277912e-04 -2.450809691771030190e-03 -7.086856821783546262e-04 -2.044262173923632635e-04 -1.579747592456666027e-03 -5.495789276197927216e-04 -1.162381917757737492e-04 -1.174726919036661946e-03 -4.171259769480433117e-04 -3.688456065310509257e-05 -8.608218578287640810e-03 -9.079465359125730778e-04 -3.036649378698413437e-04 -2.450809691771070956e-03 -7.086856821783681787e-04 -2.044262173923666517e-04 -1.579747592456682941e-03 -5.495789276198096351e-04 -1.162381917757754433e-04 -1.174726919036678859e-03 -4.171259769480534490e-04 -3.688456065310678663e-05 -7.147017201396006075e-03 -9.079465359126341183e-04 -3.036649378698481200e-04 -2.450809691771108252e-03 -7.086856821783614566e-04 -2.044262173923734279e-04 -1.579747592456764256e-03 -5.495789276198300181e-04 -1.162381917757754433e-04 -1.174726919036709434e-03 -4.171259769480636405e-04 -3.688456065310932773e-05 -4.885777959485939487e-03 -9.079465359125799082e-04 -3.036649378698345675e-04 -2.450809691770952561e-03 -7.086856821783343516e-04 -2.044262173923802042e-04 -1.579747592456764256e-03 -5.495789276198435706e-04 -1.162381917757686670e-04 -1.174726919036682329e-03 -4.171259769480500880e-04 -3.688456065310593960e-05 -2.744576773996455776e-03 -9.079465359125528032e-04 -3.036649378698210149e-04 -2.450809691771115191e-03 -7.086856821783614566e-04 -2.044262173923395466e-04 -1.579747592456506866e-03 -5.495789276197351504e-04 -1.162381917757686670e-04 -1.174726919036682329e-03 -4.171259769480365354e-04 -3.688456065310593960e-05 -1.477854642296765053e-03 -9.079465359124714880e-04 -3.036649378697939099e-04 -2.450809691770640744e-03 -7.086856821782530364e-04 -2.044262173923259941e-04 -1.579747592456506866e-03 -5.495789276197351504e-04 -1.162381917757551145e-04 -1.174726919036438383e-03 -4.171259769479823253e-04 -3.688456065310255147e-05 -9.079465359126612234e-04 1.250481991216644169e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216646771e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216646771e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216645557e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359125528032e-04 1.250481991216645210e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359125528032e-04 1.250481991216644516e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216645557e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216645557e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216646771e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.079465359126612234e-04 1.250481991216644169e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256806675e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256793014e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256820119e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378698481200e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378698481200e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256799953e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256793014e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256793014e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.036649378700649604e-04 0.000000000000000000e+00 1.398769613256806675e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744029912e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744029912e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744014647e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744006320e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771074425e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744010483e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771074425e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744014647e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744021585e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691770857585e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744029912e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744031300e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.450809691771291265e-03 0.000000000000000000e+00 0.000000000000000000e+00 9.111210234744013259e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821780090909e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821783343516e-04 0.000000000000000000e+00 0.000000000000000000e+00 4.065758146820641628e-17 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821783343516e-04 0.000000000000000000e+00 0.000000000000000000e+00 4.065758146820641628e-17 7.618407641132628541e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821780090909e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132607724e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821788764527e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132634613e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.086856821784427718e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 7.618407641132662368e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173927190174e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147201128e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173927190174e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147268349e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173923937567e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173923937567e-04 0.000000000000000000e+00 0.000000000000000000e+00 -4.065758146820641628e-17 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173927190174e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.044262173922853365e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.339136085147336654e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329860035e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456940547e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329845464e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456723707e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329841300e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456723707e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329843382e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329839219e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.579747592456506866e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.785578827329846158e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276201146212e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755678940e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -6.776263578034402713e-17 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755692818e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276197893605e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755692818e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276197893605e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755689349e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755692818e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -6.776263578034402713e-17 4.581598566755678940e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276196809403e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.495789276201146212e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 4.581598566755705829e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942447680e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942464485e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917757483382e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942464485e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942447680e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917758567584e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.162381917754230776e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.049531418942481561e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327382486e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036628119e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327388037e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036628119e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327388037e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327389078e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327388037e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -1.174726919036736539e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.093296422327390466e-02 0.000000000000000000e+00 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769484431112e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769481178506e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.776263578034402713e-18 2.639315834218475265e-03 0.000000000000000000e+00 -4.171259769481178506e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 6.776263578034402713e-18 2.639315834218475265e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769484431112e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218464857e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -4.171259769480094304e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.639315834218478301e-03 0.000000000000000000e+00 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345213453e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345213453e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065272308071e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345086398e-05 -3.688456065304834136e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345128750e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345044047e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885345213453e-05 -3.688456065315676158e-05 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.063697885344874640e-05 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener deleted file mode 100644 index 7a283f79a..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.ener +++ /dev/null @@ -1,11 +0,0 @@ -#Bead Energy (eV) -0 -0.11109882108420299 -1 -0.0943154626112268 -2 -0.06365389758180684 -3 -0.02814597370633024 -4 -0.0034917385208372695 -5 -0.0034917385208372642 -6 -0.02814597370633021 -7 -0.06365389758180683 -8 -0.0943154626112268 -9 -0.11109882108420309 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz deleted file mode 100644 index 444d06b92..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_22.xyz +++ /dev/null @@ -1,60 +0,0 @@ -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 0 -H -0.5348541232080581 -0.024811750232936948 -0.019022244394218887 -H -0.013379653082377777 -0.025759870905132605 -0.014054863385410017 -H -0.018851937470266734 -0.025128240616751864 -0.008454111769641903 -H -0.022472973733640152 -0.022836765494468347 -0.0027510382405951366 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 1 -H -0.4864563622053626 -0.022432768841312054 -0.01717984318004767 -H -0.012134505160844227 -0.023279949524292798 -0.012692453306145133 -H -0.017070852532265184 -0.022702306420212013 -0.007634224340828866 -H -0.02033095271196232 -0.02062777940689945 -0.002484185403369972 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 2 -H -0.3912637786536233 -0.017867407434110402 -0.013659497945798682 -H -0.009714140655624117 -0.018529153695066913 -0.010090167403116586 -H -0.013631047539681055 -0.018060544033768836 -0.006068506716267914 -H -0.01620972694699658 -0.016404634800015343 -0.0019746282819481783 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 3 -H -0.25465831218809365 -0.011513700025975392 -0.008786524762181462 -H -0.0062919751562975695 -0.011931657074548553 -0.006489591382477243 -H -0.008806211277978782 -0.011624147668387732 -0.0039026944492845054 -H -0.01045617099190619 -0.010554764816250844 -0.0012698497152878357 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 4 -H -0.08850357482186076 -0.003976427108850816 -0.0030312008212020846 -H -0.0021799990734237993 -0.0041189527838122264 -0.0022385942363618875 -H -0.0030461902126435033 -0.00401155942813208 -0.001346170176684053 -H -0.0036134941028878884 -0.003641734050405462 -0.0004380038463501842 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 5 -H 0.08850357482186069 0.003976427108850813 0.003031200821202117 -H 0.002179999073423798 0.0041189527838122264 0.0022385942363622314 -H 0.0030461902126435016 0.0040115594281320815 0.0013461701766833525 -H 0.0036134941028878875 0.003641734050405474 0.00043800384635109453 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 6 -H 0.2546583121880934 0.011513700025975387 0.008786524762181492 -H 0.006291975156297566 0.011931657074548546 0.006489591382477585 -H 0.008806211277978777 0.011624147668387728 0.0039026944492838037 -H 0.010456170991906183 0.010554764816250853 0.0012698497152887453 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 7 -H 0.3912637786536232 0.017867407434110392 0.013659497945798713 -H 0.009714140655624114 0.01852915369506691 0.010090167403116928 -H 0.013631047539681048 0.018060544033768833 0.006068506716267213 -H 0.016209726946996576 0.016404634800015354 0.001974628281949088 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 8 -H 0.4864563622053627 0.022432768841312057 0.017179843180047706 -H 0.012134505160844229 0.0232799495242928 0.012692453306145478 -H 0.017070852532265184 0.022702306420212016 0.007634224340828166 -H 0.02033095271196232 0.020627779406899468 0.002484185403370883 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 9 -H 0.5348541232080584 0.024811750232936962 0.019022244394218926 -H 0.013379653082377783 0.025759870905132615 0.014054863385410366 -H 0.01885193747026674 0.02512824061675187 0.008454111769641205 -H 0.02247297373364016 0.022836765494468374 0.0027510382405960486 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz deleted file mode 100644 index 89a3979ed..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/simulation.instanton_FINAL_forces_22.xyz +++ /dev/null @@ -1,60 +0,0 @@ -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 -H -0.0067412347451789685 -0.00033136815818743664 -0.00025664125758041907 -H -0.00017343404957779576 -0.00034543108751673826 -0.00018978261482237524 -H -0.00024808241099952586 -0.00033791523568359904 -0.00011421084911364058 -H -0.0002983529445770538 -0.00030770053286353406 -3.717296506424839e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 -H -0.006517946084283843 -0.00030454567775130644 -0.00023373851754084727 -H -0.0001636723729839984 -0.00031631844291162475 -0.00017271815962912723 -H -0.0002310146465327905 -0.00030865522139660083 -0.00010389742378683749 -H -0.0002756473124096979 -0.0002805683153399247 -3.3809964816010384e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 -H -0.005768301914374969 -0.00024909968865260897 -0.0001884181650740105 -H -0.00013953224108501357 -0.00025723025711272 -0.00013906169307489075 -H -0.00019291072877767397 -0.0002499808396499299 -8.35939891818199e-05 -H -0.00022735381443351628 -0.00022659568382739898 -2.7194750130916368e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 -H -0.00411584126599374 -0.00016485854664692395 -0.00012290868638619492 -H -9.608118694903266e-05 -0.00016926743868503452 -9.06029087883054e-05 -H -0.0001302584155754721 -0.00016383483813829698 -5.442628909834236e-05 -H -0.0001516983696533509 -0.00014809261759109952 -1.7700599695048103e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 -H -0.0015116028941607616 -5.788610744197028e-05 -4.277485913568424e-05 -H -3.454631004472836e-05 -5.922657643229126e-05 -3.150811319035038e-05 -H -4.629333367848433e-05 -5.718376339139894e-05 -1.891916990945284e-05 -H -5.352911660723943e-05 -5.159982865719587e-05 -6.151769743526251e-06 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 -H 0.0015116028941607603 5.788610744197017e-05 4.277485913568411e-05 -H 3.4546310044728204e-05 5.9226576432291167e-05 3.150811319034994e-05 -H 4.6293333678484304e-05 5.718376339139885e-05 1.8919169909453094e-05 -H 5.352911660723932e-05 5.159982865719576e-05 6.15176974352621e-06 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 -H 0.0041158412659937395 0.00016485854664692378 0.00012290868638619473 -H 9.60811869490325e-05 0.00016926743868503436 9.060290878830489e-05 -H 0.00013025841557547186 0.0001638348381382968 5.4426289098342586e-05 -H 0.0001516983696533506 0.00014809261759109933 1.7700599695048045e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 -H 0.005768301914374969 0.0002490996886526091 0.00018841816507401035 -H 0.0001395322410850139 0.0002572302571127199 0.00013906169307489031 -H 0.00019291072877767397 0.00024998083964992984 8.359398918182017e-05 -H 0.00022735381443351633 0.00022659568382739888 2.7194750130916327e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 -H 0.006517946084283845 0.0003045456777513065 0.00023373851754084727 -H 0.0001636723729839984 0.0003163184429116248 0.00017271815962912685 -H 0.00023101464653279077 0.00030865522139660094 0.00010389742378683776 -H 0.0002756473124096982 0.0002805683153399246 3.380996481601036e-05 -4 -CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 -H 0.0067412347451789685 0.0003313681581874368 0.00025664125758041907 -H 0.00017343404957779609 0.00034543108751673826 0.0001897826148223749 -H 0.00024808241099952586 0.00033791523568359937 0.0001142108491136409 -H 0.00029835294457705394 0.00030770053286353406 3.717296506424837e-05 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/README.md similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/README.md rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/clean.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/clean.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/clean.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/init.xyz similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/init.xyz diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/input.xml similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/input.xml diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/run.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/run.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/README.md similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/README.md rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/clean.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/clean.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/clean.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/init.xyz similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/init.xyz diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/input.xml similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/input.xml diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/run.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_dependent/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/run.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/README b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/README similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/README rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/README diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/clean.sh new file mode 100755 index 000000000..4276dd3bf --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/clean.sh @@ -0,0 +1,2 @@ +#Remove simulation output files + rm -f *simulation* *RESTART* diff --git a/drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/fric_spec_dens.dat similarity index 100% rename from drivers/py/pes/friction/frictionD/test_friction_80K_D/z_friction.dat rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/fric_spec_dens.dat diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/init.xyz similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/init.xyz diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/input.xml similarity index 93% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/input.xml index 1baf21372..9bb7391cb 100644 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/input.xml +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/input.xml @@ -28,7 +28,7 @@ 0.1 nichols true - z_friction.dat + fric_spec_dens.dat powell none true diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh new file mode 100755 index 000000000..53aec69fd --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh @@ -0,0 +1,23 @@ +#Define model parameters + eta=1.674 + eta=0.5 + + wb=500 + wc=500 + V0=2085 + mass=1837.36223469 + x0=0 + epsilon=0 + delta=0 + deltaQ=1 + + address=localhost + model='DW_friction' + + +#Launch i-pi and wait + i-pi input.xml & + sleep 3 + +#Launch driver + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ} -u -a ${address} diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/z_friction.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/z_friction.dat deleted file mode 100644 index 88b85ef6d..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/meanfield_bath_pos_dependent/z_friction.dat +++ /dev/null @@ -1,1003 +0,0 @@ -#eta 1 -# bath_type Ohmic -# w_c 500 - # freq (cm^-1) Laplace transform -1 0.9915470158218098 -2 0.9848551497951816 -3 0.9788255643617454 -4 0.9732247078293326 -5 0.9679416696883935 -6 0.962911133018018 -7 0.9580899447435153 -8 0.9534474391977994 -9 0.9489606918318892 -10 0.9446119121776004 -11 0.9403868910489187 -12 0.9362740173481964 -13 0.9322636249598021 -14 0.928347541807527 -15 0.9245187684107862 -16 0.9207712425362906 -17 0.9170996629124359 -18 0.9134993545627568 -19 0.9099661641551429 -20 0.9064963774421086 -21 0.9030866532531712 -22 0.8997339700879358 -23 0.8964355824392188 -24 0.8931889847263488 -25 0.8899918812500051 -26 0.8868421609620551 -27 0.8837378761228457 -28 0.8806772241248969 -29 0.8776585319167312 -30 0.874680242577914 -31 0.8717409036863014 -32 0.8688391571880675 -33 0.8659737305354348 -34 0.8631434288998111 -35 0.8603471283020212 -36 0.857583769528487 -37 0.8548523527240882 -38 0.8521519325701771 -39 0.8494816139706848 -40 0.8468405481811211 -41 0.8442279293250585 -42 0.8416429912508109 -43 0.8390850046877706 -44 0.8365532746675381 -45 0.8340471381797273 -46 0.831565962036351 -47 0.8291091409221039 -48 0.8266760956107441 -49 0.824266271330268 -50 0.8218791362616757 -51 0.8195141801579645 -52 0.8171709130715548 -53 0.8148488641797111 -54 0.8125475806987108 -55 0.8102666268785352 -56 0.8080055830707606 -57 0.8057640448631033 -58 0.8035416222747761 -59 0.8013379390074006 -60 0.7991526317467734 -61 0.796985349511237 -62 0.7948357530428389 -63 0.7927035142377412 -64 0.7905883156132424 -65 0.7884898498073732 -66 0.7864078191101018 -67 0.7843419350226136 -68 0.7822919178430147 -69 0.7802574962764451 -70 0.7782384070678282 -71 0.7762343946556395 -72 0.7742452108452136 -73 0.7722706145002324 -74 0.770310371251143 -75 0.76836425321937 -76 0.7664320387562564 -77 0.7645135121957763 -78 0.7626084636201109 -79 0.7607166886372758 -80 0.7588379881700227 -81 0.7569721682553251 -82 0.7551190398537776 -83 0.7532784186683185 -84 0.7514501249717047 -85 0.7496339834422199 -86 0.7478298230071312 -87 0.7460374766934447 -88 0.744256781485537 -89 0.742487578189273 -90 0.740729711302249 -91 0.738983028889811 -92 0.7372473824665428 -93 0.7355226268829143 -94 0.7338086202168218 -95 0.7321052236697538 -96 0.7304123014673415 -97 0.7287297207640642 -98 0.7270573515518944 -99 0.7253950665726847 -100 0.7237427412341026 -101 0.7221002535289383 -102 0.7204674839576208 -103 0.7188443154537764 -104 0.7172306333126927 -105 0.7156263251225384 -106 0.7140312806982176 -107 0.712445392017719 -108 0.7108685531608633 -109 0.7093006602503189 -110 0.7077416113947941 -111 0.7061913066343006 -112 0.7046496478873963 -113 0.7031165389003207 -114 0.701591885197936 -115 0.7000755940363974 -116 0.6985675743574739 -117 0.6970677367444532 -118 0.6955759933795586 -119 0.694092258002813 -120 0.6926164458722978 -121 0.6911484737257331 -122 0.6896882597433415 -123 0.6882357235119293 -124 0.6867907859901439 -125 0.6853533694748546 -126 0.6839233975686164 -127 0.6825007951481693 -128 0.6810854883339358 -129 0.6796774044604751 -130 0.6782764720478581 -131 0.6768826207739282 -132 0.675495781447412 -133 0.6741158859818493 -134 0.6727428673703116 -135 0.6713766596608783 -136 0.6700171979328448 -137 0.6686644182736309 -138 0.6673182577563711 -139 0.665978654418155 -140 0.6646455472388978 -141 0.6633188761208197 -142 0.6619985818685072 -143 0.6606846061695424 -144 0.6593768915756765 -145 0.6580753814845278 -146 0.6567800201217898 -147 0.6554907525239279 -148 0.6542075245213498 -149 0.6529302827220361 -150 0.6516589744956094 -151 0.6503935479578326 -152 0.6491339519555221 -153 0.6478801360518566 -154 0.6466320505120773 -155 0.6453896462895573 -156 0.6441528750122365 -157 0.642921688969405 -158 0.6416960410988252 -159 0.640475884974183 -160 0.6392611747928573 -161 0.6380518653639957 -162 0.6368479120968908 -163 0.635649270989643 -164 0.6344558986181063 -165 0.6332677521251036 -166 0.6320847892099062 -167 0.6309069681179693 -168 0.6297342476309137 -169 0.6285665870567494 -170 0.6274039462203316 -171 0.626246285454043 -172 0.6250935655886968 -173 0.623945747944651 -174 0.6228027943231316 -175 0.6216646669977567 -176 0.6205313287062546 -177 0.6194027426423736 -178 0.6182788724479744 -179 0.6171596822053032 -180 0.6160451364294374 -181 0.6149352000609029 -182 0.6138298384584534 -183 0.6127290173920114 -184 0.6116327030357649 -185 0.610540861961415 -186 0.6094534611315701 -187 0.6083704678932862 -188 0.6072918499717428 -189 0.6062175754640584 -190 0.6051476128332351 -191 0.6040819309022343 -192 0.6030204988481755 -193 0.6019632861966588 -194 0.6009102628162061 -195 0.5998613989128165 -196 0.5988166650246367 -197 0.5977760320167395 -198 0.5967394710760106 -199 0.5957069537061387 -200 0.5946784517227086 -201 0.5936539372483923 -202 0.5926333827082372 -203 0.5916167608250495 -204 0.5906040446148677 -205 0.5895952073825281 -206 0.5885902227173152 -207 0.5875890644887002 -208 0.5865917068421604 -209 0.5855981241950815 -210 0.5846082912327386 -211 0.5836221829043546 -212 0.5826397744192342 -213 0.581661041242972 -214 0.5806859590937321 -215 0.5797145039385988 -216 0.5787466519899951 -217 0.5777823797021695 -218 0.5768216637677468 -219 0.5758644811143447 -220 0.5749108089012515 -221 0.5739606245161651 -222 0.5730139055719944 -223 0.5720706299037137 -224 0.5711307755652795 -225 0.5701943208266014 -226 0.5692612441705648 -227 0.5683315242901118 -228 0.5674051400853706 -229 0.5664820706608363 -230 0.565562295322604 -231 0.5646457935756481 -232 0.5637325451211503 -233 0.5628225298538745 -234 0.5619157278595864 -235 0.5610121194125203 -236 0.5601116849728858 -237 0.5592144051844212 -238 0.5583202608719857 -239 0.5574292330391953 -240 0.5565413028660963 -241 0.5556564517068797 -242 0.5547746610876346 -243 0.5538959127041372 -244 0.5530201884196781 -245 0.5521474702629271 -246 0.5512777404258298 -247 0.5504109812615423 -248 0.549547175282398 -249 0.548686305157909 -250 0.5478283537127981 -251 0.5469733039250656 -252 0.5461211389240842 -253 0.5452718419887275 -254 0.5444253965455269 -255 0.5435817861668577 -256 0.5427409945691563 -257 0.5419030056111626 -258 0.5410678032921926 -259 0.5402353717504378 -260 0.5394056952612899 -261 0.5385787582356935 -262 0.5377545452185236 -263 0.5369330408869883 -264 0.5361142300490556 -265 0.5352980976419066 -266 0.5344846287304097 -267 0.5336738085056196 -268 0.5328656222832998 -269 0.5320600555024659 -270 0.5312570937239519 -271 0.5304567226289982 -272 0.5296589280178607 -273 0.5288636958084402 -274 0.528071012034933 -275 0.527280862846501 -276 0.526493234505962 -277 0.5257081133884988 -278 0.5249254859803876 -279 0.5241453388777454 -280 0.5233676587852939 -281 0.5225924325151446 -282 0.5218196469855986 -283 0.5210492892199644 -284 0.5202813463453946 -285 0.5195158055917365 -286 0.5187526542904008 -287 0.5179918798732471 -288 0.5172334698714828 -289 0.5164774119145797 -290 0.5157236937292059 -291 0.5149723031381711 -292 0.5142232280593879 -293 0.5134764565048479 -294 0.5127319765796108 -295 0.5119897764808087 -296 0.5112498444966641 -297 0.5105121690055203 -298 0.5097767384748864 -299 0.5090435414604948 -300 0.5083125666053719 -301 0.507583802638921 -302 0.5068572383760178 -303 0.5061328627161186 -304 0.5054106646423798 -305 0.5046906332207897 -306 0.5039727575993115 -307 0.5032570270070392 -308 0.5025434307533622 -309 0.5018319582271428 -310 0.5011225988959046 -311 0.5004153423050312 -312 0.49971017807697427 -313 0.49900709591047493 -314 0.49830608557979217 -315 0.497607136933943 -316 0.4969102398959523 -317 0.4962153844621122 -318 0.4955225607012511 -319 0.4948317587540115 -320 0.4941429688321387 -321 0.4934561812177765 -322 0.49277138626277345 -323 0.4920885743879972 -324 0.4914077360826579 -325 0.49072886190364023 -326 0.4900519424748425 -327 0.48937696848652695 -328 0.4887039306946743 -329 0.4880328199203507 -330 0.48736362704907843 -331 0.48669634303021736 -332 0.4860309588763527 -333 0.48536746566269084 -334 0.48470585452646225 -335 0.4840461166663318 -336 0.48338824334181657 -337 0.4827322258727103 -338 0.48207805563851625 -339 0.4814257240778837 -340 0.4807752226880555 -341 0.4801265430243186 -342 0.4794796766994642 -343 0.4788346153832517 -344 0.478191350801881 -345 0.4775498747374702 -346 0.47691017902753985 -347 0.4762722555645029 -348 0.47563609629516157 -349 0.4750016932202088 -350 0.474369038393737 -351 0.4737381239227518 -352 0.4731089419666909 -353 0.4724814847369504 -354 0.4718557444964145 -355 0.471231713558992 -356 0.4706093842891585 -357 0.46998874910150146 -358 0.46936980046027404 -359 0.46875253087895113 -360 0.4681369329197923 -361 0.4675229991934086 -362 0.4669107223583348 -363 0.46630009512060633 -364 0.4656911102333418 -365 0.46508376049632844 -366 0.4644780387556143 -367 0.4638739379031033 -368 0.46327145087615657 -369 0.4626705706571957 -370 0.4620712902733141 -371 0.46147360279588856 -372 0.46087750134019834 -373 0.4602829790650468 -374 0.4596900291723878 -375 0.4590986449069562 -376 0.45850881955590195 -377 0.45792054644842906 -378 0.4573338189554377 -379 0.45674863048917047 -380 0.45616497450286275 -381 0.4555828444903966 -382 0.4550022339859583 -383 0.45442313656369987 -384 0.4538455458374046 -385 0.45326945546015474 -386 0.4526948591240039 -387 0.45212175055965415 -388 0.45155012353613266 -389 0.4509799718604769 -390 0.4504112893774181 -391 0.44984406996907317 -392 0.44927830755463477 -393 0.44871399609006835 -394 0.4481511295678115 -395 0.44758970201647463 -396 0.4470297075005478 -397 0.44647114012010813 -398 0.4459139940105313 -399 0.445358263342206 -400 0.4448039423202515 -401 0.4442510251842373 -402 0.4436995062079068 -403 0.4431493796989029 -404 0.44260063999849697 -405 0.4420532814813202 -406 0.4415072985550987 -407 0.44096268566038893 -408 0.4404194372703193 -409 0.4398775478903305 -410 0.4393370120579223 -411 0.4387978243423998 -412 0.43825997934462363 -413 0.4377234716967632 -414 0.43718829606205123 -415 0.43665444713454066 -416 0.4361219196388661 -417 0.4355907083300043 -418 0.4350608079930402 -419 0.43453221344293347 -420 0.4340049195242877 -421 0.43347892111112174 -422 0.43295421310664406 -423 0.43243079044302857 -424 0.43190864808119267 -425 0.43138778101057784 -426 0.43086818424893225 -427 0.43034985284209504 -428 0.4298327818637838 -429 0.42931696641538275 -430 0.4288024016257333 -431 0.4282890826509284 -432 0.4277770046741056 -433 0.4272661629052452 -434 0.4267565525809683 -435 0.426248168964338 -436 0.4257410073446616 -437 0.4252350630372958 -438 0.42473033138345195 -439 0.42422680775000515 -440 0.42372448752930386 -441 0.4232233661389823 -442 0.4227234390217727 -443 0.42222470164532216 -444 0.4217271495020085 -445 0.42123077810876014 -446 0.4207355830068754 -447 0.42024155976184563 -448 0.419748703963178 -449 0.4192570112242222 -450 0.4187664771819965 -451 0.41827709749701647 -452 0.4177888678531257 -453 0.41730178395732725 -454 0.4168158415396169 -455 0.4163310363528185 -456 0.4158473641724194 -457 0.41536482079640946 -458 0.4148834020451197 -459 0.41440310376106304 -460 0.41392392180877696 -461 0.4134458520746668 -462 0.41296889046685104 -463 0.4124930329150079 -464 0.4120182753702229 -465 0.41154461380483826 -466 0.41107204421230364 -467 0.4106005626070276 -468 0.41013016502423144 -469 0.4096608475198032 -470 0.4091926061701538 -471 0.4087254370720742 -472 0.40825933634259365 -473 0.40779430011883927 -474 0.407330324557897 -475 0.40686740583667413 -476 0.40640554015176156 -477 0.40594472371929935 -478 0.4054849527748419 -479 0.40502622357322515 -480 0.40456853238843427 -481 0.40411187551347244 -482 0.4036562492602327 -483 0.4032016499593676 -484 0.40274807396016254 -485 0.40229551763040994 -486 0.401843977356283 -487 0.4013934495422118 -488 0.40094393061076083 -489 0.40049541700250596 -490 0.4000479051759142 -491 0.39960139160722313 -492 0.3991558727903225 -493 0.39871134523663565 -494 0.39826780547500285 -495 0.3978252500515656 -496 0.3973836755296513 -497 0.3969430784896594 -498 0.39650345552894783 -499 0.39606480326172205 -500 0.39562711831892267 -501 0.3951903973481156 -502 0.39475463701338354 -503 0.3943198339952161 -504 0.39388598499040356 -505 0.39345308671192963 -506 0.39302113588886617 -507 0.3925901292662675 -508 0.39216006360506744 -509 0.39173093568197576 -510 0.39130274228937556 -511 0.39087548023522245 -512 0.3904491463429436 -513 0.3900237374513377 -514 0.38959925041447707 -515 0.389175682101608 -516 0.38875302939705453 -517 0.38833128920012144 -518 0.38791045842499833 -519 0.3874905340006655 -520 0.3870715128707984 -521 0.3866533919936748 -522 0.3862361683420825 -523 0.38581983890322674 -524 0.385404400678639 -525 0.38498985068408675 -526 0.3845761859494836 -527 0.38416340351880035 -528 0.38375150044997597 -529 0.38334047381483105 -530 0.3829303206989799 -531 0.3825210382017448 -532 0.38211262343607033 -533 0.38170507352843797 -534 0.38129838561878276 -535 0.3808925568604089 -536 0.38048758441990777 -537 0.38008346547707406 -538 0.3796801972248261 -539 0.37927777686912334 -540 0.3788762016288872 -541 0.37847546873592014 -542 0.3780755754348275 -543 0.37767651898293847 -544 0.3772782966502284 -545 0.3768809057192419 -546 0.3764843434850152 -547 0.37608860725500115 -548 0.37569369434899286 -549 0.3752996020990492 -550 0.3749063278494206 -551 0.37451386895647465 -552 0.37412222278862356 -553 0.373731386726251 -554 0.3733413581616405 -555 0.3729521344989033 -556 0.3725637131539079 -557 0.3721760915542089 -558 0.37178926713897814 -559 0.3714032373589341 -560 0.37101799967627386 -561 0.37063355156460415 -562 0.37024989050887425 -563 0.3698670140053074 -564 0.36948491956133556 -565 0.36910360469553166 -566 0.36872306693754475 -567 0.3683433038280338 -568 0.36796431291860365 -569 0.3675860917717399 -570 0.36720863796074577 -571 0.366831949069678 -572 0.36645602269328403 -573 0.3660808564369399 -574 0.36570644791658763 -575 0.36533279475867425 -576 0.36495989460009 -577 0.3645877450881084 -578 0.36421634388032514 -579 0.3638456886445993 -580 0.36347577705899325 -581 0.36310660681171375 -582 0.36273817560105387 -583 0.3623704811353349 -584 0.36200352113284795 -585 0.3616372933217977 -586 0.361271795440245 -587 0.3609070252360509 -588 0.36054298046682 -589 0.36017965889984516 -590 0.3598170583120531 -591 0.35945517648994796 -592 0.3590940112295585 -593 0.3587335603363829 -594 0.35837382162533604 -595 0.3580147929206956 -596 0.35765647205604956 -597 0.3572988568742431 -598 0.35694194522732786 -599 0.3565857349765085 -600 0.3562302239920924 -601 0.35587541015343827 -602 0.3555212913489055 -603 0.3551678654758042 -604 0.3548151304403445 -605 0.35446308415758787 -606 0.3541117245513971 -607 0.3537610495543878 -608 0.3534110571078797 -609 0.35306174516184863 -610 0.3527131116748783 -611 0.3523651546141128 -612 0.3520178719552097 -613 0.35167126168229296 -614 0.3513253217879061 -615 0.3509800502729663 -616 0.3506354451467184 -617 0.35029150442668927 -618 0.3499482261386421 -619 0.34960560831653265 -620 0.3492636490024624 -621 0.3489223462466368 -622 0.3485816981073192 -623 0.34824170265078774 -624 0.34790235795129204 -625 0.3475636620910101 -626 0.3472256131600049 -627 0.3468882092561822 -628 0.3465514484852485 -629 0.3462153289606681 -630 0.3458798488036226 -631 0.34554500614296846 -632 0.3452107991151962 -633 0.3448772258643897 -634 0.34454428454218505 -635 0.34421197330773123 -636 0.34388029032764894 -637 0.3435492337759909 -638 0.3432188018342032 -639 0.3428889926910855 -640 0.3425598045427515 -641 0.342231235592591 -642 0.34190328405123144 -643 0.3415759481364984 -644 0.3412492260733795 -645 0.3409231160939852 -646 0.3405976164375119 -647 0.3402727253502047 -648 0.33994844108532046 -649 0.3396247619030907 -650 0.3393016860706855 -651 0.33897921186217694 -652 0.33865733755850347 -653 0.33833606144743356 -654 0.3380153818235307 -655 0.3376952969881176 -656 0.33737580524924166 -657 0.3370569049216394 -658 0.33673859432670233 -659 0.3364208717924425 -660 0.3361037356534581 -661 0.33578718425089965 -662 0.33547121593243634 -663 0.3351558290522219 -664 0.33484102197086224 -665 0.33452679305538185 -666 0.3342131406791904 -667 0.3339000632220512 -668 0.33358755907004783 -669 0.3332756266155521 -670 0.3329642642571924 -671 0.33265347039982107 -672 0.33234324345448363 -673 0.3320335818383867 -674 0.3317244839748669 -675 0.3314159482933603 -676 0.3311079732293706 -677 0.3308005572244392 -678 0.33049369872611495 -679 0.33018739618792325 -680 0.32988164806933584 -681 0.32957645283574216 -682 0.329271808958418 -683 0.32896771491449733 -684 0.32866416918694225 -685 0.3283611702645137 -686 0.3280587166417438 -687 0.32775680681890496 -688 0.32745543930198334 -689 0.32715461260264894 -690 0.32685432523822827 -691 0.32655457573167584 -692 0.3262553626115465 -693 0.32595668441196735 -694 0.3256585396726107 -695 0.32536092693866625 -696 0.3250638447608144 -697 0.32476729169519847 -698 0.3244712663033984 -699 0.3241757671524041 -700 0.3238807928145882 -701 0.32358634186768065 -702 0.32329241289474187 -703 0.32299900448413643 -704 0.32270611522950815 -705 0.3224137437297533 -706 0.3221218885889956 -707 0.3218305484165607 -708 0.32153972182695095 -709 0.3212494074398199 -710 0.320959603879948 -711 0.32067030977721706 -712 0.32038152376658613 -713 0.3200932444880666 -714 0.3198054705866983 -715 0.31951820071252474 -716 0.3192314335205693 -717 0.3189451676708114 -718 0.3186594018281623 -719 0.31837413466244235 -720 0.3180893648483562 -721 0.3178050910654704 -722 0.3175213119981899 -723 0.31723802633573495 -724 0.316955232772118 -725 0.31667293000612123 -726 0.31639111674127374 -727 0.3161097916858287 -728 0.3158289535527413 -729 0.3155486010596463 -730 0.31526873292883634 -731 0.31498934788723887 -732 0.3147104446663956 -733 0.3144320220024395 -734 0.31415407863607436 -735 0.3138766133125523 -736 0.3135996247816527 -737 0.31332311179766137 -738 0.3130470731193488 -739 0.3127715075099498 -740 0.312496413737142 -741 0.3122217905730254 -742 0.31194763679410176 -743 0.3116739511812541 -744 0.3114007325197262 -745 0.3111279795991024 -746 0.3108556912132874 -747 0.310583866160486 -748 0.3103125032431839 -749 0.31004160126812674 -750 0.3097711590463018 -751 0.3095011753929171 -752 0.30923164912738277 -753 0.30896257907329133 -754 0.3086939640583986 -755 0.30842580291460436 -756 0.30815809447793374 -757 0.30789083758851776 -758 0.30762403109057496 -759 0.30735767383239243 -760 0.3070917646663073 -761 0.30682630244868847 -762 0.3065612860399177 -763 0.306296714304372 -764 0.3060325861104046 -765 0.305768900330328 -766 0.30550565584039485 -767 0.30524285152078096 -768 0.304980486255567 -769 0.30471855893272104 -770 0.30445706844408094 -771 0.30419601368533694 -772 0.30393539355601423 -773 0.30367520695945566 -774 0.30341545280280474 -775 0.30315612999698804 -776 0.3028972374566991 -777 0.30263877410038054 -778 0.30238073885020794 -779 0.30212313063207297 -780 0.30186594837556674 -781 0.3016091910139632 -782 0.30135285748420293 -783 0.30109694672687665 -784 0.30084145768620885 -785 0.30058638931004206 -786 0.3003317405498202 -787 0.30007751036057334 -788 0.29982369770090106 -789 0.2995703015329571 -790 0.2993173208224336 -791 0.29906475453854525 -792 0.2988126016540142 -793 0.29856086114505387 -794 0.29830953199135457 -795 0.29805861317606724 -796 0.29780810368578886 -797 0.2975580025105472 -798 0.2973083086437855 -799 0.297059021082348 -800 0.2968101388264648 -801 0.2965616608797368 -802 0.29631358624912163 -803 0.29606591394491844 -804 0.2958186429807536 -805 0.2955717723735663 -806 0.29532530114359384 -807 0.29507922831435773 -808 0.29483355291264907 -809 0.29458827396851467 -810 0.29434339051524283 -811 0.2940989015893491 -812 0.293854806230563 -813 0.2936111034818134 -814 0.2933677923892153 -815 0.2931248720020557 -816 0.2928823413727803 -817 0.2926401995569797 -818 0.292398445613376 -819 0.2921570786038094 -820 0.2919160975932247 -821 0.2916755016496583 -822 0.2914352898442247 -823 0.29119546125110335 -824 0.29095601494752615 -825 0.29071695001376363 -826 0.29047826553311235 -827 0.29023996059188234 -828 0.29000203427938387 -829 0.28976448568791496 -830 0.28952731391274866 -831 0.2892905180521204 -832 0.28905409720721553 -833 0.28881805048215686 -834 0.28858237698399214 -835 0.28834707582268215 -836 0.28811214611108754 -837 0.28787758696495763 -838 0.28764339750291784 -839 0.28740957684645724 -840 0.2871761241199174 -841 0.2869430384504794 -842 0.286710318968153 -843 0.28647796480576393 -844 0.2862459750989426 -845 0.2860143489861123 -846 0.2857830856084774 -847 0.2855521841100122 -848 0.2853216436374487 -849 0.2850914633402659 -850 0.28486164237067796 -851 0.28463217988362266 -852 0.2844030750367507 -853 0.2841743269904139 -854 0.28394593490765446 -855 0.2837178979541936 -856 0.28349021529842056 -857 0.28326288611138145 -858 0.2830359095667686 -859 0.2828092848409096 -860 0.28258301111275624 -861 0.2823570875638738 -862 0.28213151337843057 -863 0.28190628774318693 -864 0.28168140984748485 -865 0.28145687888323717 -866 0.2812326940449174 -867 0.28100885452954893 -868 0.28078535953669487 -869 0.28056220826844747 -870 0.2803393999294182 -871 0.2801169337267269 -872 0.27989480886999235 -873 0.27967302457132137 -874 0.27945158004529935 -875 0.2792304745089797 -876 0.27900970718187434 -877 0.2787892772859434 -878 0.27856918404558545 -879 0.27834942668762763 -880 0.27813000444131597 -881 0.2779109165383055 -882 0.27769216221265064 -883 0.2774737407007956 -884 0.27725565124156454 -885 0.2770378930761524 -886 0.27682046544811495 -887 0.27660336760335985 -888 0.2763865987901368 -889 0.2761701582590283 -890 0.27595404526294054 -891 0.27573825905709387 -892 0.2755227988990136 -893 0.2753076640485212 -894 0.2750928537677243 -895 0.2748783673210088 -896 0.2746642039750288 -897 0.27445036299869796 -898 0.27423684366318085 -899 0.2740236452418835 -900 0.27381076701044504 -901 0.27359820824672837 -902 0.27338596823081174 -903 0.2731740462449801 -904 0.2729624415737158 -905 0.27275115350369084 -906 0.2725401813237574 -907 0.2723295243249398 -908 0.27211918180042577 -909 0.2719091530455581 -910 0.271699437357826 -911 0.2714900340368568 -912 0.27128094238440764 -913 0.27107216170435705 -914 0.2708636913026968 -915 0.27065553048752344 -916 0.2704476785690303 -917 0.27024013485949927 -918 0.27003289867329255 -919 0.2698259693268448 -920 0.26961934613865485 -921 0.269413028429278 -922 0.2692070155213177 -923 0.26900130673941763 -924 0.26879590141025433 -925 0.2685907988625287 -926 0.26838599842695854 -927 0.2681814994362706 -928 0.2679773012251932 -929 0.2677734031304478 -930 0.267569804490742 -931 0.2673665046467618 -932 0.2671635029411637 -933 0.26696079871856737 -934 0.2667583913255481 -935 0.26655628011062926 -936 0.2663544644242748 -937 0.26615294361888214 -938 0.26595171704877413 -939 0.26575078407019265 -940 0.2655501440412903 -941 0.26534979632212374 -942 0.2651497402746465 -943 0.26494997526270114 -944 0.26475050065201294 -945 0.26455131581018193 -946 0.2643524201066763 -947 0.2641538129128253 -948 0.2639554936018118 -949 0.26375746154866575 -950 0.26355971613025697 -951 0.2633622567252881 -952 0.2631650827142882 -953 0.26296819347960493 -954 0.26277158840539866 -955 0.26257526687763516 -956 0.2623792282840789 -957 0.2621834720142861 -958 0.26198799745959866 -959 0.2617928040131365 -960 0.2615978910697918 -961 0.2614032580262219 -962 0.26120890428084254 -963 0.2610148292338218 -964 0.26082103228707326 -965 0.26062751284424945 -966 0.2604342703107354 -967 0.2602413040936423 -968 0.2600486136018011 -969 0.259856198245756 -970 0.25966405743775794 -971 0.25947219059175874 -972 0.2592805971234043 -973 0.25908927645002855 -974 0.2588982279906473 -975 0.2587074511659519 -976 0.25851694539830294 -977 0.2583267101117244 -978 0.2581367447318972 -979 0.2579470486861532 -980 0.25775762140346925 -981 0.25756846231446096 -982 0.25737957085137686 -983 0.2571909464480922 -984 0.2570025885401032 -985 0.2568144965645208 -986 0.2566266699600653 -987 0.25643910816705967 -988 0.2562518106274244 -989 0.25606477678467143 -990 0.25587800608389827 -991 0.2556914979717821 -992 0.25550525189657447 -993 0.255319267308095 -994 0.2551335436577262 -995 0.2549480803984073 -996 0.25476287698462907 -997 0.2545779328724277 -998 0.2543932475193798 -999 0.25420882038459613 From 593f0b04003c9da6981c0a434b0db51ebf10d083 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 14:32:57 +0000 Subject: [PATCH 095/120] small bugfix in test_examples.py --- ipi_tests/examples/test_examples.py | 10 ++++++---- 1 file changed, 6 insertions(+), 4 deletions(-) diff --git a/ipi_tests/examples/test_examples.py b/ipi_tests/examples/test_examples.py index f93718a4f..bdcb1b660 100644 --- a/ipi_tests/examples/test_examples.py +++ b/ipi_tests/examples/test_examples.py @@ -16,7 +16,8 @@ examples = [] examples = find_examples(examples_folder, excluded_file, examples) -print("We have found {} examples".format(len(examples))) +if __name__ != "__main__": + print("We have found {} examples".format(len(examples))) @pytest.mark.parametrize("ex", examples) @@ -56,7 +57,7 @@ def test_example(ex, verbose=False): "included in the 'excluded_test.txt' file\n" "\n" "type: python test_examples.py -f \n" - "example python test_examples.py -f examples/MBPOL/splitting> \n" + "example python test_examples.py -f examples/features/ring_polymer_instanton examples/hpc_scripts/slurm \n" "Note that the folder path is referenced to the i-pi root folder \n" "\n" "example: python test_examples.py examples/lammps/h2o-geop\n" @@ -86,8 +87,9 @@ def test_example(ex, verbose=False): try: for folder in args.folder: path = Path(__file__).resolve().parents[2] / folder - examples = find_examples(path, excluded_file, examples) - print("We will run tests in:") + print("Looking for examples inside {}".format(str(path))) + examples.extend(find_examples(path, excluded_file, examples)) + print("\nWe will run tests in:") for i in examples: print(i) print("") From 3fd52df73d51d31983b03276f81c30833e9c788c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 15:04:58 +0000 Subject: [PATCH 096/120] fix implicit_bath automatic test --- .../test_settings.dat | 4 +++ ipi_tests/test_tools.py | 27 +++++++++++++++---- 2 files changed, 26 insertions(+), 5 deletions(-) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/test_settings.dat diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/test_settings.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/test_settings.dat new file mode 100644 index 000000000..8a5bbdb43 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/test_settings.dat @@ -0,0 +1,4 @@ +#Settings file for automatic test +driver_model DW_friction +driver_code python +flags -o 500 2085 1837 0 0.5 0 0 1 diff --git a/ipi_tests/test_tools.py b/ipi_tests/test_tools.py index ea4274c2a..1bbbee832 100644 --- a/ipi_tests/test_tools.py +++ b/ipi_tests/test_tools.py @@ -8,6 +8,7 @@ import glob clean_all = False +debug = False fortran_driver_models = [ "dummy", @@ -28,8 +29,15 @@ "gas", ] -# We should do this automatically but for now I we do it explicitly here -python_driver_models = ["dummy", "harmonic"] +# We should do this automatically but for now we do it explicitly here +python_driver_models = [ + "dummy", + "harmonic", + "DW_friction", + "DW_explicit", + "rascal", + "DoubleWell", +] def get_test_list(parent): @@ -82,14 +90,12 @@ def get_test_settings( block = lines[starts[client] : starts[client + 1]] else: block = lines[starts[client] :] - driver_code = "fortran" driver_model = "dummy" address_name = "localhost" port_number = 33333 socket_mode = "unix" flaglist = {} - for line in block: if "driver_code" in line: driver_code = line.split()[1] @@ -109,8 +115,18 @@ def get_test_settings( # Checking that each driver has appropriate settings, if not, use default. if driver_code == "fortran" and driver_model not in fortran_driver_models: + print( + "{} is not in fortran_driver_model list. We default to dummy".format( + driver_model + ) + ) driver_model = "dummy" elif driver_code == "python" and driver_model not in python_driver_models: + print( + "{} is not in python_driver_model list. We default to dummy".format( + driver_model + ) + ) driver_model = "dummy" elif driver_code not in ["fortran", "python"]: raise ValueError( @@ -335,7 +351,8 @@ def run(self, cwd, nid): cmd += " {} {}".format( client[ll], ",".join(client[ll + 1 :][:]) ) - # print("cmd:", cmd) + if debug: + print(" Client call command:", cmd) driver.append( sp.Popen(cmd, cwd=(cwd), shell=True, stdout=sp.PIPE, stderr=sp.PIPE) ) From d4dd9d7065b7c05e48ea2ff23a04744a69dbaa65 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 16:51:31 +0000 Subject: [PATCH 097/120] fix bugfix with units, no idea how it got there in the first place ... --- drivers/py/pes/doublewell.py | 6 ++---- ipi/engine/motion/instanton.py | 5 ++--- ipi/inputs/motion/instanton.py | 2 +- 3 files changed, 5 insertions(+), 8 deletions(-) diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 017d85014..87b22d2f6 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -28,7 +28,7 @@ def __init__(self, args=None): def check_arguments(self): """Function that checks the arguments required to run the driver""" - self.k = 1836 * (3800.0 / 219323.0) ** 2 + self.k = 1837.36223469 * (3800.0 / 219323.0) ** 2 if self.args == "": # We used Craig's values (J. Chem. Phys. 122, 084106, 2005) w_b = 500 * invcm2au # Tc = 115K @@ -75,7 +75,6 @@ def __call__(self, cell, pos): return pot, force, vir, extras - class DoubleWell_with_friction_driver(DoubleWell_driver): """Adds to the double well potential the calculation of the friction tensor. @@ -95,7 +94,7 @@ def __init__(self, args=None): def check_arguments(self): """Function that checks the arguments required to run the driver""" - self.k = 1836 * (3800.0 / 219323.0) ** 2 + self.k = 1837.36223469 * (3800.0 / 219323.0) ** 2 try: arglist = self.args.split(",") param = list(map(float, arglist)) @@ -224,7 +223,6 @@ def __call__(self, q, x): return pot_bath, fq_bath, fx - class DoubleWell_with_explicit_bath_driver(Dummy_driver): """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index d442d2526..556198c1d 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -476,7 +476,7 @@ def set_fric_spec_dens(self, fric_spec_dens_data, fric_spec_dens_ener): invcm2au = units.unit_to_internal("frequency", "inversecm", 1) # We perform the spline in inversecm for numerical reasons - freq = fric_spec_dens_data[:, 0] / invcm2au + freq = fric_spec_dens_data[:, 0] * invcm2au spline = self.interp1d( freq, fric_spec_dens_data[:, 1], @@ -493,12 +493,11 @@ def set_fric_spec_dens(self, fric_spec_dens_data, fric_spec_dens_ener): # norm = spline(fric_spec_dens_ener / invcm2au) * fric_spec_dens_ener norm = spline(fric_spec_dens_ener / invcm2au) - fric_spec_dens = spline(self.omegak / invcm2au) + fric_spec_dens = spline(self.omegak) LT_fric_spec_dens = fric_spec_dens / norm # LT_fric_spec_dens = LT_friction(self.omegak / invcm2au, spline) / norm self.fric_LTwk = np.multiply(self.omegak, LT_fric_spec_dens)[:, np.newaxis] - info(units.unit_to_user("frequency", "inversecm", self.omegak), verbosity.debug) def get_fric_rp_hessian(self, fric_hessian, eta, SD): diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 1d7d69cb2..cca5abf93 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -144,7 +144,7 @@ class InputInst(InputDictionary): { "dtype": float, "default": input_default(factory=np.ones, args=(0,)), - "help": "Laplace Transform (LT) of friction. A two column data is expected. First column: w (a.u.). Second column: LT(eta)(w)", + "help": "Laplace Transform (LT) of friction. A two column data is expected. First column: w (cm^-1). Second column: LT(eta)(w)", }, ), "fric_spec_dens_ener": ( From dd1cb8ff851cede30ca92fe706f6b5a30c126635 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 17:17:22 +0000 Subject: [PATCH 098/120] lint --- drivers/py/pes/doublewell.py | 2 ++ 1 file changed, 2 insertions(+) diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 87b22d2f6..90dd2610e 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -75,6 +75,7 @@ def __call__(self, cell, pos): return pot, force, vir, extras + class DoubleWell_with_friction_driver(DoubleWell_driver): """Adds to the double well potential the calculation of the friction tensor. @@ -223,6 +224,7 @@ def __call__(self, q, x): return pot_bath, fq_bath, fx + class DoubleWell_with_explicit_bath_driver(Dummy_driver): """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization From 4dc9133304321cd12dac8cf4581dafaa55190a97 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 17:30:17 +0000 Subject: [PATCH 099/120] deprecated driver implemenation of harmonic bath --- drivers/f90/driver.f90 | 4 + .../README.md | 0 .../clean.sh | 0 .../init.xyz | 0 .../input.xml | 0 .../run.sh | 22 + .../README.md | 0 .../clean.sh | 0 .../init.xyz | 0 .../input.xml | 0 .../run.sh | 2 +- .../README.md | 3 + .../clean.sh | 0 .../init.xyz | 60 + .../input.xml | 38 + .../run.sh | 3 +- .../README | 0 .../implicit_bath_pos-dependent/clean.sh | 2 + .../fric_spec_dens.dat | 0 .../init.xyz | 0 .../input.xml | 0 .../implicit_bath_pos-dependent/run.sh | 22 + .../test_settings.dat | 0 .../implicit_bath_pos-independent/README | 7 + .../implicit_bath_pos-independent/clean.sh | 2 + .../fric_spec_dens.dat | 1003 +++++++++++++++++ .../implicit_bath_pos-independent/init.xyz | 96 ++ .../implicit_bath_pos-independent/input.xml | 40 + .../run.sh | 2 +- .../test_settings.dat | 4 + 30 files changed, 1306 insertions(+), 4 deletions(-) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_fortran => explicit_harmonic_bath_pos-dependent_python}/README.md (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_fortran => explicit_harmonic_bath_pos-dependent_python}/clean.sh (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_fortran => explicit_harmonic_bath_pos-dependent_python}/init.xyz (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_fortran => explicit_harmonic_bath_pos-dependent_python}/input.xml (100%) create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_python => explicit_harmonic_bath_pos-independent_fortran}/README.md (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_python => explicit_harmonic_bath_pos-independent_fortran}/clean.sh (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_python => explicit_harmonic_bath_pos-independent_fortran}/init.xyz (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_python => explicit_harmonic_bath_pos-independent_fortran}/input.xml (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_fortran => explicit_harmonic_bath_pos-independent_fortran}/run.sh (72%) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/README.md rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => explicit_harmonic_bath_pos-independent_python}/clean.sh (100%) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/init.xyz create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/input.xml rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{explicit_harmonic_bath_pos_independent_python => explicit_harmonic_bath_pos-independent_python}/run.sh (94%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => implicit_bath_pos-dependent}/README (100%) create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/clean.sh rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => implicit_bath_pos-dependent}/fric_spec_dens.dat (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => implicit_bath_pos-dependent}/init.xyz (100%) rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => implicit_bath_pos-dependent}/input.xml (100%) create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/run.sh rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => implicit_bath_pos-dependent}/test_settings.dat (100%) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/clean.sh create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/fric_spec_dens.dat create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/init.xyz create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/input.xml rename examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/{implicit_bath_pos_independent => implicit_bath_pos-independent}/run.sh (97%) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/test_settings.dat diff --git a/drivers/f90/driver.f90 b/drivers/f90/driver.f90 index 4a5a04342..b2929cd6d 100644 --- a/drivers/f90/driver.f90 +++ b/drivers/f90/driver.f90 @@ -275,6 +275,8 @@ PROGRAM DRIVER ENDIF isinit = .true. ELSEIF (28 == vstyle) THEN !harmonic_bath + WRITE(*,*) "This driver implementation is deprecated. Please use the python driver version " + STOP "ENDED" IF (par_count == 3) THEN ! defaults values vpars(4) = 0 vpars(5) = 0 @@ -293,6 +295,8 @@ PROGRAM DRIVER vpars(3) = vpars(3) * 4.5563353e-06 !Change omega_c from invcm to a.u. isinit = .true. ELSEIF (29 == vstyle) THEN !meanfield bath + WRITE(*,*) "This driver implementation is deprecated. Please use the python driver version " + STOP "ENDED" IF (par_count == 3) THEN ! defaults values vpars(2) = 0 vpars(3) = 0 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/README.md similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/README.md rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/clean.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/clean.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/clean.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/init.xyz similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/init.xyz diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/input.xml similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/input.xml diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh new file mode 100755 index 000000000..5e18e05de --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh @@ -0,0 +1,22 @@ +#Define model parameters + eta=1.5 + + wb=500 + wc=500 + V0=2085 + mass=1837.36223469 + x0=0 + epsilon=-1.0 + delta=0 + deltaQ=1 + + address=localhost + model='DW_explicit' + + +#Launch i-pi and wait + i-pi input.xml & + sleep 3 + +#Launch driver + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/README.md similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/README.md rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/clean.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/clean.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/clean.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/init.xyz similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/init.xyz diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/input.xml similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/input.xml diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh similarity index 72% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh index f6baa79a9..bd72627e3 100755 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_fortran/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh @@ -4,5 +4,5 @@ sleep 2 #Launch Driver #i-pi-driver -u -m harmonic_bath -o 1,1.674,500 - i-pi-driver -u -m harmonic_bath -o 1,0.5,500 + i-pi-driver -u -m harmonic_bath -o 1,1.5,500 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/README.md new file mode 100644 index 000000000..b8e55864d --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/README.md @@ -0,0 +1,3 @@ +Ring Polymer Instanton calculation in a double well potential coupled to an (explicit) harmonic bath + + diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/clean.sh similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/clean.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/clean.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/init.xyz new file mode 100644 index 000000000..322a4c670 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/init.xyz @@ -0,0 +1,60 @@ +4 + +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +H -1.00 0.0 0.0 +4 + +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +H -0.50 0.0 0.0 +4 + +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +H -0.20 0.0 0.0 +4 + +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +H -0.10 0.0 0.0 +4 + +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +H -0.05 0.0 0.0 +4 + +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +H 0.05 0.0 0.0 +4 + +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +H 0.10 0.0 0.0 +4 + +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +H 0.20 0.0 0.0 +4 + +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +H 0.50 0.0 0.0 +4 + +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 +H 1.00 0.0 0.0 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/input.xml new file mode 100644 index 000000000..8cca98ffb --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/input.xml @@ -0,0 +1,38 @@ + + + [ step, potential{electronvolt}] + + 100 + +
localhost
+
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + powell + none + true + true + 0.05 + + + +
diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh similarity index 94% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh index f13d6e938..d09f204c9 100755 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos_independent_python/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh @@ -1,6 +1,5 @@ #Define model parameters - eta=1.674 - eta=0.5 + eta=1.5 wb=500 wc=500 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/README b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/README rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/clean.sh new file mode 100755 index 000000000..4276dd3bf --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/clean.sh @@ -0,0 +1,2 @@ +#Remove simulation output files + rm -f *simulation* *RESTART* diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/fric_spec_dens.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/fric_spec_dens.dat similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/fric_spec_dens.dat rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/fric_spec_dens.dat diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/init.xyz similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/init.xyz rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/init.xyz diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/input.xml similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/input.xml rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/input.xml diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/run.sh new file mode 100755 index 000000000..8bc25bc1e --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/run.sh @@ -0,0 +1,22 @@ +#Define model parameters + eta=1.5 + + wb=500 + wc=500 + V0=2085 + mass=1837.36223469 + x0=0 + epsilon=-1.0 + delta=0 + deltaQ=1 + + address=localhost + model='DW_friction' + + +#Launch i-pi and wait + i-pi input.xml & + sleep 3 + +#Launch driver + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ} -u -a ${address} diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/test_settings.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat similarity index 100% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/test_settings.dat rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README new file mode 100644 index 000000000..de34452dc --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README @@ -0,0 +1,7 @@ + +Commands: + [i-pi] + i-pi input.xml + [driver] + i-pi-driver -u -m meanfield_bath -o 1.67432,0.05,0.00,0.5 + diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/clean.sh new file mode 100755 index 000000000..4276dd3bf --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/clean.sh @@ -0,0 +1,2 @@ +#Remove simulation output files + rm -f *simulation* *RESTART* diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/fric_spec_dens.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/fric_spec_dens.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/fric_spec_dens.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/init.xyz new file mode 100644 index 000000000..f0097d823 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/init.xyz @@ -0,0 +1,96 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8925581 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8772773 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8548895 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7471555 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6984112 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6435957 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.3712966 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2926568 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2111588 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2111588 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2926568 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.3712966 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6435957 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6984112 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7471555 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8548895 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8772773 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8925581 -0.0000000 -0.0000000 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/input.xml new file mode 100644 index 000000000..9bb7391cb --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/input.xml @@ -0,0 +1,40 @@ + + + [ step, potential{electronvolt}] + + 35 + +
localhost
+
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + true + fric_spec_dens.dat + powell + none + true + true + 0.05 + + + +
diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/run.sh similarity index 97% rename from examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh rename to examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/run.sh index 53aec69fd..af0c3bf97 100755 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos_independent/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/run.sh @@ -1,6 +1,6 @@ #Define model parameters eta=1.674 - eta=0.5 + eta=1.5 wb=500 wc=500 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/test_settings.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/test_settings.dat new file mode 100644 index 000000000..8a5bbdb43 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/test_settings.dat @@ -0,0 +1,4 @@ +#Settings file for automatic test +driver_model DW_friction +driver_code python +flags -o 500 2085 1837 0 0.5 0 0 1 From ea9d48e462134077d1337d4f3cbe5cf5513ef482 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 17:31:33 +0000 Subject: [PATCH 100/120] delete fortran example of DW +friction --- .../README.md | 3 - .../clean.sh | 2 - .../init.xyz | 60 ------------------- .../input.xml | 38 ------------ .../run.sh | 8 --- 5 files changed, 111 deletions(-) delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/README.md delete mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/clean.sh delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/init.xyz delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/input.xml delete mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/README.md deleted file mode 100644 index b8e55864d..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/README.md +++ /dev/null @@ -1,3 +0,0 @@ -Ring Polymer Instanton calculation in a double well potential coupled to an (explicit) harmonic bath - - diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/clean.sh deleted file mode 100755 index 4276dd3bf..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/clean.sh +++ /dev/null @@ -1,2 +0,0 @@ -#Remove simulation output files - rm -f *simulation* *RESTART* diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/init.xyz deleted file mode 100644 index 322a4c670..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/init.xyz +++ /dev/null @@ -1,60 +0,0 @@ -4 - -H -1.00 0.0 0.0 -H -1.00 0.0 0.0 -H -1.00 0.0 0.0 -H -1.00 0.0 0.0 -4 - -H -0.50 0.0 0.0 -H -0.50 0.0 0.0 -H -0.50 0.0 0.0 -H -0.50 0.0 0.0 -4 - -H -0.20 0.0 0.0 -H -0.20 0.0 0.0 -H -0.20 0.0 0.0 -H -0.20 0.0 0.0 -4 - -H -0.10 0.0 0.0 -H -0.10 0.0 0.0 -H -0.10 0.0 0.0 -H -0.10 0.0 0.0 -4 - -H -0.05 0.0 0.0 -H -0.05 0.0 0.0 -H -0.05 0.0 0.0 -H -0.05 0.0 0.0 -4 - -H 0.05 0.0 0.0 -H 0.05 0.0 0.0 -H 0.05 0.0 0.0 -H 0.05 0.0 0.0 -4 - -H 0.10 0.0 0.0 -H 0.10 0.0 0.0 -H 0.10 0.0 0.0 -H 0.10 0.0 0.0 -4 - -H 0.20 0.0 0.0 -H 0.20 0.0 0.0 -H 0.20 0.0 0.0 -H 0.20 0.0 0.0 -4 - -H 0.50 0.0 0.0 -H 0.50 0.0 0.0 -H 0.50 0.0 0.0 -H 0.50 0.0 0.0 -4 - -H 1.00 0.0 0.0 -H 1.00 0.0 0.0 -H 1.00 0.0 0.0 -H 1.00 0.0 0.0 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/input.xml deleted file mode 100644 index 8cca98ffb..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/input.xml +++ /dev/null @@ -1,38 +0,0 @@ - - - [ step, potential{electronvolt}] - - 100 - -
localhost
-
- - - init.xyz - [300.0, 300.0, 300.0 ] - - - - - - 100 - - - - -1 - - 5e-6 - 5e-6 - 1e-3 - - 0.1 - nichols - powell - none - true - true - 0.05 - - - -
diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh deleted file mode 100755 index bd72627e3..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_fortran/run.sh +++ /dev/null @@ -1,8 +0,0 @@ - -#Launch i-pi and wait - i-pi input.xml & - sleep 2 -#Launch Driver - #i-pi-driver -u -m harmonic_bath -o 1,1.674,500 - i-pi-driver -u -m harmonic_bath -o 1,1.5,500 - From 23e18e6f303dafb025c98ef65fd3f0bb5c3db8f7 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 19:08:15 +0000 Subject: [PATCH 101/120] extend doc of transfer_forces_manual --- ipi/engine/forces.py | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index 12e81b5a7..a7706db85 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -954,7 +954,9 @@ def transfer_forces_manual( - new_q list of length equal to number of force type, containing the beads positions - new_v list of length equal to number of force type, containing the beads potential energy - new_f list of length equal to number of force type, containing the beads forces - - new_x list of length equal to number of force type, containing the beads extras + - new_extra list of length equal to number of force type, containing the beads extras. + + new_q, new_v, and new_f are list of floats or numpy arrays while new_extra is a list dictionaries """ msg = "Unconsistent dimensions inside transfer_forces_manual" assert len(self.mforces) == len(new_q), msg From b53a099bee83694db037dadd66a05775eb628399 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 19:12:54 +0000 Subject: [PATCH 102/120] fix README DW+friction. update DW no friction example --- .../Rates/Double_well_1D_vanilla/README.md | 3 + .../Rates/Double_well_1D_vanilla/clean.sh | 2 + .../Rates/Double_well_1D_vanilla/init.xyz | 106 ++++++++++++++---- .../Rates/Double_well_1D_vanilla/input.xml | 9 +- .../Rates/Double_well_1D_vanilla/run.sh | 16 ++- .../implicit_bath_pos-dependent/README | 7 -- .../implicit_bath_pos-dependent/README.md | 3 + .../implicit_bath_pos-independent/README | 7 -- .../implicit_bath_pos-independent/README.md | 3 + 9 files changed, 116 insertions(+), 40 deletions(-) create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/README.md create mode 100755 examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/clean.sh delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README.md delete mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README create mode 100644 examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README.md diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/README.md new file mode 100644 index 000000000..6e5fbc68a --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/README.md @@ -0,0 +1,3 @@ +Ring Polymer Instanton calculation in a double well potential + + diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/clean.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/clean.sh new file mode 100755 index 000000000..4276dd3bf --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/clean.sh @@ -0,0 +1,2 @@ +#Remove simulation output files + rm -f *simulation* *RESTART* diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/init.xyz b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/init.xyz index 5e7910a95..f0097d823 100644 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/init.xyz +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/init.xyz @@ -1,30 +1,96 @@ 1 - -H -1.00 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8925581 0.0000000 0.0000000 1 - -H -0.50 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8772773 -0.0000000 0.0000000 1 - -H -0.20 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8548895 -0.0000000 0.0000000 1 - -H -0.10 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8256018 -0.0000000 -0.0000000 1 - -H 0.00 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7896214 -0.0000000 -0.0000000 1 - -H 0.00 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7471555 -0.0000000 -0.0000000 1 - -H 0.10 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6984112 -0.0000000 -0.0000000 1 - -H 0.20 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6435957 -0.0000000 -0.0000000 1 - -H 0.50 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5829855 -0.0000000 -0.0000000 1 - -H 1.00 0.0 0.0 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.3712966 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2926568 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2111588 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2111588 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2926568 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.3712966 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6435957 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6984112 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7471555 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8548895 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8772773 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8925581 -0.0000000 -0.0000000 diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/input.xml b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/input.xml index 161af8767..92a9fb9ee 100644 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/input.xml +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/input.xml @@ -5,10 +5,9 @@ 100
localhost
- 33330
- + init.xyz [300.0, 300.0, 300.0 ] @@ -16,11 +15,11 @@ - 200 + 100 - 1 + -1 5e-6 5e-6 @@ -28,7 +27,7 @@ 0.1 nichols - recompute + powell none true true diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh index d1b3c1e3a..531c01cda 100644 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh @@ -1,2 +1,16 @@ +#Define model parameters -COMPLETE ME + wb=500 + V0=2085 + mass=1837.36223469 + x0=0.00 + address=localhost + model='DoubleWell' + + +#Launch i-pi and wait + i-pi input.xml & + sleep 3 + +#Launch driver + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0} -u -a ${address} diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README deleted file mode 100644 index de34452dc..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README +++ /dev/null @@ -1,7 +0,0 @@ - -Commands: - [i-pi] - i-pi input.xml - [driver] - i-pi-driver -u -m meanfield_bath -o 1.67432,0.05,0.00,0.5 - diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README.md new file mode 100644 index 000000000..41de904a1 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/README.md @@ -0,0 +1,3 @@ +Ring Polymer Instanton calculation in a double well potential coupled to an (implicit) harmonic bath + + diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README deleted file mode 100644 index de34452dc..000000000 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README +++ /dev/null @@ -1,7 +0,0 @@ - -Commands: - [i-pi] - i-pi input.xml - [driver] - i-pi-driver -u -m meanfield_bath -o 1.67432,0.05,0.00,0.5 - diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README.md b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README.md new file mode 100644 index 000000000..41de904a1 --- /dev/null +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-independent/README.md @@ -0,0 +1,3 @@ +Ring Polymer Instanton calculation in a double well potential coupled to an (implicit) harmonic bath + + From b6283eb1c68bce8514600576b09bbe22d5e00ba9 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 19:19:57 +0000 Subject: [PATCH 103/120] add regtest implicit friction --- .../100K_implicit_friction/files_to_check.txt | 7 + .../100K_implicit_friction/fric_spec_dens.dat | 1003 +++++++++++++++++ .../INSTANTON/100K_implicit_friction/init.xyz | 96 ++ .../100K_implicit_friction/input.xml | 41 + .../ref_simulation.instanton_FINAL.hess_15 | 1 + .../ref_simulation.instanton_FINAL_15.xyz | 96 ++ ...f_simulation.instanton_FINAL_forces_15.xyz | 96 ++ ...ref_simulation.instantonfric_FINAL.hess_15 | 1 + .../simulation.instanton_FINAL_15.ener | 33 + .../100K_implicit_friction/test_settings.dat | 6 + 10 files changed, 1380 insertions(+) create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/fric_spec_dens.dat create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/init.xyz create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL.hess_15 create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_15.xyz create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_forces_15.xyz create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instantonfric_FINAL.hess_15 create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/simulation.instanton_FINAL_15.ener create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt new file mode 100644 index 000000000..7e450f8f7 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt @@ -0,0 +1,7 @@ + filename format +------------------------------------------------------------------- +ref_simulation.instanton_FINAL_15.xyz xyz +ref_simulation.instanton_FINAL_forces_15.xyz xyz +ref_simulation.instanton_FINAL.hess_15 numpy +ref_simulation.instantonfric_FINAL.hess_15 numpy +ref_simulation.out numpy diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/fric_spec_dens.dat b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/fric_spec_dens.dat new file mode 100644 index 000000000..88b85ef6d --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/fric_spec_dens.dat @@ -0,0 +1,1003 @@ +#eta 1 +# bath_type Ohmic +# w_c 500 + # freq (cm^-1) Laplace transform +1 0.9915470158218098 +2 0.9848551497951816 +3 0.9788255643617454 +4 0.9732247078293326 +5 0.9679416696883935 +6 0.962911133018018 +7 0.9580899447435153 +8 0.9534474391977994 +9 0.9489606918318892 +10 0.9446119121776004 +11 0.9403868910489187 +12 0.9362740173481964 +13 0.9322636249598021 +14 0.928347541807527 +15 0.9245187684107862 +16 0.9207712425362906 +17 0.9170996629124359 +18 0.9134993545627568 +19 0.9099661641551429 +20 0.9064963774421086 +21 0.9030866532531712 +22 0.8997339700879358 +23 0.8964355824392188 +24 0.8931889847263488 +25 0.8899918812500051 +26 0.8868421609620551 +27 0.8837378761228457 +28 0.8806772241248969 +29 0.8776585319167312 +30 0.874680242577914 +31 0.8717409036863014 +32 0.8688391571880675 +33 0.8659737305354348 +34 0.8631434288998111 +35 0.8603471283020212 +36 0.857583769528487 +37 0.8548523527240882 +38 0.8521519325701771 +39 0.8494816139706848 +40 0.8468405481811211 +41 0.8442279293250585 +42 0.8416429912508109 +43 0.8390850046877706 +44 0.8365532746675381 +45 0.8340471381797273 +46 0.831565962036351 +47 0.8291091409221039 +48 0.8266760956107441 +49 0.824266271330268 +50 0.8218791362616757 +51 0.8195141801579645 +52 0.8171709130715548 +53 0.8148488641797111 +54 0.8125475806987108 +55 0.8102666268785352 +56 0.8080055830707606 +57 0.8057640448631033 +58 0.8035416222747761 +59 0.8013379390074006 +60 0.7991526317467734 +61 0.796985349511237 +62 0.7948357530428389 +63 0.7927035142377412 +64 0.7905883156132424 +65 0.7884898498073732 +66 0.7864078191101018 +67 0.7843419350226136 +68 0.7822919178430147 +69 0.7802574962764451 +70 0.7782384070678282 +71 0.7762343946556395 +72 0.7742452108452136 +73 0.7722706145002324 +74 0.770310371251143 +75 0.76836425321937 +76 0.7664320387562564 +77 0.7645135121957763 +78 0.7626084636201109 +79 0.7607166886372758 +80 0.7588379881700227 +81 0.7569721682553251 +82 0.7551190398537776 +83 0.7532784186683185 +84 0.7514501249717047 +85 0.7496339834422199 +86 0.7478298230071312 +87 0.7460374766934447 +88 0.744256781485537 +89 0.742487578189273 +90 0.740729711302249 +91 0.738983028889811 +92 0.7372473824665428 +93 0.7355226268829143 +94 0.7338086202168218 +95 0.7321052236697538 +96 0.7304123014673415 +97 0.7287297207640642 +98 0.7270573515518944 +99 0.7253950665726847 +100 0.7237427412341026 +101 0.7221002535289383 +102 0.7204674839576208 +103 0.7188443154537764 +104 0.7172306333126927 +105 0.7156263251225384 +106 0.7140312806982176 +107 0.712445392017719 +108 0.7108685531608633 +109 0.7093006602503189 +110 0.7077416113947941 +111 0.7061913066343006 +112 0.7046496478873963 +113 0.7031165389003207 +114 0.701591885197936 +115 0.7000755940363974 +116 0.6985675743574739 +117 0.6970677367444532 +118 0.6955759933795586 +119 0.694092258002813 +120 0.6926164458722978 +121 0.6911484737257331 +122 0.6896882597433415 +123 0.6882357235119293 +124 0.6867907859901439 +125 0.6853533694748546 +126 0.6839233975686164 +127 0.6825007951481693 +128 0.6810854883339358 +129 0.6796774044604751 +130 0.6782764720478581 +131 0.6768826207739282 +132 0.675495781447412 +133 0.6741158859818493 +134 0.6727428673703116 +135 0.6713766596608783 +136 0.6700171979328448 +137 0.6686644182736309 +138 0.6673182577563711 +139 0.665978654418155 +140 0.6646455472388978 +141 0.6633188761208197 +142 0.6619985818685072 +143 0.6606846061695424 +144 0.6593768915756765 +145 0.6580753814845278 +146 0.6567800201217898 +147 0.6554907525239279 +148 0.6542075245213498 +149 0.6529302827220361 +150 0.6516589744956094 +151 0.6503935479578326 +152 0.6491339519555221 +153 0.6478801360518566 +154 0.6466320505120773 +155 0.6453896462895573 +156 0.6441528750122365 +157 0.642921688969405 +158 0.6416960410988252 +159 0.640475884974183 +160 0.6392611747928573 +161 0.6380518653639957 +162 0.6368479120968908 +163 0.635649270989643 +164 0.6344558986181063 +165 0.6332677521251036 +166 0.6320847892099062 +167 0.6309069681179693 +168 0.6297342476309137 +169 0.6285665870567494 +170 0.6274039462203316 +171 0.626246285454043 +172 0.6250935655886968 +173 0.623945747944651 +174 0.6228027943231316 +175 0.6216646669977567 +176 0.6205313287062546 +177 0.6194027426423736 +178 0.6182788724479744 +179 0.6171596822053032 +180 0.6160451364294374 +181 0.6149352000609029 +182 0.6138298384584534 +183 0.6127290173920114 +184 0.6116327030357649 +185 0.610540861961415 +186 0.6094534611315701 +187 0.6083704678932862 +188 0.6072918499717428 +189 0.6062175754640584 +190 0.6051476128332351 +191 0.6040819309022343 +192 0.6030204988481755 +193 0.6019632861966588 +194 0.6009102628162061 +195 0.5998613989128165 +196 0.5988166650246367 +197 0.5977760320167395 +198 0.5967394710760106 +199 0.5957069537061387 +200 0.5946784517227086 +201 0.5936539372483923 +202 0.5926333827082372 +203 0.5916167608250495 +204 0.5906040446148677 +205 0.5895952073825281 +206 0.5885902227173152 +207 0.5875890644887002 +208 0.5865917068421604 +209 0.5855981241950815 +210 0.5846082912327386 +211 0.5836221829043546 +212 0.5826397744192342 +213 0.581661041242972 +214 0.5806859590937321 +215 0.5797145039385988 +216 0.5787466519899951 +217 0.5777823797021695 +218 0.5768216637677468 +219 0.5758644811143447 +220 0.5749108089012515 +221 0.5739606245161651 +222 0.5730139055719944 +223 0.5720706299037137 +224 0.5711307755652795 +225 0.5701943208266014 +226 0.5692612441705648 +227 0.5683315242901118 +228 0.5674051400853706 +229 0.5664820706608363 +230 0.565562295322604 +231 0.5646457935756481 +232 0.5637325451211503 +233 0.5628225298538745 +234 0.5619157278595864 +235 0.5610121194125203 +236 0.5601116849728858 +237 0.5592144051844212 +238 0.5583202608719857 +239 0.5574292330391953 +240 0.5565413028660963 +241 0.5556564517068797 +242 0.5547746610876346 +243 0.5538959127041372 +244 0.5530201884196781 +245 0.5521474702629271 +246 0.5512777404258298 +247 0.5504109812615423 +248 0.549547175282398 +249 0.548686305157909 +250 0.5478283537127981 +251 0.5469733039250656 +252 0.5461211389240842 +253 0.5452718419887275 +254 0.5444253965455269 +255 0.5435817861668577 +256 0.5427409945691563 +257 0.5419030056111626 +258 0.5410678032921926 +259 0.5402353717504378 +260 0.5394056952612899 +261 0.5385787582356935 +262 0.5377545452185236 +263 0.5369330408869883 +264 0.5361142300490556 +265 0.5352980976419066 +266 0.5344846287304097 +267 0.5336738085056196 +268 0.5328656222832998 +269 0.5320600555024659 +270 0.5312570937239519 +271 0.5304567226289982 +272 0.5296589280178607 +273 0.5288636958084402 +274 0.528071012034933 +275 0.527280862846501 +276 0.526493234505962 +277 0.5257081133884988 +278 0.5249254859803876 +279 0.5241453388777454 +280 0.5233676587852939 +281 0.5225924325151446 +282 0.5218196469855986 +283 0.5210492892199644 +284 0.5202813463453946 +285 0.5195158055917365 +286 0.5187526542904008 +287 0.5179918798732471 +288 0.5172334698714828 +289 0.5164774119145797 +290 0.5157236937292059 +291 0.5149723031381711 +292 0.5142232280593879 +293 0.5134764565048479 +294 0.5127319765796108 +295 0.5119897764808087 +296 0.5112498444966641 +297 0.5105121690055203 +298 0.5097767384748864 +299 0.5090435414604948 +300 0.5083125666053719 +301 0.507583802638921 +302 0.5068572383760178 +303 0.5061328627161186 +304 0.5054106646423798 +305 0.5046906332207897 +306 0.5039727575993115 +307 0.5032570270070392 +308 0.5025434307533622 +309 0.5018319582271428 +310 0.5011225988959046 +311 0.5004153423050312 +312 0.49971017807697427 +313 0.49900709591047493 +314 0.49830608557979217 +315 0.497607136933943 +316 0.4969102398959523 +317 0.4962153844621122 +318 0.4955225607012511 +319 0.4948317587540115 +320 0.4941429688321387 +321 0.4934561812177765 +322 0.49277138626277345 +323 0.4920885743879972 +324 0.4914077360826579 +325 0.49072886190364023 +326 0.4900519424748425 +327 0.48937696848652695 +328 0.4887039306946743 +329 0.4880328199203507 +330 0.48736362704907843 +331 0.48669634303021736 +332 0.4860309588763527 +333 0.48536746566269084 +334 0.48470585452646225 +335 0.4840461166663318 +336 0.48338824334181657 +337 0.4827322258727103 +338 0.48207805563851625 +339 0.4814257240778837 +340 0.4807752226880555 +341 0.4801265430243186 +342 0.4794796766994642 +343 0.4788346153832517 +344 0.478191350801881 +345 0.4775498747374702 +346 0.47691017902753985 +347 0.4762722555645029 +348 0.47563609629516157 +349 0.4750016932202088 +350 0.474369038393737 +351 0.4737381239227518 +352 0.4731089419666909 +353 0.4724814847369504 +354 0.4718557444964145 +355 0.471231713558992 +356 0.4706093842891585 +357 0.46998874910150146 +358 0.46936980046027404 +359 0.46875253087895113 +360 0.4681369329197923 +361 0.4675229991934086 +362 0.4669107223583348 +363 0.46630009512060633 +364 0.4656911102333418 +365 0.46508376049632844 +366 0.4644780387556143 +367 0.4638739379031033 +368 0.46327145087615657 +369 0.4626705706571957 +370 0.4620712902733141 +371 0.46147360279588856 +372 0.46087750134019834 +373 0.4602829790650468 +374 0.4596900291723878 +375 0.4590986449069562 +376 0.45850881955590195 +377 0.45792054644842906 +378 0.4573338189554377 +379 0.45674863048917047 +380 0.45616497450286275 +381 0.4555828444903966 +382 0.4550022339859583 +383 0.45442313656369987 +384 0.4538455458374046 +385 0.45326945546015474 +386 0.4526948591240039 +387 0.45212175055965415 +388 0.45155012353613266 +389 0.4509799718604769 +390 0.4504112893774181 +391 0.44984406996907317 +392 0.44927830755463477 +393 0.44871399609006835 +394 0.4481511295678115 +395 0.44758970201647463 +396 0.4470297075005478 +397 0.44647114012010813 +398 0.4459139940105313 +399 0.445358263342206 +400 0.4448039423202515 +401 0.4442510251842373 +402 0.4436995062079068 +403 0.4431493796989029 +404 0.44260063999849697 +405 0.4420532814813202 +406 0.4415072985550987 +407 0.44096268566038893 +408 0.4404194372703193 +409 0.4398775478903305 +410 0.4393370120579223 +411 0.4387978243423998 +412 0.43825997934462363 +413 0.4377234716967632 +414 0.43718829606205123 +415 0.43665444713454066 +416 0.4361219196388661 +417 0.4355907083300043 +418 0.4350608079930402 +419 0.43453221344293347 +420 0.4340049195242877 +421 0.43347892111112174 +422 0.43295421310664406 +423 0.43243079044302857 +424 0.43190864808119267 +425 0.43138778101057784 +426 0.43086818424893225 +427 0.43034985284209504 +428 0.4298327818637838 +429 0.42931696641538275 +430 0.4288024016257333 +431 0.4282890826509284 +432 0.4277770046741056 +433 0.4272661629052452 +434 0.4267565525809683 +435 0.426248168964338 +436 0.4257410073446616 +437 0.4252350630372958 +438 0.42473033138345195 +439 0.42422680775000515 +440 0.42372448752930386 +441 0.4232233661389823 +442 0.4227234390217727 +443 0.42222470164532216 +444 0.4217271495020085 +445 0.42123077810876014 +446 0.4207355830068754 +447 0.42024155976184563 +448 0.419748703963178 +449 0.4192570112242222 +450 0.4187664771819965 +451 0.41827709749701647 +452 0.4177888678531257 +453 0.41730178395732725 +454 0.4168158415396169 +455 0.4163310363528185 +456 0.4158473641724194 +457 0.41536482079640946 +458 0.4148834020451197 +459 0.41440310376106304 +460 0.41392392180877696 +461 0.4134458520746668 +462 0.41296889046685104 +463 0.4124930329150079 +464 0.4120182753702229 +465 0.41154461380483826 +466 0.41107204421230364 +467 0.4106005626070276 +468 0.41013016502423144 +469 0.4096608475198032 +470 0.4091926061701538 +471 0.4087254370720742 +472 0.40825933634259365 +473 0.40779430011883927 +474 0.407330324557897 +475 0.40686740583667413 +476 0.40640554015176156 +477 0.40594472371929935 +478 0.4054849527748419 +479 0.40502622357322515 +480 0.40456853238843427 +481 0.40411187551347244 +482 0.4036562492602327 +483 0.4032016499593676 +484 0.40274807396016254 +485 0.40229551763040994 +486 0.401843977356283 +487 0.4013934495422118 +488 0.40094393061076083 +489 0.40049541700250596 +490 0.4000479051759142 +491 0.39960139160722313 +492 0.3991558727903225 +493 0.39871134523663565 +494 0.39826780547500285 +495 0.3978252500515656 +496 0.3973836755296513 +497 0.3969430784896594 +498 0.39650345552894783 +499 0.39606480326172205 +500 0.39562711831892267 +501 0.3951903973481156 +502 0.39475463701338354 +503 0.3943198339952161 +504 0.39388598499040356 +505 0.39345308671192963 +506 0.39302113588886617 +507 0.3925901292662675 +508 0.39216006360506744 +509 0.39173093568197576 +510 0.39130274228937556 +511 0.39087548023522245 +512 0.3904491463429436 +513 0.3900237374513377 +514 0.38959925041447707 +515 0.389175682101608 +516 0.38875302939705453 +517 0.38833128920012144 +518 0.38791045842499833 +519 0.3874905340006655 +520 0.3870715128707984 +521 0.3866533919936748 +522 0.3862361683420825 +523 0.38581983890322674 +524 0.385404400678639 +525 0.38498985068408675 +526 0.3845761859494836 +527 0.38416340351880035 +528 0.38375150044997597 +529 0.38334047381483105 +530 0.3829303206989799 +531 0.3825210382017448 +532 0.38211262343607033 +533 0.38170507352843797 +534 0.38129838561878276 +535 0.3808925568604089 +536 0.38048758441990777 +537 0.38008346547707406 +538 0.3796801972248261 +539 0.37927777686912334 +540 0.3788762016288872 +541 0.37847546873592014 +542 0.3780755754348275 +543 0.37767651898293847 +544 0.3772782966502284 +545 0.3768809057192419 +546 0.3764843434850152 +547 0.37608860725500115 +548 0.37569369434899286 +549 0.3752996020990492 +550 0.3749063278494206 +551 0.37451386895647465 +552 0.37412222278862356 +553 0.373731386726251 +554 0.3733413581616405 +555 0.3729521344989033 +556 0.3725637131539079 +557 0.3721760915542089 +558 0.37178926713897814 +559 0.3714032373589341 +560 0.37101799967627386 +561 0.37063355156460415 +562 0.37024989050887425 +563 0.3698670140053074 +564 0.36948491956133556 +565 0.36910360469553166 +566 0.36872306693754475 +567 0.3683433038280338 +568 0.36796431291860365 +569 0.3675860917717399 +570 0.36720863796074577 +571 0.366831949069678 +572 0.36645602269328403 +573 0.3660808564369399 +574 0.36570644791658763 +575 0.36533279475867425 +576 0.36495989460009 +577 0.3645877450881084 +578 0.36421634388032514 +579 0.3638456886445993 +580 0.36347577705899325 +581 0.36310660681171375 +582 0.36273817560105387 +583 0.3623704811353349 +584 0.36200352113284795 +585 0.3616372933217977 +586 0.361271795440245 +587 0.3609070252360509 +588 0.36054298046682 +589 0.36017965889984516 +590 0.3598170583120531 +591 0.35945517648994796 +592 0.3590940112295585 +593 0.3587335603363829 +594 0.35837382162533604 +595 0.3580147929206956 +596 0.35765647205604956 +597 0.3572988568742431 +598 0.35694194522732786 +599 0.3565857349765085 +600 0.3562302239920924 +601 0.35587541015343827 +602 0.3555212913489055 +603 0.3551678654758042 +604 0.3548151304403445 +605 0.35446308415758787 +606 0.3541117245513971 +607 0.3537610495543878 +608 0.3534110571078797 +609 0.35306174516184863 +610 0.3527131116748783 +611 0.3523651546141128 +612 0.3520178719552097 +613 0.35167126168229296 +614 0.3513253217879061 +615 0.3509800502729663 +616 0.3506354451467184 +617 0.35029150442668927 +618 0.3499482261386421 +619 0.34960560831653265 +620 0.3492636490024624 +621 0.3489223462466368 +622 0.3485816981073192 +623 0.34824170265078774 +624 0.34790235795129204 +625 0.3475636620910101 +626 0.3472256131600049 +627 0.3468882092561822 +628 0.3465514484852485 +629 0.3462153289606681 +630 0.3458798488036226 +631 0.34554500614296846 +632 0.3452107991151962 +633 0.3448772258643897 +634 0.34454428454218505 +635 0.34421197330773123 +636 0.34388029032764894 +637 0.3435492337759909 +638 0.3432188018342032 +639 0.3428889926910855 +640 0.3425598045427515 +641 0.342231235592591 +642 0.34190328405123144 +643 0.3415759481364984 +644 0.3412492260733795 +645 0.3409231160939852 +646 0.3405976164375119 +647 0.3402727253502047 +648 0.33994844108532046 +649 0.3396247619030907 +650 0.3393016860706855 +651 0.33897921186217694 +652 0.33865733755850347 +653 0.33833606144743356 +654 0.3380153818235307 +655 0.3376952969881176 +656 0.33737580524924166 +657 0.3370569049216394 +658 0.33673859432670233 +659 0.3364208717924425 +660 0.3361037356534581 +661 0.33578718425089965 +662 0.33547121593243634 +663 0.3351558290522219 +664 0.33484102197086224 +665 0.33452679305538185 +666 0.3342131406791904 +667 0.3339000632220512 +668 0.33358755907004783 +669 0.3332756266155521 +670 0.3329642642571924 +671 0.33265347039982107 +672 0.33234324345448363 +673 0.3320335818383867 +674 0.3317244839748669 +675 0.3314159482933603 +676 0.3311079732293706 +677 0.3308005572244392 +678 0.33049369872611495 +679 0.33018739618792325 +680 0.32988164806933584 +681 0.32957645283574216 +682 0.329271808958418 +683 0.32896771491449733 +684 0.32866416918694225 +685 0.3283611702645137 +686 0.3280587166417438 +687 0.32775680681890496 +688 0.32745543930198334 +689 0.32715461260264894 +690 0.32685432523822827 +691 0.32655457573167584 +692 0.3262553626115465 +693 0.32595668441196735 +694 0.3256585396726107 +695 0.32536092693866625 +696 0.3250638447608144 +697 0.32476729169519847 +698 0.3244712663033984 +699 0.3241757671524041 +700 0.3238807928145882 +701 0.32358634186768065 +702 0.32329241289474187 +703 0.32299900448413643 +704 0.32270611522950815 +705 0.3224137437297533 +706 0.3221218885889956 +707 0.3218305484165607 +708 0.32153972182695095 +709 0.3212494074398199 +710 0.320959603879948 +711 0.32067030977721706 +712 0.32038152376658613 +713 0.3200932444880666 +714 0.3198054705866983 +715 0.31951820071252474 +716 0.3192314335205693 +717 0.3189451676708114 +718 0.3186594018281623 +719 0.31837413466244235 +720 0.3180893648483562 +721 0.3178050910654704 +722 0.3175213119981899 +723 0.31723802633573495 +724 0.316955232772118 +725 0.31667293000612123 +726 0.31639111674127374 +727 0.3161097916858287 +728 0.3158289535527413 +729 0.3155486010596463 +730 0.31526873292883634 +731 0.31498934788723887 +732 0.3147104446663956 +733 0.3144320220024395 +734 0.31415407863607436 +735 0.3138766133125523 +736 0.3135996247816527 +737 0.31332311179766137 +738 0.3130470731193488 +739 0.3127715075099498 +740 0.312496413737142 +741 0.3122217905730254 +742 0.31194763679410176 +743 0.3116739511812541 +744 0.3114007325197262 +745 0.3111279795991024 +746 0.3108556912132874 +747 0.310583866160486 +748 0.3103125032431839 +749 0.31004160126812674 +750 0.3097711590463018 +751 0.3095011753929171 +752 0.30923164912738277 +753 0.30896257907329133 +754 0.3086939640583986 +755 0.30842580291460436 +756 0.30815809447793374 +757 0.30789083758851776 +758 0.30762403109057496 +759 0.30735767383239243 +760 0.3070917646663073 +761 0.30682630244868847 +762 0.3065612860399177 +763 0.306296714304372 +764 0.3060325861104046 +765 0.305768900330328 +766 0.30550565584039485 +767 0.30524285152078096 +768 0.304980486255567 +769 0.30471855893272104 +770 0.30445706844408094 +771 0.30419601368533694 +772 0.30393539355601423 +773 0.30367520695945566 +774 0.30341545280280474 +775 0.30315612999698804 +776 0.3028972374566991 +777 0.30263877410038054 +778 0.30238073885020794 +779 0.30212313063207297 +780 0.30186594837556674 +781 0.3016091910139632 +782 0.30135285748420293 +783 0.30109694672687665 +784 0.30084145768620885 +785 0.30058638931004206 +786 0.3003317405498202 +787 0.30007751036057334 +788 0.29982369770090106 +789 0.2995703015329571 +790 0.2993173208224336 +791 0.29906475453854525 +792 0.2988126016540142 +793 0.29856086114505387 +794 0.29830953199135457 +795 0.29805861317606724 +796 0.29780810368578886 +797 0.2975580025105472 +798 0.2973083086437855 +799 0.297059021082348 +800 0.2968101388264648 +801 0.2965616608797368 +802 0.29631358624912163 +803 0.29606591394491844 +804 0.2958186429807536 +805 0.2955717723735663 +806 0.29532530114359384 +807 0.29507922831435773 +808 0.29483355291264907 +809 0.29458827396851467 +810 0.29434339051524283 +811 0.2940989015893491 +812 0.293854806230563 +813 0.2936111034818134 +814 0.2933677923892153 +815 0.2931248720020557 +816 0.2928823413727803 +817 0.2926401995569797 +818 0.292398445613376 +819 0.2921570786038094 +820 0.2919160975932247 +821 0.2916755016496583 +822 0.2914352898442247 +823 0.29119546125110335 +824 0.29095601494752615 +825 0.29071695001376363 +826 0.29047826553311235 +827 0.29023996059188234 +828 0.29000203427938387 +829 0.28976448568791496 +830 0.28952731391274866 +831 0.2892905180521204 +832 0.28905409720721553 +833 0.28881805048215686 +834 0.28858237698399214 +835 0.28834707582268215 +836 0.28811214611108754 +837 0.28787758696495763 +838 0.28764339750291784 +839 0.28740957684645724 +840 0.2871761241199174 +841 0.2869430384504794 +842 0.286710318968153 +843 0.28647796480576393 +844 0.2862459750989426 +845 0.2860143489861123 +846 0.2857830856084774 +847 0.2855521841100122 +848 0.2853216436374487 +849 0.2850914633402659 +850 0.28486164237067796 +851 0.28463217988362266 +852 0.2844030750367507 +853 0.2841743269904139 +854 0.28394593490765446 +855 0.2837178979541936 +856 0.28349021529842056 +857 0.28326288611138145 +858 0.2830359095667686 +859 0.2828092848409096 +860 0.28258301111275624 +861 0.2823570875638738 +862 0.28213151337843057 +863 0.28190628774318693 +864 0.28168140984748485 +865 0.28145687888323717 +866 0.2812326940449174 +867 0.28100885452954893 +868 0.28078535953669487 +869 0.28056220826844747 +870 0.2803393999294182 +871 0.2801169337267269 +872 0.27989480886999235 +873 0.27967302457132137 +874 0.27945158004529935 +875 0.2792304745089797 +876 0.27900970718187434 +877 0.2787892772859434 +878 0.27856918404558545 +879 0.27834942668762763 +880 0.27813000444131597 +881 0.2779109165383055 +882 0.27769216221265064 +883 0.2774737407007956 +884 0.27725565124156454 +885 0.2770378930761524 +886 0.27682046544811495 +887 0.27660336760335985 +888 0.2763865987901368 +889 0.2761701582590283 +890 0.27595404526294054 +891 0.27573825905709387 +892 0.2755227988990136 +893 0.2753076640485212 +894 0.2750928537677243 +895 0.2748783673210088 +896 0.2746642039750288 +897 0.27445036299869796 +898 0.27423684366318085 +899 0.2740236452418835 +900 0.27381076701044504 +901 0.27359820824672837 +902 0.27338596823081174 +903 0.2731740462449801 +904 0.2729624415737158 +905 0.27275115350369084 +906 0.2725401813237574 +907 0.2723295243249398 +908 0.27211918180042577 +909 0.2719091530455581 +910 0.271699437357826 +911 0.2714900340368568 +912 0.27128094238440764 +913 0.27107216170435705 +914 0.2708636913026968 +915 0.27065553048752344 +916 0.2704476785690303 +917 0.27024013485949927 +918 0.27003289867329255 +919 0.2698259693268448 +920 0.26961934613865485 +921 0.269413028429278 +922 0.2692070155213177 +923 0.26900130673941763 +924 0.26879590141025433 +925 0.2685907988625287 +926 0.26838599842695854 +927 0.2681814994362706 +928 0.2679773012251932 +929 0.2677734031304478 +930 0.267569804490742 +931 0.2673665046467618 +932 0.2671635029411637 +933 0.26696079871856737 +934 0.2667583913255481 +935 0.26655628011062926 +936 0.2663544644242748 +937 0.26615294361888214 +938 0.26595171704877413 +939 0.26575078407019265 +940 0.2655501440412903 +941 0.26534979632212374 +942 0.2651497402746465 +943 0.26494997526270114 +944 0.26475050065201294 +945 0.26455131581018193 +946 0.2643524201066763 +947 0.2641538129128253 +948 0.2639554936018118 +949 0.26375746154866575 +950 0.26355971613025697 +951 0.2633622567252881 +952 0.2631650827142882 +953 0.26296819347960493 +954 0.26277158840539866 +955 0.26257526687763516 +956 0.2623792282840789 +957 0.2621834720142861 +958 0.26198799745959866 +959 0.2617928040131365 +960 0.2615978910697918 +961 0.2614032580262219 +962 0.26120890428084254 +963 0.2610148292338218 +964 0.26082103228707326 +965 0.26062751284424945 +966 0.2604342703107354 +967 0.2602413040936423 +968 0.2600486136018011 +969 0.259856198245756 +970 0.25966405743775794 +971 0.25947219059175874 +972 0.2592805971234043 +973 0.25908927645002855 +974 0.2588982279906473 +975 0.2587074511659519 +976 0.25851694539830294 +977 0.2583267101117244 +978 0.2581367447318972 +979 0.2579470486861532 +980 0.25775762140346925 +981 0.25756846231446096 +982 0.25737957085137686 +983 0.2571909464480922 +984 0.2570025885401032 +985 0.2568144965645208 +986 0.2566266699600653 +987 0.25643910816705967 +988 0.2562518106274244 +989 0.25606477678467143 +990 0.25587800608389827 +991 0.2556914979717821 +992 0.25550525189657447 +993 0.255319267308095 +994 0.2551335436577262 +995 0.2549480803984073 +996 0.25476287698462907 +997 0.2545779328724277 +998 0.2543932475193798 +999 0.25420882038459613 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/init.xyz b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/init.xyz new file mode 100644 index 000000000..f0097d823 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/init.xyz @@ -0,0 +1,96 @@ +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8925581 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8772773 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8548895 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.7471555 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6984112 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.6435957 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.3712966 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2926568 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.2111588 0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H -0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.0426670 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.1275639 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2111588 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.2926568 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.3712966 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.4463187 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5170562 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.5829855 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6435957 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.6984112 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7471555 -0.0000000 0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.7896214 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8256018 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8548895 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8772773 -0.0000000 -0.0000000 +1 +CELL(abcABC): 300.0 300.0 300.0 90.0 90.0 90.0 cell{atomic_unit} Traj: positions{angstrom} +H 0.8925581 -0.0000000 -0.0000000 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml new file mode 100644 index 000000000..b1cced15d --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml @@ -0,0 +1,41 @@ + + + [ step, potential{electronvolt}] + + 35 + +
localhost
+ 33330 +
+ + + init.xyz + [300.0, 300.0, 300.0 ] + + + + + + 100 + + + + -1 + + 5e-6 + 5e-6 + 1e-3 + + 0.1 + nichols + true + fric_spec_dens.dat + powell + none + true + true + 0.05 + + + +
diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL.hess_15 b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL.hess_15 new file mode 100644 index 000000000..b5e158708 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL.hess_15 @@ -0,0 +1 @@ +-5.918773874052235540e-04 0.000000000000000000e+00 0.000000000000000000e+00 -7.654332175397599025e-04 0.000000000000000000e+00 0.000000000000000000e+00 -1.106402061054004987e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.602518890729716372e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.235485835132711846e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.981222788153367609e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.810404775525522147e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.689419742683314379e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.581844783437810154e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.450441980960803373e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.259515764712967667e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.977285940947726611e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.577793448197616397e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.041874179164599915e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.356979655884377703e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.516049055533121886e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.516049055615304411e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.356979656113036808e-03 0.000000000000000000e+00 0.000000000000000000e+00 -9.041874179489860566e-03 0.000000000000000000e+00 0.000000000000000000e+00 -8.577793448552150507e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.977285941260410518e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.259515764925037612e-03 0.000000000000000000e+00 0.000000000000000000e+00 -6.450441981036263844e-03 0.000000000000000000e+00 0.000000000000000000e+00 -5.581844783360181278e-03 0.000000000000000000e+00 0.000000000000000000e+00 -4.689419742459101370e-03 0.000000000000000000e+00 0.000000000000000000e+00 -3.810404775176842729e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.981222787707109995e-03 0.000000000000000000e+00 0.000000000000000000e+00 -2.235485834620534740e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.602518890174171179e-03 0.000000000000000000e+00 0.000000000000000000e+00 -1.106402060475474708e-03 0.000000000000000000e+00 0.000000000000000000e+00 -7.654332169477855163e-04 0.000000000000000000e+00 0.000000000000000000e+00 -5.918773868110807634e-04 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 -8.673617379884035472e-16 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 5.515610927850894685e-01 0.000000000000000000e+00 0.000000000000000000e+00 -1.880790961315660013e-33 5.515610927850894685e-01 0.000000000000000000e+00 -2.068870057447226014e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.880790961315660013e-33 5.515610927850894685e-01 0.000000000000000000e+00 -5.172175143618065035e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.857281074299214263e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.880790961315660013e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.880790961315660013e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.874913489561548575e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.880790961315660013e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.857281074299214263e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.870505385745964997e-33 5.515610927850894685e-01 0.000000000000000000e+00 1.445858051511413635e-33 5.515610927850894685e-01 0.000000000000000000e+00 1.448429445403837389e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.871974753684492856e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.870505385745964997e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.874913489561548575e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.870505385745964997e-33 5.515610927850894685e-01 0.000000000000000000e+00 1.447878432426889441e-33 5.515610927850894685e-01 0.000000000000000000e+00 1.448062103419205424e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.871974753684492856e-33 5.515610927850894685e-01 0.000000000000000000e+00 1.445858051511413635e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.871791082692176874e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.871607411699860892e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.863158546053325700e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.869036017807437138e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.880790961315660013e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.857281074299214263e-33 5.515610927850894685e-01 0.000000000000000000e+00 1.434103108003190760e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.869036017807437138e-33 5.515610927850894685e-01 8.673617379884035472e-16 -1.857281074299214263e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.869036017807437138e-33 5.515610927850894685e-01 0.000000000000000000e+00 -1.869036017807437138e-33 5.515610927850894685e-01 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_15.xyz b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_15.xyz new file mode 100644 index 000000000..bdbd58018 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_15.xyz @@ -0,0 +1,96 @@ +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 0 +H -0.5432710665667425 -3.565031817257117e-21 4.527467049311617e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 1 +H -0.5385321677790527 -2.0795836247062185e-21 1.1128521617948034e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 2 +H -0.5290610113960423 -1.4756862718535323e-21 1.0010899922189438e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 3 +H -0.5148734442550058 -7.4875459286013515e-22 1.9182631645292928e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 4 +H -0.49599953417105735 -3.2988878238849484e-22 4.9691419192021055e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 5 +H -0.47249079765960916 -3.1572446236595216e-22 -1.1746380051295387e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 6 +H -0.44442925627014934 -2.972986320424692e-22 -1.9495170996897458e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 7 +H -0.411937767856302 4.81339775063261e-23 -5.022496152642386e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 8 +H -0.3751908878785818 4.376934841848797e-22 -7.694178706513528e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 9 +H -0.3344253171366415 2.9868593696264273e-22 -6.2245284340227935e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 10 +H -0.2899488137151837 2.330237803009859e-23 -1.6807667802718648e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 11 +H -0.24214633163583157 4.600429797711762e-23 -7.354209654005158e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 12 +H -0.19148215380802114 3.644373194690687e-24 -5.305174493155853e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 13 +H -0.1384969735592811 -8.349128927992929e-24 -2.8724042229046035e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 14 +H -0.08379929172667208 2.1993235826996966e-23 -1.523565920788758e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 15 +H -0.028051132723939998 3.7017235098042995e-23 -1.4427963872440243e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 16 +H 0.028051132748580097 2.3718621102930301e-23 8.128302471926449e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 17 +H 0.08379929175099782 -2.5334653129643496e-24 3.054255145138245e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 18 +H 0.1384969735829763 -9.237314229520721e-24 1.6541441393158643e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 19 +H 0.1914821538307557 -3.0730033751617526e-23 -8.151893559016522e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 20 +H 0.24214633165728514 -3.285084347152289e-23 -1.430425621054776e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 21 +H 0.2899488137350348 1.246021978677988e-24 -1.4115421920533226e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 22 +H 0.3344253171546121 3.7967973718154315e-24 -1.4684756703638733e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 23 +H 0.3751908878944395 -6.35210098499503e-23 -1.7629060519793755e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 24 +H 0.4119377678699092 -1.9222551373788175e-22 1.1948343065970814e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 25 +H 0.44442925628145047 -2.7145581889814877e-22 1.0046938320735108e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 26 +H 0.47249079766866403 -3.378814605467451e-22 2.8733421894184804e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 27 +H 0.4959995341780281 -3.0997852008941824e-22 -4.678851998130442e-25 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 28 +H 0.5148734442601679 -1.5076970704432161e-22 -5.949776411671422e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 29 +H 0.5290610113997589 -1.1209053239104121e-22 -9.208231668152898e-26 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 30 +H 0.5385321677817629 -1.5347628061991316e-22 5.337347679613926e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{angstrom} Bead: 31 +H 0.5432710665689344 -1.5033442625739186e-22 -7.783378997741528e-24 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_forces_15.xyz b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_forces_15.xyz new file mode 100644 index 000000000..43b1a30f4 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instanton_FINAL_forces_15.xyz @@ -0,0 +1,96 @@ +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 0 +H -0.0072005885350986815 3.7158304983702744e-21 -4.718976156331245e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 1 +H -0.0071823630891583575 2.1675487492675736e-21 -1.1599251324931963e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 2 +H -0.00714243663598649 1.5381069050874647e-21 -1.043435491008446e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 3 +H -0.007074049858750886 7.804264574797333e-22 -1.9994045315820928e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 4 +H -0.006967556099659888 3.4384287756862844e-22 -5.179333605024509e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 5 +H -0.006811043103462578 3.290794154099834e-22 1.2243244794834222e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 6 +H -0.0065911992272667036 3.098741836523405e-22 2.031980489221834e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 7 +H -0.006294428348777543 -5.0170015526954203e-23 5.234944690141584e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 8 +H -0.0059081873721015775 -4.562076527898839e-22 8.019637793743746e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 9 +H -0.005422475405534588 -3.1132017072823884e-22 6.487822207126947e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 10 +H -0.0048313497775627325 -2.4288054471113553e-23 1.7518621944830098e-22 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 11 +H -0.004134291855790857 -4.795025184684313e-23 7.665288256750107e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 12 +H -0.0033372107695203313 -3.798527967891653e-24 5.52958015281097e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 13 +H -0.0024528731452899155 8.702292011893182e-24 2.9939051773536274e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 14 +H -0.0015005956146465777 -2.2923536347757394e-23 1.5880118340991937e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 15 +H -0.0005051368589890074 -3.858304166510343e-23 1.5038257983303533e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 16 +H 0.0005051368594320931 -2.4721904373175134e-23 -8.472124730825218e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 17 +H 0.0015005956150766617 2.6406293573332143e-24 -3.183448283174327e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 18 +H 0.002452873145694894 9.62804701235217e-24 -1.7241134319803572e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 19 +H 0.0033372107698896336 3.202989551943538e-23 8.496713706574232e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 20 +H 0.004134291856116516 3.424041420269573e-23 1.4909317562430705e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 21 +H 0.004831349777839605 -1.298727951767231e-24 1.4712495696612415e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 22 +H 0.005422475405761055 -3.957399595153843e-24 1.5305912995332106e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 23 +H 0.0059081873722791915 6.62079099954077e-23 1.8374759075071808e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 24 +H 0.006294428348910884 2.0035653624591483e-22 -1.2453750722394542e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 25 +H 0.006591199227362212 2.829382352042753e-22 -1.0471917711005394e-23 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 26 +H 0.006811043103527816 3.521736411596627e-22 -2.99488281928149e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 27 +H 0.006967556099702421 3.2309042326420035e-22 4.876764596561214e-25 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 28 +H 0.007074049858777612 1.571471741019911e-22 6.201448341064897e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 29 +H 0.007142436636003065 1.1683189384762582e-22 9.597734276297986e-26 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 30 +H 0.007182363089169116 1.5996823409634594e-22 -5.563114245520034e-24 +1 +CELL(abcABC): 300.000000 300.000000 300.000000 90.000000 90.000000 90.000000 cell{atomic_unit} Traj: positions{atomic_unit} Bead: 31 +H 0.007200588535106839 1.566934812020852e-22 8.112611203126533e-24 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instantonfric_FINAL.hess_15 b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instantonfric_FINAL.hess_15 new file mode 100644 index 000000000..dde035060 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.instantonfric_FINAL.hess_15 @@ -0,0 +1 @@ +-3.651235203292246823e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.649103286959443082e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.639009079483779274e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.609437757990274775e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.543738409823804503e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.421564108718189168e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.221828078744548574e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.927677807669892829e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.533380712037014426e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.051762084434360922e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.519146904263288134e+00 -4.163336342344337027e-14 4.163336342344337027e-14 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -9.935415675856734685e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.426119896656672603e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.221146788218136825e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.195668765484986323e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.004514664950420889e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.004514670218881037e-03 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.195668769915166851e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.221146789292702539e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 5.426119898375887374e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 9.935415678028954867e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 1.519146904495283223e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.051762084651492568e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.533380712217814246e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 2.927677807805006971e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.221828078835531350e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.421564108773256230e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.543738409853225413e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.609437758004041541e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.639009079489663456e+00 1.110223024625156540e-13 -1.110223024625156540e-13 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.649103286961219439e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 3.651235203293023979e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/simulation.instanton_FINAL_15.ener b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/simulation.instanton_FINAL_15.ener new file mode 100644 index 000000000..6a2a6e394 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/simulation.instanton_FINAL_15.ener @@ -0,0 +1,33 @@ +#Bead Energy (eV) +0 -0.11866259790715851 +1 -0.11691012681205774 +2 -0.11342166079444242 +3 -0.1082351949410836 +4 -0.10141984639090063 +5 -0.09308898239047224 +6 -0.08341517679588735 +7 -0.0726445585426023 +8 -0.06110741669327686 +9 -0.049221487325502286 +10 -0.03748445701371601 +11 -0.026453159043353814 +12 -0.016708861462551 +13 -0.008810819030011201 +14 -0.0032433701350644724 +15 -0.0003644451312916968 +16 -0.0003644451319317277 +17 -0.0032433701369415356 +18 -0.008810819032999921 +19 -0.016708861466452396 +20 -0.026453159047914718 +21 -0.03748445701864777 +22 -0.04922148733051311 +23 -0.06110741669809458 +24 -0.07264455854700659 +25 -0.0834151767997177 +26 -0.09308898239364362 +27 -0.10141984639339816 +28 -0.10823519494296141 +29 -0.11342166079580748 +30 -0.11691012681305872 +31 -0.11866259790797011 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat new file mode 100644 index 000000000..d06a23737 --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat @@ -0,0 +1,6 @@ +driver_model DW_friction +driver_code python +flags -o 500 2085 1837 0 0.5 0 0 1 +address localhost +port 33335 +socket_mode unix From 813bbb1072ad8e574bd31f6fba67eda2065ae2e3 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 19:21:24 +0000 Subject: [PATCH 104/120] update readme instanton +friction regtest --- ipi_tests/regression_tests/tests/INSTANTON/README | 1 + 1 file changed, 1 insertion(+) diff --git a/ipi_tests/regression_tests/tests/INSTANTON/README b/ipi_tests/regression_tests/tests/INSTANTON/README index 26b4b4906..76b346f1a 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/README +++ b/ipi_tests/regression_tests/tests/INSTANTON/README @@ -5,3 +5,4 @@ numpy-accessible outputs. These have been tested against Yair Litman's in-the-house independent implementation (2020). +Implicit bath has been tested against explicit bath calculations (Dec 2023) From eeb85f578237f715e83100b30e2edd82c2ce565f Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 20:24:21 +0000 Subject: [PATCH 105/120] fix regtest RPI+friction --- .../implicit_bath_pos-dependent/test_settings.dat | 2 +- .../tests/INSTANTON/100K_implicit_friction/input.xml | 2 +- .../tests/INSTANTON/100K_implicit_friction/test_settings.dat | 4 +++- 3 files changed, 5 insertions(+), 3 deletions(-) diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat index 8a5bbdb43..3a1f02893 100644 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat @@ -1,4 +1,4 @@ #Settings file for automatic test driver_model DW_friction driver_code python -flags -o 500 2085 1837 0 0.5 0 0 1 +flags -o 500 2085 1837.36223469 0 1.5 -1.0 0 1 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml index b1cced15d..e6f349dcb 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/input.xml @@ -5,7 +5,7 @@ 35
localhost
- 33330 + 33335
diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat index d06a23737..bd76a9426 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat @@ -1,6 +1,8 @@ driver_model DW_friction driver_code python -flags -o 500 2085 1837 0 0.5 0 0 1 +flags -o 500 2085 1837.36223469 0 1.5 -1.0 0 1 address localhost port 33335 socket_mode unix + + From eb541ffb0a62934f728280fd8008ace8e4ddb248 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 20:49:09 +0000 Subject: [PATCH 106/120] adjust test_settings for implicit_bath_pos-dependent test --- .../implicit_bath_pos-dependent/test_settings.dat | 2 +- .../tests/INSTANTON/100K_implicit_friction/test_settings.dat | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat index 3a1f02893..e1334732b 100644 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/implicit_bath_pos-dependent/test_settings.dat @@ -1,4 +1,4 @@ #Settings file for automatic test driver_model DW_friction driver_code python -flags -o 500 2085 1837.36223469 0 1.5 -1.0 0 1 +flags -o 500,2085,1837.36223469,0,1.5,-1.0,0,1 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat index bd76a9426..0aaf82625 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat @@ -1,6 +1,6 @@ driver_model DW_friction driver_code python -flags -o 500 2085 1837.36223469 0 1.5 -1.0 0 1 +flags -o 500,2085,1837.36223469,0,1.5,-1.0,0,1 address localhost port 33335 socket_mode unix From da8a10a6c38b2651f4cd2331fb2349ef8641220c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 20:56:47 +0000 Subject: [PATCH 107/120] add reasonable tolerances to implicit friction --- .../INSTANTON/100K_implicit_friction/files_to_check.txt | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt index 7e450f8f7..ec36c6f38 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt @@ -2,6 +2,6 @@ ------------------------------------------------------------------- ref_simulation.instanton_FINAL_15.xyz xyz ref_simulation.instanton_FINAL_forces_15.xyz xyz -ref_simulation.instanton_FINAL.hess_15 numpy -ref_simulation.instantonfric_FINAL.hess_15 numpy -ref_simulation.out numpy +ref_simulation.instanton_FINAL.hess_15 numpy all,1.e-7,1e-6 +ref_simulation.instantonfric_FINAL.hess_15 numpy all,1.e-7,1e-6 +ref_simulation.out numpy all,1.e-7,1e-6 From 90dbdb62a970efd66dbf86c0fdfae4633750a2c3 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 21:05:00 +0000 Subject: [PATCH 108/120] remove tolerances from ref simulation RPI+friction --- .../tests/INSTANTON/100K_implicit_friction/files_to_check.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt index ec36c6f38..08a3f4731 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/files_to_check.txt @@ -4,4 +4,4 @@ ref_simulation.instanton_FINAL_15.xyz xyz ref_simulation.instanton_FINAL_forces_15.xyz xyz ref_simulation.instanton_FINAL.hess_15 numpy all,1.e-7,1e-6 ref_simulation.instantonfric_FINAL.hess_15 numpy all,1.e-7,1e-6 -ref_simulation.out numpy all,1.e-7,1e-6 +ref_simulation.out numpy From 30e52c7950979c1d03d4420456179e33f8219761 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 21:15:34 +0000 Subject: [PATCH 109/120] force the upload of ref_simulation.out --- .../100K_implicit_friction/ref_simulation.out | 19 +++++++++++++++++++ .../100K_implicit_friction/test_settings.dat | 2 -- 2 files changed, 19 insertions(+), 2 deletions(-) create mode 100644 ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.out diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.out b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.out new file mode 100644 index 000000000..71fef05ac --- /dev/null +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/ref_simulation.out @@ -0,0 +1,19 @@ +# column 1 --> step : The current simulation time step. +# column 2 --> potential{electronvolt} : The physical system potential energy. + 0.00000000e+00 -1.31644693e-01 + 1.00000000e+00 -1.26786599e-01 + 2.00000000e+00 -1.21776709e-01 + 3.00000000e+00 -1.16658431e-01 + 4.00000000e+00 -1.11454852e-01 + 5.00000000e+00 -1.06188313e-01 + 6.00000000e+00 -1.00880343e-01 + 7.00000000e+00 -9.55516738e-02 + 8.00000000e+00 -9.02222605e-02 + 9.00000000e+00 -8.49112940e-02 + 1.00000000e+01 -7.96372080e-02 + 1.10000000e+01 -7.44176670e-02 + 1.20000000e+01 -6.92694951e-02 + 1.30000000e+01 -6.42082944e-02 + 1.40000000e+01 -6.32147149e-02 + 1.50000000e+01 -6.31992725e-02 + 1.60000000e+01 -6.31995100e-02 diff --git a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat index 0aaf82625..42ec12ec1 100644 --- a/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat +++ b/ipi_tests/regression_tests/tests/INSTANTON/100K_implicit_friction/test_settings.dat @@ -4,5 +4,3 @@ flags -o 500,2085,1837.36223469,0,1.5,-1.0,0,1 address localhost port 33335 socket_mode unix - - From 10de82be0329a5adb7d679a69c79f20d9dc21e41 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Sun, 3 Dec 2023 21:25:14 +0000 Subject: [PATCH 110/120] extend error message to reg_test runstools.py --- ipi_tests/regression_tests/runstools.py | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/ipi_tests/regression_tests/runstools.py b/ipi_tests/regression_tests/runstools.py index fb3368d45..7d9a16a5d 100644 --- a/ipi_tests/regression_tests/runstools.py +++ b/ipi_tests/regression_tests/runstools.py @@ -196,7 +196,10 @@ def _check_xyz_output(self, cwd): ref_xyz = np.array(reff) except IOError: raise IOError( - "Please provide a reference file named {} in {}".format( + "Please provide a reference file named {} in {}\n \ + (Note that extension *out appears in gitignore\n \ + so those files require to force the addition by\n \ + 'git add -f ') ".format( refname, str((self.parent / cwd).absolute()) ) ) From 5af670ecffd766d46338257b6aa34371a075c181 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Mon, 4 Dec 2023 11:06:51 +0000 Subject: [PATCH 111/120] bug fix transfer_force_manual when there is no extra info --- ipi/engine/forces.py | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/ipi/engine/forces.py b/ipi/engine/forces.py index 3b25a275e..18919abea 100644 --- a/ipi/engine/forces.py +++ b/ipi/engine/forces.py @@ -972,7 +972,7 @@ def transfer_forces_manual( assert len(self.mforces) == len(new_v), msg assert len(self.mforces) == len(new_forces), msg if new_x == None: - new_x = [[None] * self.nbeads] * len(self.mforces) + new_x = [{"raw": [None] * self.nbeads}] * len(self.mforces) info("WARNING: No extras information has been passed.", verbosity.debug) assert len(self.mforces) == len(new_x), msg @@ -983,7 +983,6 @@ def transfer_forces_manual( mq = new_q[k] mextra = new_x[k] mself = self.mforces[k] - assert mq.shape == mf.shape, msg assert mq.shape[0] == mv.shape[0], msg assert mself.nbeads == mv.shape[0], msg From 2a87b2ef236bb1c317cf604438323e55fa4a69f4 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 12 Dec 2023 18:12:46 +0000 Subject: [PATCH 112/120] update python driver to new standars --- drivers/py/pes/__init__.py | 9 +- drivers/py/pes/bath.py | 83 +++++ drivers/py/pes/doubledoublewell.py | 138 +++++++ drivers/py/pes/doublewell.py | 343 +----------------- drivers/py/pes/doublewell_with_bath.py | 103 ++++++ drivers/py/pes/doublewell_with_friction.py | 110 ++++++ drivers/py/pes/spline.py | 4 +- .../Rates/Double_well_1D_vanilla/run.sh | 6 +- .../run.sh | 6 +- .../run.sh | 6 +- 10 files changed, 462 insertions(+), 346 deletions(-) create mode 100644 drivers/py/pes/bath.py create mode 100644 drivers/py/pes/doubledoublewell.py create mode 100644 drivers/py/pes/doublewell_with_bath.py create mode 100644 drivers/py/pes/doublewell_with_friction.py mode change 100644 => 100755 examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh diff --git a/drivers/py/pes/__init__.py b/drivers/py/pes/__init__.py index f798cfd9e..edad9e20c 100644 --- a/drivers/py/pes/__init__.py +++ b/drivers/py/pes/__init__.py @@ -23,8 +23,9 @@ __drivers__[driver_name] = getattr(module, driver_class) globals()[driver_class] = getattr(module, driver_class) # add class to globals else: - raise ImportError( - f"PES module `{module_name}` does not define __DRIVER_CLASS__ and __DRIVER_NAME__" - ) + if driver_class != "driver_tools": + raise ImportError( + f"PES module `{module_name}` does not define __DRIVER_CLASS__ and __DRIVER_NAME__" + ) -__all__.append("__drivers__") \ No newline at end of file +__all__.append("__drivers__") diff --git a/drivers/py/pes/bath.py b/drivers/py/pes/bath.py new file mode 100644 index 000000000..6ca3004df --- /dev/null +++ b/drivers/py/pes/bath.py @@ -0,0 +1,83 @@ +""" Harmonic Bath """ + +import sys +try: + from .dummy import Dummy_driver +except: + from dummy import Dummy_driver +import numpy as np +from ipi.utils import units +import json + +__DRIVER_NAME__ = None +__DRIVER_CLASS__ = 'driver_tools' + + +class Harmonic_Bath_explicit(object): + """Explicit description of an Harmonic bath""" + + def __init__(self, nbath, parameters): + self.nbath = nbath + self.m = parameters["m"] + # self.delta = parameters["delta"] + self.eta0 = parameters["eta0"] + self.eps1 = parameters["eps1"] + self.eps2 = parameters["eps2"] + self.deltaQ = parameters["deltaQ"] + self.w_c = parameters["w_c"] + + self.set_ci_and_wi() + + def set_ci_and_wi(self): + """Computes the the parameters to represent the harmonic bath""" + + omega = np.zeros(self.nbath) + self.omega2 = np.zeros(self.nbath) + self.coef = np.zeros(self.nbath) + + if self.w_c > 0: + for i in range(self.nbath): + omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) + self.omega2[i] = omega[i] ** 2 + self.coef[i] = ( + omega[i] + * ((2 * self.eta0 * self.m * self.w_c) / (self.nbath * np.pi)) + ** 0.5 + ) + self.init = True + + def S(self, q): + """S coupling function""" + return q * self.SD(q) + + def SD(self, q): + """Auxiliary function to compute friction tensor""" + dx = q / self.deltaQ + SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx**2)) + self.eps2 * np.tanh(dx) + return SD + + def dSD_dq(self, q): + """Auxiliary function to compute friction tensor""" + dx = q / self.deltaQ + dsddq1 = self.eps1 * np.exp(-0.5 * (dx**2)) * (-dx / self.deltaQ) + dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ + dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) + + return dSD_dq + + def __call__(self, q, x): + pot_bath = 0 + fq_bath = np.zeros(q.shape) + fx = np.zeros(x.shape) + assert x.size == self.nbath, "x.size {} , nbath {}".format(x.size, self.nbath) + + if self.w_c > 0: + for i in range(self.nbath): + aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) + pot_bath += 0.5 * self.m * self.omega2[i] * aux**2 + fq_bath += aux * self.coef[i] * self.dSD_dq(q) + fx[i] -= (self.m * self.omega2[i] * aux).flatten() + + return pot_bath, fq_bath, fx + + diff --git a/drivers/py/pes/doubledoublewell.py b/drivers/py/pes/doubledoublewell.py new file mode 100644 index 000000000..425484dcf --- /dev/null +++ b/drivers/py/pes/doubledoublewell.py @@ -0,0 +1,138 @@ +""" Harmonic potential """ + +import sys +try: + from .dummy import Dummy_driver +except: + from dummy import Dummy_driver +import numpy as np +from ipi.utils import units +import json + +__DRIVER_NAME__ = "double_double_well" +__DRIVER_CLASS__ = "DDW_with_explicit_bath_driver" + +# np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) + +invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) +A2au = units.unit_to_internal("length", "angstrom", 1.0) + +# ------------DOUBLE WELL POTENTIAL----------------------------- +# +# m^2*w_b^4 +# V(x,w_b,v0) = - 0.5 *m*w_b^2*(x-delta)^2 + ---------- x^4 +# 16V0 +# +# --------------------------------------------------------- + + +class DDW_with_explicit_bath_driver(Dummy_driver): + + """Adds to a double-double well (DDW) potential coupled to two (explicit) harmonic baths. + pos[0:2] = DDW + pos[2:n//2+1] = bath1 + pos[n//2+1:] = bath2 + where n = 3*natoms = # dofs + + ! V(q1,q2,x1,..,xm,y1,...,ym) = + ! DDW(q1,q2) + + ! sum_i^(m) [ 0.5 m w_i^2(xi - (c_i s(q1))/(m w_i)^2)^2 ] + + ! sum_i^(m) [ 0.5 m w_i^2(yi - (c_i s(q2))/(m w_i)^2)^2 ] + + ! + ! with + ! s(q) = q *sd(q) + ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) + ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath + ! + ! and + ! + ! DDW(q1,q2) = DW(q1) + DW(q2) + C(q1q2)^2 + """ + + def __init__(self, args=None,verbose=None): + self.error_msg = """\nDW+explicit_bath driver expects 11 arguments.\n + Example: python driver.py -m DoubleWell_with_explicit_bath -o wb1 (cm^-1) V1 (cm^-1) wb2 (cm^-1) V2 (cm^-1) coupling(au) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n + python driver.py -m DoubleWell -o 500,2085,500,2085,0.1,1837,0.00,1,0,0,1,500\n""" + self.args = args + self.check_arguments() + self.init = False + + def check_arguments(self): + """Function that checks the arguments required to run the driver""" + + try: + arglist = self.args.split(",") + param = list(map(float, arglist)) + assert len(param) == 12 + wb1 = param[0] * invcm2au + v1 = param[1] * invcm2au + wb2 = param[2] * invcm2au + v2 = param[3] * invcm2au + self.C = param[4] + self.m = param[5] + self.delta = param[6] * A2au + + self.bath_parameters = {} + self.bath_parameters["m"] = self.m + self.bath_parameters["delta"] = self.delta + self.bath_parameters["eta0"] = param[7] + self.bath_parameters["eps1"] = param[8] + self.bath_parameters["eps2"] = param[9] + self.bath_parameters["deltaQ"] = param[10] + self.bath_parameters["w_c"] = param[11] * invcm2au + + except: + print("Received arguments:") + sys.exit(self.error_msg) + + self.A1 = -0.5 * self.m * (wb1) ** 2 + self.B1 = ((self.m**2) * (wb1) ** 4) / (16 * v1) + + self.A2 = -0.5 * self.m * (wb2) ** 2 + self.B2 = ((self.m**2) * (wb2) ** 4) / (16 * v2) + + def __call__(self, cell, pos): + """DoubleWell potential""" + if not self.init: + self.ndof = np.size(pos) + assert self.ndof % 2 == 0, "Sorry we need an even number of ndof" + self.nbath = (self.ndof - 2) // 2 + self.bath1 = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) + self.bath2 = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) + self.init = True + + pot = 0 + q1 = pos.reshape(-1, 1)[0:1] + q2 = pos.reshape(-1, 1)[1:2] + x = pos.reshape(-1, 1)[2 : self.ndof // 2 + 1] + y = pos.reshape(-1, 1)[self.ndof // 2 + 1 :] + assert self.ndof == q1.size + q2.size + x.size + y.size + + # fq1 = np.zeros(q1.shape) + # fq2 = np.zeros(q2.shape) + fx = np.zeros(x.shape) + fy = np.zeros(x.shape) + + # Harmonic bath + pot_x, fq1, fx = self.bath1(q1, x) + pot_y, fq2, fy = self.bath2(q2, y) + + pot = pot_x + pot_y + + # DW + pot += self.A1 * (q1 - self.delta) ** 2 + self.B1 * (q1**4) + fq1 += -2.0 * self.A1 * (q1 - self.delta) - 4.0 * self.B1 * (q1**3) + + pot += self.A2 * (q2 - self.delta) ** 2 + self.B2 * (q2**4) + fq2 += -2.0 * self.A2 * (q2 - self.delta) - 4.0 * self.B2 * (q2**3) + + # Coupling + pot += self.C * q1 * q2 + fq1 += -self.C * q2 + fq2 += -self.C * q1 + + force = np.concatenate((fq1, fq2, fx, fy), axis=None).reshape(pos.shape) + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "empty" + + return pot, force, vir, extras diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 90dd2610e..afeff9573 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -1,11 +1,20 @@ """ Harmonic potential """ import sys -from .dummy import Dummy_driver +try: + from .dummy import Dummy_driver +except: + from dummy import Dummy_driver + import numpy as np from ipi.utils import units import json + +__DRIVER_NAME__ = "DW" +__DRIVER_CLASS__ = "DoubleWell_driver" + + # np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) @@ -21,7 +30,7 @@ class DoubleWell_driver(Dummy_driver): - def __init__(self, args=None): + def __init__(self, args=None,verbose=None): self.error_msg = """\nDW driver accepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -o omega_b (cm^-1) V0 (cm^-1) mass(a.u) delta(angs) \n python driver.py -m DoubleWell -o 500,2085,1837,0.00 \n""" super(DoubleWell_driver, self).__init__(args) @@ -76,333 +85,3 @@ def __call__(self, cell, pos): return pot, force, vir, extras -class DoubleWell_with_friction_driver(DoubleWell_driver): - """Adds to the double well potential the calculation of the friction tensor. - - friction(q) = eta0 [\partial sd(q) \partial q ]^2 - with - q = position, and - sd(q) = [1+eps1 exp( (q-0)^2 / (2deltaQ^2) ) ] + eps2 tanh(q/deltaQ) - """ - - def __init__(self, args=None): - self.error_msg = """\nDW+fric driver expects 8 arguments.\n - Example: python driver.py -m DoubleWell_with_fric -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ \n - python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1\n""" - self.args = args - self.check_arguments() - - def check_arguments(self): - """Function that checks the arguments required to run the driver""" - - self.k = 1837.36223469 * (3800.0 / 219323.0) ** 2 - try: - arglist = self.args.split(",") - param = list(map(float, arglist)) - assert len(param) == 8 - w_b = param[0] * invcm2au - v0 = param[1] * invcm2au - m = param[2] - self.delta = param[3] * A2au - self.eta0 = param[4] - self.eps1 = param[5] - self.eps2 = param[6] - self.deltaQ = param[7] - except: - sys.exit(self.error_msg) - - self.A = -0.5 * m * (w_b) ** 2 - self.B = ((m**2) * (w_b) ** 4) / (16 * v0) - - def check_dimensions(self, pos): - """Functions that checks dimensions of the received position""" - assert pos.shape == (1, 3), "We expect pos.shape (1,3), but we have {}".format( - pos.shape - ) - - def SD(self, q): - """Auxiliary function to compute friction tensor""" - dx = q / self.deltaQ - SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx**2)) + self.eps2 * np.tanh(dx) - return SD - - def dSD_dq(self, q): - """Auxiliary function to compute friction tensor""" - dx = q / self.deltaQ - dsddq1 = self.eps1 * np.exp(-0.5 * (dx**2)) * (-dx / self.deltaQ) - dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ - dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) - - return dSD_dq - - def get_friction_tensor(self, pos): - """Function that computes spatially dependent friction tensor""" - - self.check_dimensions(pos) - x = pos[0, 0] - friction_tensor = np.zeros((3, 3)) - - friction_tensor[0, 0] = self.eta0 * self.dSD_dq(x) ** 2 - return friction_tensor - - def __call__(self, cell, pos): - """DoubleWell potential l""" - - pot, force, vir, extras = super(DoubleWell_with_friction_driver, self).__call__( - cell, pos - ) - - friction_tensor = self.get_friction_tensor(pos) - extras = json.dumps({"friction": friction_tensor.tolist()}) - return pot, force, vir, extras - - -class Harmonic_Bath_explicit(object): - """Explicit description of an Harmonic bath""" - - def __init__(self, nbath, parameters): - self.nbath = nbath - self.m = parameters["m"] - # self.delta = parameters["delta"] - self.eta0 = parameters["eta0"] - self.eps1 = parameters["eps1"] - self.eps2 = parameters["eps2"] - self.deltaQ = parameters["deltaQ"] - self.w_c = parameters["w_c"] - - self.set_ci_and_wi() - - def set_ci_and_wi(self): - """Computes the the parameters to represent the harmonic bath""" - - omega = np.zeros(self.nbath) - self.omega2 = np.zeros(self.nbath) - self.coef = np.zeros(self.nbath) - - if self.w_c > 0: - for i in range(self.nbath): - omega[i] = -self.w_c * np.log((i + 0.5) / self.nbath) - self.omega2[i] = omega[i] ** 2 - self.coef[i] = ( - omega[i] - * ((2 * self.eta0 * self.m * self.w_c) / (self.nbath * np.pi)) - ** 0.5 - ) - self.init = True - - def S(self, q): - """S coupling function""" - return q * self.SD(q) - - def SD(self, q): - """Auxiliary function to compute friction tensor""" - dx = q / self.deltaQ - SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx**2)) + self.eps2 * np.tanh(dx) - return SD - - def dSD_dq(self, q): - """Auxiliary function to compute friction tensor""" - dx = q / self.deltaQ - dsddq1 = self.eps1 * np.exp(-0.5 * (dx**2)) * (-dx / self.deltaQ) - dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ - dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) - - return dSD_dq - - def __call__(self, q, x): - pot_bath = 0 - fq_bath = np.zeros(q.shape) - fx = np.zeros(x.shape) - assert x.size == self.nbath, "x.size {} , nbath {}".format(x.size, self.nbath) - - if self.w_c > 0: - for i in range(self.nbath): - aux = x[i] - (self.coef[i] * self.S(q) / (self.m * self.omega2[i])) - pot_bath += 0.5 * self.m * self.omega2[i] * aux**2 - fq_bath += aux * self.coef[i] * self.dSD_dq(q) - fx[i] -= (self.m * self.omega2[i] * aux).flatten() - - return pot_bath, fq_bath, fx - - -class DoubleWell_with_explicit_bath_driver(Dummy_driver): - """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization - - ! V(q,x1,..,xn) = DW(q) + - ! sum_2^(3*N) [ 0.5 m w_i^2(q - (c_i s(q))/(m w_i)^2)^2 ] - ! s(q) = q *sd(q) - ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) - ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath - """ - - def __init__(self, args=None): - self.error_msg = """\nDW+explicit_bath driver expects 9 arguments.\n - Example: python driver.py -m DoubleWell_with_explicit_bath -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n - python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1,500\n""" - self.args = args - self.check_arguments() - self.init = False - - def check_arguments(self): - """Function that checks the arguments required to run the driver""" - - try: - arglist = self.args.split(",") - param = list(map(float, arglist)) - assert len(param) == 9 - w_b = param[0] * invcm2au - v0 = param[1] * invcm2au - self.m = param[2] - self.delta = param[3] * A2au - - self.bath_parameters = {} - self.bath_parameters["m"] = param[2] - # self.bath_parameters["delta"] = param[3] * A2au - self.bath_parameters["eta0"] = param[4] - self.bath_parameters["eps1"] = param[5] - self.bath_parameters["eps2"] = param[6] - self.bath_parameters["deltaQ"] = param[7] - self.bath_parameters["w_c"] = param[8] * invcm2au - - except: - sys.exit(self.error_msg) - - self.A = -0.5 * self.m * (w_b) ** 2 - self.B = ((self.m**2) * (w_b) ** 4) / (16 * v0) - - def __call__(self, cell, pos): - """DoubleWell potential""" - pot = 0 - q = pos.reshape(-1, 1)[0] - x = pos.reshape(-1, 1)[1:] - fq = np.zeros(q.shape) - fx = np.zeros(x.shape) - - if not self.init: - self.nbath = np.size(x) - self.bath = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) - - # Harmonic bath - pot, fq, fx = self.bath(q, x) - - # DW - pot += self.A * (q - self.delta) ** 2 + self.B * (q**4) - fq += -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q**3) - - force = np.concatenate((fq, fx.flatten())).reshape(pos.shape) - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "empty" - - return pot, force, vir, extras - - -class DDW_with_explicit_bath_driver(Dummy_driver): - - """Adds to a double-double well (DDW) potential coupled to two (explicit) harmonic baths. - pos[0:2] = DDW - pos[2:n//2+1] = bath1 - pos[n//2+1:] = bath2 - where n = 3*natoms = # dofs - - ! V(q1,q2,x1,..,xm,y1,...,ym) = - ! DDW(q1,q2) + - ! sum_i^(m) [ 0.5 m w_i^2(xi - (c_i s(q1))/(m w_i)^2)^2 ] + - ! sum_i^(m) [ 0.5 m w_i^2(yi - (c_i s(q2))/(m w_i)^2)^2 ] + - ! - ! with - ! s(q) = q *sd(q) - ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) - ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath - ! - ! and - ! - ! DDW(q1,q2) = DW(q1) + DW(q2) + C(q1q2)^2 - """ - - def __init__(self, args=None): - self.error_msg = """\nDW+explicit_bath driver expects 11 arguments.\n - Example: python driver.py -m DoubleWell_with_explicit_bath -o wb1 (cm^-1) V1 (cm^-1) wb2 (cm^-1) V2 (cm^-1) coupling(au) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n - python driver.py -m DoubleWell -o 500,2085,500,2085,0.1,1837,0.00,1,0,0,1,500\n""" - self.args = args - self.check_arguments() - self.init = False - - def check_arguments(self): - """Function that checks the arguments required to run the driver""" - - try: - arglist = self.args.split(",") - param = list(map(float, arglist)) - assert len(param) == 12 - wb1 = param[0] * invcm2au - v1 = param[1] * invcm2au - wb2 = param[2] * invcm2au - v2 = param[3] * invcm2au - self.C = param[4] - self.m = param[5] - self.delta = param[6] * A2au - - self.bath_parameters = {} - self.bath_parameters["m"] = self.m - self.bath_parameters["delta"] = self.delta - self.bath_parameters["eta0"] = param[7] - self.bath_parameters["eps1"] = param[8] - self.bath_parameters["eps2"] = param[9] - self.bath_parameters["deltaQ"] = param[10] - self.bath_parameters["w_c"] = param[11] * invcm2au - - except: - print("Received arguments:") - sys.exit(self.error_msg) - - self.A1 = -0.5 * self.m * (wb1) ** 2 - self.B1 = ((self.m**2) * (wb1) ** 4) / (16 * v1) - - self.A2 = -0.5 * self.m * (wb2) ** 2 - self.B2 = ((self.m**2) * (wb2) ** 4) / (16 * v2) - - def __call__(self, cell, pos): - """DoubleWell potential""" - if not self.init: - self.ndof = np.size(pos) - assert self.ndof % 2 == 0, "Sorry we need an even number of ndof" - self.nbath = (self.ndof - 2) // 2 - self.bath1 = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) - self.bath2 = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) - self.init = True - - pot = 0 - q1 = pos.reshape(-1, 1)[0:1] - q2 = pos.reshape(-1, 1)[1:2] - x = pos.reshape(-1, 1)[2 : self.ndof // 2 + 1] - y = pos.reshape(-1, 1)[self.ndof // 2 + 1 :] - assert self.ndof == q1.size + q2.size + x.size + y.size - - # fq1 = np.zeros(q1.shape) - # fq2 = np.zeros(q2.shape) - fx = np.zeros(x.shape) - fy = np.zeros(x.shape) - - # Harmonic bath - pot_x, fq1, fx = self.bath1(q1, x) - pot_y, fq2, fy = self.bath2(q2, y) - - pot = pot_x + pot_y - - # DW - pot += self.A1 * (q1 - self.delta) ** 2 + self.B1 * (q1**4) - fq1 += -2.0 * self.A1 * (q1 - self.delta) - 4.0 * self.B1 * (q1**3) - - pot += self.A2 * (q2 - self.delta) ** 2 + self.B2 * (q2**4) - fq2 += -2.0 * self.A2 * (q2 - self.delta) - 4.0 * self.B2 * (q2**3) - - # Coupling - pot += self.C * q1 * q2 - fq1 += -self.C * q2 - fq2 += -self.C * q1 - - force = np.concatenate((fq1, fq2, fx, fy), axis=None).reshape(pos.shape) - vir = cell * 0.0 # makes a zero virial with same shape as cell - extras = "empty" - - return pot, force, vir, extras diff --git a/drivers/py/pes/doublewell_with_bath.py b/drivers/py/pes/doublewell_with_bath.py new file mode 100644 index 000000000..96ebd533e --- /dev/null +++ b/drivers/py/pes/doublewell_with_bath.py @@ -0,0 +1,103 @@ +""" Harmonic potential """ + +import sys +try: + from .dummy import Dummy_driver + from .bath import Harmonic_Bath_explicit +except: + from dummy import Dummy_driver + from .bath import Harmonic_Bath_explicit + +import numpy as np +from ipi.utils import units +import json + + +__DRIVER_NAME__ = "DW_bath" +__DRIVER_CLASS__ = "DoubleWell_with_explicit_bath_driver" + +# np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) + +invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) +A2au = units.unit_to_internal("length", "angstrom", 1.0) + +# ------------DOUBLE WELL POTENTIAL----------------------------- +# +# m^2*w_b^4 +# V(x,w_b,v0) = - 0.5 *m*w_b^2*(x-delta)^2 + ---------- x^4 +# 16V0 +# +# --------------------------------------------------------- + + +class DoubleWell_with_explicit_bath_driver(Dummy_driver): + """Adds to the double well potential an explicit harmonic bath. First dof correpond to the DW, the rest to the bath discretization + + ! V(q,x1,..,xn) = DW(q) + + ! sum_2^(3*N) [ 0.5 m w_i^2(q - (c_i s(q))/(m w_i)^2)^2 ] + ! s(q) = q *sd(q) + ! sd(q) = [1+eps1*exp( q^2 / (2 deltaQ^2) ) ] + eps2 tanh(q/deltaQ) + ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath + """ + + def __init__(self, args=None,verbose=None): + self.error_msg = """\nDW+explicit_bath driver expects 9 arguments.\n + Example: python driver.py -m DoubleWell_with_explicit_bath -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n + python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1,500\n""" + self.args = args + self.check_arguments() + self.init = False + + def check_arguments(self): + """Function that checks the arguments required to run the driver""" + + try: + arglist = self.args.split(",") + param = list(map(float, arglist)) + assert len(param) == 9 + w_b = param[0] * invcm2au + v0 = param[1] * invcm2au + self.m = param[2] + self.delta = param[3] * A2au + + self.bath_parameters = {} + self.bath_parameters["m"] = param[2] + # self.bath_parameters["delta"] = param[3] * A2au + self.bath_parameters["eta0"] = param[4] + self.bath_parameters["eps1"] = param[5] + self.bath_parameters["eps2"] = param[6] + self.bath_parameters["deltaQ"] = param[7] + self.bath_parameters["w_c"] = param[8] * invcm2au + + except: + sys.exit(self.error_msg) + + self.A = -0.5 * self.m * (w_b) ** 2 + self.B = ((self.m**2) * (w_b) ** 4) / (16 * v0) + + def __call__(self, cell, pos): + """DoubleWell potential""" + pot = 0 + q = pos.reshape(-1, 1)[0] + x = pos.reshape(-1, 1)[1:] + fq = np.zeros(q.shape) + fx = np.zeros(x.shape) + + if not self.init: + self.nbath = np.size(x) + self.bath = Harmonic_Bath_explicit(self.nbath, self.bath_parameters) + + # Harmonic bath + pot, fq, fx = self.bath(q, x) + + # DW + pot += self.A * (q - self.delta) ** 2 + self.B * (q**4) + fq += -2.0 * self.A * (q - self.delta) - 4.0 * self.B * (q**3) + + force = np.concatenate((fq, fx.flatten())).reshape(pos.shape) + vir = cell * 0.0 # makes a zero virial with same shape as cell + extras = "empty" + + return pot, force, vir, extras + + diff --git a/drivers/py/pes/doublewell_with_friction.py b/drivers/py/pes/doublewell_with_friction.py new file mode 100644 index 000000000..435571cfb --- /dev/null +++ b/drivers/py/pes/doublewell_with_friction.py @@ -0,0 +1,110 @@ +""" Harmonic potential """ + +import sys + +try: + from .doublewell import DoubleWell_driver +except: + from doublewell import DoubleWell_driver + +import numpy as np +from ipi.utils import units +import json + + +__DRIVER_NAME__ = "DW_friction" +__DRIVER_CLASS__ = "DoubleWell_with_friction_driver" + +# np.set_printoptions(precision=14, suppress=True,threshold='nan',linewidth=1000) + +invcm2au = units.unit_to_internal("frequency", "inversecm", 1.0) +A2au = units.unit_to_internal("length", "angstrom", 1.0) + +# ------------DOUBLE WELL POTENTIAL----------------------------- +# +# m^2*w_b^4 +# V(x,w_b,v0) = - 0.5 *m*w_b^2*(x-delta)^2 + ---------- x^4 +# 16V0 +# +# --------------------------------------------------------- + + +class DoubleWell_with_friction_driver(DoubleWell_driver): + """Adds to the double well potential the calculation of the friction tensor. + + friction(q) = eta0 [\partial sd(q) \partial q ]^2 + with + q = position, and + sd(q) = [1+eps1 exp( (q-0)^2 / (2deltaQ^2) ) ] + eps2 tanh(q/deltaQ) + """ + + def __init__(self, args=None,verbose=None): + self.error_msg = """\nDW+fric driver expects 8 arguments.\n + Example: python driver.py -m DoubleWell_with_fric -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ \n + python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1\n""" + self.args = args + self.check_arguments() + + def check_arguments(self): + """Function that checks the arguments required to run the driver""" + + self.k = 1837.36223469 * (3800.0 / 219323.0) ** 2 + try: + arglist = self.args.split(",") + param = list(map(float, arglist)) + assert len(param) == 8 + w_b = param[0] * invcm2au + v0 = param[1] * invcm2au + m = param[2] + self.delta = param[3] * A2au + self.eta0 = param[4] + self.eps1 = param[5] + self.eps2 = param[6] + self.deltaQ = param[7] + except: + sys.exit(self.error_msg) + + self.A = -0.5 * m * (w_b) ** 2 + self.B = ((m**2) * (w_b) ** 4) / (16 * v0) + + def check_dimensions(self, pos): + """Functions that checks dimensions of the received position""" + assert pos.shape == (1, 3), "We expect pos.shape (1,3), but we have {}".format( + pos.shape + ) + + def SD(self, q): + """Auxiliary function to compute friction tensor""" + dx = q / self.deltaQ + SD = 1.0 + self.eps1 * np.exp(-0.5 * (dx**2)) + self.eps2 * np.tanh(dx) + return SD + + def dSD_dq(self, q): + """Auxiliary function to compute friction tensor""" + dx = q / self.deltaQ + dsddq1 = self.eps1 * np.exp(-0.5 * (dx**2)) * (-dx / self.deltaQ) + dsddq2 = self.eps2 * (1 - np.tanh(dx) ** 2) / self.deltaQ + dSD_dq = q * (dsddq1 + dsddq2) + self.SD(q) + + return dSD_dq + + def get_friction_tensor(self, pos): + """Function that computes spatially dependent friction tensor""" + + self.check_dimensions(pos) + x = pos[0, 0] + friction_tensor = np.zeros((3, 3)) + + friction_tensor[0, 0] = self.eta0 * self.dSD_dq(x) ** 2 + return friction_tensor + + def __call__(self, cell, pos): + """DoubleWell potential l""" + + pot, force, vir, extras = super(DoubleWell_with_friction_driver, self).__call__( + cell, pos + ) + + friction_tensor = self.get_friction_tensor(pos) + extras = json.dumps({"friction": friction_tensor.tolist()}) + return pot, force, vir, extras diff --git a/drivers/py/pes/spline.py b/drivers/py/pes/spline.py index e674f7bac..9e269bb0e 100644 --- a/drivers/py/pes/spline.py +++ b/drivers/py/pes/spline.py @@ -13,9 +13,11 @@ SI = True fric_value = 0.165 +__DRIVER_NAME__ = "spline" +__DRIVER_CLASS__ = "Spline_driver" class Spline_driver(Dummy_driver): - def __init__(self, args=None): + def __init__(self, args=None,verbose=None): self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" super(Spline_driver, self).__init__(args) self.get_spline() diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh old mode 100644 new mode 100755 index 531c01cda..e10cd00ed --- a/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_1D_vanilla/run.sh @@ -5,12 +5,12 @@ mass=1837.36223469 x0=0.00 address=localhost - model='DoubleWell' + model='DW' #Launch i-pi and wait - i-pi input.xml & + i-pi input.xml & sleep 3 #Launch driver - i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0} -u -a ${address} + i-pi-py_driver -m ${model} -o ${wb},${V0},${mass},${x0} -u -a ${address} diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh index 5e18e05de..183a7217a 100755 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-dependent_python/run.sh @@ -11,12 +11,12 @@ deltaQ=1 address=localhost - model='DW_explicit' + model='DW_bath' #Launch i-pi and wait - i-pi input.xml & + i-pi input.xml & sleep 3 #Launch driver - i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} diff --git a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh index d09f204c9..55da26190 100755 --- a/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh +++ b/examples/features/ring_polymer_instanton/Rates/Double_well_with_friction/explicit_harmonic_bath_pos-independent_python/run.sh @@ -11,12 +11,12 @@ deltaQ=1 address=localhost - model='DW_explicit' + model='DW_bath' #Launch i-pi and wait - i-pi input.xml & + i-pi input.xml & sleep 3 #Launch driver - i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} + i-pi-driver-py -m ${model} -o ${wb},${V0},${mass},${x0},${eta},${epsilon},${delta},${deltaQ},${wc} -u -a ${address} From 30eecc261e480e3448331491d7d392e199ea901b Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 12 Dec 2023 18:13:42 +0000 Subject: [PATCH 113/120] black --- drivers/py/pes/bath.py | 9 ++++----- drivers/py/pes/doubledoublewell.py | 7 ++++--- drivers/py/pes/doublewell.py | 9 ++++----- drivers/py/pes/doublewell_with_bath.py | 13 ++++++------- drivers/py/pes/doublewell_with_friction.py | 2 +- drivers/py/pes/spline.py | 3 ++- 6 files changed, 21 insertions(+), 22 deletions(-) diff --git a/drivers/py/pes/bath.py b/drivers/py/pes/bath.py index 6ca3004df..daec8d2c5 100644 --- a/drivers/py/pes/bath.py +++ b/drivers/py/pes/bath.py @@ -1,16 +1,17 @@ """ Harmonic Bath """ import sys + try: - from .dummy import Dummy_driver + from .dummy import Dummy_driver except: - from dummy import Dummy_driver + from dummy import Dummy_driver import numpy as np from ipi.utils import units import json __DRIVER_NAME__ = None -__DRIVER_CLASS__ = 'driver_tools' +__DRIVER_CLASS__ = "driver_tools" class Harmonic_Bath_explicit(object): @@ -79,5 +80,3 @@ def __call__(self, q, x): fx[i] -= (self.m * self.omega2[i] * aux).flatten() return pot_bath, fq_bath, fx - - diff --git a/drivers/py/pes/doubledoublewell.py b/drivers/py/pes/doubledoublewell.py index 425484dcf..459017d8e 100644 --- a/drivers/py/pes/doubledoublewell.py +++ b/drivers/py/pes/doubledoublewell.py @@ -1,10 +1,11 @@ """ Harmonic potential """ import sys + try: - from .dummy import Dummy_driver + from .dummy import Dummy_driver except: - from dummy import Dummy_driver + from dummy import Dummy_driver import numpy as np from ipi.utils import units import json @@ -49,7 +50,7 @@ class DDW_with_explicit_bath_driver(Dummy_driver): ! DDW(q1,q2) = DW(q1) + DW(q2) + C(q1q2)^2 """ - def __init__(self, args=None,verbose=None): + def __init__(self, args=None, verbose=None): self.error_msg = """\nDW+explicit_bath driver expects 11 arguments.\n Example: python driver.py -m DoubleWell_with_explicit_bath -o wb1 (cm^-1) V1 (cm^-1) wb2 (cm^-1) V2 (cm^-1) coupling(au) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n python driver.py -m DoubleWell -o 500,2085,500,2085,0.1,1837,0.00,1,0,0,1,500\n""" diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index afeff9573..6e0b8afe6 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -1,10 +1,11 @@ """ Harmonic potential """ import sys + try: - from .dummy import Dummy_driver + from .dummy import Dummy_driver except: - from dummy import Dummy_driver + from dummy import Dummy_driver import numpy as np from ipi.utils import units @@ -30,7 +31,7 @@ class DoubleWell_driver(Dummy_driver): - def __init__(self, args=None,verbose=None): + def __init__(self, args=None, verbose=None): self.error_msg = """\nDW driver accepts 0 or 4 arguments.\nExample: python driver.py -m DoubleWell -o omega_b (cm^-1) V0 (cm^-1) mass(a.u) delta(angs) \n python driver.py -m DoubleWell -o 500,2085,1837,0.00 \n""" super(DoubleWell_driver, self).__init__(args) @@ -83,5 +84,3 @@ def __call__(self, cell, pos): force = force3.reshape(pos.shape) return pot, force, vir, extras - - diff --git a/drivers/py/pes/doublewell_with_bath.py b/drivers/py/pes/doublewell_with_bath.py index 96ebd533e..ccd2774a9 100644 --- a/drivers/py/pes/doublewell_with_bath.py +++ b/drivers/py/pes/doublewell_with_bath.py @@ -1,12 +1,13 @@ """ Harmonic potential """ import sys + try: - from .dummy import Dummy_driver - from .bath import Harmonic_Bath_explicit + from .dummy import Dummy_driver + from .bath import Harmonic_Bath_explicit except: - from dummy import Dummy_driver - from .bath import Harmonic_Bath_explicit + from dummy import Dummy_driver + from .bath import Harmonic_Bath_explicit import numpy as np from ipi.utils import units @@ -40,7 +41,7 @@ class DoubleWell_with_explicit_bath_driver(Dummy_driver): ! If eps1=eps2=0 then sd(q) =1 and s(q) = q --->Spatially independent bath """ - def __init__(self, args=None,verbose=None): + def __init__(self, args=None, verbose=None): self.error_msg = """\nDW+explicit_bath driver expects 9 arguments.\n Example: python driver.py -m DoubleWell_with_explicit_bath -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ omega_c(cm^-1) \n python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1,500\n""" @@ -99,5 +100,3 @@ def __call__(self, cell, pos): extras = "empty" return pot, force, vir, extras - - diff --git a/drivers/py/pes/doublewell_with_friction.py b/drivers/py/pes/doublewell_with_friction.py index 435571cfb..aa94f460e 100644 --- a/drivers/py/pes/doublewell_with_friction.py +++ b/drivers/py/pes/doublewell_with_friction.py @@ -38,7 +38,7 @@ class DoubleWell_with_friction_driver(DoubleWell_driver): sd(q) = [1+eps1 exp( (q-0)^2 / (2deltaQ^2) ) ] + eps2 tanh(q/deltaQ) """ - def __init__(self, args=None,verbose=None): + def __init__(self, args=None, verbose=None): self.error_msg = """\nDW+fric driver expects 8 arguments.\n Example: python driver.py -m DoubleWell_with_fric -o omega_b (cm^-1) V0 (cm^-1) mass delta(\AA) eta0 eps1 eps2 deltaQ \n python driver.py -m DoubleWell -o 500,2085,1837,0.00,1,0,0,1\n""" diff --git a/drivers/py/pes/spline.py b/drivers/py/pes/spline.py index 9e269bb0e..eb7de4ea4 100644 --- a/drivers/py/pes/spline.py +++ b/drivers/py/pes/spline.py @@ -16,8 +16,9 @@ __DRIVER_NAME__ = "spline" __DRIVER_CLASS__ = "Spline_driver" + class Spline_driver(Dummy_driver): - def __init__(self, args=None,verbose=None): + def __init__(self, args=None, verbose=None): self.error_msg = """\nspline driver requires specification of filename that contains 5 columns (pos, f1,f2,f3,e) to perform 3x1D spline.\nExample: python driver.py -m spline -u -o \n""" super(Spline_driver, self).__init__(args) self.get_spline() From 390e32fdd689839a1c21f2c3399a902f644c955c Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 12 Dec 2023 18:17:48 +0000 Subject: [PATCH 114/120] delete unused imports --- drivers/py/pes/bath.py | 8 -------- drivers/py/pes/doubledoublewell.py | 3 ++- drivers/py/pes/doublewell.py | 1 - drivers/py/pes/doublewell_with_bath.py | 1 - 4 files changed, 2 insertions(+), 11 deletions(-) diff --git a/drivers/py/pes/bath.py b/drivers/py/pes/bath.py index daec8d2c5..f4d62d95e 100644 --- a/drivers/py/pes/bath.py +++ b/drivers/py/pes/bath.py @@ -1,14 +1,6 @@ """ Harmonic Bath """ -import sys - -try: - from .dummy import Dummy_driver -except: - from dummy import Dummy_driver import numpy as np -from ipi.utils import units -import json __DRIVER_NAME__ = None __DRIVER_CLASS__ = "driver_tools" diff --git a/drivers/py/pes/doubledoublewell.py b/drivers/py/pes/doubledoublewell.py index 459017d8e..259018e95 100644 --- a/drivers/py/pes/doubledoublewell.py +++ b/drivers/py/pes/doubledoublewell.py @@ -4,11 +4,12 @@ try: from .dummy import Dummy_driver + from .bath import Harmonic_Bath_explicit except: from dummy import Dummy_driver + from .bath import Harmonic_Bath_explicit import numpy as np from ipi.utils import units -import json __DRIVER_NAME__ = "double_double_well" __DRIVER_CLASS__ = "DDW_with_explicit_bath_driver" diff --git a/drivers/py/pes/doublewell.py b/drivers/py/pes/doublewell.py index 6e0b8afe6..c46f90a61 100644 --- a/drivers/py/pes/doublewell.py +++ b/drivers/py/pes/doublewell.py @@ -9,7 +9,6 @@ import numpy as np from ipi.utils import units -import json __DRIVER_NAME__ = "DW" diff --git a/drivers/py/pes/doublewell_with_bath.py b/drivers/py/pes/doublewell_with_bath.py index ccd2774a9..8f0a00d72 100644 --- a/drivers/py/pes/doublewell_with_bath.py +++ b/drivers/py/pes/doublewell_with_bath.py @@ -11,7 +11,6 @@ import numpy as np from ipi.utils import units -import json __DRIVER_NAME__ = "DW_bath" From b11533b4f19a24da7477ed2280643fcecd2b6ea7 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Mar 2024 07:51:43 +0000 Subject: [PATCH 115/120] lint --- ipi/engine/initializer.py | 10 +++++++--- ipi/engine/motion/geop.py | 18 +++++++++--------- ipi/interfaces/sockets.py | 4 +++- tools/py/energy_ppi.py | 4 +++- 4 files changed, 22 insertions(+), 14 deletions(-) diff --git a/ipi/engine/initializer.py b/ipi/engine/initializer.py index 03ee134ad..4be127c65 100644 --- a/ipi/engine/initializer.py +++ b/ipi/engine/initializer.py @@ -360,9 +360,13 @@ def init_stage1(self, simul): """ if simul.beads.nbeads == 0: - fpos = fmom = fmass = flab = fcell = ( - False # we don't have an explicitly defined beads object yet - ) + fpos = ( + fmom + ) = ( + fmass + ) = ( + flab + ) = fcell = False # we don't have an explicitly defined beads object yet else: fpos = fmom = fmass = flab = fcell = True diff --git a/ipi/engine/motion/geop.py b/ipi/engine/motion/geop.py index 6a525dd00..c7d02ca99 100755 --- a/ipi/engine/motion/geop.py +++ b/ipi/engine/motion/geop.py @@ -481,9 +481,9 @@ def step(self, step=None): # Restore dimensionality of d and invhessian self.d[:, self.gm.fixatoms_mask] = masked_d - self.invhessian[np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask)] = ( - masked_invhessian - ) + self.invhessian[ + np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask) + ] = masked_invhessian else: fdf0 = (self.old_u, -self.old_f) @@ -576,9 +576,9 @@ def step(self, step=None): ) # Restore dimensionality of the hessian - self.hessian[np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask)] = ( - masked_hessian - ) + self.hessian[ + np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask) + ] = masked_hessian else: # Make one step. ( A step is finished when a movement is accepted) BFGSTRM( @@ -794,9 +794,9 @@ def step(self, step=None): ) # Restore dimensionality of the invhessian - self.invhessian[np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask)] = ( - masked_invhessian - ) + self.invhessian[ + np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask) + ] = masked_invhessian else: fdf0 = (self.old_u, -self.old_f) diff --git a/ipi/interfaces/sockets.py b/ipi/interfaces/sockets.py index 6cd39cabc..d3b50c7c9 100644 --- a/ipi/interfaces/sockets.py +++ b/ipi/interfaces/sockets.py @@ -886,7 +886,9 @@ def dispatch_free_client(self, fc, match_ids="any", send_threads=[]): # makes sure the request is marked as running and the client included in the jobs list fc.locked = fc.lastreq is r["id"] - r["offset"] = ( + r[ + "offset" + ] = ( self.offset ) # transmits with the request an offset value for the energy (typically zero) diff --git a/tools/py/energy_ppi.py b/tools/py/energy_ppi.py index 40607602d..d732573ae 100755 --- a/tools/py/energy_ppi.py +++ b/tools/py/energy_ppi.py @@ -152,7 +152,9 @@ def totalEnergy(prefix, temp, ss=0): rc[:] - q[j, i * 3 : i * 3 + 3], f[j, i * 3 : i * 3 + 3] ) - ePA *= 0.5 * nbeads * (Constants.kb * temperature) ** 2 / Constants.hbar**2 + ePA *= ( + 0.5 * nbeads * (Constants.kb * temperature) ** 2 / Constants.hbar**2 + ) ePA += 0.5 * nbeads * (3 * natoms) * Constants.kb * temperature + U f2ePA = f2 * ePA eVir /= 2.0 * nbeads From dfd07887330fe628fb8083dde78bbf8ad3ca9826 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Mar 2024 08:01:11 +0000 Subject: [PATCH 116/120] extend help information in input/motion/instanton --- ipi/inputs/motion/instanton.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 275329b49..7c93331e2 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -132,18 +132,18 @@ class InputInst(InputDictionary): ), "friction": ( InputValue, - {"dtype": bool, "default": False, "help": "Activates Friction."}, + {"dtype": bool, "default": False, "help": "Activates Friction. Add additional terms to the RP related to a position-independent frictional force. See Eq. 20 in J. Chem. Phys. 156, 194106 (2022)"}, ), "frictionSD": ( InputValue, - {"dtype": bool, "default": True, "help": "Activates SD Friction."}, + {"dtype": bool, "default": True, "help": "Activates SD Friction. Add additional terms to the RP related to a position-dependent frictional force. See Eq. 32 in J. Chem. Phys. 156, 194106 (2022)"}, ), "fric_spec_dens": ( InputArray, { "dtype": float, "default": input_default(factory=np.ones, args=(0,)), - "help": "Laplace Transform (LT) of friction. A two column data is expected. First column: w (cm^-1). Second column: LT(eta)(w)", + "help": "Laplace Transform (LT) of friction. A two column data is expected. First column: w (cm^-1). Second column: LT(eta)(w). See Eq. 11 in J. Chem. Phys. 156, 194106 (2022). Note that within the separable coupling approximation the frequency dependence of the friction tensor is position independent.", }, ), "fric_spec_dens_ener": ( From c1dc10cbe56ff167facdde68133c4f96154c2214 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Mar 2024 08:03:36 +0000 Subject: [PATCH 117/120] lint --- ipi/inputs/motion/instanton.py | 12 ++++++++++-- 1 file changed, 10 insertions(+), 2 deletions(-) diff --git a/ipi/inputs/motion/instanton.py b/ipi/inputs/motion/instanton.py index 7c93331e2..fd4c8a36a 100644 --- a/ipi/inputs/motion/instanton.py +++ b/ipi/inputs/motion/instanton.py @@ -132,11 +132,19 @@ class InputInst(InputDictionary): ), "friction": ( InputValue, - {"dtype": bool, "default": False, "help": "Activates Friction. Add additional terms to the RP related to a position-independent frictional force. See Eq. 20 in J. Chem. Phys. 156, 194106 (2022)"}, + { + "dtype": bool, + "default": False, + "help": "Activates Friction. Add additional terms to the RP related to a position-independent frictional force. See Eq. 20 in J. Chem. Phys. 156, 194106 (2022)", + }, ), "frictionSD": ( InputValue, - {"dtype": bool, "default": True, "help": "Activates SD Friction. Add additional terms to the RP related to a position-dependent frictional force. See Eq. 32 in J. Chem. Phys. 156, 194106 (2022)"}, + { + "dtype": bool, + "default": True, + "help": "Activates SD Friction. Add additional terms to the RP related to a position-dependent frictional force. See Eq. 32 in J. Chem. Phys. 156, 194106 (2022)", + }, ), "fric_spec_dens": ( InputArray, From 714fd5d07389c1b992a43f32f28c03eed48d7ddc Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Mar 2024 08:08:32 +0000 Subject: [PATCH 118/120] lint with correct black version --- drivers/py/pes/doubledoublewell.py | 1 - ipi/engine/initializer.py | 10 +++------- ipi/engine/motion/geop.py | 18 +++++++++--------- ipi/engine/motion/instanton.py | 2 -- ipi/interfaces/sockets.py | 4 +--- tools/py/energy_ppi.py | 4 +--- 6 files changed, 14 insertions(+), 25 deletions(-) diff --git a/drivers/py/pes/doubledoublewell.py b/drivers/py/pes/doubledoublewell.py index 259018e95..492648d4d 100644 --- a/drivers/py/pes/doubledoublewell.py +++ b/drivers/py/pes/doubledoublewell.py @@ -29,7 +29,6 @@ class DDW_with_explicit_bath_driver(Dummy_driver): - """Adds to a double-double well (DDW) potential coupled to two (explicit) harmonic baths. pos[0:2] = DDW pos[2:n//2+1] = bath1 diff --git a/ipi/engine/initializer.py b/ipi/engine/initializer.py index 4be127c65..03ee134ad 100644 --- a/ipi/engine/initializer.py +++ b/ipi/engine/initializer.py @@ -360,13 +360,9 @@ def init_stage1(self, simul): """ if simul.beads.nbeads == 0: - fpos = ( - fmom - ) = ( - fmass - ) = ( - flab - ) = fcell = False # we don't have an explicitly defined beads object yet + fpos = fmom = fmass = flab = fcell = ( + False # we don't have an explicitly defined beads object yet + ) else: fpos = fmom = fmass = flab = fcell = True diff --git a/ipi/engine/motion/geop.py b/ipi/engine/motion/geop.py index c7d02ca99..6a525dd00 100755 --- a/ipi/engine/motion/geop.py +++ b/ipi/engine/motion/geop.py @@ -481,9 +481,9 @@ def step(self, step=None): # Restore dimensionality of d and invhessian self.d[:, self.gm.fixatoms_mask] = masked_d - self.invhessian[ - np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask) - ] = masked_invhessian + self.invhessian[np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask)] = ( + masked_invhessian + ) else: fdf0 = (self.old_u, -self.old_f) @@ -576,9 +576,9 @@ def step(self, step=None): ) # Restore dimensionality of the hessian - self.hessian[ - np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask) - ] = masked_hessian + self.hessian[np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask)] = ( + masked_hessian + ) else: # Make one step. ( A step is finished when a movement is accepted) BFGSTRM( @@ -794,9 +794,9 @@ def step(self, step=None): ) # Restore dimensionality of the invhessian - self.invhessian[ - np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask) - ] = masked_invhessian + self.invhessian[np.ix_(self.gm.fixatoms_mask, self.gm.fixatoms_mask)] = ( + masked_invhessian + ) else: fdf0 = (self.old_u, -self.old_f) diff --git a/ipi/engine/motion/instanton.py b/ipi/engine/motion/instanton.py index d077c87a4..0ea375a36 100644 --- a/ipi/engine/motion/instanton.py +++ b/ipi/engine/motion/instanton.py @@ -255,7 +255,6 @@ def step(self, step=None): class PesMapper(object): - """Creation of the multi-dimensional function to compute the physical potential and forces Attributes: @@ -408,7 +407,6 @@ def evaluate(self): class FrictionMapper(PesMapper): - """Creation of the multi-dimensional function to compute the physical potential and forces, as well as the friction terms""" diff --git a/ipi/interfaces/sockets.py b/ipi/interfaces/sockets.py index d3b50c7c9..6cd39cabc 100644 --- a/ipi/interfaces/sockets.py +++ b/ipi/interfaces/sockets.py @@ -886,9 +886,7 @@ def dispatch_free_client(self, fc, match_ids="any", send_threads=[]): # makes sure the request is marked as running and the client included in the jobs list fc.locked = fc.lastreq is r["id"] - r[ - "offset" - ] = ( + r["offset"] = ( self.offset ) # transmits with the request an offset value for the energy (typically zero) diff --git a/tools/py/energy_ppi.py b/tools/py/energy_ppi.py index d732573ae..40607602d 100755 --- a/tools/py/energy_ppi.py +++ b/tools/py/energy_ppi.py @@ -152,9 +152,7 @@ def totalEnergy(prefix, temp, ss=0): rc[:] - q[j, i * 3 : i * 3 + 3], f[j, i * 3 : i * 3 + 3] ) - ePA *= ( - 0.5 * nbeads * (Constants.kb * temperature) ** 2 / Constants.hbar**2 - ) + ePA *= 0.5 * nbeads * (Constants.kb * temperature) ** 2 / Constants.hbar**2 ePA += 0.5 * nbeads * (3 * natoms) * Constants.kb * temperature + U f2ePA = f2 * ePA eVir /= 2.0 * nbeads From f856e64897348d0fb69802bbaac0c1f92db5fa1a Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Mar 2024 08:41:54 +0000 Subject: [PATCH 119/120] fix small bugfix created during merge in harmonic python driver --- drivers/py/pes/harmonic.py | 12 ++++-------- .../{harmonic => harmonic_f90}/files_to_check.txt | 0 .../NVE/NVE_1/{harmonic => harmonic_f90}/init.xyz | 0 .../NVE/NVE_1/{harmonic => harmonic_f90}/input.xml | 0 .../ref_simulation.frc_c.xyz | 0 .../ref_simulation.mom_c.xyz | 0 .../{harmonic => harmonic_f90}/ref_simulation.out | 0 .../ref_simulation.pos_c.xyz | 0 .../ref_simulation.vel_c.xyz | 0 .../{harmonic => harmonic_f90}/test_settings.dat | 0 10 files changed, 4 insertions(+), 8 deletions(-) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/files_to_check.txt (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/init.xyz (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/input.xml (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/ref_simulation.frc_c.xyz (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/ref_simulation.mom_c.xyz (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/ref_simulation.out (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/ref_simulation.pos_c.xyz (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/ref_simulation.vel_c.xyz (100%) rename ipi_tests/regression_tests/tests/NVE/NVE_1/{harmonic => harmonic_f90}/test_settings.dat (100%) diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index 965bdcf8a..f200888d0 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -19,16 +19,12 @@ def __init__(self, args=None, verbose=False): def check_arguments(self): """Function that checks the arguments required to run the driver""" - try: - k = list(map(float, self.args.split(","))) - except ValueError: - sys.exit(self.error_msg) - if len(k) == 1: - self.k = k[0] + if len(self.args) == 1: + self.k = float(self.args[0]) self.type = "isotropic" - elif len(k) == 3: - self.k = k + elif len(self.args) == 3: + self.k = np.asarray(list(map(float,self.args))) self.type = "non-isotropic" else: sys.exit(self.error_msg) diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/files_to_check.txt b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/files_to_check.txt similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/files_to_check.txt rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/files_to_check.txt diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/init.xyz b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/init.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/init.xyz rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/init.xyz diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/input.xml b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/input.xml similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/input.xml rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/input.xml diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.frc_c.xyz b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.frc_c.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.frc_c.xyz rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.frc_c.xyz diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.mom_c.xyz b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.mom_c.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.mom_c.xyz rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.mom_c.xyz diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.out b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.out similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.out rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.out diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.pos_c.xyz b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.pos_c.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.pos_c.xyz rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.pos_c.xyz diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.vel_c.xyz b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.vel_c.xyz similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/ref_simulation.vel_c.xyz rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/ref_simulation.vel_c.xyz diff --git a/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/test_settings.dat b/ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/test_settings.dat similarity index 100% rename from ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic/test_settings.dat rename to ipi_tests/regression_tests/tests/NVE/NVE_1/harmonic_f90/test_settings.dat From 21d4307a413d09815ff5a22fe9943513ed92d0a1 Mon Sep 17 00:00:00 2001 From: Yair Litman Date: Tue, 5 Mar 2024 08:44:16 +0000 Subject: [PATCH 120/120] lint --- drivers/py/pes/harmonic.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/drivers/py/pes/harmonic.py b/drivers/py/pes/harmonic.py index f200888d0..d92f7bac9 100644 --- a/drivers/py/pes/harmonic.py +++ b/drivers/py/pes/harmonic.py @@ -24,7 +24,7 @@ def check_arguments(self): self.k = float(self.args[0]) self.type = "isotropic" elif len(self.args) == 3: - self.k = np.asarray(list(map(float,self.args))) + self.k = np.asarray(list(map(float, self.args))) self.type = "non-isotropic" else: sys.exit(self.error_msg)